diff --git a/.Rhistory b/.Rhistory index 97ff8ae14324425df3fa0294343461689c85ea38..23867cfd3e2ace9be782c58cb62d9c5057e795e6 100644 --- a/.Rhistory +++ b/.Rhistory @@ -1,512 +1,512 @@ -group = vector(mode = "list", length = length(x)) -for(i in seq_along(x)){ -if(str_detect(x[[i]], "Characteristic|Parameter|Factor|Component")){ -group[[i]] <- tibble(id = x[[i]]) -if(str_detect(x[[i+1]], "Unit")) { -group[[i]] <- group[[i]] %>% mutate(isa_unit = x[[i+1]]) -if(str_detect(x[[i+2]], "Term Source REF")) { -group[[i]] <- group[[i]] %>% mutate(term_source = x[[i+2]]) -if(str_detect(x[[i+3]], "Term Accession Number")){ -group[[i]] <- group[[i]] %>% mutate(term_acc = x[[i+3]]) } } -} else if(str_detect(x[[i+1]], "Term Source REF")) { -group[[i]] <- group[[i]] %>% mutate(term_source = x[[i+1]]) -if(str_detect(x[[i+2]], "Term Accession Number")){ -group[[i]] <- group[[i]] %>% mutate(term_acc = x[[i+2]]) -} -} -} else if(str_detect(x[[i]], "Source REF|Accession Number|Unit",negate = T)){ -group[[i]] <- tibble(id = x[[i]]) -} -} -group_tib <- group %>% -discard(.p = is.null) %>% -reduce(.f = bind_rows) -assign(output_name,group_tib, pos = 1) -} -break_lines(sam_dat1, "output_samdat") -break_lines(isa_ext, "output_ext") -break_lines(isa_gc, "output_gc") -View(output_gc) -output <- bind_rows(output_samdat, -output_ext, -output_gc, -output_ms) -beak_lines(isa_ms, "output_ms") -break_lines(isa_ms, "output_ms") -output <- bind_rows(output_samdat, -output_ext, -output_gc, -output_ms) -here() -getwd() -setwd(here())# Not recommended but convenient in Rstudio to start from root -write.xlsx(output, -here("assays/cmQTL_val1_GH_2020_GC_MS/dataset/isa.dataset_temp.xlsx")) -here(out, -"cmQTL_val_1_2_met_dat_GC.csv" +dev.off() +heat.GC <- fc %>% +group_by(Compound_Name, met) %>% +mutate(log_norm = log2(mean_fc), +log_norm = if_else(is.infinite(log_norm), 0, log_norm), +log_norm_level = (log_norm - mean(log_norm))/(max(log_norm)-min(log_norm))) %>% +ungroup() %>% +#mutate(group = as_factor(str_c(tissue, treatment, genotype, sep = "_"))) %>% +pivot_wider(id_cols = c(Compound_Name, met), +names_from = group, +values_from = log_norm) %>% +left_join(GC_classes) %>% +arrange(Compound_Class, Compound_Name) %>% +as.data.frame() +norm_MM <- means %>% +filter(genotype == "MoneyMaker") %>% +select(tissue, treatment, met, MM_mean = mean) +fc <- means_tec_rep %>% +left_join(norm_MM) %>% +mutate(fc = mean_tec_rep/MM_mean) %>% +group_by(tissue, treatment, alias, genotype, met) %>% +summarise(mean_fc = mean(fc), +sd = sd(fc), +n = n()) %>% +mutate(se = sd/sqrt(n), +group = as_factor(str_c(tissue, treatment, genotype, sep = "_"))) %>% +left_join(sig_GC, by = c("tissue", "treatment", "met", "alias" = "group2")) %>% +group_by(met) %>% +filter(any(p.signif == "*"), all(is.finite(mean_fc)), tissue != "flowers") %>% +left_join(met_dat) %>% +arrange(Compound_Class, Compound_Name) %>% +ungroup() %>% +mutate(genotype = as_factor(if_else(genotype == "MoneyMaker", glue("{genotype}"),glue("*{genotype}*"))), +genotype = fct_relevel(genotype, c("MoneyMaker", "*panK4-1*", "*log2-1*", "*transp1-1*"))) +fc <- means_tec_rep %>% +left_join(norm_MM) %>% +mutate(fc = mean_tec_rep/MM_mean) %>% +group_by(tissue, treatment, alias, genotype, met) %>% +summarise(mean_fc = mean(fc), +sd = sd(fc), +n = n()) %>% +mutate(se = sd/sqrt(n), +group = as_factor(str_c(tissue, treatment, genotype, sep = "_"))) %>% +left_join(sig_GC, by = c("tissue", "treatment", "met", "alias" = "group2")) %>% +group_by(met) %>% +filter(any(p.signif == "*"), all(is.finite(mean_fc)), tissue != "flowers") %>% +left_join(met_dat) %>% +left_join(GC_classes) %>% +arrange(Compound_Class, Compound_Name) %>% +ungroup() %>% +mutate(genotype = as_factor(if_else(genotype == "MoneyMaker", glue("{genotype}"),glue("*{genotype}*"))), +genotype = fct_relevel(genotype, c("MoneyMaker", "*panK4-1*", "*log2-1*", "*transp1-1*"))) +heat.GC <- fc %>% +group_by(Compound_Name, met) %>% +mutate(log_norm = log2(mean_fc), +log_norm = if_else(is.infinite(log_norm), 0, log_norm), +log_norm_level = (log_norm - mean(log_norm))/(max(log_norm)-min(log_norm))) %>% +ungroup() %>% +#mutate(group = as_factor(str_c(tissue, treatment, genotype, sep = "_"))) %>% +pivot_wider(id_cols = c(Compound_Name, met), +names_from = group, +values_from = log_norm) %>% +left_join(GC_classes) %>% +arrange(Compound_Class, Compound_Name) %>% +as.data.frame() +heat.GC <- fc %>% +group_by(Compound_Name, met) %>% +mutate(log_norm = log2(mean_fc), +log_norm = if_else(is.infinite(log_norm), 0, log_norm), +log_norm_level = (log_norm - mean(log_norm))/(max(log_norm)-min(log_norm))) %>% +ungroup() %>% +#mutate(group = as_factor(str_c(tissue, treatment, genotype, sep = "_"))) %>% +pivot_wider(id_cols = c(Compound_Name, met), +names_from = group, +values_from = log_norm) %>% +#left_join(GC_classes) %>% +arrange(Compound_Class, Compound_Name) %>% +as.data.frame() +heat.GC <- fc %>% +group_by(Compound_Name, met) %>% +mutate(log_norm = log2(mean_fc), +log_norm = if_else(is.infinite(log_norm), 0, log_norm), +log_norm_level = (log_norm - mean(log_norm))/(max(log_norm)-min(log_norm))) %>% +ungroup() %>% +#mutate(group = as_factor(str_c(tissue, treatment, genotype, sep = "_"))) %>% +pivot_wider(id_cols = c(Compound_Name, Compound_Class, met), +names_from = group, +values_from = log_norm) %>% +#left_join(GC_classes) %>% +arrange(Compound_Class, Compound_Name) %>% +as.data.frame() +rownames(heat.GC) <- heat.GC$met +mat.heat.GC <- heat.GC %>% +select(contains("leaf"), contains("fruit")) %>% as.matrix() +annotation_row <- heat.GC %>% +select(Compound_Class) +rownames(annotation_row) <- heat.GC$met +annotation_col <- sam_dat %>% +filter(exp == 1, class == "sample") %>% +distinct(tissue, treatment, genotype) %>% +mutate(group = as_factor(str_c(tissue, treatment, genotype, sep = "_"))) %>% +as.data.frame() +rownames(annotation_col) <- annotation_col$group +annotation_col <- annotation_col %>% +select(-group, treatment, tissue, genotype) +heat.GC_signif <- means %>% +distinct(tissue, treatment, alias, genotype, met) %>% +#filter(genotype != "MoneyMaker") %>% +left_join(sig_GC, by = c("met", "tissue", "treatment", "alias" = "group2")) %>% +left_join(sig_mets) %>% +filter(sig == T) %>% +mutate(group = as_factor(str_c(tissue, treatment, genotype, sep = "_")), +signif = if_else(p.signif == "ns"| is.na(p.signif), "","X")) %>% +pivot_wider(id_cols = c(met), +names_from = group, +values_from = signif) %>% +left_join(met_dat) %>% +left_join(GC_classes) %>% +arrange(Compound_Class, Compound_Name) %>% +as.data.frame() +heat_cols <- colnames(mat.heat.GC) +rownames(heat.GC_signif) <- heat.GC_signif$met +mat.heat.GC_signif <- heat.GC_signif %>% +select(all_of(heat_cols)) %>% as.matrix() +ann_colors = list( +tissue = c(fruit = "red",leaf = "darkgreen"), +genotype = c(MoneyMaker = "yellow", `panK4-1` = "brown", `log2-1` = "blue", `transp1-1` = "grey"), +treatment = c("0.4" = "red", "0.6" = "orange", "0.8" = "yellow", "1" = "green")) +pheatmap.GC <- pheatmap(mat.heat.GC, +#color = RColorBrewer::brewer.pal(7,"BuRd"), +#cellwidth = 16, +#cellheight = 4, +#breaks = c(-2.5,-1.5, -0.5 ,0.5,1.5,2.5), +cluster_rows = T, +cluster_cols = T, +annotation_names_row = F, +show_rownames = F, +annotation_row = annotation_row, +annotation_col = annotation_col, +display_numbers = mat.heat.GC_signif, +number_color = "black", +fontsize_number = 6, +angle_col = 45, +fontsize_col = 6, +annotation_colors = ann_colors, +filename = str_c(str_replace_all(Sys.Date(),"^.{2}|-",""), +"cmQTL_val_1_heatmap_rel_tissue_wt.jpg", +sep = "_") ) -here(out, -"cmQTL_val_1_2_sam_dat_GC.csv" +pheatmap.GC <- pheatmap(mat.heat.GC, +#color = RColorBrewer::brewer.pal(7,"BuRd"), +#cellwidth = 16, +#cellheight = 4, +#breaks = c(-2.5,-1.5, -0.5 ,0.5,1.5,2.5), +cluster_rows = T, +cluster_cols = T, +annotation_names_row = F, +show_rownames = F, +annotation_row = annotation_row, +annotation_col = annotation_col, +display_numbers = mat.heat.GC_signif, +number_color = "black", +fontsize_number = 6, +angle_col = 45, +fontsize_col = 6, +annotation_colors = ann_colors, +filename = here(out, +"cmQTL_val_1_heatmap_rel_tissue_wt.jpg") ) -View(isa_ms) -View(isa_ms_tidy) -1176-1145 -source("C:/Users/Micha/Nextcloud/Data_Plant/cmqtl_val1_arc/workflows/GC_MS_normalization/210927_primary_normalization_with_split.R", echo=TRUE) -#PCA testing chunk#### -##https://www.intechopen.com/books/metabolomics-fundamentals-and-applications/processing-and-visualization-of-metabolomics-data-using-r -#exp1 -pca_base <- features_all %>% -ungroup() %>% -filter(exp == 1) %>% -arrange(batch_pca, daily_num) %>% -mutate(log_imp = log2(imp)) %>% -pivot_wider(id_cols = c(tissue, treatment, batch_GC, daily_num, class, machine_num_GC), +GC_tidy <- means_tec_rep_lt %>% +pivot_wider(id_cols = c( genotype, alias, treatment, tissue, LIMS_ID), names_from = met, -values_from = linnorm_fw_log) %>% -filter(!is.na(m_1)) -pca <- summary(prcomp( -pca_base%>% -select(starts_with("m_")))) -sam_vars <- pca_base %>% select(-starts_with("m_")) %>% colnames() -pca_plot <- as_tibble(pca$x) %>% -mutate(join_num = 1:nrow(pca$x)) %>% -left_join(pca_base %>% -mutate(join_num=1:nrow(pca$x))) %>% -#left_join(sam_dat) %>% -mutate(batch_GC= as_factor(batch_GC), -class= as_factor(class)) %>% -select(all_of(sam_vars), everything()) -exp_var <- as_tibble(pca[["importance"]]) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = tissue)) + -stat_ellipse(aes(x=PC1, y=PC2, color = tissue)) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -ggsave(here(out, -"cmQTL_val1_tissue_lin_PCA.jpg" -), -width = 183, -height = 100, -units = "mm", -dpi = 300) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = treatment)) + -stat_ellipse(aes(x=PC1, y=PC2, color = treatment)) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -ggsave(here(out, -"cmQTL_val1_treatment_PCA.jpg" -), -width = 183, -height = 100, -units = "mm", -dpi = 300) -dev.off() -pca_base <- features_all %>% +values_from = lev_t) %>% +mutate(group = str_c(tissue, treatment, alias, sep = "_")) +miss_per_clust <- GC_long %>% +group_by(met, tissue) %>% +summarise(na = sum(is.na(area)), +n = n()) %>% ungroup() %>% -filter(exp == 1) %>% -arrange(batch_pca, daily_num) %>% -mutate(log_imp = log2(imp)) %>% -pivot_wider(id_cols = c(tissue, treatment, batch_GC, daily_num, class, machine_num_GC), -names_from = met, -values_from = loess_norm_fw_log) %>% -filter(!is.na(m_1)) -pca <- summary(prcomp( -pca_base%>% -select(starts_with("m_")))) -sam_vars <- pca_base %>% select(-starts_with("m_")) %>% colnames() -pca_plot <- as_tibble(pca$x) %>% -mutate(join_num = 1:nrow(pca$x)) %>% -full_join(pca_base %>% -mutate(join_num=1:nrow(pca$x))) %>% -#left_join(sam_dat) %>% -mutate(batch_pca= as_factor(batch_GC), -class= as_factor(class)) %>% -select(all_of(sam_vars), everything()) -exp_var <- as_tibble(pca[["importance"]]) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = tissue)) + -stat_ellipse(aes(x=PC1, y=PC2, color = tissue)) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -ggsave(here(out, -"cmQTL_val1_tissue_loess_PCA.jpg" -), -width = 183, -height = 100, -units = "mm", -dpi = 300) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = treatment)) + -stat_ellipse(aes(x=PC1, y=PC2, color = treatment)) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -ggsave(here(out, -"cmQTL_val1_treatment_loess_PCA.jpg" -), -width = 183, -height = 100, -units = "mm", -dpi = 300) -pca_base <- features_all %>% +mutate(percent_na_clust = na/n*100) %>% +select(met, tissue, percent_na_clust) +miss_any_treat <- miss_per_treat %>% +group_by(met, tissue) %>% +summarise(miss_comp_treat = if_else(any(percent_na == 100), T,F)) +means_tec_rep_lt <- means_tec_rep %>% +group_by(met, tissue, treatment, genotype, alias) %>% +mutate(lev_t = abs(log10(mean_tec_rep) - log10(median(mean_tec_rep)))) %>% +ungroup() +means_lt <- means_tec_rep_lt %>% ungroup() %>% -filter(exp == 2) %>% -arrange(batch_pca, daily_num) %>% -mutate(log_imp = log2(isnorm)) %>% -pivot_wider(id_cols = c(tissue, treatment, batch_GC, daily_num, class, machine_num_GC), -names_from = met, -values_from = log_imp) -pca <- summary(prcomp( -pca_base%>% -select(starts_with("m_")))) -sam_vars <- pca_base %>% select(-starts_with("m_")) %>% colnames() -pca_plot <- as_tibble(pca$x) %>% -mutate(join_num = 1:nrow(pca$x)) %>% -full_join(pca_base %>% -mutate(join_num=1:nrow(pca$x))) %>% -#left_join(sam_dat) %>% -mutate(batch_pca= as_factor(batch_GC), -class= as_factor(class)) %>% -select(all_of(sam_vars), everything()) -exp_var <- as_tibble(pca[["importance"]]) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = class)) + -stat_ellipse(aes(x=PC1, y=PC2, color = class)) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = batch_GC)) + -stat_ellipse(aes(x=PC1, y=PC2, color = batch_GC)) + -geom_text(aes(x = PC1, y = PC2, -label = if_else(machine_num_GC %in% exclude_samples, machine_num_GC, ""))) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -ggsave(here(out, -"cmQTL_val1_treatment_loess_outlier_exp2_loess_norm_PCA.jpg" -), -width = 183, -height = 100, -units = "mm", -dpi = 300) -for(tiss in seq_along(tissues)){ -pca_base <- features_all %>% +group_by(met, tissue, treatment, genotype, alias) %>% +summarise(mean = mean(lev_t), +sd = sd(lev_t), +n = n()) %>% ungroup() %>% -filter(exp == 1, tissue == tissues[[tiss]]) %>% -arrange(batch_pca, daily_num) %>% -mutate(log_imp = log2(imp)) %>% -pivot_wider(id_cols = c(tissue, treatment,batch_GC, daily_num, class, machine_num_GC), +mutate(se = sd/sqrt(n)) +GC_tidy <- means_tec_rep_lt %>% +pivot_wider(id_cols = c(genotype, alias, treatment, tissue, LIMS_ID), names_from = met, -values_from = loess_norm_fw_log) %>% -filter(!is.na(m_1)) -pca <- summary(prcomp( -pca_base%>% -select(starts_with("m_")))) -sam_vars <- pca_base %>% select(-starts_with("m_")) %>% colnames() -pca_plot <- as_tibble(pca$x) %>% -mutate(join_num = 1:nrow(pca$x)) %>% -full_join(pca_base %>% -mutate(join_num=1:nrow(pca$x))) %>% -left_join(sam_dat) %>% -mutate(batch_pca= as_factor(batch_GC), -class= as_factor(class)) %>% -select(all_of(sam_vars), everything()) -exp_var <- as_tibble(pca[["importance"]]) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = treatment)) + -stat_ellipse(aes(x=PC1, y=PC2, color = treatment)) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -ggsave(here(out, -"cmQTL_val1", tissues[[tiss]], "treatment_loess_PCA.jpg" -), -width = 183, -height = 100, -units = "mm", -dpi = 300) +values_from = lev_t) %>% +mutate(group = str_c(tissue, treatment, alias, sep = "_")) +GC_tidy_numeric <- GC_tidy %>% +select(all_of(mets)) +GC_t <- map(.x = GC_tidy_numeric, +.f = ~pairwise.t.test(x = .x , +g = GC_tidy$group, +p.adjust.method = "none", +pool.sd = F)) %>% +map(.f = tidy) +GC_t_tidy <- GC_t %>% +map2(.y = names(GC_t), .f = ~.x %>% mutate(var = .y)) %>% +purrr::reduce(bind_rows) +sig_GC_lt<- GC_t_tidy %>% +separate(group1, into = c("tissue1", "treatment1", "alias1"), sep = "_") %>% +separate(group2, into = c("tissue2", "treatment2", "alias2"), sep = "_") %>% +filter(alias1 == "967514 MM WT" | alias2 == "967514 MM WT", +tissue1 == tissue2, treatment1 == treatment2) %>% +group_by(var) %>% +mutate(adj.p.value = p.adjust(p.value)) %>% +#mutate(adj.p.value = p.value * 121) %>% +ungroup() %>% +mutate(p.signif = if_else(p.value <= 0.05, "*", "ns")) %>% +left_join(means_lt, by = c("var" = "met", "treatment1" = "treatment", "alias1" = "alias", "tissue1" = "tissue")) %>% +select(var, treatment1, treatment2, alias1, alias2, tissue1, tissue2, p.signif, mean1 = mean, se1 = se, p.value, adj.p.value) %>% +left_join(means_lt, by = c("var" = "met", "treatment2" = "treatment", "alias2" = "alias", "tissue2" = "tissue")) %>% +select(var, treatment1, treatment2, alias1, alias2, tissue1, tissue2, p.signif, mean1, mean2 = mean, se1, se2 = se, p.value, adj.p.value) %>% +group_by(treatment1, tissue1, var) %>% +mutate(tot_val1 = mean1 + se1, +tot_val2 = mean2 + se2, +y.position = 1.1*(max(tot_val1, tot_val2))) %>% +ungroup() %>% +rename(met = var, +group1 = alias1, +group2 = alias2, +treatment = treatment1, +tissue = tissue1) %>% +left_join(miss_per_treat) %>% +mutate(met = as_factor(met), +group1 = as_factor(group1), +group2 = as_factor(group2), +treatment = as_factor(treatment), +tissue = as_factor(tissue), +p.signif = if_else(percent_na >= 60, "ns", p.signif)) +sig_mets <- sig_GC_lt %>% +filter(p.signif == "*") %>% +distinct(met) %>% +mutate(sig = T) +norm_MM_1_lt <- means_lt %>% +filter(genotype == "MoneyMaker", treatment == 1) %>% +select(tissue, met, MM_mean = mean) +fc_1_lt <- means_tec_rep_lt %>% +#left_join(norm_MM_1) %>% +#mutate(fc = mean_tec_rep/MM_mean) %>% +group_by(tissue, treatment, alias, genotype, met) %>% +summarise(mean_fc = mean(lev_t), +sd = sd(lev_t), +n = n()) %>% +mutate(se = sd/sqrt(n), +group = as_factor(str_c(tissue, treatment, genotype, sep = "_"))) %>% +left_join(sig_GC_lt, by = c("tissue", "treatment", "met", "alias" = "group2")) %>% +group_by(met) %>% +#filter(any(p.signif == "*"), all(is.finite(mean_fc)), tissue != "flowers") %>% +left_join(met_dat) %>% +arrange(Compound_Class, Compound_Name) %>% +ungroup() %>% +mutate(genotype = as_factor(if_else(genotype == "MoneyMaker", glue("{genotype}"),glue("*{genotype}*"))), +genotype = fct_relevel(genotype, c("MoneyMaker", "*panK4-1*", "*log2-1*", "*transp1-1*"))) +fc_1_lt <- means_tec_rep_lt %>% +#left_join(norm_MM_1) %>% +#mutate(fc = mean_tec_rep/MM_mean) %>% +group_by(tissue, treatment, alias, genotype, met) %>% +summarise(mean_fc = mean(lev_t), +sd = sd(lev_t), +n = n()) %>% +mutate(se = sd/sqrt(n), +group = as_factor(str_c(tissue, treatment, genotype, sep = "_"))) %>% +left_join(sig_GC_lt, by = c("tissue", "treatment", "met", "alias" = "group2")) %>% +group_by(met) %>% +#filter(any(p.signif == "*"), all(is.finite(mean_fc)), tissue != "flowers") %>% +left_join(met_dat) %>% +left_join(GC_classes) %>% +arrange(Compound_Class, Compound_Name) %>% +ungroup() %>% +mutate(genotype = as_factor(if_else(genotype == "MoneyMaker", glue("{genotype}"),glue("*{genotype}*"))), +genotype = fct_relevel(genotype, c("MoneyMaker", "*panK4-1*", "*log2-1*", "*transp1-1*"))) +# CV analysis ------------------------------------------------------------- +library(bootstrap) +theta <- function(x){ +sd(x)/mean(x) } -sam_vars <- pca_base %>% select(-starts_with("m_")) %>% colnames() -pca_plot <- as_tibble(pca$x) %>% -mutate(join_num = 1:nrow(pca$x)) %>% -full_join(pca_base %>% -mutate(join_num=1:nrow(pca$x))) %>% -left_join(sam_dat) %>% -mutate(batch_pca= as_factor(batch_pca), -class= as_factor(class)) %>% -select(all_of(sam_vars), everything()) -exp_var <- as_tibble(pca[["importance"]]) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = tissue)) + -stat_ellipse(aes(x=PC1, y=PC2, color = tissue)) + -geom_text(aes(x = PC1, y = PC2, -label = if_else(machine_num_GC == "21106rA_31", machine_num_GC, "")), -nudge_y = -2, -nudge_x = 4) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -ggsave(here(out, -"cmQTL_val1_tissue_imp_PCA.jpg" -), -width = 183, -height = 100, -units = "mm", -dpi = 300) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = batch_GC)) + -stat_ellipse(aes(x=PC1, y=PC2, color = batch_GC)) + -geom_text(aes(x = PC1, y = PC2, -label = if_else(machine_num_GC == "21106rA_31", machine_num_GC, "")), -nudge_y = -2, -nudge_x = 4) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -ggsave(here(out, -"cmQTL_val1_batch_imp_PCA.jpg" -), -width = 183, -height = 100, -units = "mm", -dpi = 300) -pca_plot %>% -# filter(treatment == "HL") %>% -ggplot()+ -geom_jitter(aes(x=PC1, y=PC2, color = class)) + -stat_ellipse(aes(x=PC1, y=PC2, color = class)) + -geom_text(aes(x = PC1, y = PC2, -label = if_else(machine_num_GC == "21106rA_31", machine_num_GC, "")), -nudge_y = -2, -nudge_x = 4) + -ylab(str_c("PC2 ", "(", exp_var$PC2[[2]]*100, "%)")) + -xlab(str_c("PC1 ", "(", exp_var$PC1[[2]]*100, "%)")) -ggsave(here(out, -"cmQTL_val1_class_imp_PCA.jpg" -), -width = 183, -height = 100, -units = "mm", -dpi = 300) -#cmQTLval2 -pca_base <- features_all %>% +cv <- means %>% ungroup() %>% -filter(exp == 2, batch_GC == "3_split") %>% -arrange(batch_GC, daily_num) %>% -mutate(log_imp = log2(isnorm)) %>% -pivot_wider(id_cols = c(tissue, treatment, batch_GC, daily_num, class, machine_num_GC), +group_by(genotype, tissue, alias, met) %>% +summarise(grand_mean = mean(mean), +grand_sd = sd(mean), +n = n()) %>% +mutate(cv = grand_sd/grand_mean) +cv_jack <- means %>% +group_by(genotype, tissue, alias, met) %>% +summarise(cv = jackknife(mean, theta)$jack.values) %>% +mutate(jack_rep = row_number()) %>% +ungroup() +cv_jack <- means %>% +group_by(genotype, tissue, alias, met) %>% +reframe(cv = jackknife(mean, theta)$jack.values) %>% +mutate(jack_rep = row_number()) %>% +ungroup() +cv_jack_mean <- cv_jack %>% +group_by(genotype,tissue, alias, met) %>% +summarise(mean_cv = mean(cv), +sd_cv = sd(cv), +n = n()) %>% +ungroup() %>% +mutate(se_cv = sd_cv/sqrt(n)) +cv_jack_wide <- cv_jack %>% +pivot_wider(id_cols = c(genotype, tissue, alias, jack_rep), names_from = met, -values_from = log_imp)%>% -filter(!is.na(m_1)) -pca <- summary(prcomp( -pca_base%>% -select(starts_with("m_")))) -sam_vars <- pca_base %>% select(-starts_with("m_")) %>% colnames() -skip <- T -if(skip == T) { -} else{ -# Plot all metabolites ---------------------------------------------------- -plotmets <- features_all %>% distinct(met) %>% as_vector -plotmet_labs <- plotmets %>% as_tibble() %>% -left_join(met_dat, by= c("value" = "met")) %>% -#mutate(peak_num = base::rank(HMDB_clear_name, ties.method = "first"), -# dup = sum(peak_num), -# HMDB_clear_name_unique = if_else(dup>1, str_c(HMDB_clear_name, peak_num), HMDB_clear_name)) %>% -#ungroup() %>% -select(Compound_Name) %>% as_vector() -plot_out <- vector("list", length = length(plotmets)) -for (meta in seq_along(plotmets)) { -plot_out [[meta]] <- features_all %>% -mutate(xint = if_else(daily_num == 4, run_num_GC-3.5, max(run_num_GC)), -is_miss = as_factor(if_else(is.na(area), T, F))) %>% -filter(met == plotmets[[meta]]) %>% -filter(class!="blank") %>% -ggplot(aes(x=run_num_GC, y=isnorm)) + -geom_point(aes(color = class, shape = is_miss)) + -geom_point(aes(y=predict), color="black", size=0.1) + -geom_vline(aes(xintercept = xint))+ -# facet_grid(rows = vars(treatment), cols = vars(rep), scales = "free") + -ggtitle(label = plotmet_labs[[meta]]) -} -pdf(file = here(out,"_loess_fit.pdf")) -for (meta in seq_along(plotmets)) { -print(plot_out[[meta]]) -} -dev.off() -plot_out <- vector("list", length = length(plotmets)) -for (meta in seq_along(plotmets)) { -plot_out [[meta]] <- features_all %>% -mutate(xint = if_else(daily_num == 4, run_num_GC-3.5, max(run_num_GC))) %>% -filter(met == plotmets[[meta]]) %>% -filter(class!="blank") %>% -ggplot(aes(x=run_num_GC, y=loess_norm_fw_log)) + -geom_point(aes(color=class)) + -#geom_point(aes(y=predp), color="black", size=0.1) + -geom_vline(aes(xintercept = xint))+ -# facet_grid(rows = vars(treatment), cols = vars(rep), scales = "free") + -ggtitle(label = plotmet_labs[[meta]]) -} -pdf(file = here(out,"_loess_norm_fw_log.pdf")) -for (meta in seq_along(plotmets)) { -print(plot_out[[meta]]) -} -dev.off() -for (meta in seq_along(plotmets)) { -plot_out [[meta]] <- features_all %>% -mutate(is_miss = as_factor(if_else(is.na(area), T, F))) %>% -filter(met == plotmets[[meta]]) %>% -filter(class!="blank") %>% -ggplot(aes(x=daily_num, y=isnorm)) + -geom_point(aes(color = class, shape = is_miss)) + -geom_point(aes(y=predict), color="black", size=0.1) + -facet_wrap(facets = vars(batch_GC), nrow = 1, scales = "free") + -ggtitle(label = plotmet_labs[[meta]]) + -theme(axis.ticks.y = element_blank(), -axis.text.y = element_blank(), -panel.spacing = unit(-0.1,"lines")) -} -pdf(file = here(out,"_loess_norm_no_scale.pdf"), -height = 3.5) -for (meta in seq_along(plotmets)) { -print(plot_out[[meta]]) -} +values_from = cv) %>% +mutate(group = str_c(tissue, alias, sep = "_")) +cv_jack_numeric <- cv_jack_wide %>% +select(-c(genotype, tissue, alias, jack_rep, group)) +GC_cv_jack <- map(.x = cv_jack_numeric, .f = ~aov(.x ~ alias, data = cv_jack_wide)) +GC_jack_t <- map(.x = cv_jack_numeric, .f = ~pairwise.t.test(x = .x , g = cv_jack_wide$group, p.adjust.method = "none")) %>% +map(.f = tidy) +GC_jack_t_tidy <- GC_jack_t %>% +map2(.y = names(GC_jack_t), .f = ~.x %>% mutate(var = .y)) %>% +purrr::reduce(bind_rows) +sig_GC_cv_groups <- GC_jack_t_tidy %>% +separate(group1, into = c("tissue1", "alias1"), sep = "_") %>% +separate(group2, into = c("tissue2", "alias2"), sep = "_") %>% +filter(alias1 == "967514 MM WT" | alias2 == "967514 MM WT", +tissue1 == tissue2) %>% +group_by(var) %>% +mutate(adj.p.value = p.adjust(p.value)) %>% +ungroup() %>% +mutate(p.signif = if_else(adj.p.value <= 0.05, "*", "ns")) %>% +left_join(cv_jack_mean, by = c("var" = "met", "alias1" = "alias", "tissue1" = "tissue")) %>% +select(var, alias1, alias2, p.signif, mean_cv1 = mean_cv, se_cv1 = se_cv, tissue1, tissue2, p.value, adj.p.value) %>% +left_join(cv_jack_mean, by = c("var" = "met", "alias2" = "alias", "tissue2" = "tissue")) %>% +select(var, alias1, alias2, p.signif, mean_cv1, mean_cv2 = mean_cv, se_cv1, se_cv2 = se_cv, tissue1, tissue2, p.value, adj.p.value) %>% +group_by(var, tissue1) %>% +mutate(tot_val1 = mean_cv1 + se_cv1, +tot_val2 = mean_cv2 + se_cv2, +y.position = 1.1*(max(tot_val1, tot_val2))) %>% +ungroup() %>% +left_join(genotypes, by = c("alias1" = "alias")) %>% +rename(genotype1 = genotype) %>% +left_join(genotypes, by = c("alias2" = "alias")) %>% +rename(genotype2 = genotype) %>% +rename(met = var, +group1 = genotype1, +group2 = genotype2, +tissue = tissue1) %>% +left_join(miss_any_treat) %>% +left_join(miss_per_clust) %>% +group_by(met, tissue) %>% +mutate(p.signif = if_else(miss_comp_treat == T| percent_na_clust >= 50, "ns", p.signif), +met = as_factor(met), +group1 = as_factor(group1), +group2 = as_factor(group2)) %>% +ungroup() +sig_mets_cv <- sig_GC_cv_groups %>% +filter(p.signif == "*") %>% +distinct(met, .keep_all = T) %>% +mutate(sig = T) %>% +select(met, sig) +heat.GC <- cv_jack_mean%>% +group_by(tissue, met) %>% +mutate(total_norm = mean_cv/mean(mean_cv), +log_norm = log2(total_norm), +log_norm = if_else(is.infinite(log_norm), 0, log_norm), +log_norm_level = (log_norm - mean(log_norm))/(max(log_norm)-min(log_norm))) %>% +ungroup() %>% +left_join(sig_mets_cv) %>% +filter(sig == T) %>% +mutate(group = as_factor(str_c(tissue, genotype, sep = "_"))) %>% +pivot_wider(id_cols = c(met), +names_from = group, +values_from = log_norm_level) %>% +left_join(met_dat) %>% +left_join(GC_classes) %>% +arrange(Compound_Class, Compound_Name) %>% +as.data.frame() +rownames(heat.GC) <- heat.GC$met +mat.heat.GC <- heat.GC %>% +select(contains("leaf"), contains("fruit")) %>% as.matrix() +annotation_row <- heat.GC %>% +select(Compound_Class) +rownames(annotation_row) <- heat.GC$met +annotation_col <- sam_dat %>% +filter(exp == 1, class == "Sample") %>% +distinct(tissue, genotype) %>% +mutate(group = as_factor(str_c(tissue, genotype, sep = "_"))) %>% +as.data.frame() +rownames(annotation_col) <- annotation_col$group +annotation_col <- annotation_col %>% +select(-group, tissue, genotype) +heat.GC_signif <- cv_jack_mean %>% +distinct(tissue, alias, genotype, met) %>% +#filter(genotype != "MoneyMaker") %>% +left_join(sig_GC_cv_groups, by = c("met", "tissue" = "tissue2", "alias" = "alias2")) %>% +left_join(sig_mets_cv) %>% +filter(sig == T) %>% +mutate(group = as_factor(str_c(tissue, genotype, sep = "_")), +signif = if_else(p.signif == "ns"| is.na(p.signif), "","X")) %>% +pivot_wider(id_cols = c(met), +names_from = group, +values_from = signif) %>% +left_join(met_dat) %>% +left_join(GC_classes) %>% +arrange(Compound_Class, Compound_Name) %>% +as.data.frame() +heat_cols <- colnames(mat.heat.GC) +rownames(heat.GC_signif) <- heat.GC_signif$met +mat.heat.GC_signif <- heat.GC_signif %>% +select(all_of(heat_cols)) %>% as.matrix() +ann_colors = list( +tissue = c(fruit = "red",leaf = "darkgreen"), +genotype = c(MoneyMaker = "yellow", `panK4-1` = "brown", `log2-1` = "blue", `transp1-1` = "grey"), +treatment = c("0.4" = "red", "0.6" = "orange", "0.8" = "yellow", "1" = "green")) +pheatmap.GC <- pheatmap(mat.heat.GC, +#color = plasma(14), +#cellwidth = 16, +#cellheight = 4, +#breaks = c(-6.5,-5.5,-4.5,-3.5,-2.5,-1.5, -0.5 ,0.5,1.5,2.5,3.5,4.5,5.5,6.5), +cluster_rows = T, +cluster_cols = T, +annotation_names_row = F, +show_rownames = F, +annotation_row = annotation_row, +annotation_col = annotation_col, +display_numbers = mat.heat.GC_signif, +number_color = "black", +fontsize_number = 6, +angle_col = 45, +fontsize_col = 6, +annotation_colors = ann_colors, +filename = here(out, +"cmQTL_val1_cv_heatmap_rel_tissue.jpg", +) +) +pheatmap.GC <- pheatmap(mat.heat.GC, +#color = plasma(14), +#cellwidth = 16, +#cellheight = 4, +#breaks = c(-6.5,-5.5,-4.5,-3.5,-2.5,-1.5, -0.5 ,0.5,1.5,2.5,3.5,4.5,5.5,6.5), +cluster_rows = T, +cluster_cols = T, +annotation_names_row = F, +show_rownames = F, +annotation_row = annotation_row, +annotation_col = annotation_col, +display_numbers = mat.heat.GC_signif, +number_color = "black", +fontsize_number = 6, +angle_col = 45, +fontsize_col = 6, +annotation_colors = ann_colors, +filename = here(out, +"cmQTL_val1_cv_heatmap_rel_tissue.jpg") +) +cv %>% +filter(genotype == "MoneyMaker") %>% +mutate(`cv > 1` = if_else(cv > 1, "yes", "no")) %>% +ggplot(aes(x = tissue, y = cv)) + +geom_dotplot(aes(fill = `cv > 1`), stackdir = "center", binaxis = "y", binwidth = 0.1) + +geom_hline(aes(yintercept = 1), color = "red") + +theme(panel.background = element_rect(fill = "white"), +panel.border = element_rect(color = "black",fill = NA), +legend.position = "bottom", +legend.text = element_text(size = 8), +text = element_text(size = 10)) + +ylim(c(-0.15, 2)) dev.off() -for (meta in seq_along(plotmets)) { -plot_out [[meta]] <- features_all %>% -mutate(xint = if_else(daily_num == 4, run_num_GC-3.5, max(run_num_GC)), -is_miss = as_factor(if_else(is.na(area), T, F))) %>% -filter(met == plotmets[[meta]]) %>% -filter(class!="blank") %>% -ggplot(aes(x=run_num_GC, y=isnorm)) + -geom_point(aes(color = class, shape = is_miss)) + -geom_point(aes(y=predp), color="black", size=0.1) + -geom_vline(aes(xintercept = xint))+ -# facet_grid(rows = vars(treatment), cols = vars(rep), scales = "free") + -ggtitle(label = plotmet_labs[[meta]]) -} -pdf(file = here(out,"_linnorm.pdf")) -for (meta in seq_along(plotmets)) { -print(plot_out[[meta]]) -} +cv %>% +filter(genotype == "MoneyMaker") %>% +mutate(`cv > 1` = if_else(cv > 1, "yes", "no")) %>% +ggplot(aes(x = tissue, y = cv)) + +geom_dotplot(aes(fill = `cv > 1`), stackdir = "center", binaxis = "y", binwidth = 0.1) + +geom_hline(aes(yintercept = 1), color = "red") + +theme(panel.background = element_rect(fill = "white"), +panel.border = element_rect(color = "black",fill = NA), +legend.position = "bottom", +legend.text = element_text(size = 8), +text = element_text(size = 10)) + +ylim(c(-0.15, 2)) dev.off() -rescale <- features_all %>% -group_by(met, tissue, exp) %>% -summarise(rescale = median(imp)) -sam_vars <- c(#"plantline","extraction_num", "sample_num", #in case I add them back -"alias", "LIMS_ID", -"treatment", "tissue", "batch_GC", "run_date_GC", -"machine_num_GC", -"class", "run_num_GC", "sample_weight", "exp", "genotype") -features_out <- features_all %>% -left_join(rescale) %>% -filter(class != "blank", -(component %in% take_split & str_detect(batch_GC, "split"))| -(!component %in% take_split & str_detect(batch_GC, "split", negate = T))| -tissue == "leaves") %>% -group_by(met, tissue, exp) %>% -mutate(loess_norm_med = loess_norm_fw/median(loess_norm_fw), -rescaled = loess_norm_med*rescale) %>% -select(all_of(sam_vars), met, Compound_Name, loess_norm_fw, loess_norm_med, area, rescaled) -#features_out %>% -# filter(met == "m_02177", tissue == "fruits", exp == 1) %>% -# ggplot(aes(x = run_num_GC, y = loess_norm_fw)) + -# geom_point() -} -write_csv(features_out, -here(out, -"cmQTL_val_1_2_feat_dat_GC.csv" -)) -here() -write_csv(features_out, -here(out, -"cmQTL_val_1_2_feat_dat_GC.csv" -)) -features_out -write_csv(features_out, -here(out, -"cmQTL_val_1_2_feat_dat_GC.csv" -)) -getwd() -here() -write_csv(features_out, -here(out, -"cmQTL_val_1_2_feat_dat_GC.csv" -)) -here::dr_here() -here::i_am("workflows/GC_MS_normalization/210927_primary_normalization_with_split.R") -write_csv(features_out, -here(out, -"cmQTL_val_1_2_feat_dat_GC.csv" -)) -here(out, -"cmQTL_val_1_2_feat_dat_GC.csv" -) -out -out <- here("runs/GC-MS normalization") -out -write_csv(features_out, -here(out, -"cmQTL_val_1_2_feat_dat_GC.csv" -)) -write_csv(met_dat, -here(out, -"cmQTL_val_1_2_met_dat_GC.csv" -)) -write_csv(sam_dat, -here(out, -"cmQTL_val_1_2_sam_dat_GC.csv" -)) -write_csv(missingness, -here(out, -"cmQTL_val_1_2_miss_GC.csv" -)) -View(features_out) -source("C:/Users/Micha/Nextcloud/Data_Plant/cmqtl_val1_arc/workflows/GC_MS_normalization/210927_primary_normalization_with_split.R", echo=TRUE) -View(features_out) -View(features_all) -features_out <- features_all %>% -left_join(rescale) %>% -filter(class != "blank", -(component %in% take_split & str_detect(batch_GC, "split"))| -(!component %in% take_split & str_detect(batch_GC, "split", negate = T))| -tissue == "leaves") %>% -group_by(met, tissue, exp) %>% -mutate(loess_norm_med = loess_norm_fw/median(loess_norm_fw), -rescaled = loess_norm_med*rescale) %>% -select(all_of(sam_vars), met, Compound_Name, loess_norm_fw, loess_norm_med, area, rescaled) -} -write_csv(features_out, -here(out, -"cmQTL_val_1_2_feat_dat_GC.csv" -)) -write_csv(met_dat, -here(out, -"cmQTL_val_1_2_met_dat_GC.csv" -)) -write_csv(sam_dat, -here(out, -"cmQTL_val_1_2_sam_dat_GC.csv" -)) -write_csv(missingness, -here(out, -"cmQTL_val_1_2_miss_GC.csv" -)) -source("C:/Users/Micha/Nextcloud/Data_Plant/cmqtl_val1_arc/workflows/GC_MS_normalization/210927_primary_normalization_with_split.R", echo=TRUE) -View(features_out) -View(met_dat) +cv %>% +filter(genotype == "MoneyMaker") %>% +mutate(`cv > 1` = if_else(cv > 1, "yes", "no")) %>% +ggplot(aes(x = tissue, y = cv)) + +geom_dotplot(aes(fill = `cv > 1`), stackdir = "center", binaxis = "y", binwidth = 0.1) + +geom_hline(aes(yintercept = 1), color = "red") + +theme(panel.background = element_rect(fill = "white"), +panel.border = element_rect(color = "black",fill = NA), +legend.position = "bottom", +legend.text = element_text(size = 8), +text = element_text(size = 10)) + +ylim(c(-0.15, 2)) +write_csv(fc_1_ind, here(out, "individual_values.csv")) +write_csv(fc_1_ind, here(out, "individual_values.csv")) +write_csv(fc_1, here(out, "mean_values_se_n.csv")) +write_csv(sig_GC, here(out, "p_values.csv")) +write_csv(means_tec_rep_lt, here(out, "individual_values_levene.csv")) +write_csv(fc_1_lt, here(out, "mean_values_se_n_levene.csv")) +write_csv(sig_GC_lt, here(out, "p_values_levene.csv")) +write_csv(cv_jack_ind, here(out, "individual_values_cv.csv")) +write_csv(cv_jack, here(out, "individual_values_cv.csv")) +write_csv(cv_jack_mean, here(out, "mean_values_se_n_cv.csv")) +write_csv(sig_GC_cv_groups, here(out, "p_values_cv.csv")) diff --git a/runs/GC-MS analysis/cmQTL_val1_cv_heatmap_rel_tissue.jpg b/runs/GC-MS analysis/cmQTL_val1_cv_heatmap_rel_tissue.jpg new file mode 100644 index 0000000000000000000000000000000000000000..8781f9188d4b9454cb7471983ca55973fd08aeb5 Binary files /dev/null and b/runs/GC-MS analysis/cmQTL_val1_cv_heatmap_rel_tissue.jpg differ diff --git a/runs/GC-MS analysis/cmQTL_val1_heatmap_rel_all.jpg b/runs/GC-MS analysis/cmQTL_val1_heatmap_rel_all.jpg new file mode 100644 index 0000000000000000000000000000000000000000..4357e82f91819080173a2525f62450073a923c84 Binary files /dev/null and b/runs/GC-MS analysis/cmQTL_val1_heatmap_rel_all.jpg differ diff --git a/runs/GC-MS analysis/cmQTL_val1_heatmap_rel_tissue.jpg b/runs/GC-MS analysis/cmQTL_val1_heatmap_rel_tissue.jpg new file mode 100644 index 0000000000000000000000000000000000000000..79eaa9400546bea4e7fc74c2844cc905db7272b1 Binary files /dev/null and b/runs/GC-MS analysis/cmQTL_val1_heatmap_rel_tissue.jpg differ diff --git a/runs/GC-MS analysis/cmQTL_val1_heatmap_rel_tissue_treatment.jpg b/runs/GC-MS analysis/cmQTL_val1_heatmap_rel_tissue_treatment.jpg new file mode 100644 index 0000000000000000000000000000000000000000..9293078bb2e19f06d4d431599905bc97357c3025 Binary files /dev/null and b/runs/GC-MS analysis/cmQTL_val1_heatmap_rel_tissue_treatment.jpg differ diff --git a/runs/GC-MS analysis/cmQTL_val1_scaled1_GC_col_plots.pdf b/runs/GC-MS analysis/cmQTL_val1_scaled1_GC_col_plots.pdf new file mode 100644 index 0000000000000000000000000000000000000000..10721764557cd8ecefc6f6c8ba109b4d1f765689 Binary files /dev/null and b/runs/GC-MS analysis/cmQTL_val1_scaled1_GC_col_plots.pdf differ diff --git a/runs/GC-MS analysis/cmQTL_val_1_heatmap_rel_tissue_wt.jpg b/runs/GC-MS analysis/cmQTL_val_1_heatmap_rel_tissue_wt.jpg new file mode 100644 index 0000000000000000000000000000000000000000..37c65f59b482f49e228186e11134d9bc8746f106 Binary files /dev/null and b/runs/GC-MS analysis/cmQTL_val_1_heatmap_rel_tissue_wt.jpg differ diff --git a/runs/GC-MS analysis/individual_values.csv b/runs/GC-MS analysis/individual_values.csv new file mode 100644 index 0000000000000000000000000000000000000000..5f3adaf8cfec1966b2e2d14477efa8820d18bb08 --- /dev/null +++ b/runs/GC-MS analysis/individual_values.csv @@ -0,0 +1,21422 @@ +alias,genotype,treatment,met,tissue,LIMS_ID,mean_tec_rep,MM_mean,fc +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441047,0.8984193869514334,73.06854961986588,0.012295568909269429 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441049,2.6686525136476997,73.06854961986588,0.03652258772797848 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441040,5.363868601746801,73.06854961986588,0.07340871865736982 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441031,6.149580976552973,73.06854961986588,0.08416180434052334 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441052,7.930976693654221,73.06854961986588,0.10854159190122951 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441051,5.435190890899264,73.06854961986588,0.07438481972306105 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441047,561.2372097637419,990.9231863649335,0.56637811839136 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441049,411.7769166143721,990.9231863649335,0.41554877540500346 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441040,50.85642316685404,990.9231863649335,0.05132226580893105 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441031,429.15190418603805,990.9231863649335,0.43308291711320557 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441052,1109.5123279793495,990.9231863649335,1.1196754130352364 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441051,3.5896570579341542,990.9231863649335,0.003622538161713948 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441047,58.757065675687485,50.719124328797626,1.1584794976897113 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441049,56.27446322945427,50.719124328797626,1.109531443497387 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441040,54.02679914715144,50.719124328797626,1.0652155348130836 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441031,46.07257031218677,50.719124328797626,0.908386548898428 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441052,41.42493027186762,50.719124328797626,0.8167516852878138 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441051,45.15309999185951,50.719124328797626,0.8902578778597366 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441047,361.9277555470954,319.2477137201226,1.133689420449192 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441049,332.36815197503,319.2477137201226,1.0410979865823247 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441040,319.746739784776,319.2477137201226,1.0015631312087983 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441031,334.87425345515504,319.2477137201226,1.0489480082815312 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441052,343.3313876938607,319.2477137201226,1.0754388299076487 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441051,343.8059976999855,319.2477137201226,1.076925481137173 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441047,26.762213195107364,44.58166891160943,0.6002963515827078 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441049,7.784388268256805,44.58166891160943,0.1746096200142406 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441040,27.427081118746223,44.58166891160943,0.6152098337351384 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441031,44.07330676320195,44.58166891160943,0.9885970588177084 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441052,13.186314252711728,44.58166891160943,0.2957788385817451 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441051,54.064320929818834,44.58166891160943,1.2127029393406141 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441047,2642.8562916682044,1543.2839395802719,1.7124886897915779 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441049,2091.5388020388095,1543.2839395802719,1.3552521013130268 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441040,2522.6652583504856,1543.2839395802719,1.6346086378871907 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441031,2431.256277900707,1543.2839395802719,1.5753784611806028 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441052,2547.294971059456,1543.2839395802719,1.6505679257909247 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441051,2067.40651199408,1543.2839395802719,1.339615127826934 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441047,31.21609615411012,31.276034215973343,0.9980835785813084 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441049,31.562164753711674,31.276034215973343,1.0091485555925181 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441040,32.16840786196339,31.276034215973343,1.0285321866521775 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441031,17.69766115242467,31.276034215973343,0.5658537470005098 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441052,41.45980651805519,31.276034215973343,1.3256094500907272 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441051,47.895004496374256,31.276034215973343,1.5313643720185357 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441047,56.42672460361151,130.468422036268,0.4324933476080966 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441049,57.801052913720255,130.468422036268,0.443027147961156 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441040,65.97,130.468422036268,0.5056395943967305 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441031,85.05020416755912,130.468422036268,0.6518834430596286 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441052,54.74115383858218,130.468422036268,0.41957397034636523 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441051,35.10375693542298,130.468422036268,0.2690594121362542 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441047,106.31508747468868,95.42663227533711,1.11410289706059 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441049,95.16064343728394,95.42663227533711,0.9972126351762503 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441040,115.00459880433002,95.42663227533711,1.2051625008886833 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441031,77.98953499626307,95.42663227533711,0.8172722136021494 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441052,704.9853387423063,95.42663227533711,7.3877210369133905 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441051,92.26903298258536,95.42663227533711,0.9669107122669797 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441047,531.439639540324,569.3868516791151,0.933354252865367 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441049,635.0190377072514,569.3868516791151,1.1152681798580135 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441040,623.2723897840858,569.3868516791151,1.0946378335679212 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441031,533.8498069404758,569.3868516791151,0.9375871700692754 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441052,549.5237282817147,569.3868516791151,0.9651148892201773 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441051,669.4948272142848,569.3868516791151,1.1758171535572914 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441047,1275.4659231194821,5328.634617598269,0.23936073959868584 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441049,1929.8762761799428,5328.634617598269,0.36217087765904654 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441040,1060.0278427705427,5328.634617598269,0.1989304801026722 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441031,8564.72656347271,5328.634617598269,1.6073022787464113 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441052,8211.317456699559,5328.634617598269,1.5409796403718476 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441051,1802.6218181227364,5328.634617598269,0.3382896271719259 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441047,823404.2366900011,656386.6079991342,1.2544500857505112 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441049,835931.4957534902,656386.6079991342,1.273535269559602 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441040,816670.2327323036,656386.6079991342,1.2441908819891412 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441031,731001.3333471356,656386.6079991342,1.1136749660012866 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441052,884687.0868413978,656386.6079991342,1.347814041389712 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441051,920741.268237305,656386.6079991342,1.4027423122540603 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441047,1250.3816479998952,5223.837669019135,0.23936073959868584 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441049,1891.9218733370485,5223.837669019135,0.3621708776590466 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441040,1039.1805354764008,5223.837669019135,0.19893048010267222 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441031,8396.286189215798,5223.837669019135,1.6073022787464113 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441052,8049.827492566019,5223.837669019135,1.5409796403718479 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441051,1767.1700974591463,5223.837669019135,0.338289627171926 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441047,823404.2366900011,656386.6079991342,1.2544500857505112 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441049,835931.4957534902,656386.6079991342,1.273535269559602 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441040,816670.2327323036,656386.6079991342,1.2441908819891412 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441031,731001.3333471356,656386.6079991342,1.1136749660012866 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441052,884687.0868413978,656386.6079991342,1.347814041389712 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441051,920741.268237305,656386.6079991342,1.4027423122540603 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441047,45.10124457734376,50.79723336807032,0.8878681295602431 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441049,50.33768859644375,50.79723336807032,0.9909533503862943 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441040,44.91822529544189,50.79723336807032,0.8842651915699841 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441031,37.82111432943024,50.79723336807032,0.7445506737617624 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441052,49.32470303245661,50.79723336807032,0.9710116036252616 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441051,48.939920497905625,50.79723336807032,0.9634367317466516 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441047,136.37904391584206,124.85055234194422,1.0923383305692014 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441049,79.47488847189146,124.85055234194422,0.6365601671847105 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441040,78.17092280229939,124.85055234194422,0.6261159549234725 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441031,114.2552328787714,124.85055234194422,0.9151359824652272 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441052,91.4868565620276,124.85055234194422,0.7327709397028601 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441051,190.39749198789156,124.85055234194422,1.5250032011586583 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441047,161.97980522227311,149.81706398084205,1.081183951402134 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441049,162.69980905425822,149.81706398084205,1.085989838080551 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441040,164.79050563094376,149.81706398084205,1.099944834401617 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441031,168.16006794056244,149.81706398084205,1.1224360127766622 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441052,212.8839396218426,149.81706398084205,1.4209592283097021 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441051,169.17252523929267,149.81706398084205,1.1291939699267215 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441047,3374.7465632987523,2791.14294318225,1.2090912690595208 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441049,3607.7666466437904,2791.14294318225,1.2925768117524243 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441040,3210.9012302928977,2791.14294318225,1.1503893908894796 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441031,3030.608828322463,2791.14294318225,1.0857949198643306 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441052,3039.226412732291,2791.14294318225,1.0888823949902025 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441051,3463.007443099325,2791.14294318225,1.2407130389212766 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441047,247.9423270068847,222.01180748199775,1.1167979298893351 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441049,267.29159649876107,222.01180748199775,1.2039521660145707 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441040,490.4506967924385,222.01180748199775,2.209119876798479 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441031,314.2625081885932,222.01180748199775,1.4155215965892975 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441052,634.2769300648495,222.01180748199775,2.85695133632152 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441051,210.1124924424006,222.01180748199775,0.9464023324950317 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441047,6502.732352155632,4330.453784028004,1.501628391957359 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441049,6150.5075676103,4330.453784028004,1.4202917002128492 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441040,7468.948829298733,4330.453784028004,1.7247496917866734 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441031,7903.307443018072,4330.453784028004,1.8250529476074335 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441052,7515.970423920868,4330.453784028004,1.7356080445060962 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441051,7043.614549927703,4330.453784028004,1.626530359452545 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441047,76.43800885184137,100.4664893584531,0.7608308933650422 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441049,107.3111120990466,100.4664893584531,1.0681284155970918 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441040,56.9511364450186,100.4664893584531,0.566866990264021 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441031,113.43801338303882,100.4664893584531,1.129112942110526 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441052,108.3886836842738,100.4664893584531,1.078854097285665 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441051,136.78121064248862,100.4664893584531,1.3614610355744459 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441047,300.60114177408656,219.8603821991507,1.3672365105860702 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441049,201.971618820689,219.8603821991507,0.9186358033242298 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441040,164.47263657765075,219.8603821991507,0.7480776433321695 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441031,363.87874404935553,219.8603821991507,1.6550446260925364 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441052,161.07998822964245,219.8603821991507,0.7326467216077853 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441051,175.25476947647675,219.8603821991507,0.7971184609227598 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441047,117.3925647421935,115.26780159034894,1.0184332755767804 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441049,80.27929146933519,115.26780159034894,0.6964589448373479 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441040,99.45998924318155,115.26780159034894,0.8628601211347218 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441031,125.68088979799896,115.26780159034894,1.0903382216367514 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441052,20.63804229213843,115.26780159034894,0.17904429517519657 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441051,73.56363422098758,115.26780159034894,0.6381975990348624 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441047,1754.438718227202,1760.6737631139824,0.9964587165337473 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441049,2330.5686869259916,1760.6737631139824,1.323680022813582 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441040,1392.6123162116191,1760.6737631139824,0.7909542047974871 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441031,1127.4416057974995,1760.6737631139824,0.6403466839895832 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441052,1791.0622783486187,1760.6737631139824,1.0172595945207306 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441051,2087.316667620792,1760.6737631139824,1.1855215380327464 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441047,913.3478825404268,518.6000624505415,1.7611796616926403 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441049,844.6572409819917,518.6000624505415,1.6287256831222345 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441040,1507.0381726920325,518.6000624505415,2.9059737586047008 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441031,954.6939875426206,518.6000624505415,1.8409060404493667 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441052,925.3901714244884,518.6000624505415,1.7844004241953637 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441051,643.6685417361452,518.6000624505415,1.2411655692724322 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441047,1180.8506348386325,841.89306662726494,1.4026135641777837 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441049,590.3562119369975,841.89306662726494,0.7012246986449747 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441040,1474.6327091781266,841.89306662726494,1.7515677081006267 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441031,2092.145508858342,841.89306662726494,2.485048982811741 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441052,979.3696658382662,841.89306662726494,1.1632946090906184 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441051,1120.5409172265672,841.89306662726494,1.3309777234721774 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441047,411.7970803645733,246.94010350613598,1.6675990433216163 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441049,208.28619272557833,246.94010350613598,0.8434684758298193 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441040,380.54458273945096,246.94010350613598,1.5410400228085883 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441031,349.41883368783004,246.94010350613598,1.4149942788824807 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441052,455.67640691882224,246.94010350613598,1.845291228313993 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441051,331.7559216007086,246.94010350613598,1.3434671683146235 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441047,5918.11767794259,6405.278640912654,0.9239438297253136 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441049,5976.470684512265,6405.278640912654,0.9330539730681738 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441040,3394.989775360917,6405.278640912654,0.5300299902140062 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441031,4980.096224146757,6405.278640912654,0.7774987636505334 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441052,9314.624233425207,6405.278640912654,1.4542106215223163 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441051,9117.041228528313,6405.278640912654,1.4233637191510649 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441047,336.8960859267592,184.84349394551683,1.8226018061856175 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441049,281.3959062215058,184.84349394551683,1.522346825495779 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441040,305.11741583442836,184.84349394551683,1.6506797687148385 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441031,463.90910821584896,184.84349394551683,2.5097399876708 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441052,892.3579164168522,184.84349394551683,4.827640385762657 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441051,262.81812706468776,184.84349394551683,1.421841372151049 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441047,42451.68356895704,66689.05961878091,0.6365614361879807 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441049,68367.9810080481,66689.05961878091,1.025175364578006 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441040,41659.4115034865,66689.05961878091,0.624681345660397 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441031,39302.82264072202,66689.05961878091,0.5893443822028883 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441052,39900.01198082331,66689.05961878091,0.5982992144274696 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441051,40083.45031178557,66689.05961878091,0.6010498654639495 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441047,1840.7953073678823,426.591426110135,4.3151249525878566 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441049,938.6353295306152,426.591426110135,2.2003145681795386 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441040,2232.8174709022137,426.591426110135,5.234088953128086 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441031,844.3313800672795,426.591426110135,1.9792507031055395 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441052,3117.879060578298,426.591426110135,7.308817922124251 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441051,1319.2138333228368,426.591426110135,3.0924527606006067 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441047,236253.9708764467,6086.038398766024,38.819007603426954 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441049,8453.37579169468,6086.038398766024,1.388978385908417 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441040,462227.9899657921,6086.038398766024,75.94891120954992 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441031,326442.7595077817,6086.038398766024,53.637972375259686 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441052,172973.59356719433,6086.038398766024,28.421377295658473 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441051,260728.3546800699,6086.038398766024,42.84040579384677 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441047,140.94518371337298,118.38689307733607,1.1905471969882742 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441049,123.8784342051382,118.38689307733607,1.0463863945159435 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441040,276.86826249427503,118.38689307733607,2.3386732711484473 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441031,185.6085516492829,118.38689307733607,1.5678133518381496 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441052,117.78078674757164,118.38689307733607,0.9948802919477877 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441051,103.27385424855682,118.38689307733607,0.8723419591820297 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441047,145.76252249765022,43.003791743375764,3.389527215820527 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441049,9.22183691255827,43.003791743375764,0.21444241399896527 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441040,129.51504408243,43.003791743375764,3.011712196340926 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441031,38.76662382921906,43.003791743375764,0.9014698996906617 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441052,20.475311055824804,43.003791743375764,0.47612803954615907 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441051,201.3699207477553,43.003791743375764,4.682608499953355 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441047,103.01053344001588,56.77751951238643,1.8142837926821263 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441049,72.87945403128256,56.77751951238643,1.2835970055962622 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441040,72.09600173424725,56.77751951238643,1.2697983700841138 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441031,16.90570428257465,56.77751951238643,0.2977534846143912 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441052,52.05454811636149,56.77751951238643,0.9168161723762063 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441051,98.37023605022875,56.77751951238643,1.7325560696389453 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441047,81.45403063212026,232.93832449773902,0.34968067537942166 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441049,78.12879487260612,232.93832449773902,0.33540549860598173 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441040,217.21764876835277,232.93832449773902,0.9325114243725968 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441031,262.7670232889716,232.93832449773902,1.1280540626174294 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441052,215.98533442309477,232.93832449773902,0.9272211212508794 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441051,245.64572073382848,232.93832449773902,1.0545526214438483 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441047,48.558624319656495,55.88566907011774,0.8688922424590055 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441049,89.0171331346139,55.88566907011774,1.592843650541739 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441040,54.27547939422667,55.88566907011774,0.9711877892367929 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441031,46.50972441057856,55.88566907011774,0.8322298933600398 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441052,47.15935086675983,55.88566907011774,0.8438540980441817 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441051,10.018737772423822,55.88566907011774,0.17927203769992753 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441047,106.2884434738194,226.42114305345407,0.46942808449971724 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441049,99.78987663556504,226.42114305345407,0.4407268477220186 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441040,148.40060888500292,226.42114305345407,0.6554185129697369 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441031,160.76943835042812,226.42114305345407,0.7100460503923579 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441052,94.68974035361217,226.42114305345407,0.41820184756887996 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441051,499.3239690825838,226.42114305345407,2.2052886154925124 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441047,160.748390493784,212.71806341276286,0.7556875420676629 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441049,179.34785271074873,212.71806341276286,0.8431246967622968 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441040,450.686523376942,212.71806341276286,2.118703584201121 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441031,170.2486998785873,212.71806341276286,0.8003490495691141 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441052,431.0787557335269,212.71806341276286,2.0265263269958043 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441051,208.42860519377157,212.71806341276286,0.9798350071913361 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441047,13097.206115571786,10996.969545575432,1.1909832123561142 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441049,13272.580945921374,10996.969545575432,1.2069307722382046 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441040,8740.092577800659,10996.969545575432,0.7947728273301607 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441031,12841.494995882254,10996.969545575432,1.167730340860038 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441052,19372.591661791703,10996.969545575432,1.761630018297737 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441051,19659.575724027385,10996.969545575432,1.787726668019855 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441047,155.57780807767932,147.8550055811589,1.0522322694870232 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441049,155.6142434337625,147.8550055811589,1.0524786957472636 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441040,126.42769731623238,147.8550055811589,0.8550789120685881 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441031,138.2598521563462,147.8550055811589,0.9351043044697879 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441052,108.1366405827656,147.8550055811589,0.7313694937667055 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441051,181.21511066182669,147.8550055811589,1.2256271605384108 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441047,122.83371112944876,92.19915296117537,1.3322650716886029 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441049,319.87101064210725,92.19915296117537,3.469348691053631 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441040,81.61382429162511,92.19915296117537,0.8851906082693873 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441031,210.91,92.19915296117537,2.2875481306082412 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441052,163.8107045582721,92.19915296117537,1.7767050921525496 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441051,164.84366238498987,92.19915296117537,1.7879086422236954 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441047,1931.1119403174928,1229.7970051816276,1.570268859153945 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441049,1912.634178361868,1229.7970051816276,1.5552438087775249 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441040,1644.9115674966115,1229.7970051816276,1.3375472216682427 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441031,3267.1393270716385,1229.7970051816276,2.6566492789508116 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441052,5489.299973591914,1229.7970051816276,4.463582160684481 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441051,1435.2645678808456,1229.7970051816276,1.1670743723016894 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441047,95748.27844441512,50083.06853493704,1.9117893780334736 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441049,66211.47654090011,50083.06853493704,1.322033143690311 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441040,110801.18632814533,50083.06853493704,2.2123481960945033 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441031,89517.3511622333,50083.06853493704,1.7873775265943943 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441052,83293.98653316568,50083.06853493704,1.663116677346982 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441051,93310.67369278889,50083.06853493704,1.863118143963105 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441047,28.22757581547385,35.678906774941794,0.7911558499684411 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441049,2.387299752328559,35.678906774941794,0.06691067546960885 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441040,68.60563277261834,35.678906774941794,1.922862525059255 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441031,42.72778071148495,35.678906774941794,1.19756417933449 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441052,26.36143259738068,35.678906774941794,0.73885202715614 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441051,36.78025634054536,35.678906774941794,1.0308683663586091 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441047,112.41695615495397,67.70693010562654,1.660346377831299 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441049,88.91094101089021,67.70693010562654,1.313173420685065 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441040,34.12496534494852,67.70693010562654,0.5040099335727036 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441031,113.8058844200518,67.70693010562654,1.680860205041173 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441052,147.02404355370876,67.70693010562654,2.1714770308496214 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441051,48.1211221420373,67.70693010562654,0.7107266873120034 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441047,91.09026467772472,64.01321127549492,1.4229916428609986 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441049,70.66887595671531,64.01321127549492,1.1039732978334156 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441040,80.56394820540694,64.01321127549492,1.258551892650445 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441031,78.12312176712298,64.01321127549492,1.2204218505911686 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441052,178.15460326843032,64.01321127549492,2.7830911731908405 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441051,210.03091505829732,64.01321127549492,3.2810557519819326 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441047,478.49806424644976,1060.427767412219,0.45123117193935536 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441049,638.0272774852609,1060.427767412219,0.6016697196097103 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441040,520.8073893094843,1060.427767412219,0.49112952839816704 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441031,536.4697609655027,1060.427767412219,0.5058993902759257 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441052,719.8181307149943,1060.427767412219,0.6787997757467059 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441051,678.9873118855077,1060.427767412219,0.6402956738321297 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441047,43.257369617313,57.09593719876665,0.7576260543149018 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441049,49.967655844673054,57.09593719876665,0.8751525641959762 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441040,13.822745255120916,57.09593719876665,0.24209682743274957 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441031,7.052413307262949,57.09593719876665,0.1235186539229851 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441052,12.43582894288978,57.09593719876665,0.21780584666816558 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441051,8.716668357430283,57.09593719876665,0.15266705102125155 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441047,46.640525835524734,50.205845180981015,0.9289859710038922 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441049,206.6396507250525,50.205845180981015,4.115848463065646 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441040,119.30160840339492,50.205845180981015,2.3762493784008396 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441031,60.1820041429228,50.205845180981015,1.198705129372485 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441052,22.33940674523453,50.205845180981015,0.4449562927325671 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441051,145.72456725785523,50.205845180981015,2.902541860067294 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441047,1247.5408447229047,1506.8779059558976,0.8278977611869086 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441049,1444.9481305976676,1506.8779059558976,0.9589019288732988 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441040,1633.274656115423,1506.8779059558976,1.0838798881183043 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441031,1004.1619649549076,1506.8779059558976,0.6663857509530018 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441052,2257.9551919177848,1506.8779059558976,1.498432741626427 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441051,1414.2315134371918,1506.8779059558976,0.9385176515280215 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441047,30552.60836153076,16162.128318216166,1.8903827367275161 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441049,18286.357453017907,16162.128318216166,1.1314325126603249 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441040,26243.402854687523,16162.128318216166,1.623759095212037 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441031,29718.713508288147,16162.128318216166,1.8387871277319643 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441052,23031.449915447556,16162.128318216166,1.4250258048928526 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441051,22186.32062090397,16162.128318216166,1.3727350868695927 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441047,89.5476554538334,24.995311385825953,3.5825781112138104 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441049,67.1588895201648,24.995311385825953,2.6868594867055138 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441040,59.888817814661785,24.995311385825953,2.396002069757084 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441031,61.529390029708736,24.995311385825953,2.4616372678837717 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441052,65.98744828998223,24.995311385825953,2.6399930479522498 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441051,36.5548675549551,24.995311385825953,1.4624689803098114 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441047,946.3346709135908,522.7489803443298,1.8103041928274048 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441049,641.4951523530179,522.7489803443298,1.2271571566346646 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441040,1396.9112873314768,522.7489803443298,2.672241056140071 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441031,925.3441178894922,522.7489803443298,1.7701500197666131 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441052,482.98533689858215,522.7489803443298,0.9239335800912406 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441051,584.0904000737077,522.7489803443298,1.1173439299469754 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441047,3.8487729084518834,2.8430683750443606,1.3537391299608932 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441049,3.764800387546144,2.8430683750443606,1.3242032518783167 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441040,3.883522195604795,2.8430683750443606,1.3659615891384251 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441031,4.796875565578252,2.8430683750443606,1.6872177987993011 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441052,5.333448699987434,2.8430683750443606,1.8759480942501834 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441051,3.68470281846916,2.8430683750443606,1.296030320906956 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441047,1717.1816851387334,1771.7543971110147,0.9691984893271515 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441049,1793.905619058297,1771.7543971110147,1.0125024224482815 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441040,2482.7592226154447,1771.7543971110147,1.4012998791840334 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441031,1998.1067435726857,1771.7543971110147,1.127756051759068 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441052,1588.522438739414,1771.7543971110147,0.8965816262850117 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441051,1561.3221678153654,1771.7543971110147,0.8812294584177267 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441047,108.26372065542002,73.62821549612136,1.470410764758019 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441049,66.79009778143134,73.62821549612136,0.9071263961972535 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441040,70.7856348672707,73.62821549612136,0.9613927811546594 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441031,137.21450515971625,73.62821549612136,1.8636130759809675 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441052,431.2746999110776,73.62821549612136,5.857465062884712 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441051,3.895121155577528,73.62821549612136,0.052902560918140384 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441047,1216.370402938453,1923.334023596175,0.6324280587851979 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441049,1278.8590096608962,1923.334023596175,0.6649177906548627 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441040,895.5726611476911,1923.334023596175,0.4656355319255384 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441031,739.3943798962835,1923.334023596175,0.3844336817344876 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441052,1127.8723452918491,1923.334023596175,0.5864152203697813 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441051,1079.3267107302008,1923.334023596175,0.561174864838151 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441047,11.93068042587922,51.40813337414527,0.23207768193115383 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441049,4.1434861513478225,51.40813337414527,0.0805998171766281 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441040,56.273910890252616,51.40813337414527,1.0946499551091364 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441031,11.297603447585596,51.40813337414527,0.21976295784486716 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441052,21.51282617504033,51.40813337414527,0.4184712566486569 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441051,24.233887189319336,51.40813337414527,0.4714018113232507 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441047,116.86391419292352,89.1451395839603,1.310939830688768 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441049,19.297377496200415,89.1451395839603,0.21647144854179523 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441040,18.79625594533771,89.1451395839603,0.2108500366151166 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441031,70.37860452425475,89.1451395839603,0.7894833622193108 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441052,114.49245805798924,89.1451395839603,1.2843376385109124 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441051,111.03060690438085,89.1451395839603,1.2455037641150135 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441047,6971.66721146443,4771.656231796832,1.4610581468563073 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441049,10206.560052959108,4771.656231796832,2.1389973537795473 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441040,5317.875699921996,4771.656231796832,1.114471672222598 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441031,12344.484264337165,4771.656231796832,2.58704392451354 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441052,7947.887595187455,4771.656231796832,1.6656454717389753 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441051,5596.616673569787,4771.656231796832,1.172887651938477 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441047,385548.5035199615,209884.98459768714,1.8369513391298127 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441049,326321.4068875624,209884.98459768714,1.5547629932320484 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441040,126736.73923396514,209884.98459768714,0.6038390000928239 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441031,270824.5984955934,209884.98459768714,1.2903476588128344 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441052,334643.26946128736,209884.98459768714,1.594412626052026 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441051,349023.3600227574,209884.98459768714,1.6629267724500358 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441047,51.499725338624906,22.903585106474594,2.2485442824436466 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441049,3.5325128660477843,22.903585106474594,0.15423405766502385 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441040,201.74537856878095,22.903585106474594,8.808462851160787 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441031,34.317553044908685,22.903585106474594,1.4983485286418101 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441052,10.046847995591236,22.903585106474594,0.4386583126128626 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441051,48.47979189539148,22.903585106474594,2.1166901020088233 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441047,33.83258400548092,83.56495705722055,0.4048656900800449 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441049,71.10046416576027,83.56495705722055,0.8508406713722679 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441040,60.74984121761041,83.56495705722055,0.7269774718607509 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441031,12.744240884727878,83.56495705722055,0.1525069997463332 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441052,99.92465515472416,83.56495705722055,1.19577223125121 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441051,38.93079067749701,83.56495705722055,0.4658745968221991 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441047,2086.0788997568125,1829.6496491832456,1.1401521054525585 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441049,1905.325064960857,1829.6496491832456,1.041360604644388 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441040,1878.8719485682495,1829.6496491832456,1.0269025818177686 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441031,1228.8482828984368,1829.6496491832456,0.6716303765843881 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441052,1743.510792647577,1829.6496491832456,0.9529205733053205 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441051,1461.0449899964,1829.6496491832456,0.7985381193872879 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441047,157207.86568320397,96234.19538703516,1.6335967173720798 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441049,148751.5107805155,96234.19538703516,1.5457240555944376 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441040,109779.29599996236,96234.19538703516,1.1407514299719705 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441031,105555.80775837718,96234.19538703516,1.0968638261467487 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441052,179359.18280305216,96234.19538703516,1.8637780685098941 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441051,190326.9095440164,96234.19538703516,1.9777471903678179 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441047,179.9684649820797,77.99112650544876,2.30755052588587 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441049,178.519387309002,77.99112650544876,2.2889704932846424 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441040,208.9010847855011,77.99112650544876,2.678523751941273 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441031,183.33022600073275,77.99112650544876,2.3506549298005663 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441052,325.84712628673384,77.99112650544876,4.178002561149939 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441051,186.49003945490372,77.99112650544876,2.39116996780236 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441047,77.01475305409593,110.33780757772625,0.6979906048961843 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441049,93.54307605783252,110.33780757772625,0.8477880620560376 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441040,86.18303623763815,110.33780757772625,0.7810834575168395 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441031,295.37220190515137,110.33780757772625,2.6769808861489266 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441052,286.48633505178344,110.33780757772625,2.596447594356733 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441051,112.8912465089998,110.33780757772625,1.023142012582358 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441047,72.16404310250799,67.31067174214355,1.0721040398906867 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441049,74.03073833921187,67.31067174214355,1.0998365700881996 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441040,82.05818140298805,67.31067174214355,1.2190961593332459 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441031,52.15612533264268,67.31067174214355,0.774856705225651 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441052,77.48240642692554,67.31067174214355,1.1511162260235386 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441051,47.241616295223295,67.31067174214355,0.7018443743393082 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441047,4370.428478700006,2375.529574917848,1.8397701821292403 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441049,3505.672926441139,2375.529574917848,1.4757437513958858 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441040,3089.2934693783386,2375.529574917848,1.300465168691985 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441031,3374.400611252305,2375.529574917848,1.4204835194985945 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441052,3733.286405491339,2375.529574917848,1.5715596408099637 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441051,4359.234760364944,2375.529574917848,1.8350580882646756 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441047,224.5408405528131,194.62377093849457,1.153717449158731 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441049,302.48858687160356,194.62377093849457,1.5542222073540886 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441040,223.66159243331765,194.62377093849457,1.1491997681208206 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441031,234.47771663039055,194.62377093849457,1.2047742960673118 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441052,240.4863665128197,194.62377093849457,1.235647451250026 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441051,179.53903789692794,194.62377093849457,0.9224928539364611 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441047,4063.6616122403134,3728.1507253933823,1.089993916973818 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441049,3866.78529818605,3728.1507253933823,1.0371858819570765 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441040,4179.323709065255,3728.1507253933823,1.1210179032190997 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441031,3934.7077603073058,3728.1507253933823,1.0554046899195924 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441052,3479.1776872150026,3728.1507253933823,0.9332180867896351 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441051,3519.392282037775,3728.1507253933823,0.9440048273977497 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441047,139.94053237125718,68.78582331086372,2.0344385752108254 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441049,95.5391230581628,68.78582331086372,1.3889362438302573 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441040,89.90374236673311,68.78582331086372,1.3070097592701797 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441031,174.48224158166627,68.78582331086372,2.536601776112046 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441052,176.37843408555426,68.78582331086372,2.5641683939501214 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441051,123.25114871595304,68.78582331086372,1.7918103292729988 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441047,854.4712196301876,696.3940975413478,1.2269937706923975 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441049,545.7340031810965,696.3940975413478,0.7836568476209607 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441040,808.1970607469865,696.3940975413478,1.1605455353518421 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441031,498.30958897455736,696.3940975413478,0.7155568818487446 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441052,926.1375997268972,696.3940975413478,1.3299044362907004 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441051,753.92934537139,696.3940975413478,1.082618804543538 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441047,106.91689889398442,81.2393188807366,1.316073304983561 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441049,74.07482091932505,81.2393188807366,0.9118099700967534 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441040,73.49354301076909,81.2393188807366,0.9046548398400692 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441031,50.43264236795856,81.2393188807366,0.6207910536768065 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441052,82.11354921975905,81.2393188807366,1.0107611726817387 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441051,50.30058238974907,81.2393188807366,0.6191654864018844 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441047,379.855782663944,543.8205698619286,0.6984946942341408 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441049,194.40073740572143,543.8205698619286,0.3574722034789492 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441040,245.2169594130641,543.8205698619286,0.4509151970388369 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441031,297.79611422577085,543.8205698619286,0.5475999451462065 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441052,1073.3486640619465,543.8205698619286,1.9737183982107565 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441051,454.74899229918685,543.8205698619286,0.8362114592587842 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441047,153314.93666140694,306516.0644612488,0.5001856490976503 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441049,194090.41979820095,306516.0644612488,0.6332145107609483 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441040,207035.77329819647,306516.0644612488,0.6754483607966685 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441031,384518.08677718334,306516.0644612488,1.2544793939366135 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441052,553406.160320231,306516.0644612488,1.8054719621072102 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441051,178171.15890373787,306516.0644612488,0.5812783718755566 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441047,386967.9685814575,335923.8645439917,1.151951407521335 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441049,255619.07836715563,335923.8645439917,0.760943491508566 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441040,511995.69705446984,335923.8645439917,1.5241420782935184 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441031,566207.5676284567,335923.8645439917,1.6855234991925014 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441052,519281.1645314484,335923.8645439917,1.545829931542255 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441051,558178.1061802929,335923.8645439917,1.6616208763197156 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441047,3.4440812550281183,33.931355493730415,0.10150143443766903 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441049,32.91567161186787,33.931355493730415,0.9700665102503726 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441040,68.82094368166918,33.931355493730415,2.0282403305221743 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441031,67.24943366219915,33.931355493730415,1.9819259408786367 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441052,187.70292092153497,33.931355493730415,5.531842692114593 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441051,60.07007812245794,33.931355493730415,1.7703412447981115 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441047,14.628367774239711,76.3332642617619,0.19163817918327372 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441049,12.146773185167795,76.3332642617619,0.15912817698341972 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441040,85.4948399816089,76.3332642617619,1.1200207512209899 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441031,51.51405258994692,76.3332642617619,0.6748571948042864 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441052,37.0599925065029,76.3332642617619,0.4855025245536054 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441051,155.66156378878912,76.3332642617619,2.039236305354305 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441047,158.32167138481063,130.67426801703346,1.2115749625945738 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441049,158.10352930274988,130.67426801703346,1.209905604997466 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441040,151.1951302199622,130.67426801703346,1.1570382793363254 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441031,82.56170163550973,130.67426801703346,0.6318130025778892 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441052,306.342772315293,130.67426801703346,2.3443236144652526 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441051,118.12568768742248,130.67426801703346,0.9039705328368455 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441047,6369.284907478775,5444.214081294075,1.1699181575836952 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441049,5623.951932976865,5444.214081294075,1.0330144716939687 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441040,7041.181424917935,5444.214081294075,1.2933329438882508 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441031,7779.542702324462,5444.214081294075,1.4289560598019844 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441052,8347.92104522492,5444.214081294075,1.533356499316912 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441051,7322.731027942781,5444.214081294075,1.345048324441016 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441047,53.84815461460597,100.67607722942154,0.5348654426800551 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441049,53.870471541957414,100.67607722942154,0.5350871132890578 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441040,89.25927321041576,100.67607722942154,0.8865986405788431 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441031,116.93652000012683,100.67607722942154,1.1615124786164528 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441052,72.6480142072241,100.67607722942154,0.7216015582497634 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441051,165.84640242115995,100.67607722942154,1.6473268226693785 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441047,547.9892774870758,599.1099853739104,0.9146722486106961 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441049,612.8865675273912,599.1099853739104,1.0229950801852898 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441040,573.1718689728596,599.1099853739104,0.9567055848937944 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441031,503.31160261400134,599.1099853739104,0.8400988381121367 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441052,524.7312714643148,599.1099853739104,0.8758513199155324 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441051,641.9766500642106,599.1099853739104,1.0715505762494457 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441047,106.58354607337417,114.30018844822946,0.932487929550961 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441049,121.692048651065,114.30018844822946,1.0646705863147685 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441040,176.67190301414922,114.30018844822946,1.5456833922384134 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441031,61.1516062179374,114.30018844822946,0.535008796119659 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441052,427.5130616713522,114.30018844822946,3.74026558901946 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441051,95.80924337055582,114.30018844822946,0.838224719235272 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441047,2239.3636041035124,1759.6959467320276,1.27258553289407 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441049,2404.057749984581,1759.6959467320276,1.3661779209352687 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441040,1944.773260589133,1759.6959467320276,1.1051757345925681 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441031,2426.850043086996,1759.6959467320276,1.379130325096194 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441052,2049.5813676377775,1759.6959467320276,1.1647360849151827 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441051,2153.6511400988297,1759.6959467320276,1.2238768544636507 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441047,102.07545010421846,38.77498679262034,2.632507669187536 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441049,100.06281107164084,38.77498679262034,2.5806020671729746 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441040,38.80555451884504,38.77498679262034,1.0007883362124192 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441031,11.181984467733578,38.77498679262034,0.28838138688577797 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441052,2361.5936196001976,38.77498679262034,60.90507863305466 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441051,189.60996010148952,38.77498679262034,4.89000708409206 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441047,1512.179968585845,2284.874121495706,0.6618220033915715 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441049,1844.7141256984255,2284.874121495706,0.8073591925015342 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441040,2525.314869477523,2284.874121495706,1.1052315073814316 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441031,1744.6299184497127,2284.874121495706,0.7635562511022083 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441052,1380.385682116225,2284.874121495706,0.6041408010751192 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441051,1404.9093328620345,2284.874121495706,0.6148738434406024 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441047,370.5333576968093,306.4947439651267,1.2089387012097308 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441049,334.4821502293352,306.4947439651267,1.0913144737887999 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441040,334.2292753925819,306.4947439651267,1.090489419389883 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441031,345.58666158461773,306.4947439651267,1.1275451484542878 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441052,356.0663435343437,306.4947439651267,1.1617371930360323 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441051,306.06951581247966,306.4947439651267,0.9986126086628898 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441047,47434.52014773318,53872.22448470133,0.8805004916996451 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441049,55477.58492175835,53872.22448470133,1.029799408738225 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441040,60342.67421502512,53872.22448470133,1.1201073427395092 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441031,45880.776421972274,53872.22448470133,0.8516592151304524 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441052,52349.939443512085,53872.22448470133,0.9717426734138008 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441051,48176.08685951599,53872.22448470133,0.8942657801924825 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441047,176.09221230326972,320.29657233769314,0.5497786349009481 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441049,110.827592571982,320.29657233769314,0.34601554354173647 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441040,97.54733324219929,320.29657233769314,0.30455315999870824 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441031,1634.9322791742647,320.29657233769314,5.104432642665102 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441052,104.70441678501363,320.29657233769314,0.326898336815863 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441051,569.9688931257498,320.29657233769314,1.7795035674775304 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441047,8260.169335673732,6299.521117687065,1.311237660983751 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441049,9845.517543996062,6299.521117687065,1.5628993633108015 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441040,18918.997279306914,6299.521117687065,3.0032437269220904 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441031,7694.543265554052,6299.521117687065,1.2214489199742826 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441052,14809.489445253632,6299.521117687065,2.350891308812866 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441051,6896.488320848176,6299.521117687065,1.094763902209172 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441047,2902.176036731441,1965.7827420843205,1.476346279067575 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441049,3111.6390789210154,1965.7827420843205,1.5829008019582789 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441040,1938.077457540238,1965.7827420843205,0.9859062326924761 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441031,2099.0576622965095,1965.7827420843205,1.0677973803304823 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441052,2197.8639849488104,1965.7827420843205,1.1180604742813105 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441051,2068.991036657349,1965.7827420843205,1.0525023912172495 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441047,8444.455150874746,6243.797224888628,1.3524550600736993 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441049,10205.251236109658,6243.797224888628,1.6344623101195748 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441040,14755.01684189866,6243.797224888628,2.363147986786494 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441031,7785.312569274273,6243.797224888628,1.2468874771014271 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441052,5949.203705279853,6243.797224888628,0.9528182115789275 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441051,7542.235420853991,6243.797224888628,1.2079564965354113 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441047,699.5538759496154,477.14850073021523,1.4661135367271132 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441049,703.332383887655,477.14850073021523,1.474032471675577 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441040,441.0211683878922,477.14850073021523,0.9242849295616884 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441031,543.2716707864882,477.14850073021523,1.1385798550243371 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441052,637.712698561217,477.14850073021523,1.3365078116881404 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441051,501.5257472277467,477.14850073021523,1.0510894332901082 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441047,468.64457359237616,205.1372392304115,2.284541682195457 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441049,390.2180137120997,205.1372392304115,1.902229040305082 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441040,442.4086283631951,205.1372392304115,2.156647081841044 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441031,321.5326193975491,205.1372392304115,1.567402489200908 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441052,426.27134902491946,205.1372392304115,2.0779813096057547 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441051,333.6402550081298,205.1372392304115,1.6264246133944646 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441047,36.94076832732715,44.32085041603382,0.8334850974331305 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441049,158.73861383562036,44.32085041603382,3.5815787004437523 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441040,94.03313885824296,44.32085041603382,2.1216456357575866 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441031,0.8944077157792588,44.32085041603382,0.02018029228644249 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441052,39.00037364630978,44.32085041603382,0.8799554449027615 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441051,7.72241334942434,44.32085041603382,0.17423883515174216 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441047,200.2859654087234,73.02499011367847,2.742704450859041 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441049,103.11556974068124,73.02499011367847,1.4120586607428576 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441040,36.00705819756504,73.02499011367847,0.4930785768202449 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441031,48.46941439188409,73.02499011367847,0.6637373632838763 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441052,75.70744113886242,73.02499011367847,1.0367333295219645 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441051,19.45354438842519,73.02499011367847,0.26639571409926566 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441047,115.8163052322663,446.9213615105917,0.25914246936151775 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441049,101.13542236041832,446.9213615105917,0.2262935519989046 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441040,70.80981785316048,446.9213615105917,0.15843909902588613 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441031,35.62910883706468,446.9213615105917,0.07972120356171496 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441052,2502.081296943866,446.9213615105917,5.598482221764575 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441051,1140.6469350419356,446.9213615105917,2.552231853913976 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441047,2277.815874759086,2631.000022355788,0.8657604923619642 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441049,3266.5869673169987,2631.000022355788,1.2415761837934567 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441040,2904.350893683012,2631.000022355788,1.1038961873829505 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441031,2228.5826636944976,2631.000022355788,0.8470477555142826 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441052,3189.393109009315,2631.000022355788,1.2122360630592255 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441051,2813.0371862689008,2631.000022355788,1.0691893433547435 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441047,34.67828089235202,48.89133349009634,0.7092930058734563 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441049,74.26166733944008,48.89133349009634,1.5189126996195117 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441040,57.527892948358584,48.89133349009634,1.1766480650402327 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441031,163.28625899962233,48.89133349009634,3.339779207141044 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441052,122.49128188938876,48.89133349009634,2.5053782162476947 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441051,46.50698966147079,48.89133349009634,0.9512317693460225 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441047,203.36008804970012,307.70649021557807,0.6608898236342912 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441049,108.30338241835987,307.70649021557807,0.35196976944647124 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441040,127.8572855184518,307.70649021557807,0.4155170254253508 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441031,158.6302638443978,307.70649021557807,0.515524595315692 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441052,310.6648250508013,307.70649021557807,1.009614145067758 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441051,319.7775814523473,307.70649021557807,1.0392292383183477 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441047,147.0156796052796,154.19153082843468,0.9534614437991442 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441049,217.85628590575553,154.19153082843468,1.412893981499925 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441040,125.92017245595451,154.19153082843468,0.8166477871995639 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441031,146.12989968160056,154.19153082843468,0.9477167708010883 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441052,139.21024433411165,154.19153082843468,0.9028397577102185 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441051,131.79976809282363,154.19153082843468,0.8547795549126116 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441047,7338.214493651714,6593.957266089812,1.1128695861268818 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441049,7413.15701871518,6593.957266089812,1.1242349198770514 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441040,7881.969557348806,6593.957266089812,1.1953322169500167 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441031,7317.877031983506,6593.957266089812,1.1097853287003443 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441052,7742.107320332599,6593.957266089812,1.1741215491564194 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441051,7863.302494945677,6593.957266089812,1.1925012822548333 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441047,247.3179250243055,127.96554716912783,1.9326914977938052 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441049,158.89962828155103,127.96554716912783,1.2417375754392599 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441040,150.36938986936508,127.96554716912783,1.1750771453399627 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441031,112.9869354860476,127.96554716912783,0.882948090213036 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441052,311.28856912621177,127.96554716912783,2.432596710697388 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441051,191.8426975049749,127.96554716912783,1.4991745962014507 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441047,1601.4588847834566,1681.9358703135756,0.9521521676595701 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441049,1344.5318681253475,1681.9358703135756,0.7993954417980732 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441040,2043.436588916127,1681.9358703135756,1.214931332985457 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441031,1509.2518951590089,1681.9358703135756,0.8973302263169095 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441052,1930.070579132711,1681.9358703135756,1.1475292329504059 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441051,1913.169317821125,1681.9358703135756,1.1374805375096964 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441047,45.825931521668096,45.403354316773296,1.0093071803009648 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441049,48.754302991551945,45.403354316773296,1.0738039892691522 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441040,45.08564141469443,45.403354316773296,0.9930024354618774 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441031,53.919015018683275,45.403354316773296,1.1875557616844192 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441052,48.254405311325336,45.403354316773296,1.0627938406193653 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441051,53.92689484750439,45.403354316773296,1.187729313373269 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441047,174.29953685562418,171.72890790902974,1.0149691101975458 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441049,174.93286469326225,171.72890790902974,1.0186570614303896 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441040,179.6143219993466,171.72890790902974,1.0459178025780844 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441031,181.61340099114088,171.72890790902974,1.0575587022736281 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441052,163.07543383150565,171.72890790902974,0.9496096831751348 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441051,187.19249227165164,171.72890790902974,1.0900464840247714 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441047,53.78838152338797,385.5886159476326,0.13949680903103492 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441049,16.60556266397949,385.5886159476326,0.043065489947542224 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441040,160.53281129944514,385.5886159476326,0.41633182272488917 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441031,160.1121188045481,385.5886159476326,0.41524078300665695 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441052,723.144830190907,385.5886159476326,1.8754309652365837 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441051,93.30935835397833,385.5886159476326,0.24199199482240633 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441047,406.38058246741815,430.1288265554666,0.9447880666863744 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441049,401.06079164429775,430.1288265554666,0.9324201655026243 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441040,300.4307162569919,430.1288265554666,0.6984668260039305 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441031,281.1418129388916,430.1288265554666,0.6536223465660639 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441052,405.0739633871816,430.1288265554666,0.9417503277589462 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441051,329.83095424303536,430.1288265554666,0.7668189944030699 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441047,28485.29515918539,54695.927744901994,0.5207937104941126 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441049,35637.31109613538,54695.927744901994,0.651553279475308 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441040,27051.720436017204,54695.927744901994,0.4945838118366791 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441031,76786.39190817736,54695.927744901994,1.4038776756160671 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441052,103849.2146504918,54695.927744901994,1.8986644697725454 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441051,33289.66797198776,54695.927744901994,0.6086315626137371 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441047,131472.07179697353,97212.60478924697,1.3524179511700125 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441049,93501.12337634445,97212.60478924697,0.9618209858593043 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441040,241891.25980736467,97212.60478924697,2.4882705317049703 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441031,199624.21391098693,97212.60478924697,2.0534807635672783 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441052,334878.52417204366,97212.60478924697,3.4448055876915027 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441051,173269.2757643433,97212.60478924697,1.7823745813619967 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441047,39605.70719273433,62941.57202670208,0.6292455990125598 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441049,47618.00954713328,62941.57202670208,0.7565430607124336 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441040,49308.737782207434,62941.57202670208,0.7834049292777259 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441031,121092.4618327748,62941.57202670208,1.9238868355782888 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441052,135725.45508649334,62941.57202670208,2.156372183219601 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441051,38251.30974727782,62941.57202670208,0.6077272701585883 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441047,21242.99803128373,14728.399701289269,1.4423154220498373 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441049,15954.329661753776,14728.399701289269,1.0832357883631576 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441040,39911.31732840113,14728.399701289269,2.709820356444254 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441031,32736.377713287275,14728.399701289269,2.2226703767702376 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441052,67881.17412829233,14728.399701289269,4.6088628435545695 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441051,26081.41809279535,14728.399701289269,1.77082497907171 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441047,3926.995917512495,3575.9352491809864,1.0981731054587507 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441049,4518.054709064409,3575.9352491809864,1.263460995301635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441040,7589.596505378318,3575.9352491809864,2.1224088179775067 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441031,20333.120573090066,3575.9352491809864,5.6860986444726755 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441052,6657.044128173535,3575.9352491809864,1.8616232298105033 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441051,2572.6431164483793,3575.9352491809864,0.7194322428062991 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441047,19072.86218384438,12966.336321671553,1.4709522960596477 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441049,15988.88403743562,12966.336321671553,1.2331073050073729 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441040,29276.84837543449,12966.336321671553,2.25791215414504 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441031,24426.68552832531,12966.336321671553,1.8838540758424773 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441052,22043.17187190471,12966.336321671553,1.700030858760188 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441051,20013.606075482458,12966.336321671553,1.5435050872490717 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441047,135.12531129456414,103.34580193186551,1.3075065340694771 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441049,115.57941100097148,103.34580193186551,1.1183754815427474 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441040,196.8015966177445,103.34580193186551,1.9043017997721199 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441031,147.15530089558413,103.34580193186551,1.4239117423715153 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441052,204.84485100333623,103.34580193186551,1.9821303543455755 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441051,103.35401044461534,103.34580193186551,1.0000794276361147 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441047,334.42449287284285,211.8154700640626,1.5788482907867765 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441049,425.3149838254235,211.8154700640626,2.007950522673292 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441040,261.8548640375807,211.8154700640626,1.236240506693793 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441031,603.7204854399229,211.8154700640626,2.8502190385684787 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441052,278.4749753499084,211.8154700640626,1.3147055560468974 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441051,268.02136516878966,211.8154700640626,1.26535311650149 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441047,113.45023066962374,76.10596635595309,1.4906877358209847 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441049,50.77236200998066,76.10596635595309,0.6671272232785885 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441040,95.01839016492008,76.10596635595309,1.2485011979285858 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441031,171.61839986236123,76.10596635595309,2.2549927171240376 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441052,92.4889812556712,76.10596635595309,1.2152658416173783 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441051,39.47063490589532,76.10596635595309,0.5186273402178262 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441047,3270.671219783942,1382.686999693948,2.3654458460287042 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441049,1630.6987024977293,1382.686999693948,1.179369374890107 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441040,2787.290562737063,1382.686999693948,2.015850704717711 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441031,1788.7648718085825,1382.686999693948,1.2936874883502325 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441052,2465.395325832642,1382.686999693948,1.7830465798682902 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441051,3105.750883927577,1382.686999693948,2.246170597261001 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441047,30.619395563041294,30.899530320120164,0.9909340124533719 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441049,32.1806965120566,30.899530320120164,1.0414623192865236 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441040,30.75888193100564,30.899530320120164,0.9954482030096444 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441031,26.68656629956668,30.899530320120164,0.8636560498846735 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441052,32.105497097644744,30.899530320120164,1.0390286442878167 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441051,31.709821041199884,30.899530320120164,1.0262233992777587 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441047,29.800072716751306,31.68183515511672,0.940604373794884 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441049,31.23446752620214,31.68183515511672,0.9858793650454832 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441040,32.423767355853485,31.68183515511672,1.023418220475683 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441031,31.76559111616405,31.68183515511672,1.0026436587602092 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441052,29.99121163437167,31.68183515511672,0.9466374497415435 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441051,36.5611716188648,31.68183515511672,1.154010537579609 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441047,708.6290137331849,628.1906149122311,1.128047756383932 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441049,689.3875424511515,628.1906149122311,1.097417767929358 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441040,1534.7645553655132,628.1906149122311,2.4431510419491795 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441031,320.3621969647935,628.1906149122311,0.5099760954078462 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441052,946.9639391856888,628.1906149122311,1.5074468110574937 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441051,640.4847658998906,628.1906149122311,1.0195707333026254 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441047,16009.657717830503,10551.186365326936,1.517332474615468 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441049,13857.4354515772,10551.186365326936,1.3133533018727812 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441040,17789.915275631844,10551.186365326936,1.6860582933207067 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441031,17871.83183479938,10551.186365326936,1.6938220230408763 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441052,15955.383338783056,10551.186365326936,1.5121885621521451 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441051,13415.616326108951,10551.186365326936,1.2714794205697133 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441047,113.4173035960452,102.14043933131707,1.1104054803225285 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441049,76.93130352337667,102.14043933131707,0.753191429633776 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441040,158.48161948018,102.14043933131707,1.5516050304630742 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441031,73.31426122521573,102.14043933131707,0.7177789884709943 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441052,224.51073994793472,102.14043933131707,2.1980592742476874 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441051,147.0401756727501,102.14043933131707,1.439588243749275 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441047,4677.739877756623,2995.2816068385046,1.5617028686307528 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441049,4891.271443854519,2995.2816068385046,1.6329921809980386 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441040,4615.919303466084,2995.2816068385046,1.5410635490591316 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441031,1843.141087532504,2995.2816068385046,0.6153481807267946 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441052,3785.296203387079,2995.2816068385046,1.26375302901233 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441051,3523.7556382105454,2995.2816068385046,1.1764355078218642 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441047,41.172334316802086,35.73806763844074,1.1520582123616587 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441049,39.6738105597832,35.73806763844074,1.1101274685906375 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441040,36.856251485156555,35.73806763844074,1.0312883130120072 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441031,34.234717829730535,35.73806763844074,0.9579342167036148 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441052,48.48683153474703,35.73806763844074,1.356727846208266 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441051,45.028304043067415,35.73806763844074,1.2599535178738615 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441047,243.1978909263859,271.6614200921023,0.8952242495232989 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441049,240.2156259262697,271.6614200921023,0.8842463749354935 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441040,285.1558654695247,271.6614200921023,1.0496737643970475 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441031,272.42714495988236,271.6614200921023,1.0028186735809614 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441052,236.2741983685201,271.6614200921023,0.8697377724389987 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441051,299.4346692205268,271.6614200921023,1.1022347932916219 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441047,142.45965345221197,166.02715311669658,0.8580503295872358 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441049,156.0810092894935,166.02715311669658,0.9400932700435322 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441040,161.36477334085728,166.02715311669658,0.9719179683062913 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441031,201.79931585360137,166.02715311669658,1.215459712856495 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441052,205.34033090488936,166.02715311669658,1.236787640155225 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441051,236.7689290344648,166.02715311669658,1.4260855805197448 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441047,1567.3421482609967,1793.9624976146763,0.873676094313564 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441049,1720.0653426657143,1793.9624976146763,0.958807859669743 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441040,1721.268722210695,1793.9624976146763,0.9594786538176591 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441031,1840.482023806914,1793.9624976146763,1.025931158680347 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441052,1552.321140984524,1793.9624976146763,0.8653030055246705 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441051,1656.3823691600207,1793.9624976146763,0.9233093620197816 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441047,92.55811221403444,59.13775760336051,1.5651271871826065 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441049,106.5274363690652,59.13775760336051,1.8013438568900313 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441040,137.55880984184398,59.13775760336051,2.3260741600054713 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441031,18.20899267772417,59.13775760336051,0.3079080678008231 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441052,273.92743334852287,59.13775760336051,4.632022661152727 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441051,25.875660616900856,59.13775760336051,0.43754889710986383 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441047,212.125004799289,238.79765196261823,0.8883043993769897 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441049,138.48081415093364,238.79765196261823,0.5799086088694526 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441040,344.61529461009565,238.79765196261823,1.4431268137596356 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441031,138.77602132127947,238.79765196261823,0.5811448319559008 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441052,190.6461399553075,238.79765196261823,0.7983585198113737 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441051,386.3981378300888,238.79765196261823,1.6180985644305086 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441047,443.4531627624867,386.8144501381946,1.1464234663520383 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441049,478.340622794238,386.8144501381946,1.2366151849377511 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441040,993.4956699005388,386.8144501381946,2.568403712802351 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441031,316.8781909758748,386.8144501381946,0.8191994659523859 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441052,682.6990052027122,386.8144501381946,1.7649263230957606 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441051,473.84596240617304,386.8144501381946,1.2249955042705496 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441047,5639.896983721729,5555.372966797932,1.0152148230962998 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441049,6218.948189444049,5555.372966797932,1.1194474658338907 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441040,6238.850717290161,5555.372966797932,1.1230300385909426 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441031,4244.300275528965,5555.372966797932,0.7639991591735276 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441052,5838.495694868685,5555.372966797932,1.0509637660266655 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441051,6548.245321556301,5555.372966797932,1.1787228977590412 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441047,80.76739128212814,84.54153084580483,0.9553575677431211 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441049,47.600420103974386,84.54153084580483,0.5630418520666809 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441040,93.81648704400152,84.54153084580483,1.1097088745070547 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441031,15.642202603583788,84.54153084580483,0.18502388645071471 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441052,87.69623380965793,84.54153084580483,1.0373154227548465 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441051,2.1255352181832987,84.54153084580483,0.02514190595933328 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441047,173.40673899586838,122.00200397429413,1.42134336606803 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441049,43.23590156981615,122.00200397429413,0.35438681465368366 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441040,213.1331104536679,122.00200397429413,1.7469640129728947 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441031,48.952506861231214,122.00200397429413,0.4012434654068922 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441052,108.43724747396575,122.00200397429413,0.8888152976307957 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441051,35.9792480809285,122.00200397429413,0.29490702536746316 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441047,111.77291276248675,143.84455848940917,0.7770395622627341 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441049,199.3716245625158,143.84455848940917,1.3860213181244176 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441040,125.78034732394649,143.84455848940917,0.8744185295907965 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441031,589.1236845705376,143.84455848940917,4.095557668341781 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441052,196.06136501634103,143.84455848940917,1.3630085633776436 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441051,266.6488807190594,143.84455848940917,1.8537293556272545 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441047,2164.6324692401013,5334.764851653101,0.40575967815513736 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441049,4289.784613090724,5334.764851653101,0.804118781685651 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441040,4232.502236479469,5334.764851653101,0.7933812181370898 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441031,894.7672097346486,5334.764851653101,0.16772383312403813 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441052,2491.1345031071432,5334.764851653101,0.4669623821067216 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441051,5041.60040994312,5334.764851653101,0.9450464172532109 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441047,162.85378646734375,159.70733471984832,1.0197013603227103 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441049,100.82463701308684,159.70733471984832,0.6313087447733634 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441040,269.9242459360537,159.70733471984832,1.6901180300174885 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441031,158.5255847618471,159.70733471984832,0.9926005279590059 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441052,268.29417335969293,159.70733471984832,1.6799114068888754 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441051,114.2299409695446,159.70733471984832,0.7152454279568425 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441047,52456.007360123,82077.5827732141,0.6391027316808596 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441049,65962.9088299232,82077.5827732141,0.8036653444361679 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441040,142002.041135593,82077.5827732141,1.7300953115048991 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441031,67235.32383476713,82077.5827732141,0.8191679331071782 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441052,97470.30535595072,82077.5827732141,1.187538692815403 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441051,55135.74966051802,82077.5827732141,0.6717516256888536 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441047,228365.42193354643,170961.68742491837,1.3357695830759637 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441049,592407.560235279,170961.68742491837,3.4651480642143753 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441040,111969.0254282634,170961.68742491837,0.6549363609752453 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441031,59635.497271271706,170961.68742491837,0.3488237520904323 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441052,127187.05889056958,170961.68742491837,0.7439506523730739 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441051,100771.5970158757,170961.68742491837,0.5894396489279611 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441047,110162.76333829602,55195.40432138408,1.995868400507689 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441049,61591.37739368953,55195.40432138408,1.1158787248855697 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441040,155804.4831955754,55195.40432138408,2.8227799961094378 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441031,136167.55794619708,55195.40432138408,2.4670089769311168 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441052,198623.27487591325,55195.40432138408,3.5985473304878326 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441051,137398.19111374076,55195.40432138408,2.489304912302441 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441047,755.8732771928325,546.121028905539,1.3840764907142473 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441049,502.5327908400921,546.121028905539,0.9201857541490382 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441040,932.1878979126494,546.121028905539,1.7069254772716091 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441031,751.6115125599841,546.121028905539,1.3762727907882637 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441052,776.1983941856713,546.121028905539,1.4212937299653556 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441051,527.1992101266706,546.121028905539,0.9653523344142434 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441047,1837.7558217944843,1228.731327313693,1.4956531024664828 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441049,1250.6231650451823,1228.731327313693,1.0178166188530002 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441040,1349.70944041071,1228.731327313693,1.0984577428830635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441031,1324.0958338207029,1228.731327313693,1.0776121715033504 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441052,2723.101033186495,1228.731327313693,2.216189147826042 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441051,3056.2232554841826,1228.731327313693,2.48729985762293 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441047,82.95273358191167,76.68368758811918,1.0817520152064748 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441049,109.04108047933464,76.68368758811918,1.4219592707253774 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441040,185.69873052224352,76.68368758811918,2.421619725953481 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441031,105.27185098674812,76.68368758811918,1.3728063203243526 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441052,132.07218748512315,76.68368758811918,1.7222983353970247 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441051,92.30979670598748,76.68368758811918,1.2037735743982307 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441047,102.2900608391386,81.06808963980528,1.2617795891530805 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441049,198.7371684603293,81.06808963980528,2.4514845402591954 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441040,189.56086237951635,81.06808963980528,2.338291962000792 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441031,147.11668372683258,81.06808963980528,1.81472986942814 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441052,63.709662830199456,81.06808963980528,0.7858784277916097 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441051,44.13455758691181,81.06808963980528,0.5444134403932134 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441047,99.54690487610296,34.254424530644805,2.9061035542151927 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441049,42.892655362230585,34.254424530644805,1.2521785418948672 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441040,71.28610437974517,34.254424530644805,2.0810772726884075 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441031,102.24180994048116,34.254424530644805,2.984776750489948 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441052,491.5276325248209,34.254424530644805,14.34931805919229 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441051,108.42179247623262,34.254424530644805,3.165190890281516 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441047,39.3627076640466,60.87738129746832,0.6465900277757769 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441049,37.07924217203167,60.87738129746832,0.6090807682881337 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441040,90.00360272784414,60.87738129746832,1.478440774054568 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441031,36.72656477502673,60.87738129746832,0.603287526373183 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441052,78.90631196246801,60.87738129746832,1.2961515472701428 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441051,505.33298966058743,60.87738129746832,8.300833230512207 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441047,146.488395590658,81.37032235510941,1.8002680996071991 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441049,133.87430770722244,81.37032235510941,1.6452473559460614 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441040,116.65088034201544,81.37032235510941,1.4335801673850772 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441031,119.51424658528074,81.37032235510941,1.4687694865421188 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441052,215.86733104076873,81.37032235510941,2.6529000352081558 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441051,140.4239077173362,81.37032235510941,1.725738618860451 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441047,480.6494260439405,592.3362991324378,0.8114468533296391 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441049,755.8757635284232,592.3362991324378,1.276092254747029 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441040,859.2497271439943,592.3362991324378,1.450611296998833 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441031,604.0049789512221,592.3362991324378,1.0196994170978122 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441052,603.1960626734553,592.3362991324378,1.0183337802476788 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441051,593.7516408318733,592.3362991324378,1.0023894225316066 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441047,865.7382971642869,1509.2244087879828,0.5736312586274283 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441049,1089.4866191328388,1509.2244087879828,0.7218851038910614 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441040,1255.710529680981,1509.2244087879828,0.8320237350848361 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441031,1439.9919091096815,1509.2244087879828,0.9541271004661924 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441052,1892.7275414200792,1509.2244087879828,1.2541061027101181 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441051,616.4733789173442,1509.2244087879828,0.4084703211316449 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441047,769622.571197947,911297.6405793307,0.8445348006263707 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441049,1188237.2360442071,911297.6405793307,1.3038958767508935 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441040,1280085.620454022,911297.6405793307,1.4046844449638267 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441031,1039649.8871411422,911297.6405793307,1.14084558199911 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441052,762635.0946516971,911297.6405793307,0.8368671888219464 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441051,970220.2605962086,911297.6405793307,1.0646579310568822 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441047,1157.0156834827342,749.6106308195243,1.543488893984611 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441049,1189.0630144545316,749.6106308195243,1.5862408636795462 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441040,716.034701115531,749.6106308195243,0.9552088399983257 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441031,2205.0729368077727,749.6106308195243,2.9416244195963976 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441052,1988.732146799427,749.6106308195243,2.6530202014680775 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441051,247.84337661334257,749.6106308195243,0.3306294847264688 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441047,3921.7473661397207,2138.7943755926544,1.8336252474261414 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441049,3353.2855106021675,2138.7943755926544,1.5678391288423792 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441040,4363.177669644858,2138.7943755926544,2.040017366529605 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441031,4589.195758439738,2138.7943755926544,2.145692830881923 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441052,4785.243398774215,2138.7943755926544,2.237355518315423 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441051,3911.973453249307,2138.7943755926544,1.8290554238835182 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441047,301.1433030152377,613.8984432679271,0.4905425422032029 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441049,373.6771988861098,613.8984432679271,0.6086954658118001 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441040,1174.0360530240616,613.8984432679271,1.9124271545215021 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441031,457.82117119561394,613.8984432679271,0.7457604367890611 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441052,1321.8850608580526,613.8984432679271,2.1532634189807434 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441051,438.51692797625054,613.8984432679271,0.7143151001359783 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441047,7615.488192091867,6365.76448478505,1.1963195010267516 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441049,7112.284609456551,6365.76448478505,1.117271087621255 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441040,4595.523136078027,6365.76448478505,0.7219122144813691 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441031,6872.236740308835,6365.76448478505,1.0795618902858117 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441052,10604.025729628976,6365.76448478505,1.6657898285388795 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441051,10977.11592170285,6365.76448478505,1.7243986873751755 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441047,56.417971223607935,70.21289390855102,0.8035272167686134 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441049,73.93556611549522,70.21289390855102,1.0530197802670376 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441040,47.817032925210995,70.21289390855102,0.6810292278721686 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441031,60.87975161581664,70.21289390855102,0.867073670188123 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441052,74.92936213576783,70.21289390855102,1.0671738190048081 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441051,92.2344786056652,70.21289390855102,1.3136401801896422 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441047,2344.744464310945,2003.7789126851078,1.1701612635342769 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441049,999.1798672044912,2003.7789126851078,0.4986477604286035 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441040,1339.0604797593344,2003.7789126851078,0.6682675774668992 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441031,2150.192190070099,2003.7789126851078,1.0730685788028351 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441052,1731.0429279903535,2003.7789126851078,0.8638891830989068 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441051,2696.882644193689,2003.7789126851078,1.3458983060061287 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441047,395.30721502033265,700.7857837159185,0.5640913731500304 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441049,406.7301097055896,700.7857837159185,0.5803914964554534 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441040,1295.4877799416895,700.7857837159185,1.8486216616329774 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441031,552.5691952737282,700.7857837159185,0.7884994360812067 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441052,962.6228438002172,700.7857837159185,1.3736335213535684 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441051,514.7641570343886,700.7857837159185,0.7345527962979648 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441047,6589.853998224944,4688.560133729121,1.4055176451333256 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441049,6331.309195930096,4688.560133729121,1.3503738920576431 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441040,3238.8205503724644,4688.560133729121,0.6907921532396806 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441031,6306.609756408712,4688.560133729121,1.3451058697188234 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441052,10086.706851923736,4688.560133729121,2.151344243056794 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441051,10157.01987047356,4688.560133729121,2.166340961994874 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441047,492.2430196164159,384.65137963543384,1.2797120865209313 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441049,359.8722423898189,384.65137963543384,0.9355802720138422 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441040,702.329098246761,384.65137963543384,1.8258847762678423 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441031,356.99789331004314,384.65137963543384,0.9281076637458048 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441052,403.5855137358454,384.65137963543384,1.0492241419187343 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441051,453.2120682408509,384.65137963543384,1.1782411093140956 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441047,436.7284592538592,772.5530415852671,0.5653054686804404 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441049,512.0837287632116,772.5530415852671,0.6628460457710756 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441040,1024.6169053793362,772.5530415852671,1.3262738611148794 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441031,559.0646738479022,772.5530415852671,0.7236586276337867 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441052,800.3921557187082,772.5530415852671,1.036035213939894 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441051,309.94733709447485,772.5530415852671,0.4011987791265019 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441047,232.81460501583672,216.68366112664066,1.0744446711179036 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441049,215.73339974255407,216.68366112664066,0.9956145222064934 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441040,198.7708209770832,216.68366112664066,0.9173318373133436 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441031,221.44205141774776,216.68366112664066,1.0219600788835024 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441052,297.4182003916056,216.68366112664066,1.3725917258605838 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441051,237.5870993365651,216.68366112664066,1.0964698404173052 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441047,706.1826659562622,615.8359185894908,1.1467058751196282 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441049,474.0416233567134,615.8359185894908,0.7697531258690744 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441040,882.7498747745432,615.8359185894908,1.433417324530845 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441031,784.239896558114,615.8359185894908,1.273455920457409 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441052,1116.458389208267,615.8359185894908,1.812915348889361 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441051,733.6942115973884,615.8359185894908,1.1913793746844776 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441047,105.00000998394076,101.73138829665541,1.032129923143817 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441049,96.49093986124385,101.73138829665541,0.9484873987944599 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441040,71.05066559409043,101.73138829665541,0.6984143909144543 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441031,70.70118077462992,101.73138829665541,0.6949790222901572 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441052,99.32194073370412,101.73138829665541,0.9763155934142452 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441051,42.417587884782634,101.73138829665541,0.4169567386723374 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441047,78.76304322857278,93.53234569214308,0.8420941722964728 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441049,189.9894350998981,93.53234569214308,2.031269863852646 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441040,200.7241413658881,93.53234569214308,2.1460398526362345 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441031,44.54726490349205,93.53234569214308,0.476276571210104 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441052,234.66728460144063,93.53234569214308,2.5089425787933934 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441051,73.16656366613483,93.53234569214308,0.7822594753151901 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441047,75.6786136245696,42.30806113801961,1.7887516371333303 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441049,98.03002976988978,42.30806113801961,2.3170532313000822 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441040,97.89909200731437,42.30806113801961,2.3139583657105613 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441031,18.090886728023705,42.30806113801961,0.42759904948153143 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441052,137.6855067571354,42.30806113801961,3.2543563343158275 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441051,72.79126712807012,42.30806113801961,1.7205058603514487 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441047,307.16230243845274,205.3077634331321,1.496106612346855 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441049,365.50330639251627,205.3077634331321,1.7802702648970175 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441040,125.69300519411892,205.3077634331321,0.6122174977326497 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441031,330.95729640128667,205.3077634331321,1.612005755978527 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441052,225.33282635673643,205.3077634331321,1.097536803230173 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441051,372.27933459274334,205.3077634331321,1.8132745122129452 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441047,945.5864963974371,761.179367641068,1.2422650121585086 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441049,978.70038381117,761.179367641068,1.2857684081009846 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441040,979.6916214098356,761.179367641068,1.287070647285078 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441031,2877.3419227809063,761.179367641068,3.7801102408988427 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441052,601.3261114248171,761.179367641068,0.7899926574315277 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441051,850.2110188545761,761.179367641068,1.1169654026348894 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441047,484101.9567663479,258075.7105503754,1.8758137127044858 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441049,373996.6206153013,258075.7105503754,1.4491740420580905 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441040,316405.21708941617,258075.7105503754,1.2260170335854024 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441031,473974.003538468,258075.7105503754,1.8365695962927517 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441052,409459.5660403238,258075.7105503754,1.5865869948283988 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441051,512642.4242825367,258075.7105503754,1.9864032271354373 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441047,118.72857591128005,131.47736122215045,0.9030343688649984 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441049,97.06442666356747,131.47736122215045,0.7382596194607433 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441040,97.86138138674958,131.47736122215045,0.7443211551941502 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441031,162.11154201628602,131.47736122215045,1.2329996625226953 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441052,174.32274659326313,131.47736122215045,1.3258765233257084 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441051,101.3528037009779,131.47736122215045,0.770876466935835 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441047,3118.327600385654,3004.2024881525895,1.037988488686475 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441049,3681.0927714152353,3004.2024881525895,1.2253144672944114 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441040,2558.570024990956,3004.2024881525895,0.8516636395452586 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441031,2208.798716144974,3004.2024881525895,0.735236298104279 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441052,3430.0993104971135,3004.2024881525895,1.141767016046387 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441051,2760.904655731249,3004.2024881525895,0.919014169856788 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441047,86.31115723127971,96.13121274223809,0.8978473772375114 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441049,70.00154960565004,96.13121274223809,0.728187522125088 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441040,94.50543350744132,96.13121274223809,0.983087915065047 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441031,33.50421513872767,96.13121274223809,0.3485258760707032 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441052,146.113873646478,96.13121274223809,1.5199420612560164 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441051,55.55712903837732,96.13121274223809,0.5779301795281175 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441047,711.1147377392717,490.807523353751,1.4488668243716665 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441049,590.7619011240624,490.807523353751,1.2036529046810658 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441040,387.40989894952736,490.807523353751,0.7893316229187068 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441031,590.3097417823183,490.807523353751,1.2027316487503203 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441052,755.3239070804549,490.807523353751,1.5389411757978553 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441051,261.2456769251281,490.807523353751,0.5322772461595592 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441047,72.51362347743647,78.64120835950264,0.9220817557373437 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441049,99.66309315983123,78.64120835950264,1.2673138579487304 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441040,65.0628083521074,78.64120835950264,0.8273373427157609 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441031,86.3639560268805,78.64120835950264,1.098202301674637 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441052,112.43300659973444,78.64120835950264,1.4296958165463967 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441051,70.69653959670374,78.64120835950264,0.8989757542066188 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441047,1592.3204316905362,1710.8868039225827,0.9306988796919778 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441049,1772.249358385297,1710.8868039225827,1.0358659347433314 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441040,1968.3717782659064,1710.8868039225827,1.1504979603285168 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441031,1662.959588285561,1710.8868039225827,0.9719869160676569 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441052,1816.8764217009616,1710.8868039225827,1.0619501053695513 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441051,1852.3101070011448,1710.8868039225827,1.0826608182109525 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441047,174.49275194017972,158.21676846284709,1.1028714189744977 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441049,133.99037760298913,158.21676846284709,0.8468784876898375 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441040,304.0745115935568,158.21676846284709,1.9218854900639715 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441031,237.73793208595217,158.21676846284709,1.5026089484426455 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441052,216.2361007179454,158.21676846284709,1.3667078579520007 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441051,178.26142703590926,158.21676846284709,1.1266911135134776 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441047,913.3299100340744,1068.4447009417866,0.8548218819645178 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441049,591.7035775028753,1068.4447009417866,0.5537989724515596 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441040,783.4843589273125,1068.4447009417866,0.7332942530733747 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441031,1022.3487755823091,1068.4447009417866,0.9568569853743054 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441052,1064.2910327366317,1068.4447009417866,0.9961124162986689 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441051,1061.566168185304,1068.4447009417866,0.9935621069107091 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441047,131.13881165163994,101.193417409009,1.2959223535419901 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441049,110.0159909520233,101.193417409009,1.0871852514611178 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441040,144.02480037323843,101.193417409009,1.4232625407946373 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441031,133.47720871404846,101.193417409009,1.319030546962883 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441052,180.5324565989145,101.193417409009,1.7840335984427595 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441051,147.22880951588814,101.193417409009,1.4549247696696597 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441047,7543.72901305292,8195.704907369402,0.9204490764753818 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441049,9653.928098446608,8195.704907369402,1.1779252922791306 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441040,11736.64537411936,8195.704907369402,1.4320483114961864 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441031,11438.219909447424,8195.704907369402,1.3956358896185272 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441052,8786.89,8195.704907369402,1.072133525951992 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441051,9031.890043038424,8195.704907369402,1.102027238061871 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441047,45.54788582951517,54.484574340672744,0.8359776391886696 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441049,94.5153513432668,54.484574340672744,1.734717623969966 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441040,86.65793376696496,54.484574340672744,1.590504006237134 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441031,23.53647532144968,54.484574340672744,0.4319842011480981 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441052,12.556540847049275,54.484574340672744,0.23046047434522793 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441051,20.329773760669188,54.484574340672744,0.37312898204094086 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441047,328.43648131037475,181.8259570369428,1.8063234021292356 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441049,190.90132156556388,181.8259570369428,1.0499123704696198 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441040,271.8535108164652,181.8259570369428,1.4951303721790992 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441031,116.71943791452544,181.8259570369428,0.6419294572491141 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441052,224.74444025549195,181.8259570369428,1.2360415636906512 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441051,221.00194657249017,181.8259570369428,1.2154587286323906 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441047,529.0978381664212,598.5025834222519,0.8840360139149731 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441049,683.5134002624741,598.5025834222519,1.142039181107838 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441040,540.5107345503549,598.5025834222519,0.9031050984938139 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441031,675.2115379698892,598.5025834222519,1.1281681260405154 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441052,761.2375843632001,598.5025834222519,1.2719035898064561 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441051,588.1286432569125,598.5025834222519,0.982666841459529 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441047,13356.597010848842,15066.853658787537,0.8864887994089455 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441049,19071.638445307985,15066.853658787537,1.2658010011389944 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441040,19950.07409824422,15066.853658787537,1.3241035288484806 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441031,17792.158592696476,15066.853658787537,1.1808808259260846 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441052,13937.904109837022,15066.853658787537,0.9250706501491722 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441051,17756.353517279305,15066.853658787537,1.1785044123610475 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441047,61.6929467578164,62.8704966822211,0.9812702302901053 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441049,62.915193223171805,62.8704966822211,1.0007109302981432 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441040,61.49085305654057,62.8704966822211,0.9780557861240713 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441031,60.87855076340639,62.8704966822211,0.9683166823242545 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441052,61.74213877314932,62.8704966822211,0.9820526643081083 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441051,64.2571150458119,62.8704966822211,1.0220551520469046 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441047,95.56797224717177,100.49015468400951,0.9510182619151547 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441049,97.8063057328112,100.49015468400951,0.9732924189475312 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441040,103.49340981554954,100.49015468400951,1.0298860633758973 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441031,100.36935125220728,100.49015468400951,0.9987978580371172 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441052,97.07317267137115,100.49015468400951,0.9659968479162657 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441051,107.9011150587167,100.49015468400951,1.0737481238635853 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441047,100.72079162827518,109.95671552102958,0.9160040034936475 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441049,106.63447552741803,109.95671552102958,0.9697859291461269 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441040,113.28894860052776,109.95671552102958,1.0303049528508414 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441031,106.8258621658242,109.95671552102958,0.9715264925805592 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441052,103.68318197391714,109.95671552102958,0.942945426139865 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441051,113.69469339295914,109.95671552102958,1.033994993886614 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441047,242.69111491656483,243.54938966397899,0.9964759724974129 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441049,245.31100476186364,243.54938966397899,1.007233091818933 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441040,263.16764925473126,243.54938966397899,1.0805514627559496 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441031,243.02196470294757,243.54938966397899,0.9978344229818884 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441052,234.3071620588598,243.54938966397899,0.9620519369074563 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441051,264.67024754742863,243.54938966397899,1.0867210462427754 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441047,58.253449763899624,49.66723175069083,1.1728749058596237 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441049,66.4251642960262,49.66723175069083,1.3374041989989158 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441040,69.87180565421131,49.66723175069083,1.4067988730465022 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441031,21.28253195750695,49.66723175069083,0.4285024795490223 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441052,110.79661579364814,49.66723175069083,2.2307789640824316 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441051,62.052422519522395,49.66723175069083,1.2493634199506054 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441047,356.8794482040003,318.9289567276793,1.1189935585207003 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441049,202.2800071382555,318.9289567276793,0.6342478563681326 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441040,305.037823072368,318.9289567276793,0.956444426376836 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441031,494.1184426947829,318.9289567276793,1.5493056753598293 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441052,304.989494160299,318.9289567276793,0.9562928913372934 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441051,457.879589720974,318.9289567276793,1.4356789500049665 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441047,45.31603482369015,52.85511393128503,0.857363298518358 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441049,46.80854879027632,52.85511393128503,0.8856011331492043 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441040,46.68515864260849,52.85511393128503,0.8832666353401892 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441031,43.68720983248319,52.85511393128503,0.8265465076715057 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441052,44.83660968623414,52.85511393128503,0.8482927450411809 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441051,53.458775367633535,52.85511393128503,1.011421060167107 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441047,143.36605929123178,145.91831693350866,0.9825089975274325 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441049,164.2984375721083,145.91831693350866,1.1259617094334702 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441040,151.92112206213253,145.91831693350866,1.0411381192901177 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441031,130.49144521821427,145.91831693350866,0.8942773461242427 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441052,144.26284916580212,145.91831693350866,0.98865483235760665 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441051,145.25819855947242,145.91831693350866,0.9954761102793075 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441047,289.7118791888576,261.347965154705,1.1085293088750954 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441049,244.38792621880248,261.347965154705,0.9351055252109463 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441040,593.13495519278,261.347965154705,2.2695219947156415 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441031,348.6220051343661,261.347965154705,1.333938088739276 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441052,526.3131211176291,261.347965154705,2.0138405164397506 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441051,290.9425642611716,261.347965154705,1.113238299326142 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441047,6761.575198944948,7540.877985370558,0.8966562265113596 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441049,6554.260394729659,7540.877985370558,0.869164095672287 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441040,5641.09670998988,7540.877985370558,0.7480689544286104 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441031,5706.78618403024,7540.877985370558,0.7567800719095986 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441052,7180.774042232213,7540.877985370558,0.9522464169507909 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441051,7737.087249147627,7540.877985370558,1.0260194189798215 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441047,6902.21231430757,5107.556668860965,1.3513726350581696 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441049,9135.954514849722,5107.556668860965,1.7887132942740562 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441040,5769.31672028988,5107.556668860965,1.1295648965509166 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441031,6217.482117815854,5107.556668860965,1.21731045212317 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441052,9010.766127314871,5107.556668860965,1.7642028687122449 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441051,6018.5641506554175,5107.556668860965,1.1783646351588333 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441047,71121.56884030672,180330.65339424144,0.3943953371300648 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441049,78179.09171800035,180330.65339424144,0.4335319051225534 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441040,161824.15221997426,180330.65339424144,0.8973746236375687 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441031,132152.19689730665,180330.65339424144,0.7328326849035125 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441052,138372.09227313063,180330.65339424144,0.7673242993836417 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441051,103727.50886456158,180330.65339424144,0.5752073034293899 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441047,203.2174658801736,98.01831453553807,2.073260153912297 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441049,244.56856776519243,98.01831453553807,2.4951313325890774 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441040,273.7282542524421,98.01831453553807,2.7926235576433798 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441031,324.3407295803728,98.01831453553807,3.308980889104944 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441052,238.73299314929577,98.01831453553807,2.435595779018822 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441051,176.20598807386352,98.01831453553807,1.7976843297991754 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441047,1545.0272410177952,1812.4793707702274,0.8524385247823393 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441049,2056.239687900936,1812.4793707702274,1.134489981547829 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441040,1670.2777503430425,1812.4793707702274,0.9215430405882329 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441031,1197.9637972173464,1812.4793707702274,0.6609530660248355 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441052,1578.2088407602696,1812.4793707702274,0.8707458226625759 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441051,1942.5067052090212,1812.4793707702274,1.0717400355202595 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441047,247.81991023472764,434.5650550234931,0.5702711420763693 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441049,275.4305152484471,434.5650550234931,0.6338073254269306 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441040,411.5131673041699,434.5650550234931,0.9469541154935318 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441031,246.827698189254,434.5650550234931,0.5679879119040306 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441052,1212.3444907256614,434.5650550234931,2.789788264636513 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441051,243.5292845800403,434.5650550234931,0.5603977626937233 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441047,30670.648179744578,9833.502392298877,3.1189953443001492 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441049,16406.65483172343,9833.502392298877,1.6684446880871588 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441040,33962.68145276387,9833.502392298877,3.4537726333764662 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441031,39333.771981413774,9833.502392298877,3.999975838946059 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441052,37130.30505568128,9833.502392298877,3.7758983091070317 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441051,33013.95700920213,9833.502392298877,3.357293840194422 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441047,41.72718517161261,42.4088060383901,0.9839273742778691 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441049,41.256156821518466,42.4088060383901,0.9728205218551023 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441040,40.128192973761855,42.4088060383901,0.9462231249197692 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441031,53.81885520462908,42.4088060383901,1.2690490544796325 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441052,35.661644488080846,42.4088060383901,0.8409018743842621 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441051,49.67365902645038,42.4088060383901,1.171305294034542 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441047,383.2406873357334,385.8715169071063,0.9931821099612123 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441049,403.0876432270088,385.8715169071063,1.0446162143759552 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441040,417.9156910742522,385.8715169071063,1.0830436369701268 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441031,391.577942830342,385.8715169071063,1.0147884092844548 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441052,373.7775120110773,385.8715169071063,0.9686579486535658 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441051,431.59223438178986,385.8715169071063,1.1184868938789547 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441047,1288.0938758335576,1002.6445024002205,1.2846964928745959 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441049,722.538785424491,1002.6445024002205,0.7206330695424079 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441040,1162.3733054820882,1002.6445024002205,1.1593075139787776 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441031,1159.1575430819282,1002.6445024002205,1.156100233240229 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441052,671.2847559110755,1002.6445024002205,0.6695142239388874 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441051,1137.4123994656786,1002.6445024002205,1.1344124430372267 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441047,14957.83800690437,6245.085755978491,2.3951373273913914 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441049,11932.11267149878,6245.085755978491,1.9106403238860306 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441040,14675.249517786344,6245.085755978491,2.3498875902124423 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441031,10251.001674437655,6245.085755978491,1.6414509063585325 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441052,18052.11962877701,6245.085755978491,2.8906119682176525 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441051,14129.583064987602,6245.085755978491,2.26251225637073 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441047,244.64090263084267,289.8012081128336,0.8441679875109153 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441049,244.40184310326504,289.8012081128336,0.8433430788463366 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441040,270.81050388378463,289.8012081128336,0.9344698928182006 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441031,262.66729156719623,289.8012081128336,0.9063705885757632 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441052,401.88102127738114,289.8012081128336,1.386747225432233 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441051,227.4542668415221,289.8012081128336,0.7848630732863031 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441047,25728.883820082337,19122.271903916942,1.3454930433664694 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441049,31873.79752774754,19122.271903916942,1.6668415598262998 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441040,25868.022719106673,19122.271903916942,1.3527693178449134 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441031,24112.10708125983,19122.271903916942,1.2609436369493725 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441052,30491.100931154466,19122.271903916942,1.5945333841272684 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441051,32470.917114982218,19122.271903916942,1.69806795333409 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441047,59.596913937580446,111.01681566749893,0.5368278091859189 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441049,64.64400213595154,111.01681566749893,0.5822901850253357 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441040,101.36344981381735,111.01681566749893,0.9130459129489544 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441031,109.35692180833531,111.01681566749893,0.985048266344307 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441052,191.3830400345452,111.01681566749893,1.7239103723506828 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441051,77.19239291462259,111.01681566749893,0.6953216271831987 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441047,1372.706873089884,1048.3386659324408,1.309411660275771 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441049,1687.7608462765488,1048.3386659324408,1.6099385638660733 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441040,1604.5499510122777,1048.3386659324408,1.5305645047300787 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441031,912.4986083279334,1048.3386659324408,0.8704234976550398 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441052,1420.345188610388,1048.3386659324408,1.354853383517117 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441051,1718.528417326043,1048.3386659324408,1.63928744896336 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441047,7021.635533926274,5453.602601951663,1.2875224042568603 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441049,6945.561059257562,5453.602601951663,1.2735730059927683 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441040,6559.0264979064395,5453.602601951663,1.2026960848887636 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441031,23132.82380351808,5453.602601951663,4.241750910717186 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441052,16289.52604910316,5453.602601951663,2.9869294185963753 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441051,4794.444715522618,5453.602601951663,0.8791334949500804 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441047,111250.86468583504,64173.361133824874,1.733598844134662 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441049,91888.86580561363,64173.361133824874,1.431884884664087 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441040,56178.02604795416,64173.361133824874,0.8754103736409018 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441031,79502.10815420923,64173.361133824874,1.2388646433590773 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441052,115603.8862973654,64173.361133824874,1.801431065084609 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441051,177465.32943535532,64173.361133824874,2.765404932823689 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441047,95.75135320428478,44.60879663763593,2.146467970927072 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441049,42.298320709888515,44.60879663763593,0.9482058225754044 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441040,95.8201787614634,44.60879663763593,2.1480108405484537 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441031,86.18205434958627,44.60879663763593,1.9319520104892371 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441052,9.13711118109102,44.60879663763593,0.20482756473601316 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441051,92.69413319671058,44.60879663763593,2.0779339543650814 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441047,130.850029471629,136.29080299882398,0.9600796722340691 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441049,133.36985779214143,136.29080299882398,0.9785682882306611 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441040,140.1112534744659,136.29080299882398,1.028031608821579 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441031,133.3190110312581,136.29080299882398,0.9781952127203218 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441052,129.96222420106147,136.29080299882398,0.9535656210212724 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441051,144.52071437369295,136.29080299882398,1.0603849356947437 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441047,50.603942075002486,82.77341642135346,0.6113550009511017 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441049,54.481471046895514,82.77341642135346,0.6582001009788049 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441040,66.3542039260951,82.77341642135346,0.8016366460980989 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441031,34.232454297072444,82.77341642135346,0.41356821763661467 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441052,152.7631030842605,82.77341642135346,1.8455575435793112 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441051,10.16845827844643,82.77341642135346,0.12284690807836733 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441047,2331.2821315992546,2141.365658987758,1.0886894173418622 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441049,2411.4098206682415,2141.365658987758,1.12610838347344 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441040,3939.774442468937,2141.365658987758,1.8398419839847917 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441031,2653.1362642424833,2141.365658987758,1.2389926274883123 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441052,2318.582265778862,2141.365658987758,1.0827586853498323 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441051,2256.1629977908574,2141.365658987758,1.053609404970735 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441047,477.805417634845,285.0677067828484,1.6761120472997506 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441049,453.31116920532855,285.0677067828484,1.5901877288073194 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441040,396.9949812999716,285.0677067828484,1.3926340018667365 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441031,535.0898598503021,285.0677067828484,1.877062350867786 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441052,316.4279886857688,285.0677067828484,1.1100099420479403 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441051,273.97396662435966,285.0677067828484,0.9610838411558856 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441047,920482.4748359538,724296.655045942,1.2708639042072722 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441049,620826.2392808761,724296.655045942,0.8571435957294282 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441040,883315.3744285037,724296.655045942,1.2195491561016185 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441031,763246.2053841237,724296.655045942,1.0537756871674508 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441052,573838.814729705,724296.655045942,0.7922704194917295 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441051,908857.915159279,724296.655045942,1.2548144587270396 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441047,37.093262992205325,126.94877083842833,0.29219080064520736 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441049,155.11212588520382,126.94877083842833,1.2218481901066995 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441040,21.133667775399715,126.94877083842833,0.16647398502422048 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441031,2.596053049575018,126.94877083842833,0.020449611543534325 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441052,61.093939311818175,126.94877083842833,0.4812487660047874 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441051,55.39907481389947,126.94877083842833,0.4363892178555049 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441047,124752.92259331142,94593.87687362579,1.3188266166527574 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441049,169995.12176331625,94593.87687362579,1.797104922450995 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441040,64809.762875070504,94593.87687362579,0.6851369773294539 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441031,66468.91967894179,94593.87687362579,0.7026767680506637 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441052,100745.32005518922,94593.87687362579,1.0650300356098266 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441051,93710.86058418085,94593.87687362579,0.9906651855423515 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441047,21.5558859445614,34.2642969985689,0.6291063244479148 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441049,69.08137636791385,34.2642969985689,2.0161328968984575 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441040,1.4259624358553322,34.2642969985689,0.04161656770354546 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441031,1.4686723497457914,34.2642969985689,0.04286305216789163 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441052,177.89591875455233,34.2642969985689,5.191874176259399 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441051,62.863237622968406,34.2642969985689,1.8346571542265695 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441047,25.84298872947562,74.66086218948179,0.34613836448725577 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441049,77.39493531827664,74.66086218948179,1.0366198976092191 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441040,36.452555016910445,74.66086218948179,0.4882418170365822 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441031,139.5204923461986,74.66086218948179,1.86872329430257 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441052,204.34380454358347,74.66086218948179,2.736960149549028 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441051,62.222625216357535,74.66086218948179,0.8334035181437196 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441047,295.54980622357897,347.6986105145094,0.8500172197589088 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441049,287.79461490021646,347.6986105145094,0.8277128702767905 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441040,369.693978790722,347.6986105145094,1.0632598682050087 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441031,185.50626278608223,347.6986105145094,0.5335260400137293 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441052,741.6305261468443,347.6986105145094,2.1329694848346143 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441051,259.81631389794114,347.6986105145094,0.7472457641216229 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441047,3884.779714390154,2521.321340016667,1.540771361719595 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441049,3994.701628674201,2521.321340016667,1.5843683092960275 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441040,4887.7761996412055,2521.321340016667,1.9385772539445112 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441031,4432.232143905495,2521.321340016667,1.757900539514807 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441052,4334.98,2521.321340016667,1.7193286437544466 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441051,4316.885922805928,2521.321340016667,1.7121522172883334 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441047,140.55253539434548,79.44971561377609,1.769075374386545 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441049,86.5757546121252,79.44971561377609,1.0896924418583254 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441040,136.76650415225828,79.44971561377609,1.7214221988800147 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441031,111.0787235184982,79.44971561377609,1.3981009580761523 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441052,197.59907033291736,79.44971561377609,2.487096005396587 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441051,105.1413240979216,79.44971561377609,1.3233694203392559 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441047,33.88587919414803,42.37178439720435,0.7997274525069044 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441049,44.49306717588602,42.37178439720435,1.0500635696338914 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441040,41.493030398892245,42.37178439720435,0.9792608687405177 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441031,323.6143747047207,42.37178439720435,7.637496964278721 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441052,147.70123605515863,42.37178439720435,3.485839413100191 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441051,72.53211473771754,42.37178439720435,1.71180222333292 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441047,1020.4794327992324,1321.2949146990686,0.7723328239945975 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441049,1301.4390866450874,1321.2949146990686,0.9849724479878866 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441040,2254.6653536500726,1321.2949146990686,1.7064058360987362 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441031,739.1577691136324,1321.2949146990686,0.5594192188970766 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441052,1686.5621926041188,1321.2949146990686,1.276446441927192 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441051,1062.9311975563992,1321.2949146990686,0.8044617335097267 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441047,20284.25005776023,23354.026662177774,0.8685547186863027 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441049,22163.48504985512,23354.026662177774,0.9490219982384984 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441040,52019.74205151013,23354.026662177774,2.227442093990453 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441031,46498.01652757295,23354.026662177774,1.9910063990325595 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441052,27859.1270590969,23354.026662177774,1.1929046524647164 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441051,19863.671898283807,23354.026662177774,0.8505459116587096 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441047,6981.267670254013,13473.54115415771,0.5181464613035089 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441049,7886.072840475207,13473.54115415771,0.5853006830384525 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441040,6616.693930219182,13473.54115415771,0.49108796674268373 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441031,21225.058487896607,13473.54115415771,1.5753140354899875 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441052,21401.87974357755,13473.54115415771,1.5884376273993333 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441051,6896.760000869879,13473.54115415771,0.5118743411223896 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441047,65576.15892962844,49612.48263442616,1.321767334499908 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441049,74591.77275749522,49612.48263442616,1.503488009401406 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441040,82687.82588647856,49612.48263442616,1.6666738186792809 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441031,66191.21194742463,49612.48263442616,1.3341644770160013 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441052,73992.64384710671,49612.48263442616,1.491411836660702 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441051,71326.06621003516,49612.48263442616,1.437663717327097 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441042,6.792923264374221,73.06854961986588,0.09296644451975493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441038,11.071854543060564,73.06854961986588,0.15152695107075656 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441053,12.902112988458937,73.06854961986588,0.17657546311759703 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441043,33.95610507398695,73.06854961986588,0.46471573954377443 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441041,64.89205008978796,73.06854961986588,0.8880982368937717 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441036,37.01300523662483,73.06854961986588,0.5065517986764819 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441042,482.3295432843354,990.9231863649335,0.48674766109136625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441038,28.97739757021628,990.9231863649335,0.029242829281768964 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441053,40.5864540837869,990.9231863649335,0.040958224252146895 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441043,97.09007035022036,990.9231863649335,0.09797941120580904 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441041,701.7650375425711,990.9231863649335,0.7081931750097608 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441036,650.1999650349339,990.9231863649335,0.6561557686626587 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441042,55.47979590225641,50.719124328797626,1.0938634417778332 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441038,55.491509321165,50.719124328797626,1.0940943885669114 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441053,100.87202075680518,50.719124328797626,1.9888360079499918 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441043,71.54712601373484,50.719124328797626,1.410653810777868 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441041,74.4777652192021,50.719124328797626,1.4684355498013724 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441036,68.06824069399957,50.719124328797626,1.3420626163167284 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441042,328.2761677557349,319.2477137201226,1.0282804031089392 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441038,346.269399745431,319.2477137201226,1.08464175267046 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441053,334.5806084365526,319.2477137201226,1.0480282052383687 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441043,383.2171448453773,319.2477137201226,1.2003755340322821 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441041,339.8689702122191,319.2477137201226,1.064593278529082 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441036,318.606548243934,319.2477137201226,0.9979916364358034 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441042,27.712143619599555,44.58166891160943,0.6216039977001195 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441038,40.77892839648036,44.58166891160943,0.9147017012156132 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441053,13.53162961587928,44.58166891160943,0.3035245190732538 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441043,129.73326187930004,44.58166891160943,2.910013578372712 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441041,6.968838520333898,44.58166891160943,0.1563162324441191 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441036,51.82620587471043,44.58166891160943,1.1625003536198815 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441042,1552.0660860067892,1543.2839395802719,1.0056905577783086 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441038,2735.8953254868147,1543.2839395802719,1.772775090389976 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441053,2323.1715690521096,1543.2839395802719,1.505342931051265 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441043,2175.90752585162,1543.2839395802719,1.4099204106558663 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441041,1265.4744639087571,1543.2839395802719,0.8199880990486619 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441036,2930.836642212816,1543.2839395802719,1.8990910013681073 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441042,32.80089498822066,31.276034215973343,1.0487549272301455 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441038,32.7348307733996,31.276034215973343,1.0466426320981967 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441053,27.99454031170084,31.276034215973343,0.8950796037115033 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441043,31.738288308740735,31.276034215973343,1.014779817977412 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441041,42.6600130376736,31.276034215973343,1.363984089002122 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441036,23.677427767364502,31.276034215973343,0.7570469965553347 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441042,136.7723174985896,130.468422036268,1.0483174040425598 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441038,37.550718786171025,130.468422036268,0.28781461598219193 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441053,494.5857740739344,130.468422036268,3.7908465999262866 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441043,39.910034030009186,130.468422036268,0.30589803576312796 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441041,28.006344244941957,130.468422036268,0.21465994458917168 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441036,27.612573927156724,130.468422036268,0.21164181720141367 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441042,101.05404499127228,95.42663227533711,1.05897109205005 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441038,157.4826087931326,95.42663227533711,1.6503003934870475 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441053,111.14087046108789,95.42663227533711,1.1646735068718557 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441043,96.53825222009807,95.42663227533711,1.0116489487080877 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441041,94.97202812042347,95.42663227533711,0.9952360872004583 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441036,151.76982211201997,95.42663227533711,1.590434645897534 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441042,644.8097443728204,569.3868516791151,1.132463355048126 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441038,608.180111363773,569.3868516791151,1.0681316394473406 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441053,631.7988950223292,569.3868516791151,1.1096127231585375 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441043,610.2957297853476,569.3868516791151,1.0718472475885115 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441041,676.033214958087,569.3868516791151,1.1873003617215132 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441036,596.4932972568636,569.3868516791151,1.0476063778041447 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441042,7265.978710283912,5328.634617598269,1.3635723279444605 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441038,7295.436547134474,5328.634617598269,1.3691005427620566 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441053,2548.017165284818,5328.634617598269,0.47817449462002415 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441043,2316.966587981239,5328.634617598269,0.43481431065460185 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441041,7823.983186651403,5328.634617598269,1.4682904248701971 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441036,22145.13715796309,5328.634617598269,4.155874580859211 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441042,834086.398630906,656386.6079991342,1.270724278140675 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441038,555557.0543347343,656386.6079991342,0.8463869426407723 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441053,793654.4936486655,656386.6079991342,1.2091265787215943 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441043,906804.3658569928,656386.6079991342,1.3815095475838668 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441041,879526.1780776634,656386.6079991342,1.339951436179855 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441036,987267.1937534518,656386.6079991342,1.5040940532942044 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441042,7123.080491148387,5223.837669019135,1.3635723279444607 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441038,7151.958987954975,5223.837669019135,1.3691005427620566 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441053,2497.9059373602704,5223.837669019135,0.4781744946200242 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441043,2271.399375026098,5223.837669019135,0.4348143106546019 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441041,7670.110830497048,5223.837669019135,1.4682904248701973 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441036,21709.614183211463,5223.837669019135,4.155874580859212 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441042,834086.398630906,656386.6079991342,1.270724278140675 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441038,555557.0543347343,656386.6079991342,0.8463869426407723 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441053,793654.4936486655,656386.6079991342,1.2091265787215943 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441043,906804.3658569928,656386.6079991342,1.3815095475838668 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441041,879526.1780776634,656386.6079991342,1.339951436179855 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441036,987267.1937534518,656386.6079991342,1.5040940532942044 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441042,54.55388734346268,50.79723336807032,1.0739539090283148 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441038,49.17026807558908,50.79723336807032,0.9679713798447946 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441053,57.760998184839465,50.79723336807032,1.1370894506460734 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441043,56.8484862474583,50.79723336807032,1.1191256389012638 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441041,54.25973353402741,50.79723336807032,1.0681631643374798 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441036,37.33325187560379,50.79723336807032,0.7349465590988347 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441042,84.75354184095859,124.85055234194422,0.6788399430451312 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441038,55.76485097073392,124.85055234194422,0.44665281750619384 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441053,115.25024984861484,124.85055234194422,0.9231056466051043 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441043,99.73641861026098,124.85055234194422,0.7988464347125999 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441041,261.8898055469949,124.85055234194422,2.097626327112464 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441036,84.50391309269538,124.85055234194422,0.676840522589389 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441042,194.91344409437875,149.81706398084205,1.3010096374556066 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441038,197.84717802114585,149.81706398084205,1.3205917454532794 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441053,198.71008188355353,149.81706398084205,1.3263514622671 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441043,192.8294042362538,149.81706398084205,1.287099073446747 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441041,203.317625045622,149.81706398084205,1.357105924006236 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441036,187.28275876888603,149.81706398084205,1.2500762849873692 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441042,3380.9458656739725,2791.14294318225,1.2113123313631777 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441038,3144.8926799507108,2791.14294318225,1.1267401003709048 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441053,3165.337023251158,2791.14294318225,1.1340648213603421 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441043,3230.2009683269675,2791.14294318225,1.1573040270893962 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441041,3586.306987403597,2791.14294318225,1.2848883272580662 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441036,3111.0797700191597,2791.14294318225,1.1146257405477564 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441042,514.8813728818513,222.01180748199775,2.3191621144906964 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441038,464.2158190217624,222.01180748199775,2.0909510367344053 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441053,481.07569912961657,222.01180748199775,2.166892403543111 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441043,179.5040866343406,222.01180748199775,0.8085339634419941 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441041,512.9540888185327,222.01180748199775,2.3104811164610086 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441036,762.0856465465929,222.01180748199775,3.4326356565895173 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441042,10889.9971218863,4330.453784028004,2.5147473371155318 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441038,10632.385208854224,4330.453784028004,2.455258903367035 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441053,11433.980923781011,4330.453784028004,2.640365535351727 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441043,8699.489347286812,4330.453784028004,2.0089094079177348 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441041,13383.000300160298,4330.453784028004,3.09043831607689 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441036,8948.91533777484,4330.453784028004,2.066507526481657 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441042,154.21388726789206,100.4664893584531,1.5349783619657924 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441038,161.99269373792268,100.4664893584531,1.612405238526361 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441053,132.35485472536456,100.4664893584531,1.3174030024393244 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441043,98.48747129284088,100.4664893584531,0.9803017097715905 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441041,109.66533231556608,100.4664893584531,1.0915613058230047 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441036,108.2529196391431,100.4664893584531,1.0775027606758398 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441042,669.432776548497,219.8603821991507,3.0448085728429293 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441038,384.9355556792404,219.8603821991507,1.7508181866552188 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441053,521.7257154479647,219.8603821991507,2.372986484556289 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441043,953.0166329000696,219.8603821991507,4.3346446657079944 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441041,496.4070619120641,219.8603821991507,2.257828613535366 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441036,183.02711347581095,219.8603821991507,0.8324697321322039 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441042,94.92799270863726,115.26780159034894,0.8235430137377178 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441038,95.93785042150772,115.26780159034894,0.8323039834008628 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441053,99.86185576333484,115.26780159034894,0.866346493865083 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441043,124.53406813411505,115.26780159034894,1.0803890281233746 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441041,85.08006966429033,115.26780159034894,0.738107853975189 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441036,69.18887913061057,115.26780159034894,0.6002446318573978 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441042,971.3678853802722,1760.6737631139824,0.5517023685650206 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441038,1584.2251831765827,1760.6737631139824,0.8997834899150611 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441053,1303.4832489307687,1760.6737631139824,0.7403320684607623 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441043,1095.156465207413,1760.6737631139824,0.6220098738056307 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441041,1304.1990905018542,1760.6737631139824,0.740738640982079 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441036,1587.1082976252465,1760.6737631139824,0.9014209962544324 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441042,1187.825656316929,518.6000624505415,2.2904464197402814 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441038,805.9470036815583,518.6000624505415,1.5540819641887738 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441053,986.2961086940228,518.6000624505415,1.901843405173298 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441043,491.27562513558536,518.6000624505415,0.9473111569137884 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441041,2175.0104078021677,518.6000624505415,4.194003366533718 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441036,1579.180191352457,518.6000624505415,3.0450829178275742 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441042,6803.139493177679,841.89306662726494,8.080764366467532 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441038,1857.06257189384,841.89306662726494,2.2058176335071606 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441053,1931.037905928095,841.89306662726494,2.2936854839107874 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441043,1676.6040528274618,841.89306662726494,1.9914691298553622 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441041,1813.7660113209067,841.89306662726494,2.1543900089201276 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441036,1550.0020130118623,841.89306662726494,1.841091314864221 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441042,664.7990098990034,246.94010350613598,2.69214680183563 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441038,457.02482577725783,246.94010350613598,1.8507517381270622 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441053,513.8145522812408,246.94010350613598,2.080725426878561 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441043,266.3963332036797,246.94010350613598,1.0787892667950563 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441041,560.9333784482113,246.94010350613598,2.2715361761167854 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441036,755.0811020850892,246.94010350613598,3.0577500023860114 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441042,4205.247824154702,6405.278640912654,0.6565284759501921 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441038,3450.453457387765,6405.278640912654,0.5386890486463097 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441053,3265.2841467767116,6405.278640912654,0.5097801875347391 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441043,4150.455554226872,6405.278640912654,0.6479742392027298 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441041,3311.5290690522943,6405.278640912654,0.517000001826689 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441036,2619.320412954452,6405.278640912654,0.4089315328491688 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441042,193.4683554360848,184.84349394551683,1.046660346580065 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441038,194.37642131307516,184.84349394551683,1.0515729667519063 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441053,143.7055962173807,184.84349394551683,0.7774447082229378 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441043,325.862963998949,184.84349394551683,1.762912813663856 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441041,67.96637673762382,184.84349394551683,0.36769688392525796 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441036,443.4010647582029,184.84349394551683,2.3987918389429312 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441042,50947.685532547395,66689.05961878091,0.7639586736382703 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441038,41070.95452438807,66689.05961878091,0.6158574548683801 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441053,59940.78886203069,66689.05961878091,0.8988099278153597 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441043,44072.7,66689.05961878091,0.6608685180438244 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441041,42218.8778461283,66689.05961878091,0.6330705229233531 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441036,38193.01090295444,66689.05961878091,0.5727027959500355 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441042,1614.2113962453268,426.591426110135,3.783975245270351 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441038,1771.0228002878814,426.591426110135,4.151566796447167 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441053,924.5533590675268,426.591426110135,2.1673041286789267 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441043,583.6695983582201,426.591426110135,1.368216899435601 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441041,1300.6176569015936,426.591426110135,3.0488602847958024 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441036,3230.1657932781222,426.591426110135,7.572036369160819 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441042,3034.4738038262367,6086.038398766024,0.49859590180066754 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441038,503344.1948737518,6086.038398766024,82.70473531284446 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441053,306867.72980774037,6086.038398766024,50.42158949735831 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441043,373846.3080673672,6086.038398766024,61.42687304489673 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441041,1724.4798621749055,6086.038398766024,0.28335014490288996 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441036,129567.86313592488,6086.038398766024,21.289360113500997 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441042,200.74079622193932,118.38689307733607,1.6956336212895264 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441038,127.71123459204536,118.38689307733607,1.0787616033526464 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441053,191.55301062999024,118.38689307733607,1.6180254895688368 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441043,83.87395236537219,118.38689307733607,0.7084732961999572 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441041,363.50777479229754,118.38689307733607,3.070506923049637 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441036,304.8456675548576,118.38689307733607,2.5749950829076798 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441042,378.9116745315539,43.003791743375764,8.81112244224187 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441038,179.18231538251447,43.003791743375764,4.1666631736052775 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441053,139.94888591588017,43.003791743375764,3.254338286052129 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441043,149.3793804059056,43.003791743375764,3.473632773996395 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441041,155.36305830260395,43.003791743375764,3.612775804276278 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441036,246.13523420706008,43.003791743375764,5.7235705092208375 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441042,82.82092129661336,56.77751951238643,1.458692137449671 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441038,83.82747093116804,56.77751951238643,1.4764200981495936 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441053,111.22741568206747,56.77751951238643,1.9590044904621522 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441043,83.58452184199672,56.77751951238643,1.4721411319098248 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441041,77.35315891429492,56.77751951238643,1.3623906006922295 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441036,15.665515383850138,56.77751951238643,0.2759105279411263 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441042,88.19330506333671,232.93832449773902,0.3786122582168429 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441038,261.1044774674953,232.93832449773902,1.1209167835756013 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441053,226.58780608433716,232.93832449773902,0.9727373396924064 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441043,274.80049404924347,232.93832449773902,1.1797135342231364 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441041,238.32879227249992,232.93832449773902,1.0231411803376873 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441036,212.9638765618296,232.93832449773902,0.914250057482047 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441042,80.6395018965606,55.88566907011774,1.4429370398229484 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441038,75.31707068831673,55.88566907011774,1.3476991855249887 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441053,26.180440879919313,55.88566907011774,0.4684643006970473 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441043,13.13232551249592,55.88566907011774,0.234985564832717 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441041,164.19866032723468,55.88566907011774,2.9381174648051633 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441036,19.166924876592766,55.88566907011774,0.34296672466325334 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441042,383.8617570824057,226.42114305345407,1.6953441357363992 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441038,555.6740427243004,226.42114305345407,2.4541614587340703 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441053,657.4582354519663,226.42114305345407,2.9036963005559597 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441043,599.390302394907,226.42114305345407,2.6472364475847625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441041,209.76933226523025,226.42114305345407,0.9264564670787276 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441036,204.6377830276421,226.42114305345407,0.9037927300779092 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441042,319.3684275893571,212.71806341276286,1.501369570903095 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441038,201.5119547756524,212.71806341276286,0.9473194309062232 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441053,216.0283553461076,212.71806341276286,1.0155618750953057 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441043,110.31091937378548,212.71806341276286,0.5185780539931661 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441041,232.5237208072552,212.71806341276286,1.0931075484457613 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441036,543.3160871397878,212.71806341276286,2.5541605561043736 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441042,11630.197341513409,10996.969545575432,1.0575820268769183 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441038,10106.879103888436,10996.969545575432,0.9190603885917717 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441053,9002.150244475779,10996.969545575432,0.8186028166366744 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441043,12770.556933967386,10996.969545575432,1.161279649001624 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441041,8382.465799875345,10996.969545575432,0.762252342805476 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441036,9747.344502088134,10996.969545575432,0.8863664177382324 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441042,176.27961780225326,147.8550055811589,1.1922465330772438 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441038,125.09194711262558,147.8550055811589,0.8460447221312472 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441053,135.92391357690187,147.8550055811589,0.9193054576856516 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441043,208.9518957156638,147.8550055811589,1.413221655190891 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441041,188.8852782253971,147.8550055811589,1.2775034398258251 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441036,788.4337170789444,147.8550055811589,5.332479032278459 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441042,346.85299963087,92.19915296117537,3.761997681008286 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441038,376.05950763456065,92.19915296117537,4.078773996903394 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441053,132.94717953728255,92.19915296117537,1.4419566261445589 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441043,311.27224733651235,92.19915296117537,3.3760857593516898 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441041,136.6213766171434,92.19915296117537,1.4818072859592757 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441036,173.4824996348528,92.19915296117537,1.8816062193966734 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441042,5526.4682788786195,1229.7970051816276,4.4938052829803565 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441038,6409.289860653394,1229.7970051816276,5.211664879365039 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441053,7281.149255572407,1229.7970051816276,5.9206106576077255 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441043,3096.4677487516183,1229.7970051816276,2.517868994399042 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441041,6116.263306037357,1229.7970051816276,4.973392584521745 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441036,6423.7173972723695,1229.7970051816276,5.223396520081504 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441042,161825.2561955213,50083.06853493704,3.231137007562445 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441038,89854.28339942612,50083.06853493704,1.794104994520162 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441053,136840.79021662282,50083.06853493704,2.732276480247315 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441043,93768.18373408169,50083.06853493704,1.872253168127482 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441041,123816.30299140798,50083.06853493704,2.472218787972945 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441036,107261.88210253471,50083.06853493704,2.141679518452644 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441042,77.63095196161292,35.678906774941794,2.1758220466590954 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441038,72.08839658279224,35.678906774941794,2.0204766092615194 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441053,72.69899692188231,35.678906774941794,2.037590371825537 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441043,2.877538837953366,35.678906774941794,0.0806509811554634 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441041,15.457777146745691,35.678906774941794,0.4332469389897922 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441036,28.458128939540085,35.678906774941794,0.7976177386557974 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441042,117.4004867929094,67.70693010562654,1.7339508172909062 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441038,9.655441243703242,67.70693010562654,0.1426063953666223 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441053,63.38353115760522,67.70693010562654,0.936145399868572 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441043,118.0917641250968,67.70693010562654,1.7441606633304323 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441041,155.29659753926111,67.70693010562654,2.2936588218811558 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441036,86.17564220421121,67.70693010562654,1.2727743241315543 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441042,76.68909319140202,64.01321127549492,1.198019778469692 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441038,72.82026950850832,64.01321127549492,1.1375818843880567 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441053,3.2467446713253794,64.01321127549492,0.05071991557105767 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441043,72.03941704931727,64.01321127549492,1.125383582761999 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441041,75.06275712176121,64.01321127549492,1.1726135218980365 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441036,13.007253631276118,64.01321127549492,0.2031963929335859 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441042,458.578702122325,1060.427767412219,0.43244690134944586 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441038,603.152653179437,1060.427767412219,0.5687824024556819 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441053,526.9998042379201,1060.427767412219,0.49696907270163926 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441043,629.4095892223233,1060.427767412219,0.5935431045513669 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441041,732.4653786219036,1060.427767412219,0.6907263286865375 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441036,777.7284074875234,1060.427767412219,0.7334100741113447 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441042,81.30349992329604,57.09593719876665,1.4239804776346208 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441038,129.59233348601597,57.09593719876665,2.2697295086841196 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441053,2.1575611107676416,57.09593719876665,0.03778834741352223 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441043,12.337051511995854,57.09593719876665,0.21607582110522483 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441041,14.688795773614038,57.09593719876665,0.25726516621451195 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441036,35.994616237035515,57.09593719876665,0.6304234242049196 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441042,43.490027829492,50.205845180981015,0.866234353245524 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441038,828.7325024888999,50.205845180981015,16.506693583217288 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441053,24.26196058162677,50.205845180981015,0.48324971911473147 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441043,15.370192382634448,50.205845180981015,0.3061434844335015 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441041,111.19441667343992,50.205845180981015,2.2147703374499232 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441036,3.158374702210414,50.205845180981015,0.06290850578902056 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441042,2208.712169353134,1506.8779059558976,1.4657539012439254 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441038,2394.0169809876256,1506.8779059558976,1.588726579323602 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441053,3535.5516815238034,1506.8779059558976,2.346276143242676 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441043,808.6117442058677,1506.8779059558976,0.5366139758303242 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441041,2335.5653223233276,1506.8779059558976,1.5499366691170289 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441036,8415.220942340973,1506.8779059558976,5.5845406645621525 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441042,58748.059215115914,16162.128318216166,3.6349209744178057 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441038,44891.44324261963,16162.128318216166,2.7775700303049167 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441053,36621.78158704868,16162.128318216166,2.2659009300014437 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441043,41593.72140191333,16162.128318216166,2.5735299573777968 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441041,27010.276774837435,16162.128318216166,1.6712079153829285 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441036,68688.519075028293,16162.128318216166,4.24996743761836 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441042,42.99948544867613,24.995311385825953,1.7203020512502907 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441038,29.539711110417805,24.995311385825953,1.1818100864776118 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441053,34.55065000797121,24.995311385825953,1.382285240405678 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441043,1.5847642569084792,24.995311385825953,0.06340246106344363 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441041,95.51413402413912,24.995311385825953,3.821282021647554 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441036,28.47894809707005,24.995311385825953,1.139371606837415 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441042,2509.446965035811,522.7489803443298,4.800481797942221 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441038,2075.766160709123,522.7489803443298,3.970866015543131 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441053,2717.8810093105285,522.7489803443298,5.1992086288150885 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441043,547.2554419361257,522.7489803443298,1.046879979709676 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441041,468.95404811706976,522.7489803443298,0.8970922292534635 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441036,649.8271365694162,522.7489803443298,1.2430959428010386 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441042,3.767586573534945,2.8430683750443606,1.3251832444853384 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441038,3.5349636873915737,2.8430683750443606,1.2433621781384057 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441053,2.0935712176231243,2.8430683750443606,0.7363773717156761 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441043,2.181975621458606,2.8430683750443606,0.7674720877666407 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441041,3.800047405117234,2.8430683750443606,1.336600779099427 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441036,7.724263589233421,2.8430683750443606,2.7168757730326827 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441042,3733.477322135392,1771.7543971110147,2.1072205765218484 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441038,2899.2022643761575,1771.7543971110147,1.6363454602418572 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441053,3117.9974756833394,1771.7543971110147,1.7598361718573863 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441043,1630.4703112583957,1771.7543971110147,0.9202575221018252 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441041,2015.8840443568283,1771.7543971110147,1.1377897792402187 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441036,1837.7094895349887,1771.7543971110147,1.0372258663681146 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441042,473.42537646363706,73.62821549612136,6.4299450050989835 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441038,4.293490783183664,73.62821549612136,0.058313117522315064 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441053,121.21575199584478,73.62821549612136,1.6463220136338939 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441043,28.039423529499256,73.62821549612136,0.38082443449924896 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441041,4.558975379273349,73.62821549612136,0.061918862878233276 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441036,21.65693683514783,73.62821549612136,0.2941390972091221 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441042,710.4253364601961,1923.334023596175,0.36937179280584376 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441038,1120.5406418114271,1923.334023596175,0.5826032441917103 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441053,810.9517447779156,1923.334023596175,0.4216385374713174 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441043,1001.2219102613932,1923.334023596175,0.5205657977127381 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441041,888.9087100710957,1923.334023596175,0.46217074058152874 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441036,1128.7278456644376,1923.334023596175,0.5868600210971083 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441042,13.13190990906834,51.40813337414527,0.25544420789401356 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441038,9.129667020153862,51.40813337414527,0.17759187935707954 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441053,104.17793091475625,51.40813337414527,2.0264873294767503 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441043,120.57538853588828,51.40813337414527,2.345453542503633 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441041,84.70575221037312,51.40813337414527,1.647711104270015 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441036,64.16109841835613,51.40813337414527,1.2480729061177063 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441042,25.85372392690165,89.1451395839603,0.2900183234617253 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441038,68.86822636113932,89.1451395839603,0.7725404512522703 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441053,67.88087851129815,89.1451395839603,0.7614647172924704 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441043,107.5422298147026,89.1451395839603,1.2063723307473786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441041,101.96784733144158,89.1451395839603,1.143840794992579 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441036,9.321339368314272,89.1451395839603,0.10456362973704335 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441042,8085.490620919505,4771.656231796832,1.6944830532929662 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441038,6687.6128023617075,4771.656231796832,1.401528626014074 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441053,2713.2164119451572,4771.656231796832,0.5686110398869741 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441043,6259.53607517397,4771.656231796832,1.3118162271335412 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441041,7507.804883181939,4771.656231796832,1.573416968546951 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441036,10585.363348436911,4771.656231796832,2.218383478235365 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441042,189257.09850256515,209884.98459768714,0.9017181427501255 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441038,384820.17907540424,209884.98459768714,1.8334812269350154 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441053,400962.98754471913,209884.98459768714,1.910393867923878 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441043,438550.8900737114,209884.98459768714,2.0894819651550436 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441041,466258.0306023839,209884.98459768714,2.221493031033731 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441036,378792.2017301491,209884.98459768714,1.8047608429742013 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441042,5.121981100878953,22.903585106474594,0.22363228625858336 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441038,15.018049196762563,22.903585106474594,0.6557073544140094 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441053,17.69820269839215,22.903585106474594,0.772726305341126 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441043,26.56069778604897,22.903585106474594,1.1596742458690692 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441041,40.00752708381664,22.903585106474594,1.7467801175156177 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441036,3.995674080862027,22.903585106474594,0.1744562723384512 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441042,108.26042398793204,83.56495705722055,1.2955241981851486 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441038,87.38345752573692,83.56495705722055,1.0456949970775629 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441053,18.153494843480026,83.56495705722055,0.21723812807142998 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441043,216.3704882176791,83.56495705722055,2.589249080443144 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441041,53.57665172314057,83.56495705722055,0.6411377880138718 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441036,45.05194807957424,83.56495705722055,0.5391248875856565 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441042,2104.5971633226927,1829.6496491832456,1.1502733128510059 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441038,2502.2998493048212,1829.6496491832456,1.3676387992760506 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441053,1798.081773335648,1829.6496491832456,0.9827464914598871 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441043,1090.0862861393314,1829.6496491832456,0.5957896292472962 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441041,1528.402618729487,1829.6496491832456,0.8353526148635969 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441036,1420.6572719764104,1829.6496491832456,0.7764641020812869 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441042,144881.494465594,96234.19538703516,1.5055094904977269 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441038,237267.61953249827,96234.19538703516,2.465522973182809 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441053,152820.2773577157,96234.19538703516,1.5880038976073148 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441043,176977.5417919328,96234.19538703516,1.839029682538142 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441041,120365.5097085164,96234.19538703516,1.2507561290914295 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441036,138229.43319244267,96234.19538703516,1.4363858152137174 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441042,241.01016653798,77.99112650544876,3.090225482525145 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441038,292.9608940567139,77.99112650544876,3.756336229304837 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441053,209.89444246445072,77.99112650544876,2.6912605557734404 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441043,211.83531586900065,77.99112650544876,2.7161463792191927 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441041,229.138321830789,77.99112650544876,2.938005028235879 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441036,365.6565889614085,77.99112650544876,4.688438356328425 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441042,132.8961574256008,110.33780757772625,1.2044480522415997 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441038,123.028254582459,110.33780757772625,1.115014493067511 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441053,166.0081127367939,110.33780757772625,1.5045442390166335 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441043,232.7104511185808,110.33780757772625,2.1090726399892485 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441041,604.090687278508,110.33780757772625,5.47492016145928 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441036,253.0146022282775,110.33780757772625,2.2930907164350187 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441042,69.22870238752898,67.31067174214355,1.0284951939379405 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441038,72.0009179436986,67.31067174214355,1.0696805733795471 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441053,64.73450068364086,67.31067174214355,0.9617271527407779 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441043,73.26357465207376,67.31067174214355,1.0884392141076058 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441041,64.31806438850884,67.31067174214355,0.9555403730763687 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441036,51.19131773559676,67.31067174214355,0.7605230554183523 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441042,2862.8819620920176,2375.529574917848,1.2051552598291786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441038,3763.673813902224,2375.529574917848,1.584351486776325 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441053,3482.8320894460257,2375.529574917848,1.46612870082515 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441043,3922.8926772352015,2375.529574917848,1.6513760631125232 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441041,4482.361621737378,2375.529574917848,1.886889419969604 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441036,4174.961145749382,2375.529574917848,1.7574864947298174 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441042,251.38319654182212,194.62377093849457,1.2916366553254421 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441038,239.86080342833355,194.62377093849457,1.2324332339862785 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441053,261.70179920551044,194.62377093849457,1.3446548586719862 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441043,225.54609810722093,194.62377093849457,1.1588825816066348 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441041,201.5753097844305,194.62377093849457,1.035717830419249 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441036,206.94613926426544,194.62377093849457,1.0633137887851583 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441042,5611.971560501371,3728.1507253933823,1.5052963181656809 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441038,4656.3382742641115,3728.1507253933823,1.2489672808957555 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441053,3940.336913843056,3728.1507253933823,1.056914594950365 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441043,4600.355728278632,3728.1507253933823,1.233951110652378 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441041,4613.059748697304,3728.1507253933823,1.2373587036802405 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441036,4987.681670287464,3728.1507253933823,1.337843353895296 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441042,96.07586258724724,68.78582331086372,1.3967392983442486 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441038,112.09279213894736,68.78582331086372,1.6295914876582416 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441053,85.65840750464044,68.78582331086372,1.2452915932622404 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441043,123.28302548922072,68.78582331086372,1.7922737499567 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441041,117.90253910389455,68.78582331086372,1.7140528880647063 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441036,84.15936985349994,68.78582331086372,1.2234987647550362 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441042,863.6740552990838,696.3940975413478,1.2402087529867438 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441038,928.8173576006878,696.3940975413478,1.3337524842325936 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441053,881.6974434658774,696.3940975413478,1.2660897709770256 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441043,717.4344046449561,696.3940975413478,1.0302132186040807 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441041,830.4052203504723,696.3940975413478,1.1924357533790952 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441036,703.8428313456874,696.3940975413478,1.0106961472399574 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441042,73.58946167802526,81.2393188807366,0.9058355324969954 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441038,94.35681153222043,81.2393188807366,1.1614672898814054 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441053,54.45348438298247,81.2393188807366,0.6702848464660679 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441043,141.03327533905343,81.2393188807366,1.7360223753980182 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441041,100.92343187687048,81.2393188807366,1.2422978585656428 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441036,29.964258156962963,81.2393188807366,0.36883935722001804 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441042,231.81659064428823,543.8205698619286,0.4262740387020382 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441038,331.75867475886804,543.8205698619286,0.610051721366661 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441053,283.8036785622951,543.8205698619286,0.5218700694502056 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441043,845.1105361246207,543.8205698619286,1.5540245863432256 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441041,301.7750541280839,543.8205698619286,0.5549165861907395 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441036,756.7009522486044,543.8205698619286,1.3914533472698989 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441042,396807.8931826815,306516.0644612488,1.2945745400983635 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441038,287828.9165127592,306516.0644612488,0.9390337078047272 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441053,107142.117542328,306516.0644612488,0.3495481312884774 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441043,275964.21150279074,306516.0644612488,0.900325442935078 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441041,426144.33100214135,306516.0644612488,1.390283839612643 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441036,820065.8757710787,306516.0644612488,2.6754417495620535 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441042,771478.83199342,335923.8645439917,2.2965883446258974 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441038,938845.4849069092,335923.8645439917,2.7948162783295216 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441053,542973.7493308829,335923.8645439917,1.6163595583420556 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441043,798613.6810925048,335923.8645439917,2.377365127591048 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441041,773808.1180971902,335923.8645439917,2.3035223149376884 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441036,564957.3282880714,335923.8645439917,1.6818017054399723 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441042,79.2868034205088,33.931355493730415,2.3366824657258043 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441038,74.7552566365444,33.931355493730415,2.203132045531076 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441053,40.682395770232986,33.931355493730415,1.198961703069893 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441043,10.72485121277062,33.931355493730415,0.31607494179689577 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441041,196.0603887913945,33.931355493730415,5.778147849932523 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441036,100.39180343364043,33.931355493730415,2.958673532868149 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441042,60.494568941403216,76.3332642617619,0.7925059870878225 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441038,25.152075350880544,76.3332642617619,0.32950346869261465 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441053,36.73917578353408,76.3332642617619,0.48129968158505787 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441043,194.88812716946572,76.3332642617619,2.5531218801433107 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441041,22.046940707210556,76.3332642617619,0.2888248120977406 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441036,77.27991229112212,76.3332642617619,1.0124015137897677 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441042,195.31840735006463,130.67426801703346,1.4946967778277878 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441038,158.40995742195773,130.67426801703346,1.2122505817389304 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441053,181.81886926540673,130.67426801703346,1.3913899960909408 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441043,199.16088810757756,130.67426801703346,1.5241018077225184 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441041,173.88715247536123,130.67426801703346,1.3306916129248565 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441036,316.53742957427056,130.67426801703346,2.4223394121711075 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441042,8480.510470872738,5444.214081294075,1.5577106895945103 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441038,9033.404241515243,5444.214081294075,1.6592669036571073 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441053,7404.820969011362,5444.214081294075,1.3601267067093834 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441043,8682.8714907703,5444.214081294075,1.594880612906832 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441041,6182.0217827220295,5444.214081294075,1.1355214343908715 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441036,7757.905032838362,5444.214081294075,1.4249816258133494 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441042,87.15371382361616,100.67607722942154,0.8656844428394792 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441038,79.22165494583984,100.67607722942154,0.7868965212590557 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441053,129.49558981487112,100.67607722942154,1.2862597886067355 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441043,101.30205772439344,100.67607722942154,1.0062177680358504 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441041,72.27977540604374,100.67607722942154,0.7179438988403566 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441036,41.410607620497395,100.67607722942154,0.4113252001876328 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441042,551.5453543290755,599.1099853739104,0.92060784796442785 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441038,513.7688607433222,599.1099853739104,0.8575534931581453 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441053,612.0793907214611,599.1099853739104,1.021647786990992 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441043,549.9469499389072,599.1099853739104,0.9179398831012305 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441041,581.0429117393911,599.1099853739104,0.9698434776992685 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441036,591.5107121890283,599.1099853739104,0.9873157293812431 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441042,107.32578662860855,114.30018844822946,0.9389817119787177 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441038,217.95539208976345,114.30018844822946,1.9068681779862773 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441053,150.92188533694613,114.30018844822946,1.3203992695541698 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441043,63.58206152054022,114.30018844822946,0.5562725869812433 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441041,45.67688596840857,114.30018844822946,0.3996221405102689 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441036,34.38411941623048,114.30018844822946,0.3008229459901919 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441042,2377.617930842795,1759.6959467320276,1.351152700702826 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441038,2618.932269378673,1759.6959467320276,1.4882868112768874 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441053,2474.172897004041,1759.6959467320276,1.4060229561810864 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441043,2860.203220582798,1759.6959467320276,1.6253962656983716 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441041,3180.902001420307,1759.6959467320276,1.8076429665747848 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441036,2699.18785589283,1759.6959467320276,1.5338944554060916 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441042,132.80066287651454,38.77498679262034,3.42490543160647 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441038,206.15797473152273,38.77498679262034,5.316777432681389 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441053,85.42355733030709,38.77498679262034,2.2030583217778146 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441043,86.78195167323608,38.77498679262034,2.2380910698273255 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441041,142.72986146167204,38.77498679262034,3.6809776938166854 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441036,127.06672802716486,38.77498679262034,3.277028273581468 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441042,3756.01512396783,2284.874121495706,1.6438608537038784 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441038,2507.0170575202187,2284.874121495706,1.0972232710479015 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441053,2902.916843237982,2284.874121495706,1.2704931164162767 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441043,2259.914079570312,2284.874121495706,0.9890759662904078 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441041,3536.0190424347757,2284.874121495706,1.5475771768643671 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441036,2481.8356604811065,2284.874121495706,1.0862023588662588 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441042,386.9162470099591,306.4947439651267,1.2623911327301025 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441038,435.2305820011552,306.4947439651267,1.4200262502729124 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441053,401.2387171880647,306.4947439651267,1.3091210374352067 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441043,394.8869802074587,306.4947439651267,1.288397233501627 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441041,387.04851008690906,306.4947439651267,1.2628226672981637 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441036,387.7433673845675,306.4947439651267,1.2650897772938166 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441042,50309.47319053946,53872.22448470133,0.9338666385462954 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441038,44923.91334799334,53872.22448470133,0.8338975005710199 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441053,50062.29905668333,53872.22448470133,0.9292784832172665 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441043,43227.90307857906,53872.22448470133,0.8024154096487133 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441041,42413.64357881686,53872.22448470133,0.787300765552414 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441036,47710.17223578715,53872.22448470133,0.8856172673793323 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441042,48.24478003449217,320.29657233769314,0.15062533976675538 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441038,276.87477355732096,320.29657233769314,0.8644325211991593 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441053,104.57729222596792,320.29657233769314,0.3265014404078937 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441043,2685.7546711975724,320.29657233769314,8.385212028950294 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441041,1073.1344827483058,320.29657233769314,3.350440109040209 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441036,281.8485282543743,320.29657233769314,0.8799611129063768 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441042,44617.49928077386,6299.521117687065,7.082681119284134 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441038,29660.619508314456,6299.521117687065,4.708392741955703 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441053,23986.56407465067,6299.521117687065,3.807680556432135 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441043,20843.853225452083,6299.521117687065,3.308799643028282 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441041,21360.22437069485,6299.521117687065,3.3907695476600734 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441036,19778.563728352023,6299.521117687065,3.1396932177622303 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441042,3656.271202760166,1965.7827420843205,1.8599569141010057 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441038,1765.9992678272947,1965.7827420843205,0.898369504432013 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441053,3367.224381992554,1965.7827420843205,1.7129178672218295 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441043,3101.0163475026216,1965.7827420843205,1.5774969843384687 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441041,2461.4761970632867,1965.7827420843205,1.2521608539778828 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441036,1533.4120490192165,1965.7827420843205,0.7800516385617156 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441042,30978.58523556572,6243.797224888628,4.96149764634906 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441038,22263.55250640816,6243.797224888628,3.5657071657712716 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441053,18978.486380601953,6243.797224888628,3.03957442835445 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441043,16832.787406451593,6243.797224888628,2.6959215362334006 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441041,15165.139923284689,6243.797224888628,2.4288328683760536 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441036,15763.523101729495,6243.797224888628,2.524669289209768 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441042,855.2559124950279,477.14850073021523,1.7924313105588037 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441038,419.47069585635177,477.14850073021523,0.8791198027750378 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441053,803.842998628404,477.14850073021523,1.6846809691285296 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441043,788.3858851874132,477.14850073021523,1.6522862043596254 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441041,608.3434680798042,477.14850073021523,1.2749562602603 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441036,484.1678926248392,477.14850073021523,1.014711126376551 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441042,619.27970363021,205.1372392304115,3.0188556010282994 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441038,503.52165175797336,205.1372392304115,2.454559950435984 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441053,556.2825076042877,205.1372392304115,2.7117577953726264 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441043,544.8097640482822,205.1372392304115,2.6558306336391135 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441041,194.59985516745832,205.1372392304115,0.9486325149812632 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441036,411.13992854931655,205.1372392304115,2.0042188833765158 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441042,13.28125506829294,44.32085041603382,0.2996615575654257 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441038,56.36870358754795,44.32085041603382,1.2718326263693625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441053,10.376281826272043,44.32085041603382,0.23411739009678945 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441043,27.024284135330507,44.32085041603382,0.6097420036316364 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441041,59.35601117718376,44.32085041603382,1.3392344826422986 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441036,1.7571956128067514,44.32085041603382,0.039647154698346135 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441042,30.990065526743138,73.02499011367847,0.4243761687403272 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441038,130.31059126609114,73.02499011367847,1.7844657159588218 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441053,155.4449633497238,73.02499011367847,2.12865435664889 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441043,28.987348197014203,73.02499011367847,0.3969510732132851 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441041,128.94139488036336,73.02499011367847,1.7657160196754489 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441036,46.4385263329105,73.02499011367847,0.6359264994164238 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441042,101.94597807923934,446.9213615105917,0.22810719481982805 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441038,93.68555646676346,446.9213615105917,0.2096242527994339 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441053,134.80647375026405,446.9213615105917,0.30163354307929907 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441043,1022.4509576775532,446.9213615105917,2.287764796521864 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441041,3222.903261173729,446.9213615105917,7.21134306554588 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441036,165.523868003454,446.9213615105917,0.3703646374028403 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441042,1872.0255224529335,2631.000022355788,0.7115262282577742 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441038,2570.4019474462634,2631.000022355788,0.9769676646162605 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441053,1938.615770361041,2631.000022355788,0.7368360904175179 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441043,2541.7299611792364,2631.000022355788,0.966069912421886 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441041,1998.331349350396,2631.000022355788,0.7595330035615496 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441036,2999.49350270539,2631.000022355788,1.140058334176544 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441042,54.018175163551014,48.89133349009634,1.1048619726130642 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441038,53.36427141872725,48.89133349009634,1.0914873375163099 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441053,50.45445661507824,48.89133349009634,1.0319713743397596 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441043,20.14377525526636,48.89133349009634,0.412011164705638 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441041,11.088435251930605,48.89133349009634,0.22679756227505493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441036,88.71891876951464,48.89133349009634,1.8146144201095673 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441042,155.7045074936465,307.70649021557807,0.5060163254423411 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441038,356.7750458790289,307.70649021557807,1.1594654556329753 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441053,221.2101360024401,307.70649021557807,0.7188998056149581 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441043,291.9811250421645,307.70649021557807,0.9488949187831675 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441041,148.7677070194277,307.70649021557807,0.4834727630060762 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441036,285.5125658591292,307.70649021557807,0.9278730704025778 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441042,142.3808487731672,154.19153082843468,0.9234025241735946 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441038,239.80193141147788,154.19153082843468,1.5552211598333496 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441053,127.69054119545012,154.19153082843468,0.8281294083364955 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441043,119.15530525819808,154.19153082843468,0.7727746434451022 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441041,154.5583961364326,154.19153082843468,1.0023792831294096 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441036,99.47436023394852,154.19153082843468,0.6451350453523372 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441042,8646.360840510972,6593.957266089812,1.3112552131594608 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441038,8301.893028977127,6593.957266089812,1.2590152914200055 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441053,7497.541763065506,6593.957266089812,1.1370322039577783 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441043,8269.633432962704,6593.957266089812,1.2541229946227057 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441041,7847.737007008294,6593.957266089812,1.1901407137359215 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441036,7969.491098105805,6593.957266089812,1.2086052087552697 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441042,200.86691818399612,127.96554716912783,1.5696953018027342 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441038,176.88840171765625,127.96554716912783,1.382312705496181 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441053,236.15232517117911,127.96554716912783,1.845436763217715 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441043,256.7589419851813,127.96554716912783,2.006469301036407 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441041,170.74142781269344,127.96554716912783,1.3342765423183018 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441036,134.38910908830644,127.96554716912783,1.0501975888141892 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441042,2460.582891246354,1681.9358703135756,1.462946914133896 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441038,1852.9785263507677,1681.9358703135756,1.101693922494978 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441053,1811.7390972364472,1681.9358703135756,1.0771748966259167 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441043,1542.0691504695112,1681.9358703135756,0.9168418235720319 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441041,2036.7159353102395,1681.9358703135756,1.210935548292052 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441036,1335.754239675091,1681.9358703135756,0.7941766765614295 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441042,44.38121637324475,45.403354316773296,0.9774876116773834 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441038,49.21964611323552,45.403354316773296,1.0840530805243254 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441053,38.74965254497845,45.403354316773296,0.8534535196370552 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441043,44.86055453317784,45.403354316773296,0.9880449409132107 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441041,45.44207396066523,45.403354316773296,1.0008527925849222 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441036,44.49739313609207,45.403354316773296,0.9800463821602154 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441042,181.563677334239,171.72890790902974,1.0572691548846223 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441038,177.98206431629504,171.72890790902974,1.0364129515723572 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441053,150.75588287390272,171.72890790902974,0.8778713188682414 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441043,175.0237674902436,171.72890790902974,1.0191864003639928 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441041,181.11069558421104,171.72890790902974,1.054631382621679 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441036,146.35258573229763,171.72890790902974,0.852230340915143 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441042,1201.7510292928926,385.5886159476326,3.1166662592966805 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441038,350.75011154355934,385.5886159476326,0.9096485140816379 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441053,195.59467619548352,385.5886159476326,0.5072625801329351 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441043,0.37925383173719646,385.5886159476326,9.835711326827748e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441041,113.61458038436707,385.5886159476326,0.2946523203366493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441036,371.6069299809312,385.5886159476326,0.9637393704367033 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441042,271.51498646330384,430.1288265554666,0.631241083369452 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441038,301.40837281657645,430.1288265554666,0.70073976494507 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441053,338.437108894899,430.1288265554666,0.7868273131218662 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441043,435.0401789232485,430.1288265554666,1.0114183287995662 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441041,440.3783674048241,430.1288265554666,1.023829002421059 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441036,351.07684167512997,430.1288265554666,0.8162132365937984 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441042,93682.26356557244,54695.927744901994,1.7127831527513349 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441038,74649.14913259886,54695.927744901994,1.3648026866050669 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441053,24438.323656571683,54695.927744901994,0.4468033483324449 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441043,45265.06810767839,54695.927744901994,0.8275765669208779 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441041,83616.78123093185,54695.927744901994,1.5287569784155544 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441036,335988.491317234,54695.927744901994,6.142842898364591 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441042,615296.773147877,97212.60478924697,6.329392926789851 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441038,532443.5024469193,97212.60478924697,5.477103546409805 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441053,309632.42956983414,97212.60478924697,3.1851057817152917 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441043,351185.8139187449,97212.60478924697,3.612554304867169 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441041,296952.4122654613,97212.60478924697,3.054669843578847 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441036,340907.53267348575,97212.60478924697,3.506824381597012 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441042,107922.54335353436,62941.57202670208,1.714646455092506 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441038,117003.80149747278,62941.57202670208,1.8589272198005407 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441053,35295.85959494826,62941.57202670208,0.5607718151681131 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441043,70174.48478616255,62941.57202670208,1.114914714179557 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441041,102284.7570818775,62941.57202670208,1.625074712758757 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441036,347458.36099431204,62941.57202670208,5.5203317903611895 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441042,190413.38612394323,14728.399701289269,12.92831468358882 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441038,140379.57926629606,14728.399701289269,9.531217383651516 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441053,65764.74006694708,14728.399701289269,4.465165354060176 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441043,66035.6,14728.399701289269,4.483555670628595 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441041,50695.17138244698,14728.399701289269,3.442001331482694 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441036,67682.09192162153,14728.399701289269,4.595345950293357 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441042,6952.595350479964,3575.9352491809864,1.9442732784583696 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441038,6522.553058422725,3575.9352491809864,1.8240131892535294 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441053,2425.1046818786504,3575.9352491809864,0.6781735442312843 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441043,5690.960551666283,3575.9352491809864,1.5914607382697188 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441041,11161.673902399172,3575.9352491809864,3.1213299807247865 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441036,16619.205454144947,3575.9352491809864,4.6475129710336125 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441042,74822.61052047102,12966.336321671553,5.770528286807948 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441038,32390.84452203551,12966.336321671553,2.498072217045489 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441053,55302.82430920244,12966.336321671553,4.265107963979843 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441043,25142.04701808394,12966.336321671553,1.9390247479592413 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441041,37359.859687262186,12966.336321671553,2.8812965174148704 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441036,52889.37714428692,12966.336321671553,4.078976191284593 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441042,155.76560402759935,103.34580193186551,1.5072272033874536 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441038,169.32690480182563,103.34580193186551,1.6384497641564635 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441053,170.33388705834207,103.34580193186551,1.6481935780094958 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441043,71.37956388939429,103.34580193186551,0.6906866322103135 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441041,282.12939392007695,103.34580193186551,2.729955050385898 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441036,227.84473399477503,103.34580193186551,2.204683013103812 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441042,591.5603868069288,211.8154700640626,2.7928101126325386 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441038,431.3432432624288,211.8154700640626,2.0364104809340464 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441053,434.1739519478307,211.8154700640626,2.0497745127705582 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441043,459.9087916013656,211.8154700640626,2.171271019355991 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441041,473.5291814254477,211.8154700640626,2.2355741121374706 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441036,563.711364466751,211.8154700640626,2.6613323582845916 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441042,72.76301654987884,76.10596635595309,0.9560750626246696 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441038,101.20266338887556,76.10596635595309,1.329759915478156 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441053,31.27084901232207,76.10596635595309,0.4108856441828234 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441043,101.02568956855713,76.10596635595309,1.327434554816014 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441041,41.779441829115065,76.10596635595309,0.5489640803417384 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441036,52.78424719886802,76.10596635595309,0.6935625382114234 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441042,3468.740836270078,1382.686999693948,2.508695631793652 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441038,3741.8364853341072,1382.686999693948,2.70620645609769 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441053,2299.658735230548,1382.686999693948,1.6631809916051625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441043,3499.8180166430343,1382.686999693948,2.5311715647993394 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441041,3074.3654701090845,1382.686999693948,2.223471740740733 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441036,2699.451490349705,1382.686999693948,1.9523228980580691 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441042,31.438680691314676,30.899530320120164,1.0174484972945834 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441038,31.356877331062694,30.899530320120164,1.014801099117184 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441053,29.25206506785649,30.899530320120164,0.946683162002921 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441043,30.609741280963835,30.899530320120164,0.9906215713910825 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441041,32.402342628862556,30.899530320120164,1.0486354418068238 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441036,27.312088252564937,30.899530320120164,0.8838997864890111 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441042,32.090145087248196,31.68183515511672,1.0128878245257056 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441038,32.93894710844687,31.68183515511672,1.0396792656478147 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441053,30.00374035264477,31.68183515511672,0.9470329040519317 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441043,35.49446170563784,31.68183515511672,1.1203410892031413 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441041,33.38697995222901,31.68183515511672,1.0538208973300875 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441036,30.443783128576538,31.68183515511672,0.9609223386057474 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441042,1254.4453263404394,628.1906149122311,1.9969182865231225 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441038,492.8514690392568,628.1906149122311,0.7845571986269112 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441053,611.5918212571495,628.1906149122311,0.9735768200589867 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441043,268.86697721423934,628.1906149122311,0.4280022191223035 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441041,1128.8283963612612,628.1906149122311,1.7969520231036524 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441036,1812.525310660491,628.1906149122311,2.885311030814638 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441042,30330.017091918933,10551.186365326936,2.874559887558117 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441038,29085.087115427352,10551.186365326936,2.756570314311393 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441053,19441.169797266375,10551.186365326936,1.8425577109654225 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441043,23430.94867682532,10551.186365326936,2.2206932818307106 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441041,26493.327307271364,10551.186365326936,2.510933499794215 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441036,29072.39604525964,10551.186365326936,2.7553675045297914 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441042,120.05684550150625,102.14043933131707,1.1754095271910179 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441038,111.32945403641445,102.14043933131707,1.0899645112675753 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441053,97.75014775081006,102.14043933131707,0.9570171069436461 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441043,161.39704457744517,102.14043933131707,1.580148329438011 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441041,128.81546901279305,102.14043933131707,1.2611603186368634 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441036,99.8700687478576,102.14043933131707,0.9777720695316869 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441042,4708.228325318665,2995.2816068385046,1.5718816937176607 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441038,8930.682077422305,2995.2816068385046,2.981583453466523 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441053,3979.4312818858866,2995.2816068385046,1.3285666605772484 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441043,5331.592448165177,2995.2816068385046,1.7799970580371005 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441041,5142.168128383475,2995.2816068385046,1.7167561529585165 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441036,5548.768384645319,2995.2816068385046,1.852503074160696 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441042,38.06112690764733,35.73806763844074,1.0650023748544213 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441038,40.44889504335136,35.73806763844074,1.1318153922749739 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441053,45.6600596264549,35.73806763844074,1.2776309029462418 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441043,59.57491478336053,35.73806763844074,1.6669875771145584 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441041,44.87174352509998,35.73806763844074,1.2555727405035977 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441036,28.02876765026724,35.73806763844074,0.7842832447974555 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441042,330.93525867827907,271.6614200921023,1.2181901227126066 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441038,275.811740149572,271.6614200921023,1.0152775467935884 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441053,251.96103389753785,271.6614200921023,0.9274818404914273 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441043,299.187953731131,271.6614200921023,1.101326620576806 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441041,331.71504204143724,271.6614200921023,1.221060546355735 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441036,274.46449586445044,271.6614200921023,1.0103182695997017 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441042,163.6947182610694,166.02715311669658,0.9859514855742436 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441038,174.6086805458455,166.02715311669658,1.0516874936903673 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441053,163.72686843333122,166.02715311669658,0.986145129635822 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441043,273.2769236048323,166.02715311669658,1.6459772903095697 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441041,163.17860515134643,166.02715311669658,0.9828428789395192 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441036,143.6958141395557,166.02715311669658,0.8654958628276622 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441042,1631.033604512392,1793.9624976146763,0.9091793204601986 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441038,2085.777919452863,1793.9624976146763,1.1626652854929778 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441053,1493.9557864515173,1793.9624976146763,0.8327686829785684 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441043,1827.5706772572096,1793.9624976146763,1.0187340480568685 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441041,1758.1619443364134,1793.9624976146763,0.9800438675134711 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441036,1989.97940886215,1793.9624976146763,1.1092647764421528 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441042,108.56231991733216,59.13775760336051,1.8357530673628906 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441038,92.96624515869428,59.13775760336051,1.572028580830252 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441053,74.26145258157737,59.13775760336051,1.255736700056369 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441043,122.26942013285442,59.13775760336051,2.06753561663465 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441041,231.2930662494525,59.13775760336051,3.911089558057731 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441036,174.16345917973163,59.13775760336051,2.9450467220595926 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441042,556.1174047767986,238.79765196261823,2.3288227510036577 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441038,380.8577206161372,238.79765196261823,1.59489725918979 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441053,214.5931866956689,238.79765196261823,0.8986402710913659 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441043,291.4045904429805,238.79765196261823,1.2202992284388017 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441041,432.2606874955261,238.79765196261823,1.810154680931255 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441036,270.8418732927762,238.79765196261823,1.1341898509754786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441042,598.9303497978445,386.8144501381946,1.5483660178255199 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441038,421.8869327177531,386.8144501381946,1.0906700423601765 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441053,510.4351103957662,386.8144501381946,1.3195864586067207 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441043,258.7672710593649,386.8144501381946,0.6689700215876548 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441041,730.8658420990529,386.8144501381946,1.8894481367951517 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441036,1505.0686493399628,386.8144501381946,3.890931811886182 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441042,10321.66639339658,5555.372966797932,1.8579610145141876 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441038,10593.05995626058,5555.372966797932,1.9068134614130734 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441053,6711.710262750966,5555.372966797932,1.2081475542441458 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441043,6642.960469939166,5555.372966797932,1.1957721848094223 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441041,9382.039666933872,5555.372966797932,1.6888226448532395 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441036,8834.338864158914,5555.372966797932,1.5902332601173577 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441042,29.529075825530047,84.54153084580483,0.34928484887963623 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441038,169.67698253625744,84.54153084580483,2.0070251962403076 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441053,66.6891507067238,84.54153084580483,0.7888330154366147 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441043,158.59844587759946,84.54153084580483,1.8759826595388593 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441041,15.39501921192612,84.54153084580483,0.1821000762335978 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441036,175.1028443353383,84.54153084580483,2.07120503477407 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441042,133.4137790227088,122.00200397429413,1.0935376032906734 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441038,117.8172300864818,122.00200397429413,0.9656991381166652 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441053,157.0343448601664,122.00200397429413,1.2871456184707721 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441043,63.10360731354834,122.00200397429413,0.5172341867994585 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441041,145.5653770888784,122.00200397429413,1.1931392300699346 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441036,72.72979071388336,122.00200397429413,0.5961360333819399 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441042,176.47875142250234,143.84455848940917,1.2268712370895554 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441038,143.6853070773169,143.84455848940917,0.9988928923432027 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441053,221.4714506324715,143.84455848940917,1.5396581765640982 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441043,116.0940446952194,143.84455848940917,0.8070798500435944 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441041,160.73276199552663,143.84455848940917,1.1174059254202577 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441036,98.8595038025708,143.84455848940917,0.6872662048585558 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441042,1968.3517550266272,5334.764851653101,0.36896691977279705 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441038,946.5649188189924,5334.764851653101,0.17743329746308822 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441053,1030.03127509021,5334.764851653101,0.1930790397951713 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441043,5259.703492783305,5334.764851653101,0.9859297717974324 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441041,5509.20882756888,5334.764851653101,1.0326994686301354 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441036,7155.916769658268,5334.764851653101,1.341374356442504 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441042,158.3324374376718,159.70733471984832,0.9913911450304503 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441038,170.92797055845216,159.70733471984832,1.0702574860339795 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441053,263.61907787542697,159.70733471984832,1.6506385153684777 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441043,137.56615295649837,159.70733471984832,0.8613640268796104 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441041,221.36700856122576,159.70733471984832,1.386079161295492 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441036,192.34465610229904,159.70733471984832,1.2043570599916509 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441042,220280.31047784103,82077.5827732141,2.683806016637824 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441038,94327.44903731727,82077.5827732141,1.1492474053232096 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441053,150613.83636241587,82077.5827732141,1.8350179339293173 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441043,77682.22052384638,82077.5827732141,0.9464486879260028 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441041,337450.6713472284,82077.5827732141,4.111362200804907 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441036,109981.03397249436,82077.5827732141,1.339964339305403 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441042,503951.99562164926,170961.68742491837,2.9477481370963363 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441038,231260.8386671526,170961.68742491837,1.3527056392018588 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441053,52890.39202977411,170961.68742491837,0.3093698525466538 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441043,68129.87475792941,170961.68742491837,0.3985096063575657 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441041,98806.24742512128,170961.68742491837,0.5779438008209544 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441036,76241.51764272433,170961.68742491837,0.4459567449941525 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441042,300877.3466820568,55195.40432138408,5.451130404447267 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441038,363691.5526643418,55195.40432138408,6.589163665632188 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441053,187137.64463443417,55195.40432138408,3.390456994296034 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441043,247868.24597725665,55195.40432138408,4.490740651776081 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441041,187936.3653169059,55195.40432138408,3.404927776642713 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441036,212089.6341922426,55195.40432138408,3.8425234274454585 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441042,1103.1496848204797,546.121028905539,2.0199729115563656 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441038,999.3049351698462,546.121028905539,1.8298232118483266 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441053,1279.821644127011,546.121028905539,2.3434762193498653 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441043,603.6075910019815,546.121028905539,1.1052634105880326 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441041,1383.0354760909013,546.121028905539,2.5324706482418224 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441036,1512.6819370958806,546.121028905539,2.7698657569136107 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441042,1941.7114580928348,1228.731327313693,1.5802571440396904 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441038,1502.679031844262,1228.731327313693,1.2229516725430005 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441053,1101.9086907766955,1228.731327313693,0.8967857059408887 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441043,1871.937441458329,1228.731327313693,1.5234717304317793 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441041,950.765113883283,1228.731327313693,0.7737778737699216 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441036,1270.0092793558597,1228.731327313693,1.0335939607989082 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441042,157.97977789961828,76.68368758811918,2.0601484209804033 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441038,66.98855546808481,76.68368758811918,0.8735698239747085 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441053,143.7943841153641,76.68368758811918,1.875162614605959 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441043,96.45671540156086,76.68368758811918,1.2578518122347726 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441041,161.14356441633456,76.68368758811918,2.1014060419454967 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441036,1021.2287551524636,76.68368758811918,13.317418440250979 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441042,215.0391641389195,81.06808963980528,2.652574707191978 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441038,188.5408144372567,81.06808963980528,2.3257093546297307 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441053,45.57845323255184,81.06808963980528,0.5622243404903468 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441043,137.0620020725089,81.06808963980528,1.6907022563562424 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441041,136.29891655371904,81.06808963980528,1.6812893600837344 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441036,163.09976550323543,81.06808963980528,2.0118861345802794 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441042,47.617143244244325,34.254424530644805,1.3901019765094849 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441038,324.1452229765564,34.254424530644805,9.462871655793503 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441053,28.294347047731534,34.254424530644805,0.8260056163669821 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441043,171.15555973856468,34.254424530644805,4.996597142814206 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441041,101.37710303597773,34.254424530644805,2.9595330946308387 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441036,47.20482771447383,34.254424530644805,1.3780651218426774 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441042,14.44851593693774,60.87738129746832,0.23733800023915622 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441038,39.01337156996901,60.87738129746832,0.6408516716469117 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441053,14.293657086890198,60.87738129746832,0.23479421719942842 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441043,111.19857086200815,60.87738129746832,1.8265991159943755 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441041,145.717343291235,60.87738129746832,2.3936204249523936 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441036,84.97002019961467,60.87738129746832,1.3957568211487488 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441042,138.00080627301713,81.37032235510941,1.6959599308303808 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441038,106.28837348564116,81.37032235510941,1.3062302128014993 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441053,127.67610216744652,81.37032235510941,1.5690745528849372 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441043,122.91145572278025,81.37032235510941,1.5105194641650868 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441041,105.26083127098076,81.37032235510941,1.2936022400355063 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441036,68.24656028372172,81.37032235510941,0.8387156190175321 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441042,1089.359751382808,592.3362991324378,1.8390899780721408 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441038,857.4055358307255,592.3362991324378,1.4474978776187106 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441053,743.8119085196375,592.3362991324378,1.2557256909783474 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441043,676.2440071682764,592.3362991324378,1.1416555226460603 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441041,1080.4643778628651,592.3362991324378,1.8240725402872684 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441036,822.6768086316688,592.3362991324378,1.3888677932394113 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441042,2961.2538795628366,1509.2244087879828,1.9621030923697684 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441038,4446.441330146269,1509.2244087879828,2.9461763964691543 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441053,4378.802425469666,1509.2244087879828,2.901359400214156 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441043,1208.4886733019282,1509.2244087879828,0.8007349114320466 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441041,2663.4978151831924,1509.2244087879828,1.7648123100011186 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441036,2839.9931986704246,1509.2244087879828,1.8817567368600578 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441042,950031.5615201948,911297.6405793307,1.0425041382925562 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441038,1250381.650983488,911297.6405793307,1.3720892003940606 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441053,665735.8367962535,911297.6405793307,0.7305361137257322 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441043,851233.8363957964,911297.6405793307,0.9340898061084076 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441041,1120887.696417513,911297.6405793307,1.2299907807343182 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441036,836408.6097696023,911297.6405793307,0.9178215464684844 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441042,252.84734676530584,749.6106308195243,0.3373049105358555 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441038,1294.3539284066542,749.6106308195243,1.726701670427993 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441053,741.4066998904406,749.6106308195243,0.9890557436197047 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441043,2089.195411879978,749.6106308195243,2.7870407995627415 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441041,1882.2828803527584,749.6106308195243,2.5110141224850575 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441036,3827.2934370116454,749.6106308195243,5.105708590108165 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441042,12906.437441715503,2138.7943755926544,6.03444519445174 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441038,8312.982774864495,2138.7943755926544,3.886761097621172 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441053,9465.363148056837,2138.7943755926544,4.425560145506745 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441043,6182.4830067303465,2138.7943755926544,2.8906392672821557 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441041,8093.718416252647,2138.7943755926544,3.784243360940155 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441036,8998.294727721142,2138.7943755926544,4.207180844688605 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441042,1318.56530755495,613.8984432679271,2.147855760206711 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441038,1321.774168911997,613.8984432679271,2.153082783327939 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441053,1147.5479131035638,613.8984432679271,1.8692797248269502 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441043,313.9512240432361,613.8984432679271,0.511405799258912 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441041,976.7821350245669,613.8984432679271,1.5911135558919547 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441036,2317.4515724781663,613.8984432679271,3.774975483146401 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441042,5434.8683443313585,6365.76448478505,0.8537652244787494 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441038,5561.697024665326,6365.76448478505,0.8736887828568678 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441053,4932.915111901087,6365.76448478505,0.7749132289910117 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441043,7836.971323319488,6365.76448478505,1.2311123576831662 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441041,5203.469841290222,6365.76448478505,0.8174147588600155 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441036,5907.60864096524,6365.76448478505,0.9280281504421255 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441042,60.81255801765051,70.21289390855102,0.8661166722006358 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441038,62.5325456457637,70.21289390855102,0.8906134210506889 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441053,84.79647703640019,70.21289390855102,1.2077051993732604 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441043,37.121722767353205,70.21289390855102,0.5287023607900636 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441041,134.44313542913147,70.21289390855102,1.9147926818717558 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441036,281.3612155022635,70.21289390855102,4.007258493984356 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441042,530.8699862872544,2003.7789126851078,0.26493441114013766 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441038,2204.6190417788994,2003.7789126851078,1.100230683047094 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441053,1679.9046992657509,2003.7789126851078,0.8383682893511648 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441043,1962.9402238192624,2003.7789126851078,0.9796191642664207 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441041,1864.5145191528657,2003.7789126851078,0.9304991221084242 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441036,1939.0770468656392,2003.7789126851078,0.9677100774891544 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441042,1351.307782869689,700.7857837159185,1.928275108128444 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441038,859.2099807934383,700.7857837159185,1.2260665109920967 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441053,979.9314128893336,700.7857837159185,1.3983323230292213 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441043,338.6369480754321,700.7857837159185,0.4832246257619679 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441041,870.0893823009633,700.7857837159185,1.241591086062437 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441036,1996.352108051392,700.7857837159185,2.8487337420940957 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441042,4228.7917516888765,4688.560133729121,0.9019382563246426 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441038,5027.688954927005,4688.560133729121,1.072331123314004 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441053,3101.298596477518,4688.560133729121,0.6614607700490024 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441043,6434.205704043058,4688.560133729121,1.3723201837075534 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441041,2833.3937845766623,4688.560133729121,0.6043206664223963 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441036,5410.869446534373,4688.560133729121,1.15405781139694 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441042,766.2880840610864,384.65137963543384,1.9921625779357959 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441038,429.8500490598273,384.65137963543384,1.1175055435059975 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441053,600.7227246440295,384.65137963543384,1.5617329260937125 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441043,217.7621670241845,384.65137963543384,0.5661286519512184 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441041,611.1930966169251,384.65137963543384,1.5889533457444083 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441036,555.3770250556236,384.65137963543384,1.4438451399342456 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441042,3424.751783487571,772.5530415852671,4.433031260170865 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441038,1996.969127041716,772.5530415852671,2.5848958188604962 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441053,1726.689470235969,772.5530415852671,2.2350432621335985 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441043,1424.9423202947614,772.5530415852671,1.8444588831995294 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441041,1489.4788682077624,772.5530415852671,1.9279956042259239 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441036,1426.7352893307147,772.5530415852671,1.8467797193615025 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441042,262.41960004855406,216.68366112664066,1.2110723932026561 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441038,171.2592805132084,216.68366112664066,0.7903654554420511 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441053,230.3510054433905,216.68366112664066,1.0630751033358348 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441043,268.55447657762045,216.68366112664066,1.239384987226443 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441041,200.04208718320805,216.68366112664066,0.9231987596254133 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441036,132.2322796044941,216.68366112664066,0.610254963004391 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441042,1443.8298596007992,615.8359185894908,2.3445041382252336 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441038,1335.5775965829316,615.8359185894908,2.168723122941474 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441053,883.6241522395648,615.8359185894908,1.4348369842788895 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441043,974.4538991466198,615.8359185894908,1.5823271584718652 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441041,767.4528659607178,615.8359185894908,1.2461969865585139 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441036,969.7241766139956,615.8359185894908,1.5746469917426213 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441042,37.99089973443904,101.73138829665541,0.3734432447108171 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441038,45.73171356844399,101.73138829665541,0.4495339573572643 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441053,90.11698393115074,101.73138829665541,0.8858326367115299 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441043,110.78836738523373,101.73138829665541,1.089028364207196 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441041,39.02279698431756,101.73138829665541,0.38358659640547244 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441036,183.88209736643392,101.73138829665541,1.8075256854867807 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441042,67.66744940422429,93.53234569214308,0.7234657583265176 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441038,93.40262793965177,93.53234569214308,0.9986131241386987 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441053,221.15119402075376,93.53234569214308,2.364435451545945 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441043,61.05680586058991,93.53234569214308,0.6527881387852205 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441041,320.55063771778225,93.53234569214308,3.4271634624973295 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441036,249.7025276745169,93.53234569214308,2.6696917074698407 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441042,107.4717443826641,42.30806113801961,2.5402190857213722 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441038,55.707109209604155,42.30806113801961,1.316702011653842 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441053,59.91039265024908,42.30806113801961,1.416051481414055 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441043,14.768512548436435,42.30806113801961,0.3490708898301392 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441041,279.7852453334455,42.30806113801961,6.61304814750823 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441036,181.72548796955036,42.30806113801961,4.2952922701117355 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441042,251.55720725425823,205.3077634331321,1.2252688502750622 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441038,290.9289317267273,205.3077634331321,1.4170381424542753 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441053,286.16800046010997,205.3077634331321,1.3938489011562085 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441043,163.89097592292012,205.3077634331321,0.7982697448082559 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441041,137.08360808849034,205.3077634331321,0.6676981220592659 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441036,215.84870842067593,205.3077634331321,1.051342164618032 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441042,626.0260099957868,761.179367641068,0.8224421688358053 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441038,386.78212519229305,761.179367641068,0.5081353247802154 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441053,18.516830533879908,761.179367641068,0.024326500849943516 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441043,945.6273001929184,761.179367641068,1.2423186181772945 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441041,715.0229862634154,761.179367641068,0.9393620172329507 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441036,863.0114797579887,761.179367641068,1.133782018333607 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441042,442220.65443680965,258075.7105503754,1.7135307057519071 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441038,577181.75,258075.7105503754,2.2364822662663415 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441053,574638.0366390042,258075.7105503754,2.2266258045498515 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441043,559585.2921849864,258075.7105503754,2.1682989499151546 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441041,731920.2003779918,258075.7105503754,2.8360677524323767 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441036,635849.0911801765,258075.7105503754,2.463808352301567 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441042,148.30921474450827,131.47736122215045,1.1280209259289735 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441038,213.33224940218128,131.47736122215045,1.62257781430314 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441053,165.62268344028806,131.47736122215045,1.2597049552922197 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441043,103.40155937330992,131.47736122215045,0.7864590406450103 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441041,118.60907479267192,131.47736122215045,0.9021254586351513 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441036,260.82981336875395,131.47736122215045,1.983838213242228 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441042,1924.8289314856904,3004.2024881525895,0.6407121154704019 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441038,2061.76212434223,3004.2024881525895,0.6862926625195941 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441053,2012.5009950490503,3004.2024881525895,0.6698952560573311 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441043,2022.4834301369904,3004.2024881525895,0.6732180797109654 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441041,2010.120046503195,3004.2024881525895,0.6691027167543897 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441036,2304.379880513748,3004.2024881525895,0.7670521176922426 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441042,90.52293557978211,96.13121274223809,0.9416601850483904 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441038,132.54006455286208,96.13121274223809,1.3787412097697034 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441053,78.80280468063864,96.13121274223809,0.8197421257124565 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441043,170.6584896290046,96.13121274223809,1.775266167572447 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441041,79.13478262326538,96.13121274223809,0.8231955091990135 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441036,180.2454871359309,96.13121274223809,1.874994416425735 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441042,371.42638949280246,490.807523353751,0.756765884424098 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441038,362.21055728451455,490.807523353751,0.7379890080117012 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441053,355.5853956924843,490.807523353751,0.7244905156765397 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441043,487.65775170132537,490.807523353751,0.9935824707190656 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441041,316.15705694274436,490.807523353751,0.6441569085624493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441036,511.1630328640653,490.807523353751,1.041473507519246 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441042,66.93354703075337,78.64120835950264,0.8511256175613613 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441038,110.2320001042124,78.64120835950264,1.4017078628839823 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441053,90.81978671747676,78.64120835950264,1.1548625537682562 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441043,57.935516577063694,78.64120835950264,0.7367068460115165 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441041,73.8104959062936,78.64120835950264,0.9385727590663945 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441036,151.31674293818523,78.64120835950264,1.9241406139952937 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441042,1761.7860344441224,1710.8868039225827,1.0297502034645671 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441038,2091.804228464869,1710.8868039225827,1.222643265275616 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441053,1686.40398618526,1710.8868039225827,0.9856899838836851 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441043,1967.422824303404,1710.8868039225827,1.1499433041348244 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441041,1882.9546576078292,1710.8868039225827,1.1005723191567924 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441036,1903.6636748803433,1710.8868039225827,1.1126765783193706 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441042,258.87978118298213,158.21676846284709,1.6362347916603608 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441038,197.7972379711833,158.21676846284709,1.2501660847511913 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441053,193.96044518955705,158.21676846284709,1.2259158562899317 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441043,132.11853587275027,158.21676846284709,0.8350476195181216 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441041,310.0340891873978,158.21676846284709,1.9595526580370075 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441036,354.77401207017346,158.21676846284709,2.2423287715769677 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441042,1057.3348428105598,1068.4447009417866,0.9896018407677685 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441038,933.4689557269506,1068.4447009417866,0.8736708178758706 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441053,1049.5667959567634,1068.4447009417866,0.9823314159652969 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441043,1090.242684259311,1068.4447009417866,1.0204016017846413 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441041,1035.24200240453,1068.4447009417866,0.9689242704765255 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441036,1173.2649036325015,1068.4447009417866,1.0981054074191399 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441042,143.9318388485484,101.193417409009,1.4223438888993831 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441038,129.80416804578724,101.193417409009,1.2827333177328892 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441053,131.93977336598812,101.193417409009,1.3038375098323525 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441043,122.27946918914834,101.193417409009,1.2083737492026048 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441041,133.33279128595154,101.193417409009,1.3176034044491243 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441036,240.90502537799247,101.193417409009,2.380639290046798 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441042,16008.569944447769,8195.704907369402,1.9532877434439113 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441038,9096.202074891551,8195.704907369402,1.1098742789912361 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441053,10120.01537883696,8195.704907369402,1.2347949924035528 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441043,9377.771907839371,8195.704907369402,1.1442300587722576 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441041,9117.9940450246,8195.704907369402,1.112533229060736 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441036,9021.324636971263,8195.704907369402,1.1007380986667152 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441042,24.279287664801263,54.484574340672744,0.4456176442343383 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441038,75.4273792553449,54.484574340672744,1.3843804447057662 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441053,489.4897650990385,54.484574340672744,8.984006409565254 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441043,11.057909432501985,54.484574340672744,0.20295486504787197 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441041,64.6153417462632,54.484574340672744,1.1859382683664987 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441036,49.50808315940495,54.484574340672744,0.9086623830416375 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441042,203.60886939004232,181.8259570369428,1.11980089481214 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441038,314.6292361304734,181.8259570369428,1.730386800970051 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441053,161.58632385190805,181.8259570369428,0.88868677764791 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441043,116.52607957389948,181.8259570369428,0.6408660318516793 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441041,165.6398682089123,181.8259570369428,0.9109803182570799 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441036,167.84131581450495,181.8259570369428,0.9230877623286949 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441042,697.6088859001997,598.5025834222519,1.165590433897972 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441038,678.6484844602727,598.5025834222519,1.1339107019049854 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441053,716.8477727436685,598.5025834222519,1.1977354694857223 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441043,779.1650628155776,598.5025834222519,1.301857476304101 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441041,755.233172770972,598.5025834222519,1.2618711993731606 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441036,755.6914956723775,598.5025834222519,1.2626369820349241 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441042,22014.07086860083,15066.853658787537,1.4610927647632272 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441038,15292.866508422168,15066.853658787537,1.0150006666788598 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441053,14785.087021606896,15066.853658787537,0.9812989066223322 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441043,15344.88225086333,15066.853658787537,1.018452996117981 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441041,15404.899279215304,15066.853658787537,1.0224363777656131 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441036,15283.763658661646,15066.853658787537,1.014396502732845 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441042,64.09883251778469,62.8704966822211,1.0195375557755206 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441038,62.31959020659773,62.8704966822211,0.9912374403783076 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441053,61.62996124253936,62.8704966822211,0.9802684008374861 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441043,63.79375227511595,62.8704966822211,1.014685037364369 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441041,65.20105253075687,62.8704966822211,1.0370691496253888 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441036,1630.6504742532345,62.8704966822211,25.93665646535857 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441042,105.11994994777598,100.49015468400951,1.0460721279445218 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441038,101.27828630388336,100.49015468400951,1.0078428739845424 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441053,95.40092175713838,100.49015468400951,0.9493559051344463 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441043,112.2293996144998,100.49015468400951,1.1168198513317473 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441041,105.4638848828458,100.49015468400951,1.0494947013911577 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441036,97.94493682572002,100.49015468400951,0.9746719679525531 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441042,130.6449173654146,109.95671552102958,1.1881485978037272 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441038,121.84218227315104,109.95671552102958,1.1080922315276718 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441053,123.0004983978137,109.95671552102958,1.118626523309433 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441043,103.72920906092853,109.95671552102958,0.9433640189178802 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441041,127.31989794427034,109.95671552102958,1.1579092494802647 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441036,131.57211791861246,109.95671552102958,1.196581011856878 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441042,271.0001940705067,243.54938966397899,1.112711448155962 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441038,260.8379695944861,243.54938966397899,1.0709859300175617 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441053,248.95182458128824,243.54938966397899,1.0221820917915783 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441043,283.3724020964461,243.54938966397899,1.1635110335830043 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441041,292.69302549197926,243.54938966397899,1.2017809853508683 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441036,274.1229374024224,243.54938966397899,1.1255332554133075 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441042,67.48374933794217,49.66723175069083,1.358717749293598 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441038,89.20505694565529,49.66723175069083,1.7960545373945573 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441053,80.56569087488249,49.66723175069083,1.6221095485910968 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441043,45.955774816088926,49.66723175069083,0.925273529371802 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441041,44.60812392270794,49.66723175069083,0.8981399274802038 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441036,73.30081221204038,49.66723175069083,1.4758384880393667 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441042,584.9693932440194,318.9289567276793,1.8341683340578618 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441038,487.4146336113202,318.9289567276793,1.5282859186332964 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441053,494.6246245941347,318.9289567276793,1.5508928059375773 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441043,438.34984446265986,318.9289567276793,1.374443540531032 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441041,586.1283485882838,318.9289567276793,1.8378022322029397 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441036,397.0171184637619,318.9289567276793,1.2448450041579604 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441042,48.04812774776825,52.85511393128503,0.9090535271617015 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441038,50.8337832509475,52.85511393128503,0.9617571407950157 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441053,60.37895304171179,52.85511393128503,1.1423483661431175 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441043,60.16698009499647,52.85511393128503,1.1383379132096343 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441041,52.25963504925269,52.85511393128503,0.9887337508569841 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441036,58.363248363551165,52.85511393128503,1.1042119489029396 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441042,123.9933157806896,145.91831693350866,0.8497446954325156 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441038,134.59586662148757,145.91831693350866,0.9224055584661078 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441053,127.0721463907927,145.91831693350866,0.8708443810292597 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441043,167.25114034171548,145.91831693350866,1.1461970221183928 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441041,139.57891455980658,145.91831693350866,0.9565551295620358 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441036,133.42095344102063,145.91831693350866,0.9143537031188294 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441042,726.509331917045,261.347965154705,2.779854557072934 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441038,681.4482798142488,261.347965154705,2.6074367153035434 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441053,695.0882747955219,261.347965154705,2.6596276515260575 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441043,208.73343500053,261.347965154705,0.7986801614352352 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441041,612.3302392337041,261.347965154705,2.342969224463772 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441036,998.3336061877034,261.347965154705,3.819940230247209 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441042,6076.097804000125,7540.877985370558,0.8057546900755941 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441038,5296.51250394536,7540.877985370558,0.7023734522983519 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441053,6750.6545548796985,7540.877985370558,0.8952080338623821 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441043,6053.196533362086,7540.877985370558,0.8027177399111082 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441041,5834.547958202335,7540.877985370558,0.7737226314391329 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441036,6063.651681574815,7540.877985370558,0.8041042028976481 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441042,6192.996410580569,5107.556668860965,1.212516436349529 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441038,5749.890708014875,5107.556668860965,1.125761510013193 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441053,8131.460117062502,5107.556668860965,1.5920450117836669 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441043,5741.574790338524,5107.556668860965,1.1241333503635802 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441041,4254.612072847623,5107.556668860965,0.8330034003903558 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441036,9213.072268648782,5107.556668860965,1.8038120506460062 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441042,334864.8933079929,180330.65339424144,1.856949370531623 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441038,150668.66567812164,180330.65339424144,0.8355133353214645 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441053,172997.52278614012,180330.65339424144,0.9593350854661991 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441043,118841.39474284436,180330.65339424144,0.659019376384289 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441041,291894.27073206234,180330.65339424144,1.6186614157822572 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441036,98552.45943650824,180330.65339424144,0.5465097451904167 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441042,233.81205977997828,98.01831453553807,2.3853915555261467 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441038,219.81610323895933,98.01831453553807,2.2426023573304925 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441053,251.97740051519503,98.01831453553807,2.5707175409942056 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441043,180.84896780542547,98.01831453553807,1.8450528216321844 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441041,283.96409519985093,98.01831453553807,2.897051398459778 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441036,213.62109437123735,98.01831453553807,2.179399792615141 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441042,3141.727598160315,1812.4793707702274,1.7333866794992614 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441038,2633.8693109659907,1812.4793707702274,1.4531858146593455 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441053,2398.3427164726213,1812.4793707702274,1.3232386283400437 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441043,1920.1766190034873,1812.4793707702274,1.0594198477345942 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441041,1646.8828435786645,1812.4793707702274,0.9086353589110416 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441036,2174.652339702093,1812.4793707702274,1.1998218433669439 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441042,1186.9928767205022,434.5650550234931,2.7314503616871173 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441038,3810.4750769018942,434.5650550234931,8.768480191523674 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441053,1380.2939172215072,434.5650550234931,3.1762653284371587 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441043,269.8472807988737,434.5650550234931,0.6209594574609444 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441041,934.4873444416309,434.5650550234931,2.150396893719656 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441036,3676.788697488847,434.5650550234931,8.460847587687592 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441042,991265.0914599176,9833.502392298877,100.80488638882403 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441038,1164819.4180155755,9833.502392298877,118.45417548561393 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441053,694889.2351901823,9833.502392298877,70.66548697180224 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441043,263678.7609511883,9833.502392298877,26.81432824561966 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441041,424392.10836171254,9833.502392298877,43.15777750703309 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441036,461101.668737959,9833.502392298877,46.89088895723171 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441042,49.2339087103891,42.4088060383901,1.160935977915074 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441038,49.6676698406337,42.4088060383901,1.1711640689830456 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441053,38.66782018448244,42.4088060383901,0.9117875223716232 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441043,42.21359414760879,42.4088060383901,0.9953969019876533 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441041,50.44520588037915,42.4088060383901,1.1894983752835246 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441036,36.42930100896049,42.4088060383901,0.8590032215475077 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441042,1212.4215481040396,385.8715169071063,3.1420343170753253 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441038,1155.410569394471,385.8715169071063,2.9942883026337013 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441053,894.2998116953189,385.8715169071063,2.3176103249688946 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441043,651.8018023698553,385.8715169071063,1.6891679582734487 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441041,778.8260495680921,385.8715169071063,2.018355891646661 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441036,773.6657415439003,385.8715169071063,2.0049827666605164 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441042,1112.6643477251407,1002.6445024002205,1.1097296649625514 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441038,629.8751031519242,1002.6445024002205,0.6282137902756886 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441053,919.1370920851542,1002.6445024002205,0.9167128427721304 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441043,707.4107215406151,1002.6445024002205,0.7055449063423295 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441041,626.9212936983895,1002.6445024002205,0.625267771575677 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441036,889.0426895479687,1002.6445024002205,0.8866978150478045 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441042,28552.53861760299,6245.085755978491,4.572001047426662 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441038,20425.39207371396,6245.085755978491,3.2706343630526615 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441053,18137.3432069917,6245.085755978491,2.904258470690914 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441043,13676.313222571558,6245.085755978491,2.1899320132600373 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441041,11428.488878061931,6245.085755978491,1.8299971088661688 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441036,21548.151265923683,6245.085755978491,3.450417193277994 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441042,293.93483532238275,289.8012081128336,1.0142636645184024 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441038,369.6480277058,289.8012081128336,1.2755227285383786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441053,228.83828162399664,289.8012081128336,0.7896388117709255 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441043,206.47176968423057,289.8012081128336,0.7124600032855665 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441041,277.7521775008555,289.8012081128336,0.9584231180731075 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441036,453.4416623475883,289.8012081128336,1.5646644998492953 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441042,32723.34258011885,19122.271903916942,1.7112685534722425 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441038,35163.62559826091,19122.271903916942,1.83888325482173 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441053,33400.420099489646,19122.271903916942,1.746676350347681 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441043,40802.83105974265,19122.271903916942,2.1337857376342786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441041,27545.771492550168,19122.271903916942,1.4405072593339594 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441036,30717.38665838341,19122.271903916942,1.6063670055905523 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441042,93.93994899049608,111.01681566749893,0.8461776571925018 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441038,118.22039359469906,111.01681566749893,1.0648872685087205 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441053,101.33714143379169,111.01681566749893,0.9128089364164581 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441043,155.83960681723087,111.01681566749893,1.4037477645186518 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441041,59.50084814620329,111.01681566749893,0.5359624826964177 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441036,127.2313073329142,111.01681566749893,1.1460543753477717 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441042,1705.4833374046057,1048.3386659324408,1.6268438748156542 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441038,1940.928628048695,1048.3386659324408,1.8514328347532079 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441053,1536.8344819003887,1048.3386659324408,1.4659713810455108 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441043,1814.7322186091744,1048.3386659324408,1.731055314071687 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441041,1431.9453851110686,1048.3386659324408,1.365918697501661 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441036,1802.4956107793632,1048.3386659324408,1.719382933544801 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441042,17088.566341994556,5453.602601951663,3.1334454651828 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441038,15224.778238458948,5453.602601951663,2.791691905275699 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441053,6206.04410712174,5453.602601951663,1.1379714585182286 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441043,9673.19275453998,5453.602601951663,1.7737252712689893 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441041,23324.294703490184,5453.602601951663,4.276859977869161 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441036,62241.379109892274,5453.602601951663,11.412892293915613 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441042,77839.81893157134,64173.361133824874,1.2129615397461715 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441038,244008.43857263337,64173.361133824874,3.8023322179398824 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441053,161980.52662684192,64173.361133824874,2.524108504914577 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441043,145393.11633641168,64173.361133824874,2.265630376336592 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441041,126641.53642114566,64173.361133824874,1.973428447312458 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441036,95196.5832430796,64173.361133824874,1.483428350348675 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441042,86.39587866264154,44.60879663763593,1.9367453321919543 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441038,39.94187428889109,44.60879663763593,0.8953811198572568 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441053,14.833213374804409,44.60879663763593,0.33251767572429414 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441043,49.72999502451281,44.60879663763593,1.114802432992693 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441041,135.11626691673806,44.60879663763593,3.0289153059722307 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441036,605.921809720398,44.60879663763593,13.583011768786173 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441042,145.1056887817815,136.29080299882398,1.0646770404825745 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441038,140.24872976057858,136.29080299882398,1.0290403070102152 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441053,127.9436649367452,136.29080299882398,0.9387549425315895 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441043,152.06216879658922,136.29080299882398,1.115718489074434 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441041,150.298867198681,136.29080299882398,1.1027807004701402 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441036,137.26301996342067,136.29080299882398,1.0071334011041455 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441042,75.55361948429173,82.77341642135346,0.9127763810024494 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441038,120.18599088252026,82.77341642135346,1.4519878008987834 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441053,67.63118618917021,82.77341642135346,0.8170640902979941 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441043,40.51921173656691,82.77341642135346,0.48951962463777166 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441041,85.39436846013642,82.77341642135346,1.0316641761582142 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441036,45.042037155094874,82.77341642135346,0.544160662957427 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441042,4657.569701943796,2141.365658987758,2.1750464160079366 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441038,3821.762306666128,2141.365658987758,1.7847312954821124 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441053,2750.721219622305,2141.365658987758,1.2845639921780547 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441043,3661.252782266024,2141.365658987758,1.709774679022699 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441041,3502.1014493422804,2141.365658987758,1.6354523267164722 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441036,4013.2071051870994,2141.365658987758,1.8741344283461505 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441042,355.92277496364346,285.0677067828484,1.2485552256354635 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441038,276.0290586809016,285.0677067828484,0.968292977819364 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441053,396.2741774989766,285.0677067828484,1.3901054664211412 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441043,449.1105750212721,285.0677067828484,1.5754523025064502 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441041,292.0079663584305,285.0677067828484,1.024346004161281 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441036,734.4709800514131,285.0677067828484,2.5764790699737157 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441042,669011.396317389,724296.655045942,0.9236704210306669 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441038,836176.5995956693,724296.655045942,1.1544670181344834 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441053,724194.4150402923,724296.655045942,0.9998588423611549 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441043,856007.2691136407,724296.655045942,1.1818462271641228 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441041,809390.5913679902,724296.655045942,1.1174849224129728 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441036,1068508.684587973,724296.655045942,1.4752362545705773 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441042,16.764905560749483,126.94877083842833,0.13206040082173542 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441038,82.89650608027223,126.94877083842833,0.6529917976581058 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441053,97.21539373556166,126.94877083842833,0.7657844427599124 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441043,35.57169701363835,126.94877083842833,0.2802051313983304 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441041,9.835065524170448,126.94877083842833,0.07747271170264297 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441036,11.875381370374948,126.94877083842833,0.09354467390227131 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441042,48211.82553251678,94593.87687362579,0.509671736965873 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441038,77360.00074524705,94593.87687362579,0.8178119271778804 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441053,65689.72814587466,94593.87687362579,0.6944395379167502 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441043,80990.60342030799,94593.87687362579,0.856192875237672 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441041,51740.4199183403,94593.87687362579,0.5469743035002546 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441036,61098.39588990402,94593.87687362579,0.6459022286561888 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441042,91.40780368633683,34.2642969985689,2.667727392456195 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441038,77.8323427252445,34.2642969985689,2.271528954132498 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441053,47.3725700503374,34.2642969985689,1.3825636070197496 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441043,416.1025836612075,34.2642969985689,12.14391130448661 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441041,73.98577599253342,34.2642969985689,2.159267297841352 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441036,0.4028943769531864,34.2642969985689,0.011758431143940117 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441042,20.17164823281736,74.66086218948179,0.27017700628240454 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441038,138.50290924349116,74.66086218948179,1.8550938896470905 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441053,90.4028183776464,74.66086218948179,1.2108461612486219 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441043,58.2678418726728,74.66086218948179,0.7804335519832981 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441041,65.62409771218667,74.66086218948179,0.8789624950437792 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441036,66.86,74.66086218948179,0.8955160446756698 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441042,308.3041437057484,347.6986105145094,0.8866993838414632 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441038,316.9714136314257,347.6986105145094,0.9116269206896889 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441053,337.2695258287877,347.6986105145094,0.9700053886603424 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441043,638.0674877892983,347.6986105145094,1.8351165880275262 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441041,267.40989539559433,347.6986105145094,0.7690853150085722 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441036,736.5562291634786,347.6986105145094,2.1183755324001856 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441042,4976.8716780918985,2521.321340016667,1.9739140739827314 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441038,4807.1688674928355,2521.321340016667,1.9066069807115733 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441053,4030.450282194159,2521.321340016667,1.5985468485217027 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441043,4639.209160036573,2521.321340016667,1.8399912325359948 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441041,3217.8926001806694,2521.321340016667,1.2762723057582965 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441036,5451.3877208118265,2521.321340016667,2.162115409206742 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441042,95.93751203371224,79.44971561377609,1.2075249268365822 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441038,110.9825971534278,79.44971561377609,1.3968910561359404 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441053,92.6710965313496,79.44971561377609,1.16641193508918 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441043,132.51405546411,79.44971561377609,1.6678984240584602 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441041,73.54176538629272,79.44971561377609,0.9256391268131995 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441036,161.65361557736608,79.44971561377609,2.034665754666796 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441042,164.1366741354742,42.37178439720435,3.873725793485907 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441038,55.44367878149384,42.37178439720435,1.308504694108468 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441053,46.556322555212695,42.37178439720435,1.0987576571895432 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441043,45.172333361883496,42.37178439720435,1.0660946666400937 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441041,460.0004343650516,42.37178439720435,10.856291301137697 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441036,87.02240790449349,42.37178439720435,2.0537819953184493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441042,1954.727116507899,1321.2949146990686,1.4794025881444475 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441038,1526.685148894354,1321.2949146990686,1.1554461702004386 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441053,1949.5450646322809,1321.2949146990686,1.4754806386856483 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441043,503.4450063799767,1321.2949146990686,0.3810239491420723 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441041,1833.4263771198912,1321.2949146990686,1.3875981483947988 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441036,3849.335838050576,1321.2949146990686,2.9133055726073698 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441042,59748.23927892933,23354.026662177774,2.558369918096076 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441038,54876.60213603832,23354.026662177774,2.3497704669881134 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441053,53478.09210955896,23354.026662177774,2.2898874306831036 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441043,41621.330205836595,23354.026662177774,1.7821907462854367 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441041,88622.7743764204,23354.026662177774,3.7947534983312505 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441036,50412.41081100889,23354.026662177774,2.1586175069609137 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441042,17521.273305272993,13473.54115415771,1.300420810297983 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441038,10782.81355185883,13473.54115415771,0.8002954404107366 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441053,4879.873124544605,13473.54115415771,0.36218192891619716 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441043,11242.130129801311,13473.54115415771,0.8343857046320875 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441041,16768.859967454413,13473.54115415771,1.2445770399624914 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441036,55622.571080006775,13473.54115415771,4.128281529228311 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441042,109439.56444930776,49612.48263442616,2.205887684672476 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441038,127983.73941566356,49612.48263442616,2.579668112130625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441053,88990.79252621249,49612.48263442616,1.793717786347214 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441043,89180.0306976766,49612.48263442616,1.7975321121260412 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441041,108079.36999300244,49612.48263442616,2.178471309113768 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441036,108983.68644232213,49612.48263442616,2.196698908324701 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441035,5.5752424659964,73.06854961986588,0.07630153458637426 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441034,4.364965919103007,73.06854961986588,0.059737957600245833 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441048,95.1349394021223,73.06854961986588,1.3019957272596117 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441045,3.8620072829092966,73.06854961986588,0.05285457701023388 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441030,4.99903868932039,73.06854961986588,0.06841573721289866 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441046,31.440393053476665,73.06854961986588,0.43028626155908606 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441035,11.1000619141271,990.9231863649335,0.011201738002363393 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441034,639.3761394331312,990.9231863649335,0.6452327972853228 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441048,69.91868718226016,990.9231863649335,0.07055913934030278 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441045,789.196362656256,990.9231863649335,0.7964253672893812 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441030,478.2070621626739,990.9231863649335,0.4825874182204892 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441046,317.9412208146898,990.9231863649335,0.3208535486802098 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441035,62.5244810871379,50.719124328797626,1.232759475140176 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441034,61.7825608608109,50.719124328797626,1.2181314578755769 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441048,61.075504972183765,50.719124328797626,1.2041908408404032 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441045,52.28184798279763,50.719124328797626,1.0308113295464116 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441030,61.06879179572658,50.719124328797626,1.2040584809752435 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441046,41.30220552142886,50.719124328797626,0.8143319914925666 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441035,332.5271849549276,319.2477137201226,1.041596135740683 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441034,354.111079908269,319.2477137201226,1.1092047481934681 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441048,336.5885480369614,319.2477137201226,1.0543178026704403 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441045,340.80518234066346,319.2477137201226,1.0675258355630382 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441030,337.05,319.2477137201226,1.0557632381213677 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441046,328.8806742387897,319.2477137201226,1.0301739373679968 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441035,109.84935750747078,44.58166891160943,2.4640028107800407 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441034,74.94766798673662,44.58166891160943,1.6811319498902753 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441048,19.84399088989012,44.58166891160943,0.44511547849933863 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441045,74.60693072640616,44.58166891160943,1.6734889596512597 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441030,22.14314023509788,44.58166891160943,0.4966871087531591 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441046,141.44742298457027,44.58166891160943,3.1727709266562747 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441035,2228.1082973300468,1543.2839395802719,1.4437448872409229 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441034,1603.686266471443,1543.2839395802719,1.039138829441586 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441048,1151.674103173675,1543.2839395802719,0.7462490042414985 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441045,2353.318265194812,1543.2839395802719,1.5248770526536066 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441030,1835.0664154276587,1543.2839395802719,1.1890659705347177 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441046,2118.3750767442257,1543.2839395802719,1.3726411727710728 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441035,36.19897592198683,31.276034215973343,1.1574030029516733 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441034,34.063551462664485,31.276034215973343,1.0891263012261156 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441048,38.205898815840854,31.276034215973343,1.221571077458672 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441045,31.05187913909805,31.276034215973343,0.9928330083242839 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441030,49.89600741278957,31.276034215973343,1.5953431649370242 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441046,35.03327364953968,31.276034215973343,1.1201315808654357 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441035,246.50414002449355,130.468422036268,1.889377798682731 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441034,29.82408557475824,130.468422036268,0.22859236824729626 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441048,108.5886219924875,130.468422036268,0.8322981170286685 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441045,43.30015279703003,130.468422036268,0.33188224492355184 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441030,48.429663127819445,130.468422036268,0.3711983510795955 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441046,112.9093163481604,130.468422036268,0.8654148995285121 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441035,118.16860820321244,95.42663227533711,1.2383189617575237 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441034,108.28904701851346,95.42663227533711,1.1347885222027334 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441048,108.65312649477632,95.42663227533711,1.1386038038236164 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441045,129.74033791391145,95.42663227533711,1.3595820665615448 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441030,249.33359963180115,95.42663227533711,2.612830335585898 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441046,151.8085628271198,95.42663227533711,1.5908406197245055 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441035,561.2631624272507,569.3868516791151,0.9857325661316066 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441034,556.7440615964878,569.3868516791151,0.9777957814702888 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441048,666.1649583391012,569.3868516791151,1.169968987472381 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441045,525.1112767754478,569.3868516791151,0.9222399063605013 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441030,503.431014709647,569.3868516791151,0.8841634000241397 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441046,543.4311289321955,569.3868516791151,0.9544146081519507 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441035,2673.903985390685,5328.634617598269,0.501799086873003 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441034,3147.2142062602475,5328.634617598269,0.5906230079777481 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441048,4314.115122535105,5328.634617598269,0.8096098592099696 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441045,2085.736162694692,5328.634617598269,0.3914203754572271 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441030,4529.044660458778,5328.634617598269,0.8499446829214415 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441046,4152.340168424082,5328.634617598269,0.7792503082704574 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441035,780548.0341699619,656386.6079991342,1.1891589874895672 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441034,861240.61140996,656386.6079991342,1.3120935145756294 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441048,764774.9750374765,656386.6079991342,1.1651288519867018 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441045,848437.1659017445,656386.6079991342,1.292587562820696 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441030,842907.4806806662,656386.6079991342,1.2841631294856917 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441046,681172.7391906818,656386.6079991342,1.037761482165371 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441035,2621.316972286599,5223.837669019135,0.5017990868730031 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441034,3085.3187172635503,5223.837669019135,0.5906230079777482 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441048,4229.270479750318,5223.837669019135,0.8096098592099696 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441045,2044.716501735076,5223.837669019135,0.39142037545722713 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441030,4439.973051227552,5223.837669019135,0.8499446829214417 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441046,4070.677113937989,5223.837669019135,0.7792503082704574 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441035,780548.0341699619,656386.6079991342,1.1891589874895672 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441034,861240.61140996,656386.6079991342,1.3120935145756294 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441048,764774.9750374765,656386.6079991342,1.1651288519867018 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441045,848377.3309605889,656386.6079991342,1.2924964047433884 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441030,842907.4806806662,656386.6079991342,1.2841631294856917 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441046,681172.7391906818,656386.6079991342,1.037761482165371 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441035,57.113766036184394,50.79723336807032,1.1243479664009508 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441034,48.70754890276377,50.79723336807032,0.9588622386151434 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441048,58.30634622809833,50.79723336807032,1.1478252330322387 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441045,44.923079379339,50.79723336807032,0.8843607496068153 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441030,28.90982665061894,50.79723336807032,0.5691220709037832 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441046,59.94589495702111,50.79723336807032,1.1801015721202914 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441035,184.76228512455043,124.85055234194422,1.4798675829524428 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441034,276.28057357467486,124.85055234194422,2.2128902787549536 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441048,100.5898812773176,124.85055234194422,0.8056823088921481 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441045,88.32615903537078,124.85055234194422,0.7074550923368012 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441030,128.06483785456842,124.85055234194422,1.0257450644176633 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441046,73.231575689906,124.85055234194422,0.5865538783467876 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441035,172.09546860907932,149.81706398084205,1.1487040530382182 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441034,153.99754756835316,149.81706398084205,1.027903921465486 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441048,159.56421494080723,149.81706398084205,1.0650603522787738 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441045,169.86045267614332,149.81706398084205,1.1337857528556583 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441030,102.54474198711895,149.81706398084205,0.6844663702676214 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441046,170.83856539609238,149.81706398084205,1.1403144665679636 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441035,3118.437734319274,2791.14294318225,1.1172619238066925 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441034,3382.797723945941,2791.14294318225,1.211975808049849 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441048,3337.3911317864963,2791.14294318225,1.1957077081768717 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441045,3221.4014215243324,2791.14294318225,1.1541513591745804 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441030,3061.3638184953984,2791.14294318225,1.0968136999121454 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441046,3124.0941980179127,2791.14294318225,1.119288499949077 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441035,221.32446285589893,222.01180748199775,0.9969040177011551 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441034,322.3329639488832,222.01180748199775,1.4518730674944853 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441048,212.3063756912671,222.01180748199775,0.956284163888366 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441045,342.00046784679915,222.01180748199775,1.540460715696533 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441030,270.00962245433146,222.01180748199775,1.2161948750235985 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441046,281.2447117567351,222.01180748199775,1.2668006938303964 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441035,4915.874365052183,4330.453784028004,1.1351868903862647 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441034,5071.403446624809,4330.453784028004,1.1711020829571364 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441048,4113.091781237857,4330.453784028004,0.9498061834554516 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441045,6873.013009796417,4330.453784028004,1.5871345943342299 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441030,4850.308363003872,4330.453784028004,1.1200462133768165 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441046,5564.233096230814,4330.453784028004,1.2849076271760143 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441035,83.85355713080013,100.4664893584531,0.8346420549405293 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441034,81.04976940051547,100.4664893584531,0.8067343640458963 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441048,61.59659059352379,100.4664893584531,0.6131058324707068 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441045,90.07033932162358,100.4664893584531,0.8965212171419942 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441030,164.5691823175413,100.4664893584531,1.6380504919444037 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441046,30.251751538863285,100.4664893584531,0.3011128559586515 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441035,288.26669045881846,219.8603821991507,1.3111352194307793 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441034,95.89057315014732,219.8603821991507,0.43614302945807276 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441048,248.5078575223658,219.8603821991507,1.1302984877796949 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441045,147.21925018341503,219.8603821991507,0.6696033578712832 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441030,58.770459195234366,219.8603821991507,0.2673080916506357 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441046,81.34181890075442,219.8603821991507,0.3699703333867334 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441035,100.55164184114405,115.26780159034894,0.8723306981987498 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441034,117.32244006836412,115.26780159034894,1.017824912505204 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441048,106.7801157514261,115.26780159034894,0.9263655095194121 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441045,69.42676741233211,115.26780159034894,0.6023084196492998 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441030,100.0026555400836,115.26780159034894,0.8675679952280494 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441046,113.923421150332,115.26780159034894,0.9883368952867277 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441035,1876.5429499812235,1760.6737631139824,1.0658095720483227 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441034,2688.639933016771,1760.6737631139824,1.5270517397053494 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441048,2155.575668195463,1760.6737631139824,1.2242902196617305 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441045,1280.0340786305946,1760.6737631139824,0.7270137747533004 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441030,2138.6415569971095,1760.6737631139824,1.2146722475233809 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441046,2269.3340651143967,1760.6737631139824,1.288900938184472 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441035,413.2945132297655,518.6000624505415,0.7969426599696585 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441034,384.12223635119585,518.6000624505415,0.7406906866460883 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441048,424.4084218231861,518.6000624505415,0.8183732562964386 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441045,849.3657201518378,518.6000624505415,1.6378048936946303 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441030,332.9961542744001,518.6000624505415,0.6421058892682986 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441046,367.7253048637195,518.6000624505415,0.709073005363915 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441035,879.2828166258747,841.89306662726494,1.0444115190880452 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441034,1129.9649825079357,841.89306662726494,1.3421716216701072 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441048,488.68506494166814,841.89306662726494,0.5804597808358313 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441045,1217.1284776441346,841.89306662726494,1.4457043606738709 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441030,669.1489497920564,841.89306662726494,0.7948146579621516 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441046,706.6030034621629,841.89306662726494,0.8393025569065535 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441035,243.28618169238615,246.94010350613598,0.9852032061140727 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441034,333.5202154846778,246.94010350613598,1.3506117910750388 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441048,223.75215127468292,246.94010350613598,0.9060988802457641 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441045,304.6662617391234,246.94010350613598,1.2337658299051981 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441030,217.53054201368852,246.94010350613598,0.8809040691451857 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441046,428.1287863985127,246.94010350613598,1.733735348450093 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441035,7637.425242536972,6405.278640912654,1.1923642468501192 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441034,15280.017036316223,6405.278640912654,2.3855351020512443 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441048,4607.574782713538,6405.278640912654,0.7193402568443189 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441045,4436.632554921312,6405.278640912654,0.6926525454463538 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441030,12519.10452500395,6405.278640912654,1.9544980362041158 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441046,10278.82536682301,6405.278640912654,1.6047428914596658 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441035,248.34710173059568,184.84349394551683,1.3435533836197489 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441034,241.00269164302347,184.84349394551683,1.303820256254514 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441048,236.1841635400502,184.84349394551683,1.2777521053008563 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441045,112.45465682291233,184.84349394551683,0.6083776843996396 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441030,302.0551662812172,184.84349394551683,1.6341130533393233 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441046,330.60452534658504,184.84349394551683,1.7885645758461572 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441035,57720.36544728711,66689.05961878091,0.8655147602505997 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441034,47403.880725473224,66689.05961878091,0.7108194506932796 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441048,77501.30386096191,66689.05961878091,1.1621292053597359 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441045,46631.03164410089,66689.05961878091,0.6992306070989897 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441030,47198.21529559179,66689.05961878091,0.7077355051247397 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441046,48355.5378969463,66689.05961878091,0.7250895150323645 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441035,2129.813684103506,426.591426110135,4.992631247946466 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441034,2752.825524744637,426.591426110135,6.453072791092448 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441048,731.0819839373693,426.591426110135,1.713775615707341 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441045,1201.179341209945,426.591426110135,2.815760626421571 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441030,1298.9862063199698,426.591426110135,3.0450358980834387 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441046,2622.213047643432,426.591426110135,6.146895805089256 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441035,536542.9226082832,6086.038398766024,88.1596347990624 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441034,9118.952519911074,6086.038398766024,1.4983396295626377 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441048,4461.711893462426,6086.038398766024,0.7331061030385646 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441045,6021.710187714579,6086.038398766024,0.9894301996082561 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441030,10559.302764580483,6086.038398766024,1.7350042955235767 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441046,6344.446968980578,6086.038398766024,1.0424592408531217 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441035,73.09297283524447,118.38689307733607,0.6174076448437293 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441034,71.95493165200757,118.38689307733607,0.6077947463745258 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441048,66.08914340700139,118.38689307733607,0.5582471309879612 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441045,140.79010197236565,118.38689307733607,1.1892372399738096 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441030,84.75406078612816,118.38689307733607,0.7159074673136552 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441046,57.20844436778789,118.38689307733607,0.4832329228406776 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441035,33.20523889974506,43.003791743375764,0.7721467701707941 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441034,144.3593151750162,43.003791743375764,3.356897364690012 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441048,18.456807908388974,43.003791743375764,0.4291902448632807 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441045,142.8974263447455,43.003791743375764,3.322902947662916 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441030,114.59098409999817,43.003791743375764,2.664671636022644 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441046,66.0505411561192,43.003791743375764,1.5359236587851237 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441035,70.04310445128723,56.77751951238643,1.233641502003391 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441034,102.85178412340208,56.77751951238643,1.8114878037418352 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441048,126.40444732579031,56.77751951238643,2.2263115474464197 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441045,65.19400572689858,56.77751951238643,1.1482362436188505 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441030,52.29047135267555,56.77751951238643,0.9209713950477884 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441046,55.96427746853066,56.77751951238643,0.9856766894566722 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441035,116.41579229257826,232.93832449773902,0.4997708837461318 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441034,367.687111092574,232.93832449773902,1.5784740956018293 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441048,234.38125169905416,232.93832449773902,1.0061944602908361 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441045,283.486297683206,232.93832449773902,1.2170015316048073 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441030,190.84585133292745,232.93832449773902,0.8192977765441937 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441046,130.03491543591943,232.93832449773902,0.5582375322579501 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441035,100.45419149292904,55.88566907011774,1.7974946558641496 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441034,109.4145482476689,55.88566907011774,1.9578283675979686 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441048,157.95342485524077,55.88566907011774,2.826367250914761 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441045,62.853322507121646,55.88566907011774,1.124676926176939 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441030,46.6159379080906,55.88566907011774,0.8341304431660871 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441046,60.39203340743414,55.88566907011774,1.0806354189239897 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441035,121.03391874959368,226.42114305345407,0.534552193833858 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441034,283.62032456331195,226.42114305345407,1.2526229694739865 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441048,170.14176219108978,226.42114305345407,0.7514393748596273 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441045,347.69980639725316,226.42114305345407,1.5356331202478177 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441030,321.92177531290196,226.42114305345407,1.4217831911435137 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441046,73.25918182159724,226.42114305345407,0.32355274261777767 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441035,214.60759404378928,212.71806341276286,1.0088827935000515 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441034,436.0042889503088,212.71806341276286,2.049681545399727 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441048,184.58047463681552,212.71806341276286,0.8677235570664794 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441045,221.06447109993312,212.71806341276286,1.0392369484436998 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441030,186.6102647360509,212.71806341276286,0.8772657184921254 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441046,344.4746706263249,212.71806341276286,1.619395481040548 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441035,11398.727218626573,10996.969545575432,1.0365334896478626 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441034,22498.5894999798,10996.969545575432,2.0458899523852896 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441048,10614.44921392846,10996.969545575432,0.9652158415041826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441045,12513.36761307532,10996.969545575432,1.137892358546178 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441030,17149.465233301882,10996.969545575432,1.559471921989806 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441046,17934.069420355063,10996.969545575432,1.6308192312463694 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441035,192.3838710699916,147.8550055811589,1.3011657624563169 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441034,164.37118127794326,147.8550055811589,1.1117052184460436 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441048,158.87095002791224,147.8550055811589,1.074505049074626 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441045,115.76451024382898,147.8550055811589,0.7829596961482973 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441030,109.77169380203212,147.8550055811589,0.7424279845688246 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441046,119.17711734662409,147.8550055811589,0.8060404642926121 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441035,297.2033308512387,92.19915296117537,3.223493072397201 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441034,159.48248409904235,92.19915296117537,1.7297608381087803 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441048,200.91525806831424,92.19915296117537,2.179144293797566 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441045,67.02109601462166,92.19915296117537,0.7269166132452858 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441030,161.14261302496865,92.19915296117537,1.747766740252213 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441046,369.0148489883987,92.19915296117537,4.00236701896588 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441035,1091.3626963393713,1229.7970051816276,0.8874332038060126 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441034,994.3290778429924,1229.7970051816276,0.8085310613487312 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441048,1410.13172793127,1229.7970051816276,1.1466377963109522 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441045,3258.08635094312,1229.7970051816276,2.649287920864579 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441030,941.672355683482,1229.7970051816276,0.7657136516968565 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441046,1583.9898715811162,1229.7970051816276,1.2880092120139601 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441035,74281.03304237193,50083.06853493704,1.483156587950573 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441034,72292.17792437227,50083.06853493704,1.44344546049415 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441048,51084.283603870885,50083.06853493704,1.0199910887695591 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441045,78866.74136064711,50083.06853493704,1.574718635812642 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441030,53191.2933944124,50083.06853493704,1.0620613902142821 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441046,58605.97955862197,50083.06853493704,1.1701754958911814 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441035,5.084941519376037,35.678906774941794,0.1425195438708711 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441034,26.186883089391117,35.678906774941794,0.7339597946365003 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441048,41.06105425876814,35.678906774941794,1.1508495626779227 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441045,34.12720397180931,35.678906774941794,0.9565092391165335 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441030,21.83799018401853,35.678906774941794,0.6120700480474337 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441046,22.876444610426802,35.678906774941794,0.6411756042506749 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441035,62.28259914887756,67.70693010562654,0.9198851439832418 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441034,149.0380643964385,67.70693010562654,2.2012231859269193 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441048,88.80653109631835,67.70693010562654,1.31163133460305 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441045,79.99486859177972,67.70693010562654,1.1814871604277926 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441030,117.77766737810364,67.70693010562654,1.7395215998475193 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441046,54.14149791309458,67.70693010562654,0.7996448491850223 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441035,72.89821544875794,64.01321127549492,1.1387995383488019 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441034,73.16547395002581,64.01321127549492,1.1429745905910285 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441048,86.71653417627809,64.01321127549492,1.354666207934397 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441045,73.49008993645604,64.01321127549492,1.1480456685757459 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441030,35.996481390544695,64.01321127549492,0.5623289423120162 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441046,79.60602156269469,64.01321127549492,1.2435873779256703 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441035,666.9722439434811,1060.427767412219,0.6289652765045048 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441034,945.4578103515022,1060.427767412219,0.8915815290830416 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441048,1013.966760873459,1060.427767412219,0.9561865428588883 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441045,876.7799797793091,1060.427767412219,0.826817258773722 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441030,729.423749386528,1060.427767412219,0.6878580246597596 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441046,606.5236669413651,1060.427767412219,0.5719613212519659 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441035,8.085747283900028,57.09593719876665,0.14161685893255976 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441034,25.056314111702008,57.09593719876665,0.4388458328387551 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441048,185.7557428620671,57.09593719876665,3.2533968610656188 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441045,53.004794231510814,57.09593719876665,0.9283461631777155 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441030,63.569732507312,57.09593719876665,1.1133845178161852 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441046,22.42372434955183,57.09593719876665,0.3927376526194619 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441035,274.12930294572817,50.205845180981015,5.460107323311706 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441034,7.06859769165574,50.205845180981015,0.14079232539906464 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441048,66.9453095140953,50.205845180981015,1.333416642480018 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441045,94.34444662986192,50.205845180981015,1.879152642282407 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441030,163.8038122633,50.205845180981015,3.2626442533299325 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441046,223.20185048501253,50.205845180981015,4.445734349863428 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441035,1151.7239582308157,1506.8779059558976,0.764311397544987 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441034,2053.441614125126,1506.8779059558976,1.362712669692049 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441048,813.4441036566561,1506.8779059558976,0.5398208444370566 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441045,785.3298580802768,1506.8779059558976,0.5211635627387461 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441030,1154.2589239150584,1506.8779059558976,0.7659936610344332 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441046,818.1126828581741,1506.8779059558976,0.5429190245769774 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441035,25461.908912639443,16162.128318216166,1.5754056898522202 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441034,20444.700794702072,16162.128318216166,1.264975774982498 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441048,18461.9592949007,16162.128318216166,1.1422975323177218 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441045,24543.66888326336,16162.128318216166,1.5185913884621525 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441030,16403.61928631746,16162.128318216166,1.014941780150892 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441046,26266.91971161259,16162.128318216166,1.6252141546238945 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441035,23.615629067667975,24.995311385825953,0.9448023552552999 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441034,11.913747932541447,24.995311385825953,0.4766393084143515 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441048,12.775949922805754,24.995311385825953,0.5111338572901551 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441045,1.5598617084038089,24.995311385825953,0.062406172274707364 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441030,137.58384951115107,24.995311385825953,5.5043862981907274 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441046,40.127290175004894,24.995311385825953,1.605392689676985 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441035,197.7418768012473,522.7489803443298,0.37827309901397915 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441034,559.8854343617148,522.7489803443298,1.0710407010127951 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441048,560.7153638345172,522.7489803443298,1.0726283262478664 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441045,63.33625934894841,522.7489803443298,0.12115998639964715 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441030,68.31509922871096,522.7489803443298,0.13068432803773708 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441046,52.2704516897204,522.7489803443298,0.09999149430246684 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441035,3.5167708575568843,2.8430683750443606,1.2369631657212647 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441034,3.5428739847041686,2.8430683750443606,1.2461444880476675 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441048,3.377772102939343,2.8430683750443606,1.188072764126413 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441045,2.757628916559425,2.8430683750443606,0.9699481520617308 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441030,2.640336722723617,2.8430683750443606,0.9286926568139324 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441046,5.385295497278281,2.8430683750443606,1.8941843061351817 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441035,1843.385144334402,1771.7543971110147,1.0404292758297577 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441034,1589.2054295533508,1771.7543971110147,0.8969671147110884 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441048,2532.4779432523233,1771.7543971110147,1.4293617373727014 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441045,1105.0871959903711,1771.7543971110147,0.6237248220138768 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441030,1060.2999639205198,1771.7543971110147,0.5984463567012576 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441046,1176.8000786384282,1771.7543971110147,0.6642004560887749 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441035,11.789965291931564,73.62821549612136,0.1601283585713502 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441034,101580.82100443788,73.62821549612136,1379.6452938586979 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441048,280.7356107943374,73.62821549612136,3.812880821607393 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441045,2.9934732653433085,73.62821549612136,0.04065660487861479 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441030,177.2037315905338,73.62821549612136,2.4067367434685236 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441046,21.317690470327054,73.62821549612136,0.28953153796658354 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441035,1121.727483323191,1923.334023596175,0.5832203192796583 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441034,819.1802151687986,1923.334023596175,0.42591677010794377 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441048,1732.9663192232474,1923.334023596175,0.9010220263160605 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441045,996.1897952849768,1923.334023596175,0.5179494477107726 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441030,938.9945397032624,1923.334023596175,0.4882118904898105 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441046,486.13755904354576,1923.334023596175,0.2527577389467612 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441035,37.79215127152072,51.40813337414527,0.7351395351484898 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441034,117.9176913352799,51.40813337414527,2.293755551812825 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441048,114.53259127994544,51.40813337414527,2.2279079935928463 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441045,4.822271715359369,51.40813337414527,0.0938036726652409 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441030,56.57109286533972,51.40813337414527,1.1004307908559672 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441046,27.71785642938665,51.40813337414527,0.5391725902136492 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441035,40.504830758387925,89.1451395839603,0.4543694804610062 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441034,28.499075384977836,89.1451395839603,0.31969298066033447 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441048,91.59217995050555,89.1451395839603,1.027450070502616 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441045,98.18711135844748,89.1451395839603,1.1014297786361207 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441030,36.10411941868213,89.1451395839603,0.4050037903039895 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441046,21.826430374230945,89.1451395839603,0.24484150763681264 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441035,5156.54982710092,4771.656231796832,1.08066247370028 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441034,3991.2702595036258,4771.656231796832,0.8364538570291471 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441048,7990.219587828677,4771.656231796832,1.674517022954072 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441045,4333.945683115691,4771.656231796832,0.9082686330661514 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441030,2736.64261686587,4771.656231796832,0.5735204893072001 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441046,5883.110554015707,4771.656231796832,1.2329284148368629 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441035,284906.9389339554,209884.98459768714,1.357443170506324 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441034,402729.3271517378,209884.98459768714,1.918809618152054 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441048,518486.8531015956,209884.98459768714,2.470338000097741 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441045,394880.80749080994,209884.98459768714,1.8814152343852872 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441030,313268.02504307654,209884.98459768714,1.4925699694218557 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441046,521868.25926179474,209884.98459768714,2.4864487579334225 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441035,31.094346588388703,22.903585106474594,1.35761918685816 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441034,97.77458447577136,22.903585106474594,4.268964182735372 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441048,89.74399661818288,22.903585106474594,3.918338382440102 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441045,236.1332845760075,22.903585106474594,10.30988308067348 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441030,72.44693928048397,22.903585106474594,3.163126599774287 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441046,5.986156642534219,22.903585106474594,0.26136330250070755 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441035,19.9588269320608,83.56495705722055,0.238842065321641 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441034,139.24143989677816,83.56495705722055,1.6662659181579367 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441048,67.80645169733238,83.56495705722055,0.8114220851080239 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441045,147.29923649734351,83.56495705722055,1.7626914640365499 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441030,63.3386330377409,83.56495705722055,0.75795686694807 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441046,355.86189569619256,83.56495705722055,4.258506295318485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441035,2362.772857324677,1829.6496491832456,1.2913799417169385 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441034,2479.298235507234,1829.6496491832456,1.3550672045951482 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441048,2224.7700915701826,1829.6496491832456,1.2159541541536756 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441045,1683.5502654676495,1829.6496491832456,0.9201489838337003 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441030,1061.295044763683,1829.6496491832456,0.5800536978417942 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441046,2680.410894402308,1829.6496491832456,1.464985876175169 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441035,150455.57619599305,96234.19538703516,1.563431538975206 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441034,80441.11774647552,96234.19538703516,0.8358891288378008 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441048,77431.47264298749,96234.19538703516,0.8046149534640281 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441045,59954.75311750869,96234.19538703516,0.6230088262948775 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441030,110052.6811820218,96234.19538703516,1.1435922619751886 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441046,60729.7195554097,96234.19538703516,0.6310617479698003 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441035,249.42470474924244,77.99112650544876,3.198116451514733 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441034,266.0597243200007,77.99112650544876,3.411410198074428 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441048,241.59941444432977,77.99112650544876,3.0977808023769304 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441045,219.64543008008073,77.99112650544876,2.816287440914646 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441030,288.57980291216217,77.99112650544876,3.700162003583842 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441046,294.713329878591,77.99112650544876,3.7788059114391843 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441035,105.21077937202514,110.33780757772625,0.9535333507321193 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441034,157.38433721485254,110.33780757772625,1.426386301032716 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441048,178.8815812635984,110.33780757772625,1.62121747015489 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441045,234.4292803885819,110.33780757772625,2.124650521295167 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441030,75.09720437465634,110.33780757772625,0.6806117143641353 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441046,40.41816020379453,110.33780757772625,0.36631288124265476 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441035,94.02211106151408,67.31067174214355,1.396838103498622 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441034,78.3369746255048,67.31067174214355,1.163812105836668 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441048,76.03496576117404,67.31067174214355,1.1296123451635107 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441045,70.9879579342743,67.31067174214355,1.0546315479693598 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441030,64.73111992972794,67.31067174214355,0.9616769266202324 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441046,93.12181161325482,67.31067174214355,1.3834628180504516 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441035,3346.3259238055493,2375.529574917848,1.4086652336969006 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441034,3687.3824268973863,2375.529574917848,1.552235958596687 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441048,3357.881816443697,2375.529574917848,1.4135297880094047 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441045,2850.2788770401085,2375.529574917848,1.1998498806897315 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441030,3151.4409325429224,2375.529574917848,1.3266266881362263 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441046,3058.0877364583625,2375.529574917848,1.2873288418495565 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441035,129.2301018446004,194.62377093849457,0.663999578373394 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441034,211.0934570778249,194.62377093849457,1.0846231992110311 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441048,165.74618869856783,194.62377093849457,0.8516235601608362 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441045,164.41824496254011,194.62377093849457,0.8448004278701389 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441030,126.72168044162804,194.62377093849457,0.6511110119311937 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441046,259.01738963853626,194.62377093849457,1.3308620441867376 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441035,3852.082692580264,3728.1507253933823,1.0332422094264455 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441034,3630.905558703039,3728.1507253933823,0.9739159776915719 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441048,3624.7327939425495,3728.1507253933823,0.9722602600945217 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441045,4588.934345980728,3728.1507253933823,1.2308875590046104 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441030,3594.2836893190924,3728.1507253933823,0.9640929120267355 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441046,4212.552727149551,3728.1507253933823,1.129930906080804 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441035,94.8645239211139,68.78582331086372,1.379129002969009 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441034,88.61112510317705,68.78582331086372,1.2882178454522069 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441048,85.6151345181891,68.78582331086372,1.244662495806275 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441045,114.1234188283727,68.78582331086372,1.6591124934656205 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441030,19.589781396758465,68.78582331086372,0.2847938783581376 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441046,154.54020543735135,68.78582331086372,2.2466868607349206 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441035,836.02055238946,696.3940975413478,1.2004991934036633 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441034,574.0276101499677,696.3940975413478,0.8242855764811896 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441048,842.1246790076726,696.3940975413478,1.2092645270556335 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441045,900.2758033734164,696.3940975413478,1.2927677109152453 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441030,640.6295252916372,696.3940975413478,0.9199238298449253 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441046,675.5747897532193,696.3940975413478,0.9701041294553873 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441035,72.09468019690004,81.2393188807366,0.8874358031329467 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441034,83.08598908021389,81.2393188807366,1.0227312368557433 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441048,78.51131272704913,81.2393188807366,0.9664201252389581 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441045,111.8530367265006,81.2393188807366,1.3768337581794166 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441030,16.461294304618555,81.2393188807366,0.20262718264273683 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441046,69.37602409085106,81.2393188807366,0.8539710210113719 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441035,424.9896810752174,543.8205698619286,0.7814887935980772 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441034,250.6658403423309,543.8205698619286,0.46093482709926337 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441048,331.32880633456426,543.8205698619286,0.609261261336043 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441045,411.1311004161656,543.8205698619286,0.7560050560804428 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441030,193.33665815479193,543.8205698619286,0.3555155300651435 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441046,210.74983706059845,543.8205698619286,0.387535611450126 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441035,175208.48929065562,306516.0644612488,0.5716127459701424 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441034,175069.74511783512,306516.0644612488,0.5711600970263934 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441048,267674.3875697041,306516.0644612488,0.8732801265740665 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441045,210961.10718713744,306516.0644612488,0.6882546517029554 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441030,165931.43452965096,306516.0644612488,0.5413466169262681 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441046,220013.6933742516,306516.0644612488,0.7177884583666471 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441035,421890.24600584694,335923.8645439917,1.2559103134234078 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441034,572854.8416983265,335923.8645439917,1.705311536814935 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441048,199025.51121300264,335923.8645439917,0.5924720813841995 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441045,467155.66817714,335923.8645439917,1.3906593650656294 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441030,508668.7688255465,335923.8645439917,1.5142382620420605 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441046,462663.3251010688,335923.8645439917,1.3772862661279597 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441035,36.3301457032429,33.931355493730415,1.0706953840955666 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441034,113.28227068424718,33.931355493730415,3.338571920746834 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441048,29.318384162977296,33.931355493730415,0.8640498953363219 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441045,24.149283741165583,33.931355493730415,0.7117099623570213 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441030,198.3175048721183,33.931355493730415,5.844667918107838 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441046,117.00043061169342,33.931355493730415,3.448150800616023 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441035,13.734532884284784,76.3332642617619,0.17992854120827778 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441034,602.4374164242628,76.3332642617619,7.892200369663027 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441048,26.240594496946755,76.3332642617619,0.34376355774544837 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441045,4.24303837748483,76.3332642617619,0.05558570589795047 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441030,103.42969384588471,76.3332642617619,1.3549753812597845 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441046,30.07739301305014,76.3332642617619,0.3940273392463448 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441035,154.7903966046805,130.67426801703346,1.1845514725554345 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441034,163.9688190763048,130.67426801703346,1.2547904156228478 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441048,148.0786871807001,130.67426801703346,1.1331893373330237 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441045,151.09986028182797,130.67426801703346,1.1563092150792231 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441030,7.790504954590098,130.67426801703346,0.05961774320843796 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441046,203.89596311881488,130.67426801703346,1.560337518724321 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441035,8152.558161077373,5444.214081294075,1.4974720022654826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441034,6713.9916999135985,5444.214081294075,1.2332343290801857 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441048,5860.018486036961,5444.214081294075,1.0763754691740648 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441045,7167.398646524083,5444.214081294075,1.3165166798180743 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441030,5728.392363353121,5444.214081294075,1.052198219580575 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441046,6798.442416751766,5444.214081294075,1.248746341572188 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441035,45.14800407770005,100.67607722942154,0.4484481847143923 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441034,45.14265264549734,100.67607722942154,0.44839502976090206 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441048,41.149287828395714,100.67607722942154,0.4087295508606712 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441045,57.22971129372316,100.67607722942154,0.5684539253879309 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441030,31.010035315595413,100.67607722942154,0.30801791417567326 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441046,177.4030759207735,100.67607722942154,1.7621174841417966 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441035,560.4077818605178,599.1099853739104,0.9354005033162014 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441034,560.8290129837548,599.1099853739104,0.936103598129375 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441048,475.73318675987406,599.1099853739104,0.7940665293084113 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441045,604.3338288032936,599.1099853739104,1.0087193396152845 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441030,538.9587854939151,599.1099853739104,0.89959906970595 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441046,591.4433845465483,599.1099853739104,0.9872033499448731 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441035,127.79382589434952,114.30018844822946,1.1180543761940673 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441034,117.22905701485958,114.30018844822946,1.0256243546611186 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441048,118.34093426718648,114.30018844822946,1.0353520486170258 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441045,212.13294746273343,114.30018844822946,1.8559282389881258 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441030,155.0455654243998,114.30018844822946,1.356476901126242 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441046,239.33353396967,114.30018844822946,2.0939032316475354 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441035,1897.3377292179407,1759.6959467320276,1.07821907116484 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441034,2086.1507389844787,1759.6959467320276,1.1855177270020527 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441048,2735.2150072177333,1759.6959467320276,1.5543679647028597 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441045,2383.220755544249,1759.6959467320276,1.354336673884022 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441030,2046.199980505679,1759.6959467320276,1.1628145102599825 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441046,2032.1672401891497,1759.6959467320276,1.1548399846934552 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441035,159.21623267493845,38.77498679262034,4.106158269671945 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441034,192.61779710998024,38.77498679262034,4.967578664569379 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441048,117.09567719327048,38.77498679262034,3.019876649334053 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441045,148.53990900191863,38.77498679262034,3.830817784577267 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441030,237.23138251030045,38.77498679262034,6.1181550822720165 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441046,956.614517401433,38.77498679262034,24.670917942994528 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441035,1732.13515126971,2284.874121495706,0.7580877804050902 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441034,1047.7416885741366,2284.874121495706,0.45855554085766104 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441048,2525.5461033042075,2284.874121495706,1.1053327093796113 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441045,1489.740628599,2284.874121495706,0.6520011822899889 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441030,1301.6217589620221,2284.874121495706,0.5696689137999275 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441046,1064.819299946813,2284.874121495706,0.4660297431395344 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441035,322.7909467847196,306.4947439651267,1.0531695996112975 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441034,351.75762050771783,306.4947439651267,1.1476791280562422 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441048,339.5970341844849,306.4947439651267,1.1080027989749952 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441045,301.18158566053967,306.4947439651267,0.9826647653533935 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441030,345.00847021371055,306.4947439651267,1.125658684225156 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441046,250.52070554595363,306.4947439651267,0.8173735781076172 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441035,59243.4208152715,53872.22448470133,1.0997025161286127 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441034,45787.28734277464,53872.22448470133,0.8499238295938075 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441048,61052.29736840229,53872.22448470133,1.133279680807314 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441045,51141.88982613512,53872.22448470133,0.949318323409096 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441030,39246.05054350655,53872.22448470133,0.7285025060483936 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441046,38152.91836589825,53872.22448470133,0.7082113042637203 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441035,72.24393193832178,320.29657233769314,0.22555324713919822 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441034,75.7918895252246,320.29657233769314,0.23663034846753264 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441048,41.65139703619095,320.29657233769314,0.13004009606533443 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441045,87.5602626628048,320.29657233769314,0.2733724623518256 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441030,343.3130340142111,320.29657233769314,1.0718598438582458 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441046,169.20417057251964,320.29657233769314,0.5282734352652557 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441035,9792.34202272637,6299.521117687065,1.5544581627375718 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441034,4778.256455457122,6299.521117687065,0.758511062379216 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441048,10008.515766779734,6299.521117687065,1.5887740639012993 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441045,5832.143982418216,6299.521117687065,0.925807513533592 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441030,4467.437276071484,6299.521117687065,0.709170934204559 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441046,3205.6974382731187,6299.521117687065,0.5088795447121421 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441035,2675.695195007779,1965.7827420843205,1.3611347468493584 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441034,2597.2943976189217,1965.7827420843205,1.321252009194571 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441048,2305.370839213047,1965.7827420843205,1.1727495566314012 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441045,2104.121023192696,1965.7827420843205,1.0703731282947857 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441030,1336.062139048167,1965.7827420843205,0.6796591049688123 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441046,2262.972711870188,1965.7827420843205,1.151181492961301 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441035,4499.504559704384,6243.797224888628,0.7206359203608894 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441034,5401.1418749285385,6243.797224888628,0.8650412049575937 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441048,10056.114671521002,6243.797224888628,1.6105767547088101 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441045,6173.63289906253,6243.797224888628,0.988762555333089 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441030,5193.350584346725,6243.797224888628,0.8317615702901626 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441046,4018.6692400627257,6243.797224888628,0.6436258410256761 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441035,657.2928241350265,477.14850073021523,1.3775435176451845 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441034,593.029499475289,477.14850073021523,1.2428614960913271 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441048,546.5983292135116,477.14850073021523,1.1455518111804024 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441045,493.88116950925365,477.14850073021523,1.0350680527203402 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441030,405.5350629462992,477.14850073021523,0.8499137319423182 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441046,534.8288170453974,477.14850073021523,1.1208854606624767 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441035,87.75844149619273,205.1372392304115,0.4278035612910919 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441034,220.2920144556276,205.1372392304115,1.0738762756195337 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441048,626.6758485129108,205.1372392304115,3.0549102194410658 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441045,368.1740479772491,205.1372392304115,1.7947694400026197 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441030,304.8247316921889,205.1372392304115,1.4859551236809214 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441046,24.547093217070884,205.1372392304115,0.11966180937776699 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441035,42.907724215362464,44.32085041603382,0.9681159953519273 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441034,201.56326518569637,44.32085041603382,4.547820344006247 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441048,103.63559164216548,44.32085041603382,2.3383033193034928 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441045,14.31439190494487,44.32085041603382,0.3229719594858314 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441030,43.843623044114224,44.32085041603382,0.9892324409969591 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441046,4.139602862618397,44.32085041603382,0.09340079948287332 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441035,115.821032810534,73.02499011367847,1.586046538729203 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441034,44.11298629245723,73.02499011367847,0.6040806883203443 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441048,84.52982850614116,73.02499011367847,1.1575465929478803 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441045,42.04539835448605,73.02499011367847,0.5757672584280219 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441030,52.4244158960056,73.02499011367847,0.7178969256195198 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441046,25.3478370144925,73.02499011367847,0.34711181713319456 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441035,113.7696685158462,446.9213615105917,0.2545630580988686 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441034,90.25615838396654,446.9213615105917,0.2019508713544173 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441048,75.4235477194299,446.9213615105917,0.1687624584882198 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441045,75.48083755907317,446.9213615105917,0.16889064622901076 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441030,186.5643747667947,446.9213615105917,0.4174434046656624 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441046,314.77306418455714,446.9213615105917,0.70431420668868 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441035,2674.1719071428383,2631.000022355788,1.0164089260434115 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441034,2325.9443498432593,2631.000022355788,0.8840533371644053 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441048,3222.428019503935,2631.000022355788,1.224792091266721 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441045,3081.06060344773,2631.000022355788,1.1710606527053387 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441030,2718.089816250098,2631.000022355788,1.0331014037074504 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441046,2886.5080862310892,2631.000022355788,1.0971144286219048 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441035,45.61285006582327,48.89133349009634,0.9329434648180095 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441034,35.55939889148216,48.89133349009634,0.7273149728813438 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441048,39.8831127394417,48.89133349009634,0.8157501522743414 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441045,43.653521684100795,48.89133349009634,0.8928682972605657 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441030,11.897523369433236,48.89133349009634,0.24334626446307203 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441046,20.27095450294428,48.89133349009634,0.4146124283366184 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441035,168.30804919394953,307.70649021557807,0.5469759480082254 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441034,134.87263955736438,307.70649021557807,0.4383158751798608 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441048,44.77901116368467,307.70649021557807,0.14552507856533237 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441045,623.4854990606233,307.70649021557807,2.026234476314788 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441030,334.88413125823394,307.70649021557807,1.0883232622867829 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441046,133.7490835887588,307.70649021557807,0.4346644865860797 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441035,160.22778834159547,154.19153082843468,1.0391477889915834 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441034,174.1328804703915,154.19153082843468,1.1293284367488712 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441048,147.87862996839243,154.19153082843468,0.9590580570403282 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441045,157.62811375634206,154.19153082843468,1.0222877541291888 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441030,91.43605879668492,154.19153082843468,0.5930031195969102 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441046,111.31152769491844,154.19153082843468,0.7219042907017519 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441035,7294.549751094523,6593.957266089812,1.1062476532275374 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441034,7439.325721384393,6593.957266089812,1.128203508330572 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441048,7131.157882649356,6593.957266089812,1.0814686226921972 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441045,7322.290269157676,6593.957266089812,1.1104546137739475 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441030,7178.536376076845,6593.957266089812,1.0886537607687115 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441046,7002.298797499479,6593.957266089812,1.0619266268996936 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441035,162.14394525008862,127.96554716912783,1.2670906258525065 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441034,143.60045340338726,127.96554716912783,1.122180591418058 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441048,136.56570590954033,127.96554716912783,1.0672068297339905 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441045,220.4410505690612,127.96554716912783,1.7226593832925323 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441030,106.30387985973329,127.96554716912783,0.8307226609927668 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441046,182.9012895596989,127.96554716912783,1.4293010392708618 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441035,2254.578131640818,1681.9358703135756,1.3404661684398707 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441034,1489.1272324715471,1681.9358703135756,0.8853650479515122 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441048,1849.9826068732111,1681.9358703135756,1.0999126896130145 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441045,2067.626192441887,1681.9358703135756,1.2293133340787863 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441030,1549.1595591691812,1681.9358703135756,0.9210574472618627 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441046,1268.4747676159182,1681.9358703135756,0.7541754653103552 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441035,48.93765509470638,45.403354316773296,1.077842283485813 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441034,46.51951049387394,45.403354316773296,1.02458312153136 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441048,48.089445393460814,45.403354316773296,1.0591606306870416 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441045,47.475881008976835,45.403354316773296,1.0456469951040135 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441030,60.34285221056892,45.403354316773296,1.3290395196259002 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441046,38.24215940868045,45.403354316773296,0.8422760825526211 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441035,163.16744691346352,171.72890790902974,0.9501454874440738 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441034,185.83430705691953,171.72890790902974,1.0821375930216819 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441048,151.9297977864206,171.72890790902974,0.8847071796840555 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441045,160.42206896662074,171.72890790902974,0.9341587908519247 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441030,192.13624996239224,171.72890790902974,1.1188346347848024 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441046,166.88316286995277,171.72890790902974,0.9717825897917902 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441035,258.5067849185976,385.5886159476326,0.6704212059873308 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441034,270.7922532297065,385.5886159476326,0.7022828009696304 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441048,657.1129707539533,385.5886159476326,1.7041814606974726 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441045,43.44535578748209,385.5886159476326,0.1126728175849011 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441030,107.96538547361446,385.5886159476326,0.28000148606118963 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441046,140.32025820675702,385.5886159476326,0.3639118283144908 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441035,370.25684558331267,430.1288265554666,0.8608045374414512 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441034,379.45791900445033,430.1288265554666,0.8821959738044153 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441048,355.424753538034,430.1288265554666,0.8263216310897515 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441045,461.7657738220462,430.1288265554666,1.073552259958796 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441030,425.1476122000782,430.1288265554666,0.9884192501226232 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441046,326.3478748213018,430.1288265554666,0.758721235762649 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441035,31085.455150724538,54695.927744901994,0.5683321671716575 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441034,28281.84059158825,54695.927744901994,0.5170739716399507 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441048,49903.44958053671,54695.927744901994,0.9123796165097141 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441045,54897.04721584427,54695.927744901994,1.0036770465231029 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441030,54838.10753121792,54695.927744901994,1.0025994583541766 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441046,34081.94229744759,54695.927744901994,0.6231166323095094 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441035,229374.3260247395,97212.60478924697,2.3595121900294087 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441034,216240.5167537752,97212.60478924697,2.2244082156071836 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441048,57833.52665717097,97212.60478924697,0.5949179819073025 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441045,148820.9627984004,97212.60478924697,1.530881341170091 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441030,160000.96222512602,97212.60478924697,1.6458869975966768 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441046,128344.3337810622,97212.60478924697,1.3202437488359413 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441035,40633.56417404492,62941.57202670208,0.6455759344047953 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441034,37406.18557689053,62941.57202670208,0.59430014809642 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441048,66085.57177185865,62941.57202670208,1.0499510839008401 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441045,42366.91577361213,62941.57202670208,0.6731149923557447 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441030,60475.59150583848,62941.57202670208,0.9608211164503891 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441046,43754.18043872963,62941.57202670208,0.6951555073992676 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441035,36850.94763345456,14728.399701289269,2.502033376391107 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441034,30065.51670033567,14728.399701289269,2.04132949336674 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441048,11086.37993316536,14728.399701289269,0.7527212839148371 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441045,21984.579963803295,14728.399701289269,1.4926658978353804 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441030,22839.56910716883,14728.399701289269,1.5507162740273501 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441046,21427.007819543014,14728.399701289269,1.4548089578032959 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441035,1974.1139073060217,3575.9352491809864,0.5520552721859722 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441034,1495.3244947741844,3575.9352491809864,0.4181631910467802 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441048,3360.87879290004,3575.9352491809864,0.9398600809871482 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441045,3967.844207874753,3575.9352491809864,1.1095962122869891 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441030,3622.917216094283,3575.9352491809864,1.0131383718214857 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441046,1304.7477158905635,3575.9352491809864,0.3648689433594739 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441035,17462.870564479952,12966.336321671553,1.3467852546206922 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441034,15511.597230695892,12966.336321671553,1.1962976160637038 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441048,8842.943793516004,12966.336321671553,0.6819924745231363 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441045,17065.557865355364,12966.336321671553,1.3161433917792562 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441030,10769.412467438267,12966.336321671553,0.8305671085701045 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441046,10087.389529481285,12966.336321671553,0.777967598497466 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441035,69.80635644468674,103.34580193186551,0.6754638808716114 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441034,51.59800522866459,103.34580193186551,0.4992752899888711 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441048,80.6089825275102,103.34580193186551,0.7799928107447907 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441045,143.70600480800147,103.34580193186551,1.3905354849609168 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441030,88.05118361829285,103.34580193186551,0.8520054223038862 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441046,49.3515789561906,103.34580193186551,0.47753830376900486 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441035,393.2507163351136,211.8154700640626,1.8565722145609893 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441034,303.7584294355345,211.8154700640626,1.4340710305232387 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441048,363.9467318293201,211.8154700640626,1.7182254521789466 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441045,355.8174487081819,211.8154700640626,1.6798463709972016 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441030,177.15809498750028,211.8154700640626,0.8363793963392742 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441046,395.25754190681687,211.8154700640626,1.8660466196698149 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441035,72.2094542782413,76.10596635595309,0.9488014900239552 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441034,63.77887479161502,76.10596635595309,0.8380272644238774 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441048,80.6537574771642,76.10596635595309,1.0597560393614973 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441045,123.96908422089494,76.10596635595309,1.6289009936630015 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441030,48.33470317741226,76.10596635595309,0.6350974239174281 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441046,51.70404959535289,76.10596635595309,0.6793692015357814 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441035,2560.3271177137667,1382.686999693948,1.8517040503602653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441034,2299.265315028223,1382.686999693948,1.6628964585167545 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441048,2321.0600442444393,1382.686999693948,1.6786590491978273 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441045,2617.292765175743,1382.686999693948,1.8929032859606474 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441030,1628.6028797166225,1382.686999693948,1.177853614069639 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441046,2021.1611394167064,1382.686999693948,1.461763320161455 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441035,35.26863041380153,30.899530320120164,1.141396974271691 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441034,33.89675570268993,30.899530320120164,1.096999059581761 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441048,33.92627877266592,30.899530320120164,1.0979545132624522 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441045,30.14115194370808,30.899530320120164,0.975456637413085 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441030,30.145156231511976,30.899530320120164,0.975586227984929 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441046,33.99204468644979,30.899530320120164,1.1000828923382029 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441035,31.852588696657964,31.68183515511672,1.0053896354395262 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441034,35.18112609733708,31.68183515511672,1.1104510179125533 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441048,34.91233373061158,31.68183515511672,1.1019669018438512 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441045,33.221437100401936,31.68183515511672,1.0485957312051908 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441030,32.9778731713396,31.68183515511672,1.0409079212071328 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441046,32.4473135048762,31.68183515511672,1.0241614270767978 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441035,691.1661379153625,628.1906149122311,1.1002490669363632 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441034,1441.9606407142471,628.1906149122311,2.2954189484599565 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441048,472.8710308934937,628.1906149122311,0.7527508683961505 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441045,677.1436086283251,628.1906149122311,1.077926974001249 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441030,101.9618075636834,628.1906149122311,0.16231030063690013 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441046,1319.9365806342803,628.1906149122311,2.101172079463011 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441035,14658.832883260626,10551.186365326936,1.3893066026614924 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441034,11907.135529426196,10551.186365326936,1.1285115357790616 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441048,12851.483273416048,10551.186365326936,1.2180131056776984 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441045,13520.417719030593,10551.186365326936,1.2814120849444075 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441030,9495.74410531131,10551.186365326936,0.8999693282374392 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441046,12299.27336082186,10551.186365326936,1.165676819171676 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441035,191.90455844876865,102.14043933131707,1.8788303604831784 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441034,95.46228824420623,102.14043933131707,0.9346179521957151 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441048,175.57496718102982,102.14043933131707,1.718956451827177 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441045,170.14254570048766,102.14043933131707,1.6657706469089038 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441030,168.65657920033678,102.14043933131707,1.651222378760861 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441046,233.7810167366779,102.14043933131707,2.2888193771945016 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441035,2845.931008251767,2995.2816068385046,0.9501380443675959 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441034,2747.55188396984,2995.2816068385046,0.9172933448717895 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441048,5112.365703586692,2995.2816068385046,1.7068063623516028 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441045,5188.554206684368,2995.2816068385046,1.7322425360067712 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441030,5308.696591743658,2995.2816068385046,1.7723530834708208 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441046,4540.582555809175,2995.2816068385046,1.5159117411339906 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441035,43.466419010941735,35.73806763844074,1.216249838986487 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441034,41.38814752387811,35.73806763844074,1.1580969609940523 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441048,39.8121575962957,35.73806763844074,1.1139986078450634 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441045,34.69735519128585,35.73806763844074,0.9708794426804579 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441030,23.421614246238295,35.73806763844074,0.6553687928287828 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441046,37.8777949597164,35.73806763844074,1.059872496267093 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441035,272.2604542459182,271.6614200921023,1.0022050762806616 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441034,329.84386577824944,271.6614200921023,1.2141726479469237 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441048,221.12496710445,271.6614200921023,0.813972654009838 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441045,275.506413150822,271.6614200921023,1.014153622024858 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441030,270.5842059267185,271.6614200921023,0.9960347179035632 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441046,230.8848629774759,271.6614200921023,0.8498993449242747 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441035,179.81316459913657,166.02715311669658,1.0830346797113972 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441034,206.74667202367905,166.02715311669658,1.245258189052737 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441048,169.4555611831096,166.02715311669658,1.0206496829106217 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441045,169.92708466834736,166.02715311669658,1.0234897212801668 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441030,91.03157445077416,166.02715311669658,0.5482932926446689 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441046,163.5081489538067,166.02715311669658,0.9848277578962079 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441035,1516.5177149573367,1793.9624976146763,0.8453452716953441 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441034,2196.8350854350138,1793.9624976146763,1.224571354393424 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441048,1784.3037133709756,1793.9624976146763,0.994615949744466 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441045,1723.0651915139808,1793.9624976146763,0.9604800511744458 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441030,1864.673483369972,1793.9624976146763,1.039416089159788 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441046,1922.206458489239,1793.9624976146763,1.0714864224001788 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441035,84.88715335625464,59.13775760336051,1.4354137998534953 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441034,109.41033615851936,59.13775760336051,1.8500927426491074 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441048,54.6494146995723,59.13775760336051,0.9241036000402362 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441045,83.336544851227,59.13775760336051,1.409193520832643 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441030,29.067525040397825,59.13775760336051,0.4915222730519302 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441046,253.6874417864003,59.13775760336051,4.289771071265382 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441035,222.12313294778477,238.79765196261823,0.9301730193836089 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441034,268.8886991331854,238.79765196261823,1.1260106492809137 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441048,235.42951791126816,238.79765196261823,0.9858954473644602 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441045,288.6767748048978,238.79765196261823,1.2088761025593657 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441030,493.94008611174866,238.79765196261823,2.0684461595504753 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441046,474.1730193562116,238.79765196261823,1.9856686841729894 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441035,489.2112368888485,386.8144501381946,1.2647181011828055 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441034,874.04119800275,386.8144501381946,2.2595877627903693 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441048,334.2947829055153,386.8144501381946,0.864225167353712 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441045,466.83100209762785,386.8144501381946,1.206860296793065 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441030,415.1235863746518,386.8144501381946,1.0731853120439099 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441046,627.3025309710237,386.8144501381946,1.6217143148269448 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441035,5238.367846553664,5555.372966797932,0.9429372029314915 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441034,6982.712524860054,5555.372966797932,1.2569295646921843 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441048,7112.041087473166,5555.372966797932,1.2802094710793979 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441045,7502.304405423784,5555.372966797932,1.3504591771356884 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441030,7295.659960207448,5555.372966797932,1.313261954473707 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441046,6700.132330419412,5555.372966797932,1.2060634579286058 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441035,61.82589952046808,84.54153084580483,0.7313080198799835 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441034,74.49272964724244,84.54153084580483,0.8811376953075243 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441048,71.44263687883371,84.54153084580483,0.8450596548711405 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441045,100.7587419014046,84.54153084580483,1.1918253773423895 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441030,118.4831686883559,84.54153084580483,1.401478864919742 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441046,63.948042475751535,84.54153084580483,0.7564098004374474 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441035,155.9069760695769,122.00200397429413,1.27790504246493 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441034,179.3056464104718,122.00200397429413,1.4696942719748405 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441048,150.4791182730966,122.00200397429413,1.233415135580909 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441045,203.4282317451948,122.00200397429413,1.6674171334764076 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441030,289.45349867128914,122.00200397429413,2.372530690006347 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441046,39.81629522731918,122.00200397429413,0.3263577148758023 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441035,149.6922599143932,143.84455848940917,1.040652920669325 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441034,288.4582978934645,143.84455848940917,2.0053473063056657 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441048,117.10065323946148,143.84455848940917,0.8140777410643812 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441045,89.9286086129977,143.84455848940917,0.6251790791211533 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441030,60.25216132971614,143.84455848940917,0.41886993823372415 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441046,141.36775882010866,143.84455848940917,0.9827814156106374 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441035,4128.592962185014,5334.764851653101,0.7739034572265492 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441034,12449.228188490792,5334.764851653101,2.3336039234481176 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441048,609.9945442178858,5334.764851653101,0.11434328619542901 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441045,2039.4251908483504,5334.764851653101,0.382289613049465 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441030,3950.225103515595,5334.764851653101,0.7404684580036411 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441046,4007.907243366163,5334.764851653101,0.751280957046161 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441035,205.3314061481397,159.70733471984832,1.2856729874574837 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441034,175.01831622737762,159.70733471984832,1.0958689939594017 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441048,94.68779588887044,159.70733471984832,0.5928832013568298 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441045,202.45600233929557,159.70733471984832,1.2676687811141243 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441030,122.10693317316752,159.70733471984832,0.7645668458957268 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441046,152.85831925956393,159.70733471984832,0.957115210317055 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441035,90266.74080055348,82077.5827732141,1.0997733820934588 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441034,128210.48411598496,82077.5827732141,1.5620645709101737 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441048,70031.26555568397,82077.5827732141,0.8532325537556958 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441045,103021.92215120044,82077.5827732141,1.2551773416117402 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441030,69071.49848126531,82077.5827732141,0.841539140743393 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441046,29924.27883616605,82077.5827732141,0.36458528413109886 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441035,485092.867177472,170961.68742491837,2.8374361208297696 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441034,446820.22548506747,170961.68742491837,2.613569345361653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441048,687229.6182744508,170961.68742491837,4.0197872905077805 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441045,94658.60701968124,170961.68742491837,0.5536831581710532 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441030,240060.4990603217,170961.68742491837,1.4041771737059485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441046,58641.61645888288,170961.68742491837,0.3430102810878996 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441035,118054.11961844422,55195.40432138408,2.1388396564876166 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441034,100439.18160241823,55195.40432138408,1.8197018907153033 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441048,26368.980904564876,55195.40432138408,0.4777387035889304 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441045,101558.29695065173,55195.40432138408,1.8399774075267623 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441030,102704.602430249,55195.40432138408,1.8607455401945243 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441046,93493.1587223906,55195.40432138408,1.6938576657218 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441035,479.7220105393289,546.121028905539,0.8784170269010187 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441034,460.73130110435153,546.121028905539,0.8436432159144029 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441048,433.88817777485457,546.121028905539,0.7944908817087558 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441045,670.259551715814,546.121028905539,1.2273095453933653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441030,375.241982481579,546.121028905539,0.6871040714795172 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441046,453.7261304325629,546.121028905539,0.8308160763226032 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441035,1791.9939368680673,1228.731327313693,1.458409903803628 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441034,2780.4366568701057,1228.731327313693,2.262851605605938 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441048,1024.818700630112,1228.731327313693,0.8340462050972658 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441045,1189.2432023934564,1228.731327313693,0.9678626856478321 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441030,1790.2636513657903,1228.731327313693,1.457001715159118 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441046,1328.5471592154745,1228.731327313693,1.0812348718413514 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441035,113.51378762257691,76.68368758811918,1.4802859798850352 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441034,179.2648596948949,76.68368758811918,2.3377182988089493 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441048,74.55537804220718,76.68368758811918,0.9722456025153158 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441045,109.88022660003044,76.68368758811918,1.4329022254408965 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441030,429.7237366971855,76.68368758811918,5.603848096159681 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441046,173.86199439601543,76.68368758811918,2.2672617849295023 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441035,111.33999443973713,81.06808963980528,1.373413323718782 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441034,65.20111805386875,81.06808963980528,0.8042759900173387 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441048,96.48846646739476,81.06808963980528,1.1902151252867061 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441045,76.04759621521046,81.06808963980528,0.9380706582959899 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441030,52.48313950291576,81.06808963980528,0.64739578465589 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441046,115.44254170283884,81.06808963980528,1.424019515147861 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441035,56.38764755357842,34.254424530644805,1.6461420189129938 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441034,32.508313687555024,34.254424530644805,0.949025246606386 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441048,66.87687275330185,34.254424530644805,1.9523572113573897 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441045,56.481630671667375,34.254424530644805,1.648885697120312 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441030,48.76836202832546,34.254424530644805,1.4237098622017763 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441046,18.391729428341435,34.254424530644805,0.5369154402780221 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441035,37.50620636298373,60.87738129746832,0.6160942794124997 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441034,71.31007326938264,60.87738129746832,1.17137221985513 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441048,22.64730933931463,60.87738129746832,0.37201516978287724 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441045,36.7268888606983,60.87738129746832,0.6032928499542021 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441030,115.3222350971811,60.87738129746832,1.8943363304948362 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441046,14.64238933465528,60.87738129746832,0.24052265426969352 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441035,134.44235334644733,81.37032235510941,1.6522283488041931 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441034,119.93114184245708,81.37032235510941,1.4738929178511035 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441048,112.08217439224198,81.37032235510941,1.3774330879887944 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441045,127.59096548429268,81.37032235510941,1.5680282662205896 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441030,349.4815172731935,81.37032235510941,4.29495063013289 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441046,196.73204636306545,81.37032235510941,2.4177370897525052 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441035,693.5919654380523,592.3362991324378,1.1709428688633772 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441034,822.793919691042,592.3362991324378,1.3890655036609147 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441048,890.3196236193475,592.3362991324378,1.5030644330312852 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441045,775.7006338345518,592.3362991324378,1.3095611985466322 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441030,580.031301750063,592.3362991324378,0.9792263324054303 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441046,470.6638987800805,592.3362991324378,0.7945889851245582 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441035,1055.5515276425594,1509.2244087879828,0.6993999841880667 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441034,766.4343404349734,1509.2244087879828,0.5078332526111713 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441048,1199.5315607274747,1509.2244087879828,0.794800000412653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441045,1764.5445134248237,1509.2244087879828,1.1691730554781323 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441030,995.863431103906,1509.2244087879828,0.6598511296962504 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441046,993.8308419251724,1509.2244087879828,0.6585043523933535 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441035,1288508.72521641,911297.6405793307,1.4139274237528787 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441034,1264579.2614395774,911297.6405793307,1.387668754015053 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441048,921195.1430537744,911297.6405793307,1.0108608889496866 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441045,1076662.6975903178,911297.6405793307,1.181461083237153 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441030,1169098.7305952956,911297.6405793307,1.282894499597382 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441046,808629.6709796662,911297.6405793307,0.887338707983051 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441035,346.0550103189522,749.6106308195243,0.4616463482389808 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441034,312.39242941031995,749.6106308195243,0.41673959328563914 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441048,447.5821928342019,749.6106308195243,0.5970862397520633 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441045,289.3839616488596,749.6106308195243,0.3860457012629154 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441030,3093.7889570386455,749.6106308195243,4.12719461256347 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441046,1465.057954525758,749.6106308195243,1.9544252633184498 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441035,3349.6889499977888,2138.7943755926544,1.566157545682529 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441034,3330.0111119853123,2138.7943755926544,1.5569571109717244 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441048,2727.205840264773,2138.7943755926544,1.2751136207327418 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441045,3656.3864245384143,2138.7943755926544,1.7095549091881443 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441030,2753.822089038374,2138.7943755926544,1.287558131096776 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441046,3139.522592318546,2138.7943755926544,1.4678936077941538 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441035,597.5371398871797,613.8984432679271,0.9733485178857072 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441034,1044.1154643607963,613.8984432679271,1.700795100249354 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441048,385.8051016146859,613.8984432679271,0.6284510179907833 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441045,593.1183561614881,613.8984432679271,0.9661506111730441 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441030,694.4157664185706,613.8984432679271,1.1311573991327144 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441046,892.3005050530448,613.8984432679271,1.4534985628944057 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441035,6614.885770185593,6365.76448478505,1.0391345432266579 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441034,10324.993274446928,6365.76448478505,1.6219565299855054 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441048,7217.167544840926,6365.76448478505,1.1337471818335147 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441045,6529.511451312808,6365.76448478505,1.0257230638863775 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441030,8193.143009504232,6365.76448478505,1.2870634829621548 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441046,8507.13878466965,6365.76448478505,1.336389180750049 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441035,70.79984268140943,70.21289390855102,1.0083595581977134 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441034,72.73253864965969,70.21289390855102,1.0358857839471818 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441048,69.00449600950063,70.21289390855102,0.982789515831319 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441045,94.98292493271548,70.21289390855102,1.352784647452735 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441030,146.62474640689004,70.21289390855102,2.0882880372066968 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441046,88.38642201667557,70.21289390855102,1.2588346256144165 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441035,2197.862127499839,2003.7789126851078,1.0968585973163354 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441034,2635.1759198686714,2003.7789126851078,1.3151031299842744 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441048,2182.2968070687557,2003.7789126851078,1.089090614365449 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441045,1735.2736453943332,2003.7789126851078,0.8660005524606647 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441030,3222.3411529690584,2003.7789126851078,1.6081320811241846 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441046,778.3558142667785,2003.7789126851078,0.38844395923089364 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441035,666.4012778192277,700.7857837159185,0.9509343558392883 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441034,1458.7979683605815,700.7857837159185,2.081660333669016 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441048,461.08636656943673,700.7857837159185,0.657956221835045 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441045,580.5389522253361,700.7857837159185,0.828411428592382 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441030,734.1879229448508,700.7857837159185,1.047663836803049 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441046,995.478166111184,700.7857837159185,1.420517067045308 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441035,5206.38056106335,4688.560133729121,1.1104433797508686 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441034,9489.23944834128,4688.560133729121,2.0239133503005458 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441048,5202.686516249775,4688.560133729121,1.109655495046778 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441045,4866.204960746127,4688.560133729121,1.0378889940515093 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441030,7720.814076883539,4688.560133729121,1.6467345745105475 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441046,7582.859445680647,4688.560133729121,1.617310907698543 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441035,412.1627539303914,384.65137963543384,1.0715228795514327 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441034,496.23817884108513,384.65137963543384,1.2900985284685873 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441048,349.5890471770145,384.65137963543384,0.9088464663986106 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441045,395.1045124134337,384.65137963543384,1.0271756019383245 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441030,234.61179071372644,384.65137963543384,0.609933573970507 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441046,411.31896068181686,384.65137963543384,1.0693292224030448 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441035,553.1568076359102,772.5530415852671,0.7160114294558221 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441034,46.31469486054154,772.5530415852671,0.05995018123998903 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441048,399.5569605553289,772.5530415852671,0.5171903274569265 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441045,260.08927006799917,772.5530415852671,0.33666202327583866 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441030,60.9781028830579,772.5530415852671,0.07893063595728231 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441046,2576.491172479896,772.5530415852671,3.3350346627242256 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441035,256.21456145482216,216.68366112664066,1.1824359996625573 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441034,228.96895515594423,216.68366112664066,1.0566969099812442 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441048,202.23171446923897,216.68366112664066,0.9333039391052412 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441045,182.1184136726052,216.68366112664066,0.840480600732356 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441030,72.10438730529611,216.68366112664066,0.33276337925246124 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441046,242.8094365701587,216.68366112664066,1.1205710449402497 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441035,894.8830047484025,615.8359185894908,1.4531192120103038 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441034,802.055795944184,615.8359185894908,1.30238554091033 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441048,463.4277551433924,615.8359185894908,0.7525182295388458 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441045,846.4928846732661,615.8359185894908,1.374542892223746 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441030,701.0189048284323,615.8359185894908,1.138320912547687 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441046,985.1236972075563,615.8359185894908,1.599652874200455 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441035,76.28874236427286,101.73138829665541,0.7499036791064905 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441034,66.5831998726292,101.73138829665541,0.6545000612639652 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441048,52.79411931898199,101.73138829665541,0.5189560488944757 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441045,72.83931095156541,101.73138829665541,0.7159964311030652 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441030,44.69749897533188,101.73138829665541,0.4393678266238837 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441046,80.87417273430326,101.73138829665541,0.7949775785863539 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441035,55.68734967628501,93.53234569214308,0.5953806596444942 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441034,67.96707705266891,93.53234569214308,0.7266692238894452 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441048,258.3744029290229,93.53234569214308,2.762406962180217 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441045,156.04124245888318,93.53234569214308,1.6683131520349648 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441030,95.4910495872831,93.53234569214308,1.0209414602044409 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441046,134.78801185389125,93.53234569214308,1.441084481057912 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441035,40.33497344819325,42.30806113801961,0.9533637884423575 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441034,43.5546361504623,42.30806113801961,1.0294642434304906 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441048,34.261692887247975,42.30806113801961,0.8098147720709218 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441045,90.88773616975294,42.30806113801961,2.148236854278293 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441030,57.47226786417089,42.30806113801961,1.3584235797684463 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441046,68.18424984049624,42.30806113801961,1.6116136737644853 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441035,169.0890945289618,205.3077634331321,0.8235884104014091 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441034,469.8049481906492,205.3077634331321,2.2882960699324104 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441048,459.00931976606984,205.3077634331321,2.2357134094228606 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441045,243.4253314885728,205.3077634331321,1.1856606268464633 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441030,235.19188771010457,205.3077634331321,1.145557692399224 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441046,106.35943945297907,205.3077634331321,0.5180487950112024 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441035,974.824060602696,761.179367641068,1.2806758854009974 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441034,894.1015385088035,761.179367641068,1.1746266077595715 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441048,1535.8832351228125,761.179367641068,2.0177678224287523 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441045,660.2211281081927,761.179367641068,0.8673660324691278 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441030,1635.0058841631933,761.179367641068,2.147990281489311 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441046,456.9140174381992,761.179367641068,0.600271154030617 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441035,384797.0365662391,258075.7105503754,1.4910238384914887 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441034,529266.1268506263,258075.7105503754,2.05081728040933 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441048,524456.2447607816,258075.7105503754,2.032179795775123 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441045,369932.237807178,258075.7105503754,1.433425241834096 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441030,359273.56677104323,258075.7105503754,1.3921246831205154 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441046,378128.34545771405,258075.7105503754,1.4651837813458422 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441035,110.40011384324004,131.47736122215045,0.8396891511741151 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441034,106.21317980531016,131.47736122215045,0.8078438661835271 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441048,117.02289766845314,131.47736122215045,0.8900611982219938 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441045,109.3176285483098,131.47736122215045,0.8314559064172385 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441030,141.4068900883154,131.47736122215045,1.0755227270601175 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441046,128.34583235455526,131.47736122215045,0.9761819918008241 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441035,3632.6206436266775,3004.2024881525895,1.2091796934302284 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441034,3048.783510409035,3004.2024881525895,1.0148395530701595 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441048,2932.4857938616424,3004.2024881525895,0.9761278760091006 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441045,5455.118256961417,3004.2024881525895,1.815829085580712 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441030,4697.753233561291,3004.2024881525895,1.5637272294685227 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441046,5238.373295618848,3004.2024881525895,1.7436818311272166 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441035,84.22349245115747,96.13121274223809,0.876130551655377 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441034,92.66900281104267,96.13121274223809,0.9639845391269657 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441048,93.45047005978068,96.13121274223809,0.9721137120193685 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441045,82.2826516289055,96.13121274223809,0.8559410547491427 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441030,37.180314622373686,96.13121274223809,0.3867663120205017 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441046,136.61922037601136,96.13121274223809,1.421174418576576 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441035,630.6179238800819,490.807523353751,1.2848579002436402 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441034,627.7256071140392,490.807523353751,1.278964924630147 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441048,576.003797173506,490.807523353751,1.1735838791500137 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441045,572.739077065158,490.807523353751,1.1669321471512053 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441030,387.4050975020067,490.807523353751,0.7893218401682554 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441046,587.6527285085057,490.807523353751,1.1973180942561739 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441035,78.17716709475287,78.64120835950264,0.9940992607510755 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441034,83.29321724016575,78.64120835950264,1.0591548499534338 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441048,75.46394368530169,78.64120835950264,0.9595979672683014 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441045,77.75945820636142,78.64120835950264,0.9887876830540246 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441030,72.97073014684689,78.64120835950264,0.9278943148135064 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441046,52.81889124541915,78.64120835950264,0.6716439427527789 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441035,1641.9930987132032,1710.8868039225827,0.9597321663528963 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441034,1788.0318194004226,1710.8868039225827,1.0450906601774987 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441048,1718.3693032527283,1710.8868039225827,1.0043734625300693 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441045,1924.8409345588311,1710.8868039225827,1.125054521518146 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441030,1809.834033995529,1710.8868039225827,1.0578338846533202 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441046,2021.123416965272,1710.8868039225827,1.1813308819329273 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441035,165.39183683709354,158.21676846284709,1.0453496076550908 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441034,174.0996664930569,158.21676846284709,1.1003869449775767 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441048,147.33331868748525,158.21676846284709,0.931211780640574 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441045,178.40392950883717,158.21676846284709,1.12759179221089 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441030,163.0298706918654,158.21676846284709,1.0304209362621923 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441046,172.01152457477482,158.21676846284709,1.0871889638876493 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441035,782.5143937264205,1068.4447009417866,0.7323864239643557 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441034,990.5836290907454,1068.4447009417866,0.9271267181329926 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441048,897.1778363015942,1068.4447009417866,0.8397045120919893 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441045,1061.453091745017,1068.4447009417866,0.993456274161305 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441030,917.3826335887755,1068.4447009417866,0.8586149875423066 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441046,803.8042767233748,1068.4447009417866,0.7523124743984008 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441035,143.8399612019093,101.193417409009,1.421435947958247 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441034,126.63352519981608,101.193417409009,1.2514008167940596 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441048,131.84921427388278,101.193417409009,1.302942598933758 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441045,134.5476871230318,101.193417409009,1.329609084938892 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441030,86.01038340551476,101.193417409009,0.8499602603386084 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441046,165.5966390392988,101.193417409009,1.6364368679237444 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441035,8131.366139215268,8195.704907369402,0.9921496968373908 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441034,10347.383093174596,8195.704907369402,1.2625372936341879 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441048,9846.07976798744,8195.704907369402,1.2013707032245702 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441045,10011.287236100134,8195.704907369402,1.2215285139290704 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441030,8970.869272819076,8195.704907369402,1.0945817808487301 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441046,8160.852157680981,8195.704907369402,0.9957474372146949 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441035,65.84774469500863,54.484574340672744,1.2085575686667938 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441034,120.55083044198216,54.484574340672744,2.212568087404345 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441048,12.546468553051952,54.484574340672744,0.2302756092871962 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441045,78.44414670836906,54.484574340672744,1.4397496476321097 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441030,73.75927686833273,54.484574340672744,1.3537643959029964 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441046,38.116577153400875,54.484574340672744,0.699584746961065 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441035,191.90980175998052,181.8259570369428,1.055458774354142 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441034,19.14185454313598,181.8259570369428,0.10527569800854561 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441048,240.34817426149027,181.8259570369428,1.3218584308766053 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441045,109.69969334111434,181.8259570369428,0.6033225130712548 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441030,281.9079598545155,181.8259570369428,1.5504274771793907 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441046,83.89551196345212,181.8259570369428,0.4614055843875278 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441035,726.0521320944076,598.5025834222519,1.2131144496366657 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441034,655.9841312054037,598.5025834222519,1.0960422717884877 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441048,805.3867094766441,598.5025834222519,1.3456695623123696 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441045,630.06316680330406,598.5025834222519,1.0527325766926319 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441030,755.9135958340477,598.5025834222519,1.2630080751059016 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441046,717.8532490498112,598.5025834222519,1.1994154560622101 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441035,15359.262592707602,15066.853658787537,1.0194074317400383 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441034,21644.606622172847,15066.853658787537,1.4365711058425874 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441048,18770.362670534763,15066.853658787537,1.2458050695665452 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441045,15070.170071062814,15066.853658787537,1.0002201131271586 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441030,19108.39638798738,15066.853658787537,1.2682406573214886 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441046,27359.45015131577,15066.853658787537,1.8158701724270576 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441035,70.68655003053466,62.8704966822211,1.1243198918535637 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441034,67.48964780648609,62.8704966822211,1.0734708864733882 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441048,66.89568850241675,62.8704966822211,1.06402354097091 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441045,60.054629906384655,62.8704966822211,0.9552116346389111 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441030,74.07904333435985,62.8704966822211,1.1782799125763606 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441046,58.38947832994123,62.8704966822211,0.9287262135858544 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441035,100.7940559204493,100.49015468400951,1.0030241891595788 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441034,109.4351043989748,100.49015468400951,1.0890131948059252 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441048,98.95220096473632,100.49015468400951,0.9846954786356009 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441045,107.39077397316024,100.49015468400951,1.0686696056031526 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441030,103.67137679107124,100.49015468400951,1.03165705254475 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441046,102.49782867327887,100.49015468400951,1.019978812805916 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441035,118.2630456184436,109.95671552102958,1.0755418171419044 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441034,119.03322527764732,109.95671552102958,1.082546206601468 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441048,113.5195340377183,109.95671552102958,1.0324020092797999 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441045,103.59947217082284,109.95671552102958,0.9421841283628475 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441030,130.98428408482752,109.95671552102958,1.191234964268975 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441046,98.50490281664295,109.95671552102958,0.8958516298879768 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441035,250.3169687067776,243.54938966397899,1.0277872962528698 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441034,262.3939340292049,243.54938966397899,1.0773746318610176 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441048,241.13384419659175,243.54938966397899,0.9900819071206874 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441045,254.67614923830175,243.54938966397899,1.0456858446234423 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441030,254.0730535794117,243.54938966397899,1.0432095680057012 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441046,258.4817667865536,243.54938966397899,1.061311494736967 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441035,54.34794462101198,49.66723175069083,1.0942414687779745 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441034,83.80291100008357,49.66723175069083,1.6872877357195961 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441048,57.54480301045399,49.66723175069083,1.1586070127545127 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441045,46.94301700547582,49.66723175069083,0.9451506627369639 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441030,26.136386980824003,49.66723175069083,0.5262299922817919 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441046,69.89255294767001,49.66723175069083,1.407216599034591 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441035,242.1193994176882,318.9289567276793,0.7591640530289768 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441034,285.41955203945247,318.9289567276793,0.8949314448206747 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441048,361.0445389819501,318.9289567276793,1.1320531778813412 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441045,294.7912811510339,318.9289567276793,0.9243164502078888 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441030,318.2217027449954,318.9289567276793,0.9977824090043734 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441046,286.2141122476589,318.9289567276793,0.8974227840090597 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441035,51.711389134663506,52.85511393128503,0.9783611326974256 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441034,53.53968027240338,52.85511393128503,1.0129517522563347 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441048,49.35549016806134,52.85511393128503,0.9337883602375084 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441045,44.14927357369348,52.85511393128503,0.8352885896923864 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441030,59.241494445537754,52.85511393128503,1.1208280531294552 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441046,49.147164070374814,52.85511393128503,0.9298469043935694 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441035,158.94947731849155,145.91831693350866,1.0893044866390615 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441034,143.05534241971415,145.91831693350866,0.9803796084414879 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441048,169.73159516146336,145.91831693350866,1.1631959491336912 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441045,168.21801629457494,145.91831693350866,1.152823167301386 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441030,184.91959130256305,145.91831693350866,1.267281553054277 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441046,152.87443178687676,145.91831693350866,1.0476712930874732 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441035,265.9797475202032,261.347965154705,1.0177226647345674 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441034,298.0836100597341,261.347965154705,1.1405621998368476 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441048,180.16960286593095,261.347965154705,0.6893859026577058 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441045,279.8105272444835,261.347965154705,1.0706436037443399 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441030,189.36441589544236,261.347965154705,0.7245681663652827 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441046,319.23232511962306,261.347965154705,1.221483874690409 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441035,5892.313890566943,7540.877985370558,0.7813830036765136 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441034,6310.926175661476,7540.877985370558,0.8368954103096202 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441048,4350.2224003436795,7540.877985370558,0.576885398329371 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441045,6834.308790742053,7540.877985370558,0.9063014683437045 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441030,6645.0942672620095,7540.877985370558,0.881209625742999 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441046,7529.988298830536,7540.877985370558,0.9985559126455635 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441035,6361.7046780768505,5107.556668860965,1.245547546611083 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441034,7100.559002001444,5107.556668860965,1.390206602168731 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441048,6150.598693167728,5107.556668860965,1.204215457983234 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441045,7714.650790394804,5107.556668860965,1.5104386090179682 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441030,8050.800778347219,5107.556668860965,1.5762528544088825 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441046,6455.158708851411,5107.556668860965,1.2638447554006236 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441035,142235.50813668952,180330.65339424144,0.7887483656244079 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441034,208884.0317636338,180330.65339424144,1.1583390168668029 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441048,297997.2259802469,180330.65339424144,1.652504554113499 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441045,230831.2958716727,180330.65339424144,1.2800446930507485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441030,193286.2963830285,180330.65339424144,1.0718438199215263 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441046,155091.2116632712,180330.65339424144,0.8600379843587025 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441035,202.09763498150852,98.01831453553807,2.061835443091963 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441034,120.19580077629698,98.01831453553807,1.2262585961189745 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441048,156.37923747491288,98.01831453553807,1.5954083501223146 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441045,192.25948394236136,98.01831453553807,1.9614649043231067 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441030,186.36756590671283,98.01831453553807,1.9013545253233504 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441046,239.69202466605688,98.01831453553807,2.4453799864019574 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441035,1725.5598054722752,1812.4793707702274,0.9520438319466141 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441034,1141.5191279133169,1812.4793707702274,0.6298108250623671 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441048,2577.0333617051156,1812.4793707702274,1.4218276926429154 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441045,2046.931532232469,1812.4793707702274,1.1293543889344293 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441030,1199.8831791195637,1812.4793707702274,0.6620120474031458 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441046,1513.51368441184,1812.4793707702274,0.8350515370382727 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441035,331.63286743455905,434.5650550234931,0.7631374488144947 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441034,1007.5826555583692,434.5650550234931,2.3186002737930647 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441048,297.58765521776155,434.5650550234931,0.6847942598644376 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441045,427.8519935858945,434.5650550234931,0.9845522290391351 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441030,371.10230588084835,434.5650550234931,0.853962603736709 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441046,553.619885118512,434.5650550234931,1.2739631931255555 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441035,12952.98520192442,9833.502392298877,1.3172300860035964 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441034,16747.255566738328,9833.502392298877,1.7030814554795826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441048,12637.386706109311,9833.502392298877,1.285135875495012 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441045,11392.468449912243,9833.502392298877,1.158536195489643 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441030,11512.895268592682,9833.502392298877,1.1707827800610517 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441046,9207.418130502434,9833.502392298877,0.9363315086711361 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441035,47.99213390822168,42.4088060383901,1.131654917725751 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441034,47.84969940773726,42.4088060383901,1.1282963110166755 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441048,44.55855742388084,42.4088060383901,1.0506911555950127 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441045,39.372953933477866,42.4088060383901,0.9284145820525092 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441030,67.29139668753072,42.4088060383901,1.5867316949837242 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441046,33.36452432031699,42.4088060383901,0.7867357616744534 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441035,372.6115225526562,385.8715169071063,0.9656362447771902 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441034,462.38587483687496,385.8715169071063,1.1982897274799076 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441048,400.88850638586297,385.8715169071063,1.0389170716696663 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441045,370.13662134948584,385.8715169071063,0.9592224487473419 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441030,432.4635309082092,385.8715169071063,1.1207448903576869 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441046,436.3869375312632,385.8715169071063,1.1309125406017408 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441035,971.0051013429172,1002.6445024002205,0.9684440487315673 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441034,1075.6453741200985,1002.6445024002205,1.0728083299166573 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441048,1031.9149000880298,1002.6445024002205,1.0291931962103609 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441045,753.7159204267443,1002.6445024002205,0.7517279739952011 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441030,618.451737085415,1002.6445024002205,0.6168205536507801 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441046,852.1143146879208,1002.6445024002205,0.8498668397902277 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441035,9353.401739411323,6245.085755978491,1.4977219056531301 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441034,7763.506604735418,6245.085755978491,1.243138510516581 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441048,4679.114657978359,6245.085755978491,0.7492474628549319 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441045,9677.506439135914,6245.085755978491,1.5496194635712612 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441030,6659.009839350572,6245.085755978491,1.0662799678892843 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441046,8015.473073998004,6245.085755978491,1.2834848690948242 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441035,329.56383054031227,289.8012081128336,1.1372065447428954 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441034,310.4005550477832,289.8012081128336,1.0710809560425618 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441048,305.80221293600073,289.8012081128336,1.0552137271178565 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441045,251.2975454799422,289.8012081128336,0.8671376738433054 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441030,42.021323991301614,289.8012081128336,0.1450005135069716 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441046,440.13788798717275,289.8012081128336,1.5187579473989143 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441035,27344.381087389025,19122.271903916942,1.4299755397677352 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441034,19323.520025655427,19122.271903916942,1.0105242788487523 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441048,17534.356439270006,19122.271903916942,0.9169598951094471 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441045,16571.654307437646,19122.271903916942,0.8666153473135775 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441030,19219.282314832803,19122.271903916942,1.0050731634506247 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441046,10779.682370649203,19122.271903916942,0.5637239353573427 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441035,95.13361475139084,111.01681566749893,0.8569297739211049 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441034,110.76972032038314,111.01681566749893,0.9977742529757307 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441048,82.88736900643178,111.01681566749893,0.7466199467897162 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441045,78.00733692438658,111.01681566749893,0.7026623530440881 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441030,32.74665722580922,111.01681566749893,0.29497024418253126 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441046,152.87101141472203,111.01681566749893,1.3770077127106453 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441035,1475.8104238030417,1048.3386659324408,1.4077611288813694 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441034,1066.2556898854502,1048.3386659324408,1.017090873908646 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441048,801.6667632487397,1048.3386659324408,0.7647020846414172 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441045,1034.7643458779555,1048.3386659324408,0.987051588865692 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441030,1038.627127533799,1048.3386659324408,0.9907362585066879 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441046,668.4436202368038,1048.3386659324408,0.6376218315311867 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441035,3079.2631220885255,5453.602601951663,0.5646291720974608 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441034,2850.3784709033325,5453.602601951663,0.5226597313642319 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441048,6001.606137581447,5453.602601951663,1.1004846842770817 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441045,4832.103832593966,5453.602601951663,0.8860388600490833 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441030,3283.632569975935,5453.602601951663,0.6021033818637302 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441046,2393.4161670496096,5453.602601951663,0.43886882520429443 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441035,67712.44092315894,64173.361133824874,1.0551487365910879 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441034,77715.59275425221,64173.361133824874,1.2110257493321386 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441048,74793.36581222664,64173.361133824874,1.165489301024068 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441045,68416.77980373023,64173.361133824874,1.0661243013445452 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441030,85970.64340620367,64173.361133824874,1.3396624687761565 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441046,110264.4094370968,64173.361133824874,1.7182271193050846 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441035,36.54140472675689,44.60879663763593,0.8191524425908258 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441034,40.82791344523053,44.60879663763593,0.9152435511067897 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441048,69.79514058745433,44.60879663763593,1.5646048727655872 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441045,19.8601000233904,44.60879663763593,0.4452059127422115 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441030,26.477255538516676,44.60879663763593,0.5935433711336234 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441046,27.02492351194766,44.60879663763593,0.605820500639711 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441035,136.5847244393692,136.29080299882398,1.002156575748899 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441034,148.59989742039593,136.29080299882398,1.0903149306536712 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441048,136.878244241318,136.29080299882398,1.0043102045741052 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441045,135.59132995963196,136.29080299882398,0.9948677898742878 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441030,142.7285692646739,136.29080299882398,1.0472355149738568 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441046,138.35,136.29080299882398,1.0151088478156063 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441035,88.15690357573146,82.77341642135346,1.0650388420235508 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441034,66.63254415058721,82.77341642135346,0.8049993226254908 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441048,83.80103751767899,82.77341642135346,1.012414868695216 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441045,102.92140160499284,82.77341642135346,1.2434113034682195 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441030,4.054709916695966,82.77341642135346,0.04898565375211398 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441046,165.33989314484563,82.77341642135346,1.997499925618536 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441035,2652.6759261214083,2141.365658987758,1.2387776534043007 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441034,1820.8214442226792,2141.365658987758,0.8503085106368042 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441048,2657.8352145825347,2141.365658987758,1.2411869983190618 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441045,2385.3728053145237,2141.365658987758,1.1139493132817448 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441030,1693.5185646998946,2141.365658987758,0.7908591218841323 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441046,1960.1792089520973,2141.365658987758,0.9153874307850305 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441035,461.5556607992393,285.0677067828484,1.619108898753065 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441034,467.10081483127766,285.0677067828484,1.6385609583869625 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441048,483.7384059794932,285.0677067828484,1.696924605872608 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441045,317.8006743982076,285.0677067828484,1.114825239185348 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441030,715.5908555961488,285.0677067828484,2.5102487534347526 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441046,385.2145189462703,285.0677067828484,1.351308863756038 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441035,1012379.1910153496,724296.655045942,1.3977410829698427 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441034,1112236.589160736,724296.655045942,1.5356091753456833 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441048,598301.2248111475,724296.655045942,0.8260444399997917 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441045,973426.9774304164,724296.655045942,1.3439617187914144 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441030,921710.909346073,724296.655045942,1.2725599420138272 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441046,669740.559688957,724296.655045942,0.9246771402616452 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441035,76.20043903672608,126.94877083842833,0.6002455835803937 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441034,71.81397107483468,126.94877083842833,0.5656925277853582 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441048,121.11094260992364,126.94877083842833,0.954014298917989 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441045,14.5389065940988,126.94877083842833,0.11452577680017809 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441030,74.54016299286148,126.94877083842833,0.5871672683442605 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441046,148.83313115693684,126.94877083842833,1.1723873352532213 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441035,151199.74485897555,94593.87687362579,1.5984094304642285 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441034,101747.53996490204,94593.87687362579,1.075625012185866 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441048,288682.9510119483,94593.87687362579,3.051814351552785 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441045,84118.30944723822,94593.87687362579,0.8892574469658054 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441030,90595.19846415245,94593.87687362579,0.9577279360817884 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441046,60489.210755228625,94593.87687362579,0.6394622226557027 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441035,12.387901850005036,34.2642969985689,0.3615396472462994 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441034,1150.44206758141,34.2642969985689,33.5755339626393 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441048,274.9966739099446,34.2642969985689,8.02574977450815 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441045,2.7164671712347443,34.2642969985689,0.07927981628656212 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441030,15.292837669315416,34.2642969985689,0.44631990173194397 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441046,186.95483802258607,34.2642969985689,5.456257807664769 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441035,35.83890345670842,74.66086218948179,0.48002263040778814 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441034,176.48077938621913,74.66086218948179,2.363765622453282 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441048,143.08706463567242,74.66086218948179,1.9164936010587688 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441045,337.13139414374155,74.66086218948179,4.515503628770531 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441030,62.98874413069243,74.66086218948179,0.843664837017731 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441046,64.14539718144572,74.66086218948179,0.8591569304229454 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441035,344.7259944211939,347.6986105145094,0.9914505954196458 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441034,379.11144232734654,347.6986105145094,1.090345002432865 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441048,302.3741462379883,347.6986105145094,0.869644390555798 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441045,280.19954457458186,347.6986105145094,0.8058690374400825 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441030,618.0122476001894,347.6986105145094,1.7774366330819715 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441046,510.9220809509222,347.6986105145094,1.4694395246356655 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441035,3709.713605166107,2521.321340016667,1.4713370907103749 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441034,3213.402698974138,2521.321340016667,1.2744915326631456 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441048,2841.1800616760397,2521.321340016667,1.1268615454058937 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441045,2876.506034145151,2521.321340016667,1.1408724419578093 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441030,2800.133324464451,2521.321340016667,1.1105816938216773 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441046,3181.792197305418,2521.321340016667,1.2619542566059372 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441035,61.05394116630429,79.44971561377609,0.7684601599218048 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441034,70.27034197107652,79.44971561377609,0.884463102582737 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441048,55.06198770449758,79.44971561377609,0.6930419735190364 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441045,72.3634727485066,79.44971561377609,0.9108084552534158 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441030,94.39876672629258,79.44971561377609,1.188157389828648 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441046,75.8101754272381,79.44971561377609,0.9541906455118019 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441035,28.34130661421435,42.37178439720435,0.6688721520088798 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441034,24.18212408081467,42.37178439720435,0.5707129030518286 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441048,102.08927882503524,42.37178439720435,2.4093693545691455 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441045,220.2204000772703,42.37178439720435,5.197335991632211 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441030,51.0254243161259,42.37178439720435,1.204231189269728 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441046,37.37575858445864,42.37178439720435,0.8820907383575909 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441035,937.1324714619152,1321.2949146990686,0.7092530676055404 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441034,1496.8387164185444,1321.2949146990686,1.1328573960034174 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441048,899.1532965725315,1321.2949146990686,0.6805091630715298 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441045,1379.7017644253522,1321.2949146990686,1.0442042492380181 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441030,1157.456675631706,1321.2949146990686,0.8760017636905251 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441046,1177.1112505612366,1321.2949146990686,0.8908770006348882 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441035,20663.23640040976,23354.026662177774,0.8847825987059529 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441034,18394.4585962485,23354.026662177774,0.7876354198926485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441048,13911.823522147735,23354.026662177774,0.5956927138684037 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441045,35792.21476603987,23354.026662177774,1.5325928707620233 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441030,20486.359272052305,23354.026662177774,0.877208867164235 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441046,19260.236364587123,23354.026662177774,0.8247073039348451 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441035,8035.562951042854,13473.54115415771,0.5963957699838408 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441034,7465.774481391874,13473.54115415771,0.5541063329953211 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441048,11265.067840411642,13473.54115415771,0.8360881309168993 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441045,7460.8418344566435,13473.54115415771,0.553740234218556 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441030,12223.389424976507,13473.54115415771,0.9072143162010956 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441046,8524.767811066007,13473.54115415771,0.6327043286935302 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441035,67918.03002168836,49612.48263442616,1.3689705980276818 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441034,53108.28565110422,49612.48263442616,1.070462166597007 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441048,77562.70153588412,49612.48263442616,1.5633706965928624 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441045,61756.233291056335,49612.48263442616,1.2447720817785404 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441030,58792.50492660592,49612.48263442616,1.1850345276978689 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441046,43037.85670050569,49612.48263442616,0.8674804084615929 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441050,147.3953028679332,73.06854961986588,2.0172194964146293 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441037,223.66247728967232,73.06854961986588,3.060995167596196 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441044,8.281885166035893,73.06854961986588,0.1133440475980683 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441032,12.843248176582778,73.06854961986588,0.17576985232906492 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441033,144.95235017917318,73.06854961986588,1.9837857865426076 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441039,117.3437826791792,73.06854961986588,1.605941041524051 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441050,37.86228219545058,990.9231863649335,0.03820909906684412 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441037,394.37865558231266,990.9231863649335,0.3979911470525147 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441044,834.9147385943279,990.9231863649335,0.8425625215785885 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441032,14.847822575079316,990.9231863649335,0.014983827989277885 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441033,1216.8656881441834,990.9231863649335,1.2280121253475653 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441039,329.1034000014754,990.9231863649335,0.33211797294676926 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441050,61.39857351232314,50.719124328797626,1.2105605986864774 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441037,55.648393087454224,50.719124328797626,1.0971875761636094 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441044,52.97590999171443,50.719124328797626,1.04449575367837 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441032,62.22132012411963,50.719124328797626,1.226782223619567 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441033,44.64541199765587,50.719124328797626,0.8802480837057121 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441039,46.4980079060671,50.719124328797626,0.9167746588965884 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441050,338.6989595091602,319.2477137201226,1.0609283792901023 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441037,314.6630888630084,319.2477137201226,0.985639286798046 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441044,328.3709100932317,319.2477137201226,1.0285771705826756 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441032,356.5258295788567,319.2477137201226,1.116768622786176 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441033,329.6634330599908,319.2477137201226,1.0326258228085525 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441039,352.03594924486345,319.2477137201226,1.1027046839041283 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441050,113.1587858333092,44.58166891160943,2.538235750161469 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441037,244.84797962098656,44.58166891160943,5.492122336344976 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441044,109.46270056457438,44.58166891160943,2.4553298078993495 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441032,158.3321714998695,44.58166891160943,3.551508397179777 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441033,66.10014388238811,44.58166891160943,1.4826754021578383 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441039,173.77824171685612,44.58166891160943,3.897975243174507 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441050,2750.621744920518,1543.2839395802719,1.7823173522226938 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441037,4014.525869636877,1543.2839395802719,2.6012879203088906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441044,2862.876089996977,1543.2839395802719,1.855054676960868 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441032,3256.564889902595,1543.2839395802719,2.1101527764153922 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441033,3549.205729654787,1543.2839395802719,2.299774940067132 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441039,3886.6149761518063,1543.2839395802719,2.5184056390872906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441050,41.935142856341024,31.276034215973343,1.3408075514549682 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441037,45.59302102150741,31.276034215973343,1.4577622184024237 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441044,31.36900131260839,31.276034215973343,1.0029724707420726 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441032,35.6167860277559,31.276034215973343,1.1387884340389178 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441033,22.825731281120415,31.276034215973343,0.7298153955037824 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441039,25.93115198704961,31.276034215973343,0.829106139479986 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441050,27.507425707748887,130.468422036268,0.21083588870341582 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441037,40.857311771350815,130.468422036268,0.3131586259240046 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441044,27.147312644905934,130.468422036268,0.20807573373853974 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441032,110.54432900384046,130.468422036268,0.847288004856156 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441033,35.141700324723125,130.468422036268,0.2693502364499689 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441039,244.5682703379705,130.468422036268,1.8745399577990194 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441050,107.32919675019184,95.42663227533711,1.124730006614002 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441037,103.2236519966838,95.42663227533711,1.081706956804781 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441044,100.71615199675642,95.42663227533711,1.055430225245268 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441032,117.28829527490686,95.42663227533711,1.2290939382256694 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441033,109.22974349165668,95.42663227533711,1.144646320290263 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441039,74.17355222117293,95.42663227533711,0.7772835575623995 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441050,513.2635766718319,569.3868516791151,0.9014320846331868 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441037,576.2627482518532,569.3868516791151,1.0120759665462262 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441044,530.8826080334022,569.3868516791151,0.9323759522508039 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441032,547.3724378148044,569.3868516791151,0.9613366311508765 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441033,586.6445042684813,569.3868516791151,1.0303091870465109 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441039,563.8742718452818,569.3868516791151,0.9903183928157512 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441050,15674.69226810824,5328.634617598269,2.9415963737392006 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441037,32820.5869881372,5328.634617598269,6.159286448304115 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441044,1017.7722405546928,5328.634617598269,0.19100056836199902 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441032,41192.83136008959,5328.634617598269,7.730466492119157 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441033,359.92251816500436,5328.634617598269,0.06754497990467007 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441039,15705.821579999189,5328.634617598269,2.9474382664800056 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441050,1016708.5128168308,656386.6079991342,1.5489476787408372 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441037,541568.967082591,656386.6079991342,0.8250761982080314 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441044,910355.915283047,656386.6079991342,1.3869203060953488 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441032,929504.0021890814,656386.6079991342,1.416092270716022 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441033,1008657.6502939388,656386.6079991342,1.53668225098107 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441039,787182.971824114,656386.6079991342,1.19926726449171 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441050,15366.421944188927,5223.837669019135,2.9415963737392006 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441037,32175.112562930117,5223.837669019135,6.1592864483041145 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441044,997.7559638134752,5223.837669019135,0.19100056836199908 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441032,40382.702060622265,5223.837669019135,7.730466492119156 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441033,2801.1082992296765,5223.837669019135,0.5362165665755905 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441039,15396.939043546712,5223.837669019135,2.947438266480005 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441050,1016708.5128168308,656386.6079991342,1.5489476787408372 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441037,541568.967082591,656386.6079991342,0.8250761982080314 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441044,910355.915283047,656386.6079991342,1.3869203060953488 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441032,929504.0021890814,656386.6079991342,1.416092270716022 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441033,1008657.6502939388,656386.6079991342,1.53668225098107 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441039,787182.971824114,656386.6079991342,1.19926726449171 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441050,52.26115864769955,50.79723336807032,1.02881899628316 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441037,54.28566863476224,50.79723336807032,1.068673725622322 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441044,47.31739213225873,50.79723336807032,0.9314954574278268 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441032,55.38267740403639,50.79723336807032,1.0902695625712628 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441033,63.71631138936341,50.79723336807032,1.2543264104106435 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441039,41.66114641235176,50.79723336807032,0.820145973511596 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441050,69.30517686401627,124.85055234194422,0.5551050881553274 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441037,205.5877170339212,124.85055234194422,1.6466704646275954 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441044,75.08691049206521,124.85055234194422,0.6014143236340281 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441032,99.03181381990709,124.85055234194422,0.7932028490244557 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441033,233.51687114545197,124.85055234194422,1.8703711498679587 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441039,162.27564389132337,124.85055234194422,1.299759118781295 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441050,256.4597693429416,149.81706398084205,1.7118194852339155 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441037,291.67940468069577,149.81706398084205,1.9469037566908562 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441044,262.825114038362,149.81706398084205,1.754306933100564 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441032,241.89352888629196,149.81706398084205,1.614592640243065 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441033,231.89419680980853,149.81706398084205,1.5478490276612427 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441039,285.0074620481385,149.81706398084205,1.9023698267413918 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441050,3479.299123579356,2791.14294318225,1.2465499597854786 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441037,3576.9469053607936,2791.14294318225,1.2815348329249772 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441044,3879.481567109269,2791.14294318225,1.3899257924376234 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441032,3549.2779472654574,2791.14294318225,1.271621704626435 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441033,3388.6624802873503,2791.14294318225,1.2140770104822556 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441039,3357.855237301618,2791.14294318225,1.203039509496868 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441050,528.855719098169,222.01180748199775,2.382106272167764 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441037,775.1367357749525,222.01180748199775,3.4914212201880566 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441044,726.2201181801955,222.01180748199775,3.271087814728424 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441032,798.3005453403362,222.01180748199775,3.5957571554164653 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441033,607.3235660315661,222.01180748199775,2.7355462437772013 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441039,774.7138584014158,222.01180748199775,3.489516468461863 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441050,11434.640497626777,4330.453784028004,2.6405178459128504 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441037,17689.617455436553,4330.453784028004,4.084933897847173 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441044,14811.084173926973,4330.453784028004,3.420215273640522 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441032,16627.419401966054,4330.453784028004,3.839648275035956 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441033,16353.761672481773,4330.453784028004,3.776454498325162 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441039,16582.487496109447,4330.453784028004,3.8292724788498083 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441050,230.64479545476027,100.4664893584531,2.2957385783815503 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441037,296.28772612683713,100.4664893584531,2.949119930623991 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441044,356.4822818403688,100.4664893584531,3.5482705140465316 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441032,325.1247913636782,100.4664893584531,3.236151610749228 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441033,416.4529022890995,100.4664893584531,4.145192142658061 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441039,238.2627962297059,100.4664893584531,2.371564864575004 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441050,966.6801733316944,219.8603821991507,4.396791107440495 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441037,597.3665590598391,219.8603821991507,2.7170268380537124 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441044,518.5794715974098,219.8603821991507,2.3586762945207553 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441032,76.04164266677877,219.8603821991507,0.34586332428868355 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441033,622.6260908548393,219.8603821991507,2.8319158032339873 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441039,36.786345867306224,219.8603821991507,0.16731684671586242 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441050,86.68729810157977,115.26780159034894,0.7520512832339631 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441037,44.126767202061906,115.26780159034894,0.3828195436474475 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441044,57.822293671071314,115.26780159034894,0.5016343928946123 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441032,104.2271521200482,115.26780159034894,0.9042174022756313 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441033,85.87193166246608,115.26780159034894,0.7449776128085357 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441039,90.92191089850002,115.26780159034894,0.7887884530116055 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441050,1084.8578137978811,1760.6737631139824,0.6161606065391512 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441037,1112.6603336026894,1760.6737631139824,0.6319514477428253 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441044,1100.630425585706,1760.6737631139824,0.6251188883732196 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441032,757.4844700691881,1760.6737631139824,0.4302242050392558 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441033,983.638714156611,1760.6737631139824,0.5586717623467716 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441039,853.0748072315105,1760.6737631139824,0.4845161125833646 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441050,1139.2384360978488,518.6000624505415,2.196757228903144 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441037,3515.4417857887606,518.6000624505415,6.778714543876527 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441044,2255.104583632467,518.6000624505415,4.348446417411557 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441032,2168.3551803635414,518.6000624505415,4.1811703032147935 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441033,2652.3867239001784,518.6000624505415,5.114512928068023 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441039,2286.32587598167,518.6000624505415,4.40864944207313 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441050,1162.5428288271294,841.89306662726494,1.3808675649087239 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441037,8305.804094172954,841.89306662726494,9.865628336205576 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441044,1992.144336155562,841.89306662726494,2.366267659307798 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441032,2418.6360127950634,841.89306662726494,2.8728541767001827 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441033,3077.470095624022,841.89306662726494,3.6554168428453444 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441039,3609.9519126557952,841.89306662726494,4.287898375405015 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441050,682.4520003924624,246.94010350613598,2.7636337342650577 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441037,756.9771836451337,246.94010350613598,3.0654283079067564 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441044,811.7650798772166,246.94010350613598,3.2872954548552937 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441032,873.0397797765628,246.94010350613598,3.5354313348899584 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441033,752.1131286927202,246.94010350613598,3.0457310012184053 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441039,809.6009259851411,246.94010350613598,3.278531573001564 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441050,2043.84807369059,6405.278640912654,0.31908808160754315 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441037,2949.9847860705663,6405.278640912654,0.46055526253425233 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441044,2251.2043227492995,6405.278640912654,0.3514607949090779 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441032,1717.643118125331,6405.278640912654,0.26816056168956814 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441033,2530.71644026497,6405.278640912654,0.39509857137212406 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441039,1771.43751574005,6405.278640912654,0.2765590093809951 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441050,124.88258158103052,184.84349394551683,0.6756125353150922 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441037,86.39339549802172,184.84349394551683,0.4673867262187028 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441044,115.0416704045929,184.84349394551683,0.6223733816593068 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441032,222.53821659674992,184.84349394551683,1.2039277761236418 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441033,184.25203159816877,184.84349394551683,0.9968001992673737 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441039,145.15136756616778,184.84349394551683,0.7852663053910438 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441050,24893.71437806113,66689.05961878091,0.3732803329416057 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441037,26371.197519719462,66689.05961878091,0.3954351383940167 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441044,24853.47031118189,66689.05961878091,0.372676874636611 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441032,15366.000772384166,66689.05961878091,0.230412617305175 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441033,23747.1388129142,66689.05961878091,0.3560874744472563 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441039,14806.01132637667,66689.05961878091,0.22201559612645994 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441050,704.3107960405964,426.591426110135,1.6510195773572847 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441037,1605.7864572761864,426.591426110135,3.7642258118465173 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441044,499.1785455839638,426.591426110135,1.170156067447752 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441032,4371.034005699572,426.591426110135,10.246417855972293 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441033,1350.5992311997247,426.591426110135,3.16602526102115 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441039,1405.6827486865627,426.591426110135,3.2951500256445647 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441050,158913.72051274186,6086.038398766024,26.111192552607363 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441037,258848.8977123894,6086.038398766024,42.53159128356343 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441044,159452.31275619043,6086.038398766024,26.199688912334206 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441032,140115.3340502546,6086.038398766024,23.0224203118179 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441033,176988.432189364,6086.038398766024,29.08105742895893 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441039,127940.45087732072,6086.038398766024,21.021959194878118 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441050,218.35673243926215,118.38689307733607,1.8444333385505853 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441037,513.7977558020012,118.38689307733607,4.339988510944059 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441044,324.12179659946395,118.38689307733607,2.737818251448932 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441032,352.91441755750043,118.38689307733607,2.9810260948985254 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441033,374.56887895784183,118.38689307733607,3.1639387538716406 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441039,340.9252494638537,118.38689307733607,2.879755018498076 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441050,171.1531027374988,43.003791743375764,3.979953762190353 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441037,664.9460516631659,43.003791743375764,15.462498182281639 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441044,283.4761377905301,43.003791743375764,6.5918870475926425 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441032,64.35765441983216,43.003791743375764,1.496557671097589 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441033,346.12284607631284,43.003791743375764,8.048658782039356 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441039,536.9996420443633,43.003791743375764,12.487262640673585 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441050,72.05860587579237,56.77751951238643,1.2691397316163533 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441037,82.69935026751477,56.77751951238643,1.4565509549862128 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441044,71.60738431835506,56.77751951238643,1.2611925447488666 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441032,98.91248592739638,56.77751951238643,1.7421065023070954 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441033,137.81080394444726,56.77751951238643,2.4272071962281276 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441039,20.41184954763306,56.77751951238643,0.3595058347552515 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441050,170.60684659749188,232.93832449773902,0.7324120964867156 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441037,115.62700250888696,232.93832449773902,0.4963846235187 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441044,163.98377451452367,232.93832449773902,0.7039793682216314 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441032,91.41848698813575,232.93832449773902,0.3924579056935008 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441033,278.9328130928777,232.93832449773902,1.1974535048893817 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441039,164.1014626063204,232.93832449773902,0.7044846010640607 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441050,96.84914640803406,55.88566907011774,1.732987150722324 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441037,75.03637219076323,55.88566907011774,1.3426764578342578 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441044,75.38555831037169,55.88566907011774,1.3489246807761779 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441032,103.05576861948248,55.88566907011774,1.8440464314774885 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441033,46.54839179592,55.88566907011774,0.8329217949867863 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441039,20.35477201150376,55.88566907011774,0.3642216752556967 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441050,967.391792336474,226.42114305345407,4.272532941449243 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441037,1296.1110752474422,226.42114305345407,5.724337655787971 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441044,1442.6637933956886,226.42114305345407,6.371594869367393 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441032,1026.862108150821,226.42114305345407,4.535186486133042 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441033,2343.249791536069,226.42114305345407,10.349076768784215 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441039,1043.361259055092,226.42114305345407,4.608055789245674 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441050,162.3782621071047,212.71806341276286,0.7633496634088018 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441037,298.71572144117334,212.71806341276286,1.4042799969532382 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441044,155.99553361968557,212.71806341276286,0.7333440852034666 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441032,425.6176158670091,212.71806341276286,2.000853190549837 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441033,183.8255904302006,212.71806341276286,0.8641748024637727 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441039,230.19941588728017,212.71806341276286,1.0821808557019255 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441050,8437.237101923836,10996.969545575432,0.7672329242121536 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441037,10368.99680750093,10996.969545575432,0.9428958373057272 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441044,11154.524680329629,10996.969545575432,1.014327141136586 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441032,10335.827779225036,10996.969545575432,0.9398796401490079 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441033,9668.256698765052,10996.969545575432,0.8791746361300982 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441039,10042.647112378336,10996.969545575432,0.9132195074977668 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441050,142.73403755227147,147.8550055811589,0.9653649329709267 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441037,111.96843891755728,147.8550055811589,0.7572854126747628 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441044,114.29417675725956,147.8550055811589,0.7730152679512936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441032,172.58725445025317,147.8550055811589,1.1672736663319696 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441033,356.0018125333658,147.8550055811589,2.4077765317045916 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441039,123.81938636542196,147.8550055811589,0.8374379066757832 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441050,152.52003034624155,92.19915296117537,1.6542454615658673 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441037,369.559747214175,92.19915296117537,4.008277032325827 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441044,233.09790936580328,92.19915296117537,2.5282001176730953 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441032,222.47040085715332,92.19915296117537,2.4129332397536727 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441033,154.9364475423162,92.19915296117537,1.6804541318026989 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441039,176.1236886662181,92.19915296117537,1.910252784430492 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441050,10609.961776272325,1229.7970051816276,8.627409020812625 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441037,14962.4468349029,1229.7970051816276,12.166598854819222 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441044,12807.414653111786,1229.7970051816276,10.414250969183545 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441032,9168.854262980458,1229.7970051816276,7.455583502275904 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441033,11288.496215724806,1229.7970051816276,9.17915409466916 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441039,13590.41241089338,1229.7970051816276,11.050939588917135 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441050,130982.41249631294,50083.06853493704,2.615303261718918 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441037,232370.8707989221,50083.06853493704,4.639709139163955 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441044,220607.40928514017,50083.06853493704,4.404830129991904 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441032,169568.4059513524,50083.06853493704,3.385743144573192 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441033,164637.16148138518,50083.06853493704,3.2872818359070246 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441039,176126.14042970064,50083.06853493704,3.5166802989884345 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441050,96.87783838293456,35.678906774941794,2.7152692484113423 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441037,156.93289005003652,35.678906774941794,4.398478099117502 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441044,56.79205133499004,35.678906774941794,1.5917542455330091 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441032,114.2746013192341,35.678906774941794,3.2028616246586363 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441033,55.74469219284553,35.678906774941794,1.5623991100533507 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441039,21.415462599920236,35.678906774941794,0.6002275443865579 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441050,135.31054485798492,67.70693010562654,1.9984740800815075 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441037,30.82169237133914,67.70693010562654,0.4552221216241174 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441044,132.87485515722102,67.70693010562654,1.9625000712619658 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441032,21.17060039828217,67.70693010562654,0.31267996297062745 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441033,382.31872836150006,67.70693010562654,5.646670551523482 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441039,132.6813239897359,67.70693010562654,1.9596417055498707 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441050,91.63886224118146,64.01321127549492,1.4315617107036462 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441037,104.31230434275771,64.01321127549492,1.6295433749421941 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441044,76.85672240448474,64.01321127549492,1.2006384443629134 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441032,54.179831993031506,64.01321127549492,0.8463851588363016 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441033,75.83931117355863,64.01321127549492,1.1847446747698296 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441039,53.24201825882858,64.01321127549492,0.8317348434480165 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441050,686.8416816417487,1060.427767412219,0.6477024675785893 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441037,510.4965512563578,1060.427767412219,0.4814062465585296 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441044,781.5668693629214,1060.427767412219,0.7370298038028493 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441032,536.6174799055212,1060.427767412219,0.5060386915508998 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441033,1040.863561528811,1060.427767412219,0.9815506473098579 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441039,606.9964451799132,1060.427767412219,0.5724071585386504 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441050,252.0377067611739,57.09593719876665,4.4142844329494295 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441037,11.58032631643923,57.09593719876665,0.20282224768681756 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441044,151.42602069503005,57.09593719876665,2.6521330259957807 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441032,19.00668566978835,57.09593719876665,0.3328903351497823 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441033,3.5879857681314444,57.09593719876665,0.06284134991322902 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441039,44.74050071032636,57.09593719876665,0.783602177411895 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441050,35.60599607417441,50.205845180981015,0.7092002125613589 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441037,219.7859110184362,50.205845180981015,4.377695669222506 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441044,11.117434085710208,50.205845180981015,0.22143704673498288 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441032,29.65854111547168,50.205845180981015,0.5907388075742809 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441033,5.452798431070132,50.205845180981015,0.10860883650925494 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441039,28.645171653248003,50.205845180981015,0.5705545151164862 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441050,9961.482056979848,1506.8779059558976,6.610676298064586 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441037,25321.14157686211,1506.8779059558976,16.8037114863659 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441044,9148.59200190789,1506.8779059558976,6.071223133439216 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441032,4587.308423035299,1506.8779059558976,3.0442469193450084 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441033,8991.630296059675,1506.8779059558976,5.967059614133619 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441039,13943.455457801036,1506.8779059558976,9.253208506601545 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441050,35411.76910343617,16162.128318216166,2.1910337800946635 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441037,43436.15027939377,16162.128318216166,2.687526631652673 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441044,34445.55041686361,16162.128318216166,2.1312508933641117 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441032,28245.646585530205,16162.128318216166,1.74764400018374 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441033,51311.88936927253,16162.128318216166,3.174822545582653 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441039,39905.56202980222,16162.128318216166,2.4690784062656572 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441050,20.98670306315514,24.995311385825953,0.8396255897438442 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441037,32.97680578320234,24.995311385825953,1.3193196625628931 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441044,24.05722279399783,24.995311385825953,0.9624694176700642 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441032,27.272458223345975,24.995311385825953,1.091102959365864 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441033,17.842772707162876,24.995311385825953,0.713844785997783 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441039,326.0160793369161,24.995311385825953,13.043089334017637 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441050,2595.8693954915343,522.7489803443298,4.965804799431 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441037,635.8661024574726,522.7489803443298,1.2163889866196078 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441044,1520.694944820969,522.7489803443298,2.909034741338571 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441032,418.178855917964,522.7489803443298,0.7999611125831628 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441033,1082.0299794484022,522.7489803443298,2.0698844381019725 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441039,772.1944163693079,522.7489803443298,1.47718014841592 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441050,4.444401424781231,2.8430683750443606,1.5632411319379136 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441037,4.138605758073972,2.8430683750443606,1.455682808898114 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441044,4.37125134362455,2.8430683750443606,1.5375118593679074 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441032,4.221288504409538,2.8430683750443606,1.4847650311412832 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441033,2.06827413431083,2.8430683750443606,0.727479561330831 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441039,6.544862370774724,2.8430683750443606,2.3020418461348484 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441050,2869.1206258205666,1771.7543971110147,1.6193670130007263 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441037,1365.0718463048152,1771.7543971110147,0.770463360232475 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441044,2278.645077943976,1771.7543971110147,1.2860953423677044 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441032,1268.7306363592645,1771.7543971110147,0.7160871949453208 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441033,1718.5094056042603,1771.7543971110147,0.9699478711081093 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441039,1369.7488958655708,1771.7543971110147,0.773103144600095 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441050,349.02436667855255,73.62821549612136,4.740361617170238 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441037,205.9905012665491,73.62821549612136,2.797711446332696 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441044,160.48002970447627,73.62821549612136,2.17959960896961 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441032,237.1043784559806,73.62821549612136,3.2202923411673745 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441033,16.224397546494167,73.62821549612136,0.22035570789229367 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441039,15.089903648934731,73.62821549612136,0.2049472956427913 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441050,852.3367547135546,1923.334023596175,0.4431558659373625 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441037,489.3422324961087,1923.334023596175,0.2544239463830394 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441044,863.4248463311444,1923.334023596175,0.44892090283763936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441032,568.1147190094201,1923.334023596175,0.29538016384027843 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441033,841.2007577341078,1923.334023596175,0.43736592157885473 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441039,362.8461854523155,1923.334023596175,0.18865479474744581 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441050,106.23223046379024,51.40813337414527,2.0664479235345605 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441037,6.282507059441994,51.40813337414527,0.12220842592588005 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441044,36.27527882841013,51.40813337414527,0.705633067133577 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441032,15.074356108814609,51.40813337414527,0.2932290110419758 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441033,74.63188083713617,51.40813337414527,1.451752396726212 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441039,14.626080260444828,51.40813337414527,0.2845090708506591 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441050,25.169967649438902,89.1451395839603,0.28234817699435943 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441037,22.943607086279354,89.1451395839603,0.25737361782545853 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441044,85.8998460990527,89.1451395839603,0.9635953962262737 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441032,24.598878104677855,89.1451395839603,0.2759418877964703 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441033,12.453244609901947,89.1451395839603,0.1396962825794109 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441039,17.692892156627664,89.1451395839603,0.19847287512477135 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441050,11183.682308571912,4771.656231796832,2.343773684710842 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441037,20250.534893262964,4771.656231796832,4.243921588131119 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441044,11628.94561467944,4771.656231796832,2.437087889355433 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441032,14723.896176257666,4771.656231796832,3.0856992752625816 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441033,20311.654319474965,4771.656231796832,4.256730437562627 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441039,5825.9169899974195,4771.656231796832,1.2209423116391582 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441050,904792.5050058936,209884.98459768714,4.310896783494173 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441037,521313.0803188435,209884.98459768714,2.4838035999483696 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441044,868012.22561401,209884.98459768714,4.135656618208482 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441032,694306.1474002522,209884.98459768714,3.308031533228143 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441033,618706.9705822503,209884.98459768714,2.947838177982115 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441039,821144.343064975,209884.98459768714,3.9123539239310774 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441050,183.44644528838592,22.903585106474594,8.009507875538995 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441037,126.0102418726816,22.903585106474594,5.5017693206929374 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441044,46.688994667182975,22.903585106474594,2.038501590477401 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441032,22.40367422915608,22.903585106474594,0.978173247769093 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441033,17.5414397983718,22.903585106474594,0.7658818353906099 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441039,7.999889090886118,22.903585106474594,0.34928545263530103 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441050,123.82050152784956,83.56495705722055,1.4817275792179763 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441037,79.49366005364725,83.56495705722055,0.951279852860027 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441044,93.30851921660692,83.56495705722055,1.116598661717908 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441032,8.52356049165382,83.56495705722055,0.10199922062806024 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441033,50.37598492763431,83.56495705722055,0.6028362450200231 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441039,33.59987815325886,83.56495705722055,0.4020809599680828 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441050,1808.9950965681096,1829.6496491832456,0.9887111980021114 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441037,2634.9310332926243,1829.6496491832456,1.4401287341917377 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441044,2411.155962425532,1829.6496491832456,1.317823859612615 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441032,4437.889507276332,1829.6496491832456,2.4255405996756823 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441033,4459.252278289135,1829.6496491832456,2.4372164803681087 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441039,2120.105421434192,1829.6496491832456,1.158749393568657 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441050,257275.494715017,96234.19538703516,2.6734311403582183 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441037,218988.35508525537,96234.19538703516,2.275577347579277 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441044,205191.0649531429,96234.19538703516,2.13220533644932 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441032,208536.0751201461,96234.19538703516,2.166964396402492 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441033,232649.2722134639,96234.19538703516,2.417532263638657 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441039,163171.94623184926,96234.19538703516,1.6955713670759498 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441050,251.1753302886653,77.99112650544876,3.2205629222590755 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441037,305.81179991589244,77.99112650544876,3.921110177765252 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441044,231.75925903059087,77.99112650544876,2.9716106102711475 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441032,484.73802864279594,77.99112650544876,6.215297180108435 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441033,338.63451307235033,77.99112650544876,4.341962069860499 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441039,262.6386004772125,77.99112650544876,3.3675446457215044 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441050,376.1641466340496,110.33780757772625,3.4092044684598695 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441037,228.849190891018,110.33780757772625,2.074077742842658 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441044,290.3222777892885,110.33780757772625,2.631213037152058 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441032,381.96046674000416,110.33780757772625,3.46173696147566 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441033,279.6558908377197,110.33780757772625,2.5345427553535465 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441039,264.8511870611336,110.33780757772625,2.4003665912480825 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441050,68.19722545061053,67.31067174214355,1.0131710720680849 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441037,59.95425345167145,67.31067174214355,0.8907094803829417 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441044,59.962459732520266,67.31067174214355,0.8908313968730974 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441032,68.27672349130093,67.31067174214355,1.014352133534756 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441033,56.77630217932883,67.31067174214355,0.8434962942700941 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441039,57.30770357658388,67.31067174214355,0.8513910512752058 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441050,5094.385123584896,2375.529574917848,2.1445260784686604 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441037,4751.041102178439,2375.529574917848,1.9999924026804603 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441044,4882.671296447295,2375.529574917848,2.055403286913888 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441032,6185.688313951675,2375.529574917848,2.603919723527581 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441033,5178.503049330106,2375.529574917848,2.17993625674359 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441039,6321.878699353756,2375.529574917848,2.6612502601961427 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441050,267.1428712686593,194.62377093849457,1.3726117317554307 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441037,266.5727362106861,194.62377093849457,1.3696823102606979 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441044,223.37610628721708,194.62377093849457,1.147732906469112 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441032,192.67606929774112,194.62377093849457,0.9899924781471378 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441033,224.97673208541715,194.62377093849457,1.155957111510879 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441039,295.6464444212921,194.62377093849457,1.5190664685801556 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441050,3402.589616045753,3728.1507253933823,0.9126749068565951 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441037,4044.9952415394737,3728.1507253933823,1.084987045718936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441044,3896.7712869599186,3728.1507253933823,1.0452290086927063 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441032,3111.270052879249,3728.1507253933823,0.8345344064786859 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441033,4265.245627551879,3728.1507253933823,1.144064696338645 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441039,4043.51,3728.1507253933823,1.0845886601254144 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441050,155.65829238394036,68.78582331086372,2.2629414738626297 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441037,109.48394771368466,68.78582331086372,1.5916644221716143 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441044,88.59400983077309,68.78582331086372,1.2879690256870264 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441032,123.4683664939854,68.78582331086372,1.7949682151218123 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441033,83.94044178973549,68.78582331086372,1.2203160149786028 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441039,49.83424465530907,68.78582331086372,0.7244842360916901 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441050,839.5176348913327,696.3940975413478,1.2055208937802449 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441037,998.5255795082552,696.3940975413478,1.43385129631856 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441044,550.1443276680784,696.3940975413478,0.7899899347372255 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441032,548.2370179912701,696.3940975413478,0.7872510980877735 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441033,645.9047685901315,696.3940975413478,0.9274989131449114 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441039,337.79245923317256,696.3940975413478,0.48505933698428055 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441050,335.07515942962755,81.2393188807366,4.124544174496769 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441037,91.95152678410832,81.2393188807366,1.1318598931029662 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441044,91.43192759292874,81.2393188807366,1.1254639853290178 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441032,107.01072953873074,81.2393188807366,1.3172282955231058 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441033,28.542126327911145,81.2393188807366,0.3513338949802425 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441039,21.35588547986204,81.2393188807366,0.2628762251344518 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441050,430.5834020760022,543.8205698619286,0.7917747616375079 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441037,513.0087659403412,543.8205698619286,0.9433419667641291 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441044,270.73091210569237,543.8205698619286,0.49783131994148117 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441032,213.04513857671137,543.8205698619286,0.39175630784028953 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441033,242.0142358700492,543.8205698619286,0.4450258950879599 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441039,104.55483514611332,543.8205698619286,0.19225980211204388 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441050,769566.6195697172,306516.0644612488,2.5106893530110863 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441037,1141397.6185151266,306516.0644612488,3.7237774813575144 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441044,657254.6638137723,306516.0644612488,2.1442747706192917 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441032,1761151.2241094178,306516.0644612488,5.74570610909064 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441033,1400189.964027714,306516.0644612488,4.568080196673452 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441039,526512.0299154981,306516.0644612488,1.7177306215285242 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441050,862300.6505935999,335923.8645439917,2.5669526389979813 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441037,1550124.0705891522,335923.8645439917,4.614510114348104 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441044,978430.5264619316,335923.8645439917,2.912655603644376 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441032,1028556.3883510462,335923.8645439917,3.061873528239162 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441033,1418530.7944551834,335923.8645439917,4.222774694440967 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441039,805089.2662336235,335923.8645439917,2.3966420704480527 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441050,30.697130207471204,33.931355493730415,0.9046832866179836 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441037,59.32622333661624,33.931355493730415,1.7484189026158445 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441044,78.60506208685277,33.931355493730415,2.3165906856086793 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441032,72.24446677872785,33.931355493730415,2.1291358900199744 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441033,72.48864440221504,33.931355493730415,2.1363321136878533 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441039,29.110916805489996,33.931355493730415,0.8579355696788741 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441050,129.0307023436409,76.3332642617619,1.6903600755388772 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441037,118.90638360334626,76.3332642617619,1.557726958925701 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441044,13.98744724803,76.3332642617619,0.18324183281438444 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441032,12.665849974952756,76.3332642617619,0.16592831575391623 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441033,12.880027232741048,76.3332642617619,0.168734133897024 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441039,155.50061787220645,76.3332642617619,2.0371278416571315 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441050,192.5107230610265,130.67426801703346,1.473210647990258 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441037,199.19507738892617,130.67426801703346,1.5243634451655088 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441044,197.66330879517648,130.67426801703346,1.5126414082488755 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441032,228.40888065555365,130.67426801703346,1.7479254647577627 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441033,166.68112887652953,130.67426801703346,1.2755466811170701 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441039,240.48491886158956,130.67426801703346,1.8403387484844547 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441050,7430.634949327334,5444.214081294075,1.3648682506550316 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441037,9491.25782768182,5444.214081294075,1.7433660186679827 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441044,6792.660275426495,5444.214081294075,1.2476842706765672 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441032,6750.925638774279,5444.214081294075,1.2400184008138053 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441033,8603.637132339494,5444.214081294075,1.5803267476018197 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441039,7196.267613742749,5444.214081294075,1.3218193675499652 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441050,137.32913016687905,100.67607722942154,1.3640691408141798 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441037,193.56740220630667,100.67607722942154,1.9226752524852906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441044,148.2436239501252,100.67607722942154,1.4724811298746405 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441032,133.55741714687824,100.67607722942154,1.3266052951440133 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441033,78.27252916988259,100.67607722942154,0.777469000818481 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441039,130.849717609278,100.67607722942154,1.2997101318429054 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441050,510.70572340028286,599.1099853739104,0.8524406801224427 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441037,820.2439280751386,599.1099853739104,1.369104084558391 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441044,880.5568484498212,599.1099853739104,1.469774949419775 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441032,565.8603987674284,599.1099853739104,0.9445016984890836 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441033,686.8160746600854,599.1099853739104,1.1463939701012273 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441039,832.147718049741,599.1099853739104,1.3889732075328196 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441050,87.55332850992936,114.30018844822946,0.7659946120699994 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441037,117.60231224169064,114.30018844822946,1.028889924315014 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441044,115.87326561629996,114.30018844822946,1.0137626821917534 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441032,114.74902170675324,114.30018844822946,1.0039267936878955 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441033,121.83018599535204,114.30018844822946,1.06587913501589 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441039,114.62745581198236,114.30018844822946,1.0028632268082491 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441050,4444.618872876266,1759.6959467320276,2.5257879812307755 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441037,3968.942866182222,1759.6959467320276,2.25547082355508 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441044,4883.052671934663,1759.6959467320276,2.7749411374181396 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441032,3457.9683803731145,1759.6959467320276,1.9650942464208025 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441033,4111.531225788664,1759.6959467320276,2.3365009355305304 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441039,4102.709706818713,1759.6959467320276,2.331487842793496 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441050,56.74454417595447,38.77498679262034,1.4634316828898084 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441037,62.282436833392,38.77498679262034,1.6062529477184915 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441044,34.044630846395435,38.77498679262034,0.8780049630571328 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441032,89.86690148556124,38.77498679262034,2.3176513757746715 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441033,100.46718892835918,38.77498679262034,2.5910309000409537 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441039,38.50915139074196,38.77498679262034,0.9931441523552248 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441050,1657.627441914184,2284.874121495706,0.7254786713716558 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441037,1489.9794581408953,2284.874121495706,0.6521057086355099 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441044,1740.390015495244,2284.874121495706,0.761700611478747 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441032,911.0145642619806,2284.874121495706,0.3987154284305254 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441033,1364.0029520200917,2284.874121495706,0.5969707211385453 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441039,500.0061926034442,2284.874121495706,0.21883314616742836 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441050,475.66175936040895,306.4947439651267,1.5519409997273241 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441037,427.16403520370994,306.4947439651267,1.3937075385942446 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441044,459.8559963949025,306.4947439651267,1.5003715575860752 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441032,498.2741191757544,306.4947439651267,1.6257183165021862 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441033,531.1287957639744,306.4947439651267,1.7329132268069392 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441039,450.9922671649275,306.4947439651267,1.4714518798281313 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441050,32008.06362115779,53872.22448470133,0.5941477993032841 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441037,27046.989319867032,53872.22448470133,0.5020581492332445 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441044,30753.553731322325,53872.22448470133,0.5708610332223378 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441032,19376.49279893251,53872.22448470133,0.35967500849041534 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441033,25618.8117516319,53872.22448470133,0.4755476870814412 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441039,18151.39666897515,53872.22448470133,0.3369342335980538 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441050,62.61807989385346,320.29657233769314,0.1955003122163741 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441037,33.090104986507654,320.29657233769314,0.10331083078722521 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441044,290.85819990354446,320.29657233769314,0.9080902670319201 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441032,116.64635297036943,320.29657233769314,0.3641823330141278 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441033,580.6639117556849,320.29657233769314,1.81289455431163 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441039,171.95377126236727,320.29657233769314,0.5368579813619548 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441050,11891.828172080432,6299.521117687065,1.8877352658905984 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441037,9444.7929284525,6299.521117687065,1.4992874461416608 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441044,10615.170829801278,6299.521117687065,1.6850758385422713 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441032,3302.7085102323326,6299.521117687065,0.5242792981452782 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441033,5951.051016592773,6299.521117687065,0.9446830807319784 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441039,2027.4950704666935,6299.521117687065,0.32184907909493754 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441050,2056.32884535019,1965.7827420843205,1.0460610937960841 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441037,2151.546961828658,1965.7827420843205,1.094498855731825 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441044,2302.495284854294,1965.7827420843205,1.1712867528854978 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441032,3586.0754383482804,1965.7827420843205,1.824248103097071 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441033,4775.011928009243,1965.7827420843205,2.429063917280246 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441039,1691.8737114136154,1965.7827420843205,0.8606615956042634 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441050,10994.805523146326,6243.797224888628,1.760916494744501 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441037,8979.88306795252,6243.797224888628,1.4382086324260308 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441044,9680.366366916622,6243.797224888628,1.5503973012335122 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441032,3975.997347229181,6243.797224888628,0.6367915555265492 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441033,5983.146994549849,6243.797224888628,0.9582545331069062 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441039,3167.2429544068896,6243.797224888628,0.5072623021423288 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441050,469.5406698988064,477.14850073021523,0.9840556329533342 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441037,508.026879483631,477.14850073021523,1.064714399618065 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441044,567.4020741454522,477.14850073021523,1.1891519585142054 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441032,898.4463450614988,477.14850073021523,1.882949110573628 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441033,1197.343280881577,477.14850073021523,2.5093724051300486 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441039,428.1240293307503,477.14850073021523,0.8972553171089521 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441050,354.58081080988933,205.1372392304115,1.728505327165985 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441037,451.89751691535656,205.1372392304115,2.2029033763478814 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441044,320.1782901397596,205.1372392304115,1.56080042483234 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441032,180.8359956597956,205.1372392304115,0.8815366548668397 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441033,276.22689289361585,205.1372392304115,1.346546799254503 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441039,108.6512484114234,205.1372392304115,0.5296515094920703 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441050,2.355574635266922,44.32085041603382,0.05314822737279321 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441037,65.93446550312362,44.32085041603382,1.487662463247111 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441044,13.958261168128846,44.32085041603382,0.31493667285497773 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441032,14.713903608216013,44.32085041603382,0.3319860397555235 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441033,18.857774461154047,44.32085041603382,0.4254831368112 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441039,12.771810918340313,44.32085041603382,0.2881670996484285 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441050,28.117272794922545,73.02499011367847,0.38503631087319845 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441037,113.22154050840274,73.02499011367847,1.5504492411727826 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441044,7.289665435964287,73.02499011367847,0.09982425775910984 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441032,11.303463272475096,73.02499011367847,0.15478897367707853 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441033,7.766823155699272,73.02499011367847,0.10635842803413748 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441039,14.049878387045842,73.02499011367847,0.1923982237474364 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441050,76.66498876166168,446.9213615105917,0.17154022019116394 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441037,139.75277521295038,446.9213615105917,0.3127010414999784 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441044,84.14459872914348,446.9213615105917,0.18827607265120472 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441032,111.91722092068323,446.9213615105917,0.25041815084068403 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441033,212.3155142223967,446.9213615105917,0.47506235438102906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441039,164.77296805579,446.9213615105917,0.36868447616569117 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441050,2715.5831249907096,2631.000022355788,1.032148651431476 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441037,2697.09265820791,2631.000022355788,1.0251207279705543 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441044,2633.161204133292,2631.000022355788,1.0008214297830256 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441032,1981.4935817841672,2631.000022355788,0.753133243993645 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441033,2552.9314218896548,2631.000022355788,0.9703274041038468 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441039,2040.0278827118225,2631.000022355788,0.7753811727014691 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441050,49.55198360284861,48.89133349009634,1.013512622086409 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441037,70.68783683628395,48.89133349009634,1.44581527625142 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441044,73.65144440395368,48.89133349009634,1.5064314909486536 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441032,37.30375813308093,48.89133349009634,0.762993264248711 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441033,126.37064528648706,48.89133349009634,2.584724863601548 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441039,79.14297266015313,48.89133349009634,1.618752588864951 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441050,156.90193593061898,307.70649021557807,0.5099077884925145 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441037,187.44946208115965,307.70649021557807,0.6091826725846219 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441044,355.0487488031801,307.70649021557807,1.1538552487288591 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441032,196.8019485005036,307.70649021557807,0.6395768524824578 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441033,363.170309481113,307.70649021557807,1.1802491043548584 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441039,220.44645494110017,307.70649021557807,0.7164179565619697 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441050,331.0067023060828,154.19153082843468,2.1467242755011378 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441037,337.29755615582263,154.19153082843468,2.187523233887118 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441044,533.7623328034997,154.19153082843468,3.4616838547209485 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441032,389.93532769107185,154.19153082843468,2.5289023696440487 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441033,396.90731865460384,154.19153082843468,2.574118802259207 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441039,296.8006543561577,154.19153082843468,1.9248829865137072 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441050,8193.966394169156,6593.957266089812,1.2426477854667903 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441037,9051.416511931971,6593.957266089812,1.3726835262460568 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441044,8143.263868293639,6593.957266089812,1.2349585445709992 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441032,8196.561148446626,6593.957266089812,1.2430412903338621 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441033,8729.710523951137,6593.957266089812,1.3238955261121699 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441039,7959.625868670571,6593.957266089812,1.2071091072433648 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441050,198.7487011103328,127.96554716912783,1.5531422754567932 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441037,204.7963923703447,127.96554716912783,1.6004025841398708 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441044,205.94424434032004,127.96554716912783,1.60937259204722 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441032,252.6345721504885,127.96554716912783,1.9742389865030605 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441033,242.026209946682,127.96554716912783,1.8913388431559939 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441039,216.65439994482952,127.96554716912783,1.693068210449525 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441050,1591.6736694618494,1681.9358703135756,0.9463343386362894 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441037,2051.3966492645063,1681.9358703135756,1.219664010662933 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441044,1233.5642372645716,1681.9358703135756,0.7334193051216568 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441032,1234.6063763608706,1681.9358703135756,0.7340389120369339 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441033,1316.9545383869893,1681.9358703135756,0.7829992579571181 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441039,744.6294025477216,1681.9358703135756,0.4427216374241991 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441050,51.75204467812213,45.403354316773296,1.139828663694203 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441037,49.26486705068256,45.403354316773296,1.085049062828442 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441044,45.16309804173672,45.403354316773296,0.9947084025254975 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441032,53.203110443817565,45.403354316773296,1.171788103421311 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441033,35.00324361724045,45.403354316773296,0.7709395956304764 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441039,37.65927648773037,45.403354316773296,0.829438200204031 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441050,148.8504342448166,171.72890790902974,0.8667756410799945 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441037,179.56311445963547,171.72890790902974,1.045619614344463 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441044,174.53088618265713,171.72890790902974,1.0163162877336394 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441032,156.28633987341067,171.72890790902974,0.910075896809409 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441033,150.20609189515656,171.72890790902974,0.8746698137434468 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441039,130.1159195886581,171.72890790902974,0.7576821000782503 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441050,145.16038860322442,385.5886159476326,0.37646440428868594 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441037,765.8909571365494,385.5886159476326,1.9862903764787658 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441044,732.6973664920326,385.5886159476326,1.9002048716903546 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441032,111.4941079611248,385.5886159476326,0.2891530075054575 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441033,241.1649943447698,385.5886159476326,0.6254463549243445 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441039,121.56974179324294,385.5886159476326,0.3152835347445878 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441050,356.52932568774185,430.1288265554666,0.8288896341658378 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441037,327.95267507537363,430.1288265554666,0.7624522115889458 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441044,402.7841225955869,430.1288265554666,0.9364267115532339 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441032,201.77578131889737,430.1288265554666,0.4691054606470968 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441033,293.34225244352695,430.1288265554666,0.6819869637491024 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441039,486.8483561488776,430.1288265554666,1.1318663760520984 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441050,180131.14926757364,54695.927744901994,3.29331920481709 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441037,234975.36250297487,54695.927744901994,4.29603029313048 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441044,184484.80651930385,54695.927744901994,3.372916670866763 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441032,244366.15162266413,54695.927744901994,4.467721121074513 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441033,351164.2878104089,54695.927744901994,6.420300418857776 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441039,139371.7581947042,54695.927744901994,2.5481194659449673 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441050,444607.48119744833,97212.60478924697,4.573557947154482 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441037,537259.431426035,97212.60478924697,5.526643716530299 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441044,384873.6198391694,97212.60478924697,3.9590917317107177 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441032,309069.78149353235,97212.60478924697,3.1793179718163427 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441033,390893.5272412111,97212.60478924697,4.0210169050469595 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441039,180293.3011522996,97212.60478924697,1.854628847186723 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441050,210760.07584093115,62941.57202670208,3.348503525643102 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441037,378760.9422331194,62941.57202670208,6.017659394850122 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441044,192033.84318529896,62941.57202670208,3.050985811155643 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441032,346907.93059624586,62941.57202670208,5.511586689462968 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441033,427245.9244966944,62941.57202670208,6.7879767018758495 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441039,149868.4548905486,62941.57202670208,2.38107263712716 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441050,104954.20911815274,14728.399701289269,7.125975071749679 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441037,151245.6831057019,14728.399701289269,10.268982793321559 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441044,91760.1662656622,14728.399701289269,6.230151824140804 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441032,71711.84195258365,14728.399701289269,4.868950015411808 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441033,92815.5656045999,14728.399701289269,6.301809258780177 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441039,40551.32447443336,14728.399701289269,2.753274306568666 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441050,13397.900349922062,3575.9352491809864,3.7466842703571457 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441037,36368.42379001549,3575.9352491809864,10.170325035484108 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441044,15182.021291807789,3575.9352491809864,4.2456085566104695 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441032,21172.645775102366,3575.9352491809864,5.9208694508525115 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441033,23169.67158637924,3575.9352491809864,6.47933197103776 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441039,10025.980741675165,3575.9352491809864,2.803736657136469 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441050,52987.5138999052,12966.336321671553,4.086544771428104 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441037,200365.81651660113,12966.336321671553,15.452770277269115 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441044,185777.26366990744,12966.336321671553,14.327660417029657 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441032,105659.74809674258,12966.336321671553,8.14877429333265 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441033,99123.56717542016,12966.336321671553,7.644685801474079 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441039,152064.1829443057,12966.336321671553,11.727613658312263 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441050,273.9518306581003,103.34580193186551,2.6508268893081213 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441037,575.1858257042311,103.34580193186551,5.565642870364907 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441044,420.4400670740873,103.34580193186551,4.068283947820907 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441032,311.96586165209794,103.34580193186551,3.0186602244160126 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441033,487.97426199413223,103.34580193186551,4.721761821693029 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441039,457.96842802592096,103.34580193186551,4.43141781731834 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441050,513.915028190159,211.8154700640626,2.4262393489707232 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441037,1643.807990862697,211.8154700640626,7.7605662625375516 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441044,1810.8844937837796,211.8154700640626,8.549349550512463 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441032,792.6908114344938,211.8154700640626,3.742365046305391 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441033,973.0817243467014,211.8154700640626,4.594006868584232 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441039,1021.6031598969848,211.8154700640626,4.823080956211583 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441050,151.3153891461281,76.10596635595309,1.9882197991996464 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441037,100.22395804200076,76.10596635595309,1.3169001438500378 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441044,199.32659107967385,76.10596635595309,2.619066554485479 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441032,54.901378686530535,76.10596635595309,0.7213807447073576 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441033,257.05715595729947,76.10596635595309,3.3776216013738614 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441039,106.13474769613175,76.10596635595309,1.394565403712659 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441050,4097.075915195491,1382.686999693948,2.963126084285425 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441037,3826.5111983217857,1382.686999693948,2.767445704753692 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441044,2814.4106613356785,1382.686999693948,2.035464759528828 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441032,3147.8551752237354,1382.686999693948,2.276621661967242 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441033,4837.7193082003105,1382.686999693948,3.498781220385466 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441039,2461.230740822403,1382.686999693948,1.780034629216291 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441050,34.40939375876224,30.899530320120164,1.1135895401088554 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441037,30.983923861640456,30.899530320120164,1.0027312240880677 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441044,29.558317338920997,30.899530320120164,0.956594389387018 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441032,34.59527416665565,30.899530320120164,1.1196051787275554 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441033,25.72826596750551,30.899530320120164,0.8326426227505667 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441039,45.1179261591074,30.899530320120164,1.460149254428277 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441050,30.35988146260685,31.68183515511672,0.9582740808404097 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441037,31.91344977435947,31.68183515511672,1.0073106440365196 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441044,30.900400342755105,31.68183515511672,0.9753349258799041 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441032,31.4330857646559,31.68183515511672,0.9921485169895329 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441033,31.275799534973643,31.68183515511672,0.9871839614670332 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441039,30.427931582826147,31.68183515511672,0.96042200313992665 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441050,473.05051028462105,628.1906149122311,0.7530365768847315 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441037,501.11947984386063,628.1906149122311,0.7977188260188757 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441044,202.14914769304147,628.1906149122311,0.3217958735682244 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441032,1210.567318989658,628.1906149122311,1.927070048887621 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441033,341.3557251209684,628.1906149122311,0.5433951367908633 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441039,237.86923861571375,628.1906149122311,0.37865774013345954 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441050,24224.608202336072,10551.186365326936,2.295913214265878 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441037,29447.11843235839,10551.186365326936,2.7908822205175743 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441044,39878.01309043136,10551.186365326936,3.779481444994429 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441032,29237.522335075628,10551.186365326936,2.77101752568368 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441033,31179.16656198846,10551.186365326936,2.9550389389811853 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441039,37363.90725215523,10551.186365326936,3.5412043687276378 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441050,140.69593770161202,102.14043933131707,1.3774753527858925 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441037,106.04146923720208,102.14043933131707,1.0381928052338907 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441044,220.88198955622505,102.14043933131707,2.1625322056794882 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441032,69.73375978158445,102.14043933131707,0.6827242984082558 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441033,82.98108004652137,102.14043933131707,0.8124214130052083 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441039,149.57703867795232,102.14043933131707,1.4644252526931398 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441050,8948.099730066248,2995.2816068385046,2.987398483547226 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441037,6158.558732156063,2995.2816068385046,2.0560867192238304 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441044,8692.367975889314,2995.2816068385046,2.9020202828488095 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441032,8887.067823862717,2995.2816068385046,2.967022467461063 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441033,10172.444297298558,2995.2816068385046,3.396156232547193 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441039,6037.45891255652,2995.2816068385046,2.0156565241720323 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441050,44.8429505733886,35.73806763844074,1.2547670743438413 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441037,37.853505534330075,35.73806763844074,1.059192844931938 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441044,36.69321987774056,35.73806763844074,1.0267264657105422 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441032,40.08806490603264,35.73806763844074,1.1217188716413122 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441033,27.712340677453657,35.73806763844074,0.7754291854225936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441039,40.99257778147426,35.73806763844074,1.1470283787079087 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441050,216.22630167569935,271.6614200921023,0.7959404084775505 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441037,304.6696355698901,271.6614200921023,1.1215049802308952 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441044,224.54586062426665,271.6614200921023,0.826565143288061 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441032,233.1402434458479,271.6614200921023,0.8582015192543924 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441033,236.29388619226705,271.6614200921023,0.8698102443554758 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441039,234.32071789344195,271.6614200921023,0.8625469078899736 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441050,190.25876254754527,166.02715311669658,1.145949677362816 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441037,158.85209246329822,166.02715311669658,0.9567838120529888 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441044,147.2697953990846,166.02715311669658,0.887022349263389 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441032,179.53234310887936,166.02715311669658,1.0813432606574318 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441033,159.60223174203418,166.02715311669658,0.9613019843197186 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441039,216.54496478480053,166.02715311669658,1.3042743956020022 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441050,1459.4453246386213,1793.9624976146763,0.8135316800541581 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441037,1554.4346574157526,1793.9624976146763,0.8664811329571217 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441044,1515.13174369029,1793.9624976146763,0.8445726963104687 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441032,1396.6514359023502,1793.9624976146763,0.7785287807071738 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441033,1537.4115654293405,1793.9624976146763,0.8569920315912646 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441039,1883.3459362026715,1793.9624976146763,1.0498245859134976 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441050,66.25168932462165,59.13775760336051,1.1202942419456379 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441037,108.7104541293149,59.13775760336051,1.8382579680893651 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441044,72.50956155689086,59.13775760336051,1.2261127999342756 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441032,126.72390577522096,59.13775760336051,2.1428595014569822 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441033,195.73329360179164,59.13775760336051,3.3097855166336076 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441039,107.55006686841934,59.13775760336051,1.81863620176068 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441050,278.97146791186697,238.79765196261823,1.1682337142726078 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441037,308.78638233277945,238.79765196261823,1.2930880173860226 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441044,407.49605237252274,238.79765196261823,1.70644915904078 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441032,563.1624351620209,238.79765196261823,2.358324843370651 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441033,540.6164811213634,238.79765196261823,2.263910372142153 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441039,348.46823579567894,238.79765196261823,1.4592615669865494 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441050,459.0538943769627,386.8144501381946,1.186754771474953 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441037,753.6885398280209,386.8144501381946,1.9484498047028895 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441044,453.36396331495513,386.8144501381946,1.1720450545551875 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441032,883.3352640095248,386.8144501381946,2.2836149572332203 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441033,384.93322277195654,386.8144501381946,0.9951366155903276 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441039,522.4314962901275,386.8144501381946,1.350599741306153 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441050,12430.35595126114,5555.372966797932,2.23753761008523 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441037,11077.807424382469,5555.372966797932,1.9940708734750565 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441044,16686.119535665435,5555.372966797932,3.003600232674057 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441032,12561.981694706468,5555.372966797932,2.2612310226125256 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441033,14392.02058094732,5555.372966797932,2.5906488487743697 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441039,11682.483592875493,5555.372966797932,2.1029161611104525 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441050,31.931425787330113,84.54153084580483,0.3777010596788198 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441037,110.31819643901554,84.54153084580483,1.3048994421478448 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441044,50.971072238400815,84.54153084580483,0.602911630868938 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441032,155.45162238337983,84.54153084580483,1.8387604391373964 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441033,28.214506798876204,84.54153084580483,0.3337354613359983 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441039,57.712545759457214,84.54153084580483,0.6826531904741474 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441050,74.9401271428433,122.00200397429413,0.6142532475010264 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441037,30.480513385303176,122.00200397429413,0.2498361698364023 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441044,121.9159202452654,122.00200397429413,0.9992944072537786 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441032,166.467631215896,122.00200397429413,1.36446636770795 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441033,90.6366478466581,122.00200397429413,0.7429111399330397 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441039,85.93908483980555,122.00200397429413,0.7044071575899109 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441050,113.1383153958636,143.84455848940917,0.7865317714065189 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441037,93.58975119393274,143.84455848940917,0.6506311547462775 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441044,114.49308372994666,143.84455848940917,0.7959500514465164 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441032,187.61597659881232,143.84455848940917,1.3042966558420486 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441033,148.3226333240836,143.84455848940917,1.03113134679338 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441039,87.06517733829014,143.84455848940917,0.6052726516220667 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441050,2225.2199400475715,5334.764851653101,0.4171167805752554 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441037,4237.489572035423,5334.764851653101,0.7943160926244648 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441044,3667.726248159233,5334.764851653101,0.6875141360771886 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441032,749.3874596781463,5334.764851653101,0.1404724445250724 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441033,2757.6428994683974,5334.764851653101,0.5169192975045335 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441039,1732.496129264498,5334.764851653101,0.3247558566199303 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441050,248.6249708561676,159.70733471984832,1.5567536161835944 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441037,290.7548298636691,159.70733471984832,1.8205477561421872 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441044,465.0265837890348,159.70733471984832,2.9117421851962173 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441032,268.0107751039963,159.70733471984832,1.6781369219774984 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441033,456.97722005934185,159.70733471984832,2.86134147101604 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441039,240.74883056816785,159.70733471984832,1.5074375324745042 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441050,121622.98158606996,82077.5827732141,1.4818051101982677 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441037,150256.73161774105,82077.5827732141,1.8306671144654751 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441044,141455.6486742237,82077.5827732141,1.7234382872248466 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441032,43181.71570460216,82077.5827732141,0.5261085212988807 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441033,108560.5893627236,82077.5827732141,1.322658217928808 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441039,48480.088566818005,82077.5827732141,0.5906617486625033 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441050,397912.395801443,170961.68742491837,2.3274945503576356 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441037,204864.70364253657,170961.68742491837,1.198307683600207 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441044,150108.46014963303,170961.68742491837,0.8780239737371363 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441032,60112.64675185041,170961.68742491837,0.3516147252480192 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441033,274928.962097149,170961.68742491837,1.608132010383263 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441039,123197.0038657687,170961.68742491837,0.7206117681768519 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441050,285325.16468864644,55195.40432138408,5.1693645185982335 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441037,468587.3454751927,55195.40432138408,8.489607988860229 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441044,248465.14522104457,55195.40432138408,4.501554944218118 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441032,286217.04227614624,55195.40432138408,5.185523066551006 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441033,366535.8657314596,55195.40432138408,6.64069536654258 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441039,191045.3320152736,55195.40432138408,3.461254326589974 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441050,1681.0256369933602,546.121028905539,3.078119222697287 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441037,1973.7199216751196,546.121028905539,3.6140705396944317 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441044,1933.0904300470731,546.121028905539,3.539674042439106 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441032,1638.6063762137824,546.121028905539,3.000445486411049 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441033,2226.60033032781,546.121028905539,4.077118829849964 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441039,2169.000379098021,546.121028905539,3.9716477928799674 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441050,1475.3402312620726,1228.731327313693,1.2007020562318753 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441037,2553.6553541691924,1228.731327313693,2.078286194388896 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441044,1597.7116597276809,1228.731327313693,1.3002937454363346 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441032,1768.751570297118,1228.731327313693,1.4394941603418228 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441033,1852.291828868095,1228.731327313693,1.5074831964426736 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441039,1430.7145902698649,1228.731327313693,1.164383586929257 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441050,66.27652626725178,76.68368758811918,0.8642845480154007 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441037,64.25098421270437,76.68368758811918,0.8378702985412891 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441044,29.801944706121212,76.68368758811918,0.38863473632348516 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441032,163.56576166592905,76.68368758811918,2.1329929064505597 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441033,41.08726959317656,76.68368758811918,0.5358019532636863 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441039,72.77184512114322,76.68368758811918,0.9489872932560687 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441050,137.50723792357422,81.06808963980528,1.696194378509898 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441037,233.99308616799243,81.06808963980528,2.8863772072050824 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441044,240.0220574835168,81.06808963980528,2.9607464361126805 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441032,319.9113871879567,81.06808963980528,3.9462060671388617 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441033,123.11984126690056,81.06808963980528,1.5187213836410354 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441039,338.2855910051882,81.06808963980528,4.1728575634165 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441050,33.66766445296657,34.254424530644805,0.9828705317424525 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441037,48.085250067126275,34.254424530644805,1.4037675636357019 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441044,220.5245377565188,34.254424530644805,6.4378409731926 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441032,486.0403742642264,34.254424530644805,14.189126833218388 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441033,86.96390406510466,34.254424530644805,2.5387641233705365 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441039,43.7936289854456,34.254424530644805,1.2784809432798032 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441050,109.26689919738862,60.87738129746832,1.7948685844989305 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441037,181.7122121792472,60.87738129746832,2.9848887765283028 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441044,376.19288737359386,60.87738129746832,6.1795182275561915 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441032,65.72263543436335,60.87738129746832,1.0795903837127852 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441033,115.8997097709114,60.87738129746832,1.903822196368543 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441039,43.63365848111337,60.87738129746832,0.7167466397397082 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441050,115.11388162385452,81.37032235510941,1.4146912325292795 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441037,123.26095999109098,81.37032235510941,1.5148146943939345 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441044,121.72080934869987,81.37032235510941,1.495887023987644 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441032,180.36628751699905,81.37032235510941,2.216610212380134 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441033,144.06219853490168,81.37032235510941,1.7704513680823057 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441039,125.1695700526514,81.37032235510941,1.538270544221234 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441050,578.9733233239206,592.3362991324378,0.9774402213268218 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441037,1053.9030802229202,592.3362991324378,1.7792309567495925 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441044,519.6486610033253,592.3362991324378,0.877286537671971 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441032,395.69161688067726,592.3362991324378,0.6680185182981777 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441033,560.5123186309467,592.3362991324378,0.9462737965778866 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441039,486.0559310771727,592.3362991324378,0.8205742781407656 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441050,5940.807261224435,1509.2244087879828,3.9363312881981125 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441037,6578.5747808767,1509.2244087879828,4.358910936352914 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441044,7251.50419841973,1509.2244087879828,4.804788576301397 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441032,6849.63061507225,1509.2244087879828,4.538510360147835 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441033,15291.771970140408,1509.2244087879828,10.13220557598907 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441039,9221.646347788914,1509.2244087879828,6.110188977923149 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441050,849908.5189380882,911297.6405793307,0.9326354871255716 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441037,926463.8112736504,911297.6405793307,1.0166423899492136 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441044,738495.0250605062,911297.6405793307,0.8103774136746691 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441032,634907.4603578717,911297.6405793307,0.6967070165508691 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441033,744187.4777589408,911297.6405793307,0.8166239487746785 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441039,714928.2882630965,911297.6405793307,0.7845167774258713 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441050,1729.8550059751065,749.6106308195243,2.307671389457102 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441037,2503.3160719019234,749.6106308195243,3.3394884877301316 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441044,324.7634927457389,749.6106308195243,0.4332429122445686 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441032,1682.5930479521817,749.6106308195243,2.2446227131446346 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441033,2854.32462141898,749.6106308195243,3.807742985579649 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441039,3632.6945903589985,749.6106308195243,4.846108687636266 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441050,18296.642115022623,2138.7943755926544,8.554652248864583 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441037,30843.844679390833,2138.7943755926544,14.421136052802684 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441044,29163.7612091382,2138.7943755926544,13.635607771344077 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441032,20794.274141621947,2138.7943755926544,9.722427914960225 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441033,19329.29215186204,2138.7943755926544,9.037471003497446 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441039,26402.71404860709,2138.7943755926544,12.344671535472392 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441050,1332.7065265509816,613.8984432679271,2.1708908715530675 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441037,1929.4574417951017,613.8984432679271,3.1429586814459767 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441044,1528.89249952638,613.8984432679271,2.4904648583041236 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441032,2062.3701497728935,613.8984432679271,3.3594647003735796 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441033,1668.9362367786837,613.8984432679271,2.718586852728507 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441039,1833.6196454489811,613.8984432679271,2.986845243796659 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441050,4478.733341037232,6365.76448478505,0.7035656678380026 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441037,5887.887350182604,6365.76448478505,0.9249301265001822 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441044,5173.226384234523,6365.76448478505,0.812663804418018 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441032,5081.8963510639605,6365.76448478505,0.7983167399941217 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441033,5933.108455693602,6365.76448478505,0.9320339245780224 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441039,5001.51548694815,6365.76448478505,0.7856896840752403 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441050,78.38618210322957,70.21289390855102,1.1164072257913749 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441037,232.77441576813692,70.21289390855102,3.315265940630714 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441044,128.4491375584513,70.21289390855102,1.8294237768599915 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441032,132.21548074549915,70.21289390855102,1.8830655366192934 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441033,98.78535867331996,70.21289390855102,1.4069404232502256 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441039,85.0558778364255,70.21289390855102,1.2113996888834515 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441050,1693.2993898530997,2003.7789126851078,0.8450530041680303 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441037,1792.676826076504,2003.7789126851078,0.8946480146725757 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441044,980.5909965858752,2003.7789126851078,0.4893708534300632 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441032,1878.4080563744856,2003.7789126851078,0.93743278985673 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441033,1686.5814056972742,2003.7789126851078,0.8417003467898652 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441039,2134.518661735695,2003.7789126851078,1.065246593934554 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441050,1013.5042146026614,700.7857837159185,1.4462396900070555 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441037,1198.028156397636,700.7857837159185,1.709549742925846 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441044,870.5366623712703,700.7857837159185,1.2422293411194036 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441032,1603.2128061525327,700.7857837159185,2.2877359150345384 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441033,986.9120496237786,700.7857837159185,1.4082934793435375 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441039,1112.181491234959,700.7857837159185,1.5870491626379941 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441050,4049.251025874008,4688.560133729121,0.863644895315307 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441037,3873.294955807604,4688.560133729121,0.826116087952767 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441044,4378.053825370744,4688.560133729121,0.9337736320955723 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441032,4186.329717274381,4688.560133729121,0.8928817372221091 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441033,4830.665361524711,4688.560133729121,1.0303089272063073 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441039,4180.371390920709,4688.560133729121,0.8916109150115099 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441050,470.5039786296195,384.65137963543384,1.2231958691414426 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441037,784.3715307417949,384.65137963543384,2.039175139538585 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441044,549.1814012737435,384.65137963543384,1.4277380255187138 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441032,794.4238852620015,384.65137963543384,2.0653088155174255 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441033,1337.7089344801243,384.65137963543384,3.477717760295004 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441039,1010.2469979032744,384.65137963543384,2.626396397851919 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441050,691.817597778051,772.5530415852671,0.8954952741606605 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441037,427.2018350233621,772.5530415852671,0.5529741157277052 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441044,619.6897172123583,772.5530415852671,0.8021322599944263 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441032,263.32485491556497,772.5530415852671,0.3408501950561561 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441033,303.1934720119877,772.5530415852671,0.39245651196950737 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441039,61.036802007316254,772.5530415852671,0.0790066166616465 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441050,171.54618431745024,216.68366112664066,0.7916895229917228 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441037,194.8908467150652,216.68366112664066,0.8994256682840583 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441044,164.70991300039876,216.68366112664066,0.7601399761476899 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441032,241.85979727060916,216.68366112664066,1.1161884380809604 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441033,162.41337152945863,216.68366112664066,0.7495413852848657 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441039,187.20830437155135,216.68366112664066,0.8639705615004241 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441050,988.9768696298032,615.8359185894908,1.6059096908393289 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441037,1830.1416140064216,615.8359185894908,2.9718007000926057 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441044,990.4528730563422,615.8359185894908,1.6083064387099624 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441032,1052.5389138390815,615.8359185894908,1.709122319870225 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441033,1178.1836551570896,615.8359185894908,1.9131454005729298 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441039,1007.610386308758,615.8359185894908,1.6361669657342928 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441050,65.31449740145094,101.73138829665541,0.642028959744357 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441037,56.74417356839406,101.73138829665541,0.5577843231916223 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441044,109.8624978548073,101.73138829665541,1.0799272446222894 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441032,30.93736651829861,101.73138829665541,0.30410836848194006 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441033,0.2666790292068362,101.73138829665541,0.002621403616641726 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441039,74.40687838153907,101.73138829665541,0.7314053177428753 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441050,225.48997802001043,93.53234569214308,2.4108235108547276 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441037,203.7303092145819,93.53234569214308,2.178180261672788 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441044,358.2992191509197,93.53234569214308,3.8307519874487403 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441032,248.5952857176173,93.53234569214308,2.657853642801346 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441033,270.20996991637793,93.53234569214308,2.8889467907258544 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441039,210.61754781096604,93.53234569214308,2.251815094044609 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441050,86.61086079911574,42.30806113801961,2.047147954064101 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441037,238.43000036498256,42.30806113801961,5.635569060637487 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441044,153.67794068388733,42.30806113801961,3.6323560227104466 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441032,124.63000962760182,42.30806113801961,2.9457745468653638 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441033,117.8632948540294,42.30806113801961,2.7858354101722953 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441039,206.18747070626696,42.30806113801961,4.873479548817688 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441050,272.47084623577257,205.3077634331321,1.3271336732695704 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441037,1118.1998873145455,205.3077634331321,5.446456912374571 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441044,332.8150312146235,205.3077634331321,1.6210542925865539 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441032,346.2797523797825,205.3077634331321,1.6866374003073898 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441033,417.56067324999793,205.3077634331321,2.033827977411072 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441039,819.3871550339323,205.3077634331321,3.9910188554599078 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441050,386.44807046884887,761.179367641068,0.5076964601214432 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441037,518.868213284284,761.179367641068,0.6816635281277814 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441044,112.2542507870929,761.179367641068,0.1474741113056891 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441032,170.01112766995686,761.179367641068,0.2233522542746129 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441033,71.31873492832737,761.179367641068,0.09369504476894534 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441039,374.0258748458517,761.179367641068,0.49137679073590257 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441050,1015537.611615379,258075.7105503754,3.9350375494448167 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441037,827213.0890177587,258075.7105503754,3.2053116787071283 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441044,976564.7692802784,258075.7105503754,3.7840243361052632 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441032,805302.9465128893,258075.7105503754,3.1204135592438766 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441033,873859.9302845473,258075.7105503754,3.3860603480309828 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441039,1046565.7108709178,258075.7105503754,4.0552662187348005 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441050,207.0788532216877,131.47736122215045,1.5750152824545767 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441037,308.21865004769745,131.47736122215045,2.3442716463324547 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441044,286.5410122059354,131.47736122215045,2.1793943044063835 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441032,463.87037516076,131.47736122215045,3.52813876738051 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441033,272.34873989637845,131.47736122215045,2.0714496957100086 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441039,218.19018841986505,131.47736122215045,1.6595266773813664 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441050,2162.511343592881,3004.2024881525895,0.7198287572562062 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441037,3227.644864913484,3004.2024881525895,1.074376603322201 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441044,2099.401276961158,3004.2024881525895,0.6988214959678595 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441032,2626.5040501551343,3004.2024881525895,0.874276637647778 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441033,2956.5625281089265,3004.2024881525895,0.9841422273526713 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441039,2726.8372140642637,3004.2024881525895,0.9076742412729678 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441050,124.3090294504452,96.13121274223809,1.2931182901412244 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441037,145.0060284309697,96.13121274223809,1.5084177583380993 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441044,178.6575375116105,96.13121274223809,1.8584758520695541 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441032,256.33019308391255,96.13121274223809,2.6664616597652295 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441033,64.1401004365234,96.13121274223809,0.6672140983855658 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441039,157.27967709058217,96.13121274223809,1.6360937577299146 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441050,243.2583910056555,490.807523353751,0.4956288961168313 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441037,220.4505066064932,490.807523353751,0.4491587763368551 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441044,340.48799541170445,490.807523353751,0.6937301879260247 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441032,194.51926216323903,490.807523353751,0.3963249398339779 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441033,202.04750077828325,490.807523353751,0.4116634141988425 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441039,180.5916347012165,490.807523353751,0.3679479757506784 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441050,148.72173954336108,78.64120835950264,1.8911426038049965 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441037,152.66988113353713,78.64120835950264,1.9413470916623983 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441044,220.25440591488405,78.64120835950264,2.800750529010272 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441032,179.8367749274473,78.64120835950264,2.2868007585200925 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441033,160.15739942818075,78.64120835950264,2.0365582214356714 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441039,122.35953574545329,78.64120835950264,1.5559213585083211 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441050,2022.0492593758945,1710.8868039225827,1.1818720296047078 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441037,1871.7120406742351,1710.8868039225827,1.0940010971987892 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441044,2072.246540635299,1710.8868039225827,1.2112119491974689 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441032,1594.6135100716608,1710.8868039225827,0.93203916613048865 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441033,1937.476043432552,1710.8868039225827,1.1324396441602471 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441039,1566.7087309625097,1710.8868039225827,0.9157290402675892 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441050,262.58033890750687,158.21676846284709,1.6596239542660534 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441037,280.7779390536371,158.21676846284709,1.774640841053268 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441044,263.8235473750938,158.21676846284709,1.667481581998343 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441032,237.9160726348176,158.21676846284709,1.5037348755526234 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441033,261.94485418904196,158.21676846284709,1.655607409593583 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441039,293.2280650603901,158.21676846284709,1.8533311475720526 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441050,1000.1869814282344,1068.4447009417866,0.9361148785207264 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441037,978.4509052209188,1068.4447009417866,0.9157712180690847 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441044,1183.752827083556,1068.4447009417866,1.107921473184462 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441032,975.4043534626242,1068.4447009417866,0.9129198287968002 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441033,1009.2886458193024,1068.4447009417866,0.9446334891545246 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441039,1123.7977040089002,1068.4447009417866,1.0518070827795976 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441050,166.06604155493883,101.193417409009,1.6410755344265544 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441037,149.5893120712663,101.193417409009,1.4782514110245746 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441044,153.86180082927163,101.193417409009,1.520472425665641 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441032,166.49710663954377,101.193417409009,1.6453353479168196 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441033,180.1349031659668,101.193417409009,1.780104949296137 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441039,161.29145212644875,101.193417409009,1.593892727967989 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441050,8951.506704985872,8195.704907369402,1.0922192546167528 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441037,10613.457409450508,8195.704907369402,1.2950023859335291 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441044,9793.012738600552,8195.704907369402,1.1948957227333654 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441032,10681.497747615387,8195.704907369402,1.3033043366423325 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441033,9865.087690476576,8195.704907369402,1.2036899573587747 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441039,10117.474344805903,8195.704907369402,1.2344849478058304 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441050,49.416947963155856,54.484574340672744,0.9069897041714814 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441037,92.40980346211904,54.484574340672744,1.6960727798718456 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441044,66.96191558430289,54.484574340672744,1.2290068591820824 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441032,53.8829076218105,54.484574340672744,0.9889571181175019 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441033,27.313734442240737,54.484574340672744,0.5013113302759352 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441039,153.0930149627998,54.484574340672744,2.8098414425625022 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441050,193.7999859934257,181.8259570369428,1.0658543430850749 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441037,161.26906272760027,181.8259570369428,0.8869419160809595 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441044,194.6170648060481,181.8259570369428,1.0703480843854787 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441032,118.84338120599888,181.8259570369428,0.6536106458213371 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441033,113.0520189813182,181.8259570369428,0.6217595156578698 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441039,208.38832202484133,181.8259570369428,1.1460867602225884 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441050,539.4440930790979,598.5025834222519,0.9013229149230132 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441037,691.253551614025,598.5025834222519,1.1549717089965108 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441044,541.2398427736908,598.5025834222519,0.9043233191724398 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441032,735.3691443318672,598.5025834222519,1.228681654349776 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441033,725.4766721985346,598.5025834222519,1.2121529502015547 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441039,738.2114604983375,598.5025834222519,1.2334307001270186 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441050,15120.511359145929,15066.853658787537,1.003561307594376 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441037,16417.30423751662,15066.853658787537,1.0896305631761047 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441044,12164.97107884525,15066.853658787537,0.8073995642580757 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441032,15733.47687146765,15066.853658787537,1.0442443543806053 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441033,14803.700100687092,15066.853658787537,0.9825342726451077 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441039,18626.53477437328,15066.853658787537,1.236259088738783 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441050,69.81601325008648,62.8704966822211,1.110473384725613 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441037,62.58162184116578,62.8704966822211,0.9954052400362694 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441044,60.00867551853419,62.8704966822211,0.9544806973905108 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441032,69.8278357692816,62.8704966822211,1.1106614303085018 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441033,61.24842664501883,62.8704966822211,0.9741998214933624 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441039,65.87851979972267,62.8704966822211,1.0478447487492522 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441050,95.29872108695692,100.49015468400951,0.9483388834122406 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441037,98.10578418462632,100.49015468400951,0.9762725959883252 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441044,98.92759013544814,100.49015468400951,0.9844505707700935 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441032,99.53226995215068,100.49015468400951,0.9904678748393722 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441033,97.32890971540768,100.49015468400951,0.9685417444271796 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441039,96.2274510304385,100.49015468400951,0.9575808827543848 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441050,148.15093560020486,109.95671552102958,1.347356865819355 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441037,139.17690866131522,109.95671552102958,1.2657426879461235 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441044,141.07797472622613,109.95671552102958,1.2830319099450047 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441032,145.1467456548487,109.95671552102958,1.3200352972264702 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441033,150.00938884032385,109.95671552102958,1.3642585460060788 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441039,151.60081165870557,109.95671552102958,1.378731721299109 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441050,263.1801416270999,243.54938966397899,1.080602755729362 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441037,253.3023568802328,243.54938966397899,1.0400451310089909 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441044,303.25766704623413,243.54938966397899,1.2451588052207139 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441032,242.05789344765356,243.54938966397899,0.9938760010099668 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441033,275.0301770927049,243.54938966397899,1.1292583301980736 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441039,244.50500244227436,243.54938966397899,1.0039236919444299 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441050,93.4899686213498,49.66723175069083,1.882326945271103 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441037,201.91278419051628,49.66723175069083,4.06531181774003 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441044,68.71241397688821,49.66723175069083,1.3834556820439763 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441032,123.25328335218047,49.66723175069083,2.481581497653453 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441033,47.851990393187315,49.66723175069083,0.9634519321186394 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441039,69.05343664395055,49.66723175069083,1.3903218321200288 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441050,366.8013790498576,318.9289567276793,1.1501037184373781 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441037,383.98093642959253,318.9289567276793,1.2039701266682363 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441044,309.9839480547194,318.9289567276793,0.9719529742148887 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441032,405.6150144460918,318.9289567276793,1.2718036599995222 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441033,445.85401902806,318.9289567276793,1.3979728388499917 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441039,537.169748794299,318.9289567276793,1.6842928102416452 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441050,57.04658922946618,52.85511393128503,1.079301225301119 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441037,53.62593267757641,52.85511393128503,1.014583617155636 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441044,49.1886319630642,52.85511393128503,0.9306314622084159 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441032,62.271017872725665,52.85511393128503,1.1781455613487448 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441033,57.88212336518144,52.85511393128503,1.095109234660469 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441039,51.16665179129093,52.85511393128503,0.9680548954602727 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441050,121.9650196260806,145.91831693350866,0.8358444792209125 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441037,128.25846899608348,145.91831693350866,0.8789744268673799 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441044,132.80207769500942,145.91831693350866,0.9101124552822523 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441032,124.8946525502419,145.91831693350866,0.8559216908124926 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441033,131.21480996472783,145.91831693350866,0.8992346726731995 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441039,116.03597447298355,145.91831693350866,0.7952118480496061 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441050,1465.0169409653397,261.347965154705,5.605618318467192 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441037,1619.1054239663888,261.347965154705,6.195209604972279 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441044,1249.1210414029338,261.347965154705,4.779532301556342 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441032,1076.069894962822,261.347965154705,4.117383865322396 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441033,941.1901017654266,261.347965154705,3.601291103254961 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441039,1637.2533371981588,261.347965154705,6.264649262637214 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441050,6409.506917294319,7540.877985370558,0.8499682569760285 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441037,7693.481058935032,7540.877985370558,1.0202367779800345 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441044,7418.258321277997,7540.877985370558,0.9837393385318731 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441032,6928.350545840003,7540.877985370558,0.9187723974955079 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441033,8606.96600731575,7540.877985370558,1.1413745221728056 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441039,8123.2766182819405,7540.877985370558,1.0772322047964769 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441050,7262.79078455293,5107.556668860965,1.421969692246724 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441037,3919.10631567722,5107.556668860965,0.7673152878695753 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441044,8883.928351204328,5107.556668860965,1.739369512112634 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441032,3607.739558488399,5107.556668860965,0.7063533098875945 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441033,2995.0428944520913,5107.556668860965,0.5863944521089406 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441039,5286.788547120051,5107.556668860965,1.0350915104577891 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441050,73670.63506611835,180330.65339424144,0.40853084974443343 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441037,131928.62457038922,180330.65339424144,0.7315928938712654 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441044,94908.33986624626,180330.65339424144,0.526301757797973 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441032,62567.97100021501,180330.65339424144,0.34696248154454373 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441033,84675.54874489148,180330.65339424144,0.4695571559859687 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441039,51659.76623947866,180330.65339424144,0.2864724619310248 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441050,266.9950511205362,98.01831453553807,2.7239302408503767 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441037,404.6256553392664,98.01831453553807,4.12806175311822 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441044,286.83314996873395,98.01831453553807,2.9263219973522205 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441032,373.1624981505756,98.01831453553807,3.807069116815712 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441033,361.2446618421073,98.01831453553807,3.6854812649439346 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441039,357.87746603368015,98.01831453553807,3.6511285439817076 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441050,2591.4096602707928,1812.4793707702274,1.4297595338530957 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441037,1607.2295082620776,1812.4793707702274,0.8867574076603546 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441044,1457.6917396662598,1812.4793707702274,0.804252872156444 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441032,2133.7656030851294,1812.4793707702274,1.1772633871018179 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441033,1548.3161178288844,1812.4793707702274,0.854253098158527 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441039,1643.0758734446194,1812.4793707702274,0.9065349376894598 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441050,10383.614868120816,434.5650550234931,23.894270255024225 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441037,11226.78354945525,434.5650550234931,25.834529076085783 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441044,13517.29808374581,434.5650550234931,31.10534988372466 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441032,9323.879698692765,434.5650550234931,21.45565914909726 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441033,10483.043828998949,434.5650550234931,24.12307135103678 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441039,5376.078297214835,434.5650550234931,12.37117028870211 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441050,1644285.2990960265,9833.502392298877,167.2125793535934 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441037,2487044.417639798,9833.502392298877,252.91542305288203 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441044,1895781.13719028,9833.502392298877,192.78798759178255 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441032,2770429.104296309,9833.502392298877,281.7337092901889 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441033,2625282.963135956,9833.502392298877,266.9733385321542 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441039,3030318.872251152,9833.502392298877,308.1627228386451 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441050,68.2393147238964,42.4088060383901,1.6090836101851942 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441037,59.83704336190024,42.4088060383901,1.410957981409178 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441044,59.40567909697308,42.4088060383901,1.400786408445377 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441032,60.33733491021532,42.4088060383901,1.4227548602899978 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441033,70.73475130932752,42.4088060383901,1.6679260256772068 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441039,63.96518185877799,42.4088060383901,1.5082995215869606 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441050,1514.0666827373695,385.8715169071063,3.9237585994248496 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441037,1654.0239803865782,385.8715169071063,4.286463001063547 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441044,1396.9802876381057,385.8715169071063,3.6203249693975494 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441032,1348.903708729729,385.8715169071063,3.4957327753591634 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441033,1680.557057893891,385.8715169071063,4.355224431603911 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441039,1304.5630593598746,385.8715169071063,3.380822377915838 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441050,1075.899654839295,1002.6445024002205,1.0730619399634762 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441037,1304.3850630198642,1002.6445024002205,1.3009447116074642 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441044,1668.631718162311,1002.6445024002205,1.6642306561974762 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441032,1470.70709202764,1002.6445024002205,1.4668280616977696 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441033,1257.5365035465677,1002.6445024002205,1.2542197164958904 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441039,1376.3421860011445,1002.6445024002205,1.3727120457014752 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441050,17905.52374498895,6245.085755978491,2.8671381698558407 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441037,24263.60928369994,6245.085755978491,3.885232362177271 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441044,15039.372570943731,6245.085755978491,2.4081931231362788 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441032,16367.957655701648,6245.085755978491,2.620934010398883 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441033,23609.721770140015,6245.085755978491,3.780528033188041 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441039,16174.926577304155,6245.085755978491,2.590024734539428 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441050,306.0078961662778,289.8012081128336,1.0559234661545447 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441037,349.66086363828657,289.8012081128336,1.2065541959443686 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441044,357.0996004719942,289.8012081128336,1.2322226080332905 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441032,575.6037279417607,289.8012081128336,1.9862019613032476 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441033,397.38261142953667,289.8012081128336,1.371224826898639 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441039,254.1744268354266,289.8012081128336,0.8770647592899758 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441050,41022.38753720635,19122.271903916942,2.145267452702807 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441037,34309.44084951002,19122.271903916942,1.7942136280617467 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441044,41887.922602585786,19122.271903916942,2.1905306447402624 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441032,48391.21176965907,19122.271903916942,2.530620420670139 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441033,44619.54274334081,19122.271903916942,2.3333808329647847 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441039,48568.41147816049,19122.271903916942,2.539887086754158 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441050,97.4829932528206,111.01681566749893,0.8780921400663048 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441037,107.73120580970348,111.01681566749893,0.9704043947032671 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441044,97.54638011894237,111.01681566749893,0.8786631064171286 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441032,168.34046418119866,111.01681566749893,1.5163510425788738 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441033,76.86915672088645,111.01681566749893,0.6924100304868546 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441039,140.24328066080832,111.01681566749893,1.2632616042676288 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441050,2087.38628369273,1048.3386659324408,1.9911373600210696 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441037,2059.9103097116854,1048.3386659324408,1.9649282971734197 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441044,1915.408591224264,1048.3386659324408,1.8270895212289162 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441032,1783.552292060191,1048.3386659324408,1.7013130870965416 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441033,2069.668238097297,1048.3386659324408,1.9742362896215782 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441039,1939.6212497539864,1048.3386659324408,1.850185739384894 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441050,40767.67609131912,5453.602601951663,7.475366114269074 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441037,53699.40881152469,5453.602601951663,9.846593661281345 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441044,25413.190675438647,5453.602601951663,4.659890448626402 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441032,41583.33217910227,5453.602601951663,7.624928916569934 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441033,59380.867546385016,5453.602601951663,10.88837450773083 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441039,32249.720855723528,5453.602601951663,5.913471004319681 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441050,254258.7396171721,64173.361133824874,3.9620605049336572 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441037,136300.47415994835,64173.361133824874,2.123941644192707 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441044,142480.20532131934,64173.361133824874,2.220239096160105 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441032,111104.97723169206,64173.361133824874,1.7313255105961747 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441033,137392.6619562995,64173.361133824874,2.14096097709119 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441039,149355.2022226027,64173.361133824874,2.3273707280368656 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441050,46.012945065078725,44.60879663763593,1.0314769402736619 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441037,127.57946701229018,44.60879663763593,2.859962084353848 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441044,200.700230737764,44.60879663763593,4.499117794368734 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441032,20.56408936124439,44.60879663763593,0.4609873144144557 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441033,14.71784571901688,44.60879663763593,0.32993146707301224 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441039,25.959824085885472,44.60879663763593,0.5819440568361681 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441050,134.04258160120744,136.29080299882398,0.9835042325076334 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441037,137.47021799519027,136.29080299882398,1.0086536653274871 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441044,143.3359198807012,136.29080299882398,1.0516917996435755 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441032,136.4186329409418,136.29080299882398,1.0009379205295232 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441033,136.6172155850942,136.29080299882398,1.0023949714807463 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441039,130.55669016458756,136.29080299882398,0.9579273677455266 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441050,95.84191976427974,82.77341642135346,1.157882855485894 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441037,113.49265997180656,82.77341642135346,1.371124509275762 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441044,98.5920517756911,82.77341642135346,1.1911076772983944 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441032,71.45474734275479,82.77341642135346,0.8632571957525395 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441033,52.59792651030459,82.77341642135346,0.635444672750461 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441039,105.9846031477361,82.77341642135346,1.280418372587491 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441050,3416.146890624191,2141.365658987758,1.5953122607929715 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441037,4060.003705699843,2141.365658987758,1.8959880526051969 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441044,3850.009399346168,2141.365658987758,1.7979224534524854 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441032,3081.4139122018346,2141.365658987758,1.438994736498411 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441033,4283.243482634552,2141.365658987758,2.0002391766473355 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441039,3989.168495607845,2141.365658987758,1.8629085970742427 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441050,279.88551238177547,285.0677067828484,0.9818211804502273 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441037,246.51336003209087,285.0677067828484,0.8647537204902467 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441044,203.17124516285708,285.0677067828484,0.7127122445953644 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441032,344.76427529064716,285.0677067828484,1.2094118943934709 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441033,0.1743996137936887,285.0677067828484,6.11783129565561e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441039,170.45153853767357,285.0677067828484,0.5979335241487588 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441050,843733.452518156,724296.655045942,1.1649003852774082 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441037,439058.5319962749,724296.655045942,0.6061860550335214 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441044,694860.4816759146,724296.655045942,0.9593589544215687 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441032,258001.6531308193,724296.655045942,0.3562099194210061 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441033,437234.0438615055,724296.655045942,0.6036670759355803 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441039,238450.3037687114,724296.655045942,0.3292163536963822 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441050,66.47375356335718,126.94877083842833,0.5236266024817239 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441037,16.19765681685325,126.94877083842833,0.12759207284857066 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441044,58.919319774572266,126.94877083842833,0.464118867677425 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441032,75.50950219890203,126.94877083842833,0.5948029405893605 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441033,88.0573263977992,126.94877083842833,0.6936445765975356 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441039,29.386832710997723,126.94877083842833,0.23148576009766383 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441050,49834.80120696499,94593.87687362579,0.5268290385596797 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441037,18931.126777294336,94593.87687362579,0.20013057296071793 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441044,34318.206535647245,94593.87687362579,0.36279522174035855 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441032,16856.699186632173,94593.87687362579,0.17820074347044842 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441033,24160.777010026373,94593.87687362579,0.2554158663176936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441039,13752.485668142011,94593.87687362579,0.1453845230015772 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441050,33.3351513024573,34.2642969985689,0.972882977982872 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441037,41.902217418372146,34.2642969985689,1.2229119254984935 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441044,30.4942537227326,34.2642969985689,0.8899716729634417 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441032,17.846550962779148,34.2642969985689,0.5208497627581425 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441033,11.825760705773806,34.2642969985689,0.34513361550268273 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441039,65.98005179761932,34.2642969985689,1.9256210568211884 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441050,93.17932475834456,74.66086218948179,1.2480344055211252 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441037,60.237003837403314,74.66086218948179,0.80680830720288 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441044,49.50640354674881,74.66086218948179,0.663083737515735 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441032,17.68809976125012,74.66086218948179,0.23691261046998752 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441033,101.52252614897854,74.66086218948179,1.3597823969849765 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441039,86.33491493944062,74.66086218948179,1.1563610760391603 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441050,350.5444433616669,347.6986105145094,1.008184769110657 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441037,425.0859076427904,347.6986105145094,1.2225700500032675 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441044,343.9422670427622,347.6986105145094,0.9891965531119358 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441032,563.5762117815271,347.6986105145094,1.6208756513221936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441033,294.84855753371033,347.6986105145094,0.8480003906182028 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441039,463.73762700535855,347.6986105145094,1.333734484354538 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441050,6451.230755926012,2521.321340016667,2.5586705881303358 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441037,8637.64437640931,2521.321340016667,3.425840347804382 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441044,5752.679493464535,2521.321340016667,2.281612978941632 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441032,7774.635043373488,2521.321340016667,3.083555800674774 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441033,8496.899245213523,2521.321340016667,3.37001837503083 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441039,8823.05827934316,2521.321340016667,3.4993787342016613 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441050,120.72865772024193,79.44971561377609,1.5195606024209396 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441037,148.04774140120563,79.44971561377609,1.8634143653943434 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441044,94.14514092969776,79.44971561377609,1.184965109093148 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441032,129.71387220206697,79.44971561377609,1.6326537005196704 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441033,124.08570075129042,79.44971561377609,1.5618142845784424 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441039,84.58506984075356,79.44971561377609,1.064636533778694 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441050,263.3986774494911,42.37178439720435,6.2163697185920235 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441037,44.00414944686104,42.37178439720435,1.0385248125109499 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441044,152.75530803821653,42.37178439720435,3.6051185998268975 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441032,173.49953341430808,42.37178439720435,4.094694992966956 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441033,104.9172390700897,42.37178439720435,2.4761109441737847 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441039,94.51661211487747,42.37178439720435,2.2306497934770384 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441050,2328.204896662751,1321.2949146990686,1.7620630116426437 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441037,4576.76939695584,1321.2949146990686,3.4638515187188337 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441044,3938.9286375023826,1321.2949146990686,2.981112387312482 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441032,2503.595555802086,1321.2949146990686,1.8948045042406692 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441033,1763.303808509897,1321.2949146990686,1.33452705288849 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441039,4211.030802646126,1321.2949146990686,3.18704836883839 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441050,74103.77152938771,23354.026662177774,3.173061870713712 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441037,73024.5467493342,23354.026662177774,3.126850363136677 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441044,80327.20331395601,23354.026662177774,3.4395440441989056 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441032,80891.91244625444,23354.026662177774,3.463724419620545 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441033,84446.94310233374,23354.026662177774,3.6159478758794488 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441039,67293.98467648056,23354.026662177774,2.88147246082682 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441050,33328.61699485212,13473.54115415771,2.4736345563146527 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441037,35475.44410346467,13473.54115415771,2.632971072531852 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441044,25417.46259658985,13473.54115415771,1.8864723316443386 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441032,48267.2169246027,13473.54115415771,3.5823705418161906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441033,62932.28398144367,13473.54115415771,4.6708050438561814 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441039,21475.459845664776,13473.54115415771,1.5938987085839573 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441050,119928.789737059,49612.48263442616,2.4173107929462954 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441037,125178.17167294292,49612.48263442616,2.5231184779711393 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441044,108832.0801045244,49612.48263442616,2.1936430979772354 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441032,97274.29552533946,49612.48263442616,1.9606818760132094 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441033,120713.29423625044,49612.48263442616,2.4331234364088714 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441039,91540.74434963906,49612.48263442616,1.8451151703930018 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441800,117.3193695567586,73.06854961986588,1.6056069289332358 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441809,47.30446351377317,73.06854961986588,0.6473984191539507 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441793,64.25834496696798,73.06854961986588,0.8794254888220393 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441801,59.701515673623206,73.06854961986588,0.8170617315413574 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441812,61.19628966783315,73.06854961986588,0.8375188776320681 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441800,59.20740423775249,990.9231863649335,0.05974974150614719 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441809,3666.4861358686776,990.9231863649335,3.7000709906876654 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441793,2487.3469860174996,990.9231863649335,2.5101309770962095 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441801,1869.324278516664,990.9231863649335,1.8864472082584172 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441812,1266.853837648668,990.9231863649335,1.27845816414484 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441798,44.69094745219187,990.9231863649335,0.045100314602723665 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441800,59.31972190883099,50.719124328797626,1.169573069209124 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441809,58.68075848989281,50.719124328797626,1.1569749924995192 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441793,60.85203406700564,50.719124328797626,1.1997847926655683 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441801,53.076250043024494,50.719124328797626,1.0464741011486376 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441812,58.805304921948256,50.719124328797626,1.1594306033505277 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441800,327.2376319484268,319.2477137201226,1.0250273310815587 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441809,329.13954481738705,319.2477137201226,1.0309848142121274 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441793,310.61110138966745,319.2477137201226,0.9729469876860992 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441801,320.4017246198471,319.2477137201226,1.0036147820332901 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441812,400.9296251553324,319.2477137201226,1.2558574671792906 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441798,307.2684700768492,319.2477137201226,0.9624766501733656 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441800,48.08932148712369,44.58166891160943,1.0786792567696102 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441809,40.2831496760074,44.58166891160943,0.903581015683272 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441793,57.34319234150584,44.58166891160943,1.286250464404961 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441801,8.394203899874773,44.58166891160943,0.18828823830076166 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441812,287.87465430865666,44.58166891160943,6.4572426590717376 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441800,1342.1620760749447,1543.2839395802719,0.8696792869107246 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441809,2382.047610045802,1543.2839395802719,1.5434927746955296 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441793,2118.3704265615424,1543.2839395802719,1.3726381595973047 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441801,1763.0711221490817,1543.2839395802719,1.1424152593906896 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441812,2803.8788466728292,1543.2839395802719,1.816826297975603 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441798,1555.259508200836,1543.2839395802719,1.007759796051413 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441800,36.73930232134871,31.276034215973343,1.1746790551400905 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441809,32.82290924443619,31.276034215973343,1.0494587970386866 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441793,34.77063153409594,31.276034215973343,1.111734029128854 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441801,30.39135826491048,31.276034215973343,0.9717139345431768 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441812,33.45138295926953,31.276034215973343,1.0695532153557112 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441800,24.303390221984483,130.468422036268,0.1862779501941746 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441809,214.58529396706092,130.468422036268,1.6447297408671797 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441793,40.34614389554629,130.468422036268,0.30924068265599736 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441801,188.8584771613796,130.468422036268,1.447541667277007 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441812,42.07664251992577,130.468422036268,0.3225044180286719 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441798,26.573351247290116,130.468422036268,0.20367649759650788 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441800,97.6678691345844,95.42663227533711,1.0234864922486269 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441809,115.60816842786026,95.42663227533711,1.211487460799128 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441793,100.32964352340794,95.42663227533711,1.051379904447681 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441801,89.79322128472565,95.42663227533711,0.9409660505008997 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441812,87.00507328797782,95.42663227533711,0.9117483370568885 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441800,573.2120481616103,569.3868516791151,1.0067180976715824 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441809,613.6272222468941,569.3868516791151,1.0776982651378666 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441793,527.8537935621993,569.3868516791151,0.927056520545855 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441801,559.0849851061164,569.3868516791151,0.981907087347348 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441812,770.8710182474804,569.3868516791151,1.3538616425268528 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441798,588.7680253511933,569.3868516791151,1.0340386744353567 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441800,15970.452737435116,5328.634617598269,2.997100361261652 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441809,4620.033223798378,5328.634617598269,0.8670200821314198 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441793,2950.114505444844,5328.634617598269,0.5536342266181734 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441801,3821.364441269261,5328.634617598269,0.7171376375946064 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441812,44745.51910930679,5328.634617598269,8.397182828323585 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441800,768220.134153567,656386.6079991342,1.1703775256709386 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441809,839924.3034818232,656386.6079991342,1.2796182817351616 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441793,765782.4756612704,656386.6079991342,1.1666637715166188 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441801,734117.8454888137,656386.6079991342,1.1184229485221033 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441812,840909.3996824943,656386.6079991342,1.2811190682970233 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441798,716185.8317687341,656386.6079991342,1.0911036621418682 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441800,15656.365764989474,5223.837669019135,2.9971003612616514 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441809,4529.172164834175,5223.837669019135,0.8670200821314198 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441793,2892.0953278662905,5223.837669019135,0.5536342266181734 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441801,3746.2106051380983,5223.837669019135,0.7171376375946065 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441812,43865.51997223738,5223.837669019135,8.397182828323583 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441800,768220.134153567,656386.6079991342,1.1703775256709386 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441809,839924.3034818232,656386.6079991342,1.2796182817351616 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441793,765782.4756612704,656386.6079991342,1.1666637715166188 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441801,734117.8454888137,656386.6079991342,1.1184229485221033 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441812,840909.3996824943,656386.6079991342,1.2811190682970233 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441798,716185.8317687341,656386.6079991342,1.0911036621418682 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441800,55.73358542016681,50.79723336807032,1.0971775769032204 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441809,54.77671155853383,50.79723336807032,1.0783404513712138 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441793,57.17696647087027,50.79723336807032,1.1255921372050561 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441801,47.357917988383434,50.79723336807032,0.9322932539501503 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441812,53.30840536916703,50.79723336807032,1.0494352120104864 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441800,71.67066488165496,124.85055234194422,0.5740516444441617 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441809,77.60585646082659,124.85055234194422,0.6215900130603946 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441793,119.29091033058744,124.85055234194422,0.9554696242261718 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441801,79.97577672282523,124.85055234194422,0.6405720697477197 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441812,80.2321383013329,124.85055234194422,0.6426254173196675 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441798,194.13770507800433,124.85055234194422,1.5549607225308422 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441800,203.5713125138691,149.81706398084205,1.3587992389164754 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441809,157.43728467123105,149.81706398084205,1.0508635030477131 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441793,184.48080709185652,149.81706398084205,1.2313737980838226 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441801,140.51089645763267,149.81706398084205,0.9378831270889182 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441812,252.64300448912857,149.81706398084205,1.6863433161487897 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441800,3229.062627091891,2791.14294318225,1.1568961865530105 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441809,2993.723986540962,2791.14294318225,1.07257996006745 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441793,2788.2798075011015,2791.14294318225,0.9989742067176667 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441801,2767.8606136101243,2791.14294318225,0.9916584961622995 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441812,3257.498003416942,2791.14294318225,1.167083904238523 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441798,3253.2227002662235,2791.14294318225,1.1655521650056178 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441800,496.8049360096423,222.01180748199775,2.2377410537046623 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441809,250.4271654468435,222.01180748199775,1.1279903005480907 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441793,319.25442123871,222.01180748199775,1.4380064955085659 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441801,154.92222843637427,222.01180748199775,0.6978107614791453 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441812,2263.274075830852,222.01180748199775,10.194386062166418 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441800,4942.795069751508,4330.453784028004,1.1414034917038025 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441809,5851.1665764125155,4330.453784028004,1.351167075837029 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441793,5955.774110013457,4330.453784028004,1.375323328003203 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441801,5033.044999931184,4330.453784028004,1.1622442475877575 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441812,7993.863531746163,4330.453784028004,1.845964402444358 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441798,5526.055725299799,4330.453784028004,1.276091606307295 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441800,232.11785848419268,100.4664893584531,2.3104008109213643 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441809,81.25542898343544,100.4664893584531,0.8087814106206621 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441793,67.80606190188121,100.4664893584531,0.6749122253088473 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441801,90.76153515166882,100.4664893584531,0.9034010816068421 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441812,216.62936330049763,100.4664893584531,2.156235026065144 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441800,172.48115397567292,219.8603821991507,0.7845031117040385 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441809,626.974968884501,219.8603821991507,2.851695983665596 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441793,170.0328784358505,219.8603821991507,0.7733675195826496 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441801,272.2649725868059,219.8603821991507,1.2383539492812619 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441812,169.98055820183563,219.8603821991507,0.7731295493149208 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441798,414.2078109331099,219.8603821991507,1.8839583866361074 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441800,87.46253378136834,115.26780159034894,0.7587768012805697 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441809,106.9715708621507,115.26780159034894,0.928026468677851 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441793,85.04885250887908,115.26780159034894,0.7378370311176299 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441801,92.30272209573492,115.26780159034894,0.8007676109220008 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441812,127.20198149206654,115.26780159034894,1.1035343759233873 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441800,1867.5424450131952,1760.6737631139824,1.0606976057337285 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441809,1694.9908993227928,1760.6737631139824,0.9626944723280133 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441793,1716.6137303040136,1760.6737631139824,0.9749754703381035 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441801,1553.379060661632,1760.6737631139824,0.8822639907544697 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441812,1483.406862435147,1760.6737631139824,0.8425222738660838 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441798,1859.2350241001625,1760.6737631139824,1.0559792864817055 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441800,1213.8226671847358,518.6000624505415,2.3405756286435024 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441809,555.515462354814,518.6000624505415,1.0711827910892184 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441793,753.324318973952,518.6000624505415,1.4526113155757594 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441801,310.57543416933834,518.6000624505415,0.598872728055172 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441812,4856.2128415928255,518.6000624505415,9.364080711147155 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441800,788.9510845338385,841.89306662726494,0.9371155504278957 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441809,913.714402966204,841.89306662726494,1.0853093334366857 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441793,594.8480218210319,841.89306662726494,0.7065600673064951 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441801,556.7980271499797,841.89306662726494,0.6613643100549412 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441812,1916.80430661436,841.89306662726494,2.2767788245285496 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441798,1040.426697776186,841.89306662726494,1.2358181092336027 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441800,385.2580863263167,246.94010350613598,1.5601276619564701 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441809,189.36380892767815,246.94010350613598,0.7668410527048023 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441793,215.43861953030188,246.94010350613598,0.8724326930759088 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441801,216.2515595641949,246.94010350613598,0.8757247465834219 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441812,1029.351811499531,246.94010350613598,4.1684270674728765 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441800,8757.303939069796,6405.278640912654,1.367201089915741 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441809,4250.488339556598,6405.278640912654,0.6635914810024515 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441793,3797.39134317876,6405.278640912654,0.5928534191976526 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441801,7408.674567713001,6405.278640912654,1.1566514094158717 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441812,5737.914541105064,6405.278640912654,0.8958102937872348 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441798,7227.566553762928,6405.278640912654,1.1283766029471454 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441800,219.2341006077055,184.84349394551683,1.1860525676512337 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441809,189.9738236942659,184.84349394551683,1.0277549922869411 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441793,115.9503844955639,184.84349394551683,0.6272895086572028 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441801,109.56507874823852,184.84349394551683,0.5927451186382202 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441812,90.74585792145776,184.84349394551683,0.49093347017236844 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441800,57737.78803442881,66689.05961878091,0.8657760113049899 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441809,50921.59054329641,66689.05961878091,0.7635673802327229 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441793,63386.20010255466,66689.05961878091,0.9504737428431799 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441801,53551.827078782815,66689.05961878091,0.8030076804936922 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441812,44528.78164397802,66689.05961878091,0.6677074455468535 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441798,66513.47695049559,66689.05961878091,0.997367144336882 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441800,729.2533347107177,426.591426110135,1.7094889631523986 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441809,352.95426774654135,426.591426110135,0.8273824698375855 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441793,170.4221638019868,426.591426110135,0.3994973958008902 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441801,433.48227207138984,426.591426110135,1.0161532687707506 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441812,1735.8973117113906,426.591426110135,4.069226912364681 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441800,267764.2598307303,6086.038398766024,43.996478872861026 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441809,3937.3256181662055,6086.038398766024,0.6469439330130613 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441793,6972.1322972307,6086.038398766024,1.1455945297098906 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441801,5459.424168332662,6086.038398766024,0.8970407037588833 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441812,8163.84698085798,6086.038398766024,1.3414057628215494 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441798,6474.6509382148315,6086.038398766024,1.0638531198764043 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441800,219.08265026897257,118.38689307733607,1.8505650800875155 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441809,97.87460166442841,118.38689307733607,0.826735115013889 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441793,126.74258442910744,118.38689307733607,1.0705795306775474 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441801,62.07857143742216,118.38689307733607,0.5243703067439183 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441812,759.9716615466743,118.38689307733607,6.419390202682521 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441800,26.05590878505712,43.003791743375764,0.6058979389665269 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441809,135.93,43.003791743375764,3.1608840636927895 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441793,8.345186666070177,43.003791743375764,0.1940569965520693 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441801,24.69079481246451,43.003791743375764,0.574153901586314 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441812,42.9990748748258,43.003791743375764,0.9998903150545861 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441798,141.47573942738364,43.003791743375764,3.289843376408229 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441800,66.80854636248674,56.77751951238643,1.1766725094059802 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441809,79.972802486469,56.77751951238643,1.4085293470600166 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441793,68.25615049148446,56.77751951238643,1.2021685885131683 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441801,67.68992411542006,56.77751951238643,1.1921958672508228 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441812,70.7502803504742,56.77751951238643,1.246096711481725 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441800,260.09894953013884,232.93832449773902,1.1166000703875736 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441809,219.2716621586787,232.93832449773902,0.9413292665836405 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441793,149.11669840014562,232.93832449773902,0.640155280251417 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441801,196.5889316633589,232.93832449773902,0.8439527161846099 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441812,102.68237507114084,232.93832449773902,0.4408135728311101 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441798,179.93,232.93832449773902,0.7724362248589389 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441800,68.95214693855746,55.88566907011774,1.2338073084898684 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441809,88.00298317470532,55.88566907011774,1.5746967807487664 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441793,67.89247553733266,55.88566907011774,1.2148458928200432 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441801,66.37228710402331,55.88566907011774,1.1876441350419977 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441812,78.78168292086818,55.88566907011774,1.409693830846395 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441800,307.80400764286276,226.42114305345407,1.3594313830055862 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441809,248.66019843403973,226.42114305345407,1.098219870638739 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441793,107.77805078687936,226.42114305345407,0.47600700770879356 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441801,312.39675543468127,226.42114305345407,1.3797154771934432 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441812,101.05362271298912,226.42114305345407,0.44630824378945977 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441798,370.23574088702713,226.42114305345407,1.6351641719237366 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441800,223.75857348297623,212.71806341276286,1.0519020805900725 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441809,225.43005100273797,212.71806341276286,1.0597597937195793 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441793,165.4568045999913,212.71806341276286,0.7778220708926596 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441801,154.79927222590965,212.71806341276286,0.7277203907480753 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441812,630.1866058827975,212.71806341276286,2.9625439220926406 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441800,16244.05410924625,10996.969545575432,1.4771391374619158 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441809,8538.400201284921,10996.969545575432,0.7764321039445179 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441793,8440.5621520487,10996.969545575432,0.7675352847953201 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441801,15607.078139758987,10996.969545575432,1.419216273635895 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441812,9598.900499930742,10996.969545575432,0.8728677896350823 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441798,13325.331595551936,10996.969545575432,1.2117276073491816 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441800,140.94509611803048,147.8550055811589,0.9532656372642351 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441809,129.8489435966955,147.8550055811589,0.8782181102784531 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441793,146.2513611229911,147.8550055811589,0.9891539386721165 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441801,133.85266998624877,147.8550055811589,0.9052968444330136 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441812,181.55961986528325,147.8550055811589,1.227957208155686 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441800,98.99889209044912,92.19915296117537,1.0737505596405759 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441809,119.10450996454112,92.19915296117537,1.2918178328026015 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441793,164.4533801019779,92.19915296117537,1.783675606772965 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441801,74.75100139801312,92.19915296117537,0.8107558366560093 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441812,309.5852751217091,92.19915296117537,3.3577887125717307 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441798,157.90381474661802,92.19915296117537,1.7126384535561903 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441800,6623.650619810928,1229.7970051816276,5.3859706861399355 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441809,1810.5943642296963,1229.7970051816276,1.4722709167455579 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441793,3196.4382639487376,1229.7970051816276,2.5991592518772304 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441801,607.2661438195687,1229.7970051816276,0.49379380601913414 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441812,11047.108554750534,1229.7970051816276,8.982871570027116 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441800,83216.47008506453,50083.06853493704,1.661568919784023 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441809,66622.38468652639,50083.06853493704,1.330237675833537 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441793,50169.01888883493,50083.06853493704,1.0017161559068197 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441801,68694.4420551826,50083.06853493704,1.371610088292865 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441812,83706.47890407995,50083.06853493704,1.6713528414435674 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441798,55320.41613133369,50083.06853493704,1.1045732170492544 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441800,77.79119193633153,35.678906774941794,2.1803132149487907 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441809,48.187288589707904,35.678906774941794,1.3505819809353314 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441793,28.21298821389824,35.678906774941794,0.7907469921055131 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441801,49.60357880218383,35.678906774941794,1.3902774296050375 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441812,87.9535969913886,35.678906774941794,2.465142711523904 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441800,138.92044687898925,67.70693010562654,2.0517906610485177 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441809,149.6815527019168,67.70693010562654,2.2107272101748716 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441793,90.99372538164153,67.70693010562654,1.3439351812242306 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441801,199.1697955321303,67.70693010562654,2.9416456368855366 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441812,12.47129573985388,67.70693010562654,0.1841952621452187 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441798,247.53568409144057,67.70693010562654,3.6559874108200043 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441800,61.90871946873034,64.01321127549492,0.9671241019653358 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441809,69.21238919826035,64.01321127549492,1.0812203890285963 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441793,95.82025666544476,64.01321127549492,1.496882514658751 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441801,77.07679891516739,64.01321127549492,1.204076430152058 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441812,59.75594814410523,64.01321127549492,0.9334939921531569 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441800,714.7096470976965,1060.427767412219,0.6739823956532327 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441809,726.070447401784,1060.427767412219,0.6846958083468776 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441793,539.3547791113874,1060.427767412219,0.5086200075914502 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441801,2611.700256041525,1060.427767412219,2.462874262916468 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441812,525.2620577865395,1060.427767412219,0.49533035057007785 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441798,744.6548080430684,1060.427767412219,0.7022211516209755 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441800,15.574585758637644,57.09593719876665,0.272779229534638 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441809,71.11695352211702,57.09593719876665,1.2455694224711533 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441793,57.456121057035546,57.09593719876665,1.0063083973385882 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441801,110.37537217823692,57.09593719876665,1.9331563258869 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441812,92.20238517791314,57.09593719876665,1.614867706907609 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441800,3.9378101630758935,50.205845180981015,0.0784333009210572 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441809,63.27781165048325,50.205845180981015,1.260367421808769 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441793,54.284284088714344,50.205845180981015,1.0812343441890373 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441801,109.13783970921712,50.205845180981015,2.1738074384725374 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441812,227.58594636140907,50.205845180981015,4.533056769406269 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441798,103.84391623216366,50.205845180981015,2.068363073220443 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441800,2444.56187808283,1506.8779059558976,1.6222693745928318 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441809,1722.5422609628768,1506.8779059558976,1.1431199927708615 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441793,3579.7783184761975,1506.8779059558976,2.375625990883012 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441801,705.5116128968582,1506.8779059558976,0.4681942777900857 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441812,44504.545027398424,1506.8779059558976,29.534274045359158 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441800,15014.520007243647,16162.128318216166,0.9289939859171232 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441809,17357.820745955712,16162.128318216166,1.07398112452751 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441793,13649.242962443352,16162.128318216166,0.8445201457198822 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441801,15807.670689375977,16162.128318216166,0.9780686292138465 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441812,25492.79105123754,16162.128318216166,1.577316461626213 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441798,21731.303335532943,16162.128318216166,1.344581784506674 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441800,67.21869292081152,24.995311385825953,2.6892520714476515 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441809,55.2666201494044,24.995311385825953,2.211079481920131 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441793,46.04760876077059,24.995311385825953,1.8422498543819994 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441801,9.08947385451362,24.995311385825953,0.36364715422861155 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441812,363.6079481790993,24.995311385825953,14.547046146634116 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441800,581.0114323847209,522.7489803443298,1.1114539754855461 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441809,794.6341357562695,522.7489803443298,1.5201065246131167 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441793,844.6495925867434,522.7489803443298,1.6157842948452636 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441801,190.00618718063788,522.7489803443298,0.363475002965061 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441812,710.5356371285989,522.7489803443298,1.3592291211368328 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441798,1288.7833960129196,522.7489803443298,2.4653962886049254 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441800,6.119843328091671,2.8430683750443606,2.1525487680176467 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441809,2.8046137765977823,2.8430683750443606,0.9864742618277768 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441793,3.1029769922898995,2.8430683750443606,1.091418349107233 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441801,2.4640534198282755,2.8430683750443606,0.8666880619041843 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441812,7.217314138179807,2.8430683750443606,2.538565094505402 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441800,1581.1478648357247,1771.7543971110147,0.8924193259595748 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441809,1684.8494261561298,1771.7543971110147,0.9509497642017481 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441793,1637.3989862972321,1771.7543971110147,0.9241681516169173 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441801,1058.4020267007804,1771.7543971110147,0.5973751375622877 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441812,1519.7012768203658,1771.7543971110147,0.8577381149996629 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441798,2280.687119449568,1771.7543971110147,1.2872478957401818 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441800,250.06732888219588,73.62821549612136,3.3963518903343397 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441809,200.22272523791324,73.62821549612136,2.719374955494619 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441793,234.96810087411305,73.62821549612136,3.1912779535786915 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441801,82.1320750613255,73.62821549612136,1.1154972928231857 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441812,418.6874110213024,73.62821549612136,5.6865076547096045 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441800,4504.425643108075,1923.334023596175,2.3419882286935656 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441809,584.5898124071101,1923.334023596175,0.3039460672120108 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441793,589.6909814068966,1923.334023596175,0.3065983205061362 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441801,3172.1432353061173,1923.334023596175,1.6492939845024774 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441812,622.9588025797036,1923.334023596175,0.32389527504687904 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441798,4738.95747671018,1923.334023596175,2.463928479697698 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441800,21.97131335915683,51.40813337414527,0.4273898295285485 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441809,48.36397136350104,51.40813337414527,0.9407844282442817 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441793,24.615456342485505,51.40813337414527,0.47882416121464105 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441801,30.24722212894152,51.40813337414527,0.5883742541049696 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441812,101.03915702170694,51.40813337414527,1.9654313508399555 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441800,9.078804478716687,89.1451395839603,0.10184295544420481 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441809,113.0995324004244,89.1451395839603,1.2687122699931714 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441793,103.49644050717995,89.1451395839603,1.1609880358053963 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441801,48.56947335246659,89.1451395839603,0.544835911179678 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441812,41.913818911346425,89.1451395839603,0.4701750326148784 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441798,2.1868215359654597,89.1451395839603,0.0245310237458973 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441800,21368.444554702983,4771.656231796832,4.478202853824699 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441809,5943.550424106792,4771.656231796832,1.245594849121951 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441793,7775.29663389202,4771.656231796832,1.629475439173481 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441801,5670.28595640291,4771.656231796832,1.1883265853516207 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441812,32907.39936023299,4771.656231796832,6.896431293802835 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441800,339029.2895302829,209884.98459768714,1.6153098811720277 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441809,202349.17974764245,209884.98459768714,0.9640955504059068 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441793,97074.86036759708,209884.98459768714,0.46251455554894805 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441801,141459.29179819638,209884.98459768714,0.6739848115831113 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441812,261008.16673946092,209884.98459768714,1.2435771298254994 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441798,453583.1241378,209884.98459768714,2.1611032585643972 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441800,29.05938839378472,22.903585106474594,1.2687702933271328 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441809,27.875684775213653,22.903585106474594,1.2170882700513772 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441793,180.6543087788205,22.903585106474594,7.887599602376289 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441801,108.53311260822684,22.903585106474594,4.738695365973326 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441812,25.570333897538553,22.903585106474594,1.1164336840135172 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441800,71.76005142637945,83.56495705722055,0.858733779725899 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441809,167.20020794673627,83.56495705722055,2.0008411879186037 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441793,12.892917070855807,83.56495705722055,0.15428616880671006 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441801,16.888216642971898,83.56495705722055,0.20209687454763847 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441812,80.50075997243103,83.56495705722055,0.9633315543656495 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441798,17.497832278512842,83.56495705722055,0.20939198552488117 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441800,2194.3456886146337,1829.6496491832456,1.1993256138377029 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441809,1814.6723034286174,1829.6496491832456,0.9918140908772812 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441793,1273.9971775565807,1829.6496491832456,0.6963066279521285 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441801,2044.3384138372337,1829.6496491832456,1.1173387291658952 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441812,1687.365103119375,1829.6496491832456,0.9222339937444382 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441800,109532.2892013421,96234.19538703516,1.1381847041046542 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441809,95351.4488958754,96234.19538703516,0.9908271016595553 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441793,94392.70256589905,96234.19538703516,0.9808644649261109 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441801,120710.6321979818,96234.19538703516,1.2543424061738886 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441812,195582.70503588812,96234.19538703516,2.03236182574492 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441798,81335.61534537032,96234.19538703516,0.8451841366600962 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441800,64.66918895478564,77.99112650544876,0.8291864966236588 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441809,61.8042814419399,77.99112650544876,0.7924527341917803 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441793,59.34376731639758,77.99112650544876,0.7609040922399242 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441801,50.27466556265947,77.99112650544876,0.6446203281747327 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441812,73.70797053052846,77.99112650544876,0.9450814962312274 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441800,116.87086225991536,110.33780757772625,1.0592095749010326 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441809,248.3779266125912,110.33780757772625,2.251068170242771 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441793,150.56232939170408,110.33780757772625,1.3645579216864727 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441801,217.64839514855316,110.33780757772625,1.972564073246001 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441812,95.47546464273483,110.33780757772625,0.8653014477877694 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441798,156.08832861703118,110.33780757772625,1.414640475859342 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441800,75.43313356810526,67.31067174214355,1.12067123408124 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441809,75.16640368839178,67.31067174214355,1.1167085655650901 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441793,71.75902172944336,67.31067174214355,1.0660868458472785 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441801,69.03603735968056,67.31067174214355,1.0256328687989715 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441812,79.66939550934515,67.31067174214355,1.1836071970065296 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441800,3406.1796716608324,2375.529574917848,1.4338611935734906 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441809,2881.5020287533703,2375.529574917848,1.212993540125898 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441793,2237.625181078003,2375.529574917848,0.9419479364534479 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441801,2343.384459006895,2375.529574917848,0.98646823165227715 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441812,3743.272109432083,2375.529574917848,1.5757632104249997 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441798,3460.6355525511185,2375.529574917848,1.4567848740299503 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441800,125.97664752012945,194.62377093849457,0.6472829444864721 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441809,200.96382275582206,194.62377093849457,1.0325759375987587 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441793,212.5062982737824,194.62377093849457,1.0918825447120697 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441801,151.79251901168317,194.62377093849457,0.7799279516562906 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441812,231.9804014632611,194.62377093849457,1.1919427947810757 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441800,3496.84423161846,3728.1507253933823,0.9379567751380236 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441809,3918.625912288874,3728.1507253933823,1.0510910638880873 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441793,4624.198463442687,3728.1507253933823,1.2403464355521079 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441801,2724.510305235308,3728.1507253933823,0.7307940332664062 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441812,3548.057587015156,3728.1507253933823,0.9516937077807595 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441798,3692.9740198276672,3728.1507253933823,0.9905645699016089 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441800,74.99694365106332,68.78582331086372,1.0902965181085307 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441809,62.34212080614833,68.78582331086372,0.9063222304457363 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441793,70.83998069581246,68.78582331086372,1.0298630922198224 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441801,59.47583466083284,68.78582331086372,0.8646525082943871 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441812,192.5874499259498,68.78582331086372,2.7998131105531656 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441800,810.1886779819276,696.3940975413478,1.1634054350005794 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441809,639.909288240724,696.3940975413478,0.9188895921145137 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441793,584.1364848160749,696.3940975413478,0.8388016022513636 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441801,885.59640867863,696.3940975413478,1.2716885622742495 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441812,860.9602953501875,696.3940975413478,1.2363118791354613 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441798,767.63208375915,696.3940975413478,1.102295505475005 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441800,74.13049354790756,81.2393188807366,0.912495261767702 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441809,57.917435064687176,81.2393188807366,0.7129236909249925 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441793,44.24835280047642,81.2393188807366,0.5446667132381454 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441801,47.609356900053626,81.2393188807366,0.586038356253904 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441812,413.9306844813751,81.2393188807366,5.0952013161145056 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441800,866.3671331986853,543.8205698619286,1.5931121057422462 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441809,338.2712820098062,543.8205698619286,0.6220273758598179 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441793,370.68986382302006,543.8205698619286,0.6816400194592401 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441801,927.0460509705028,543.8205698619286,1.7046910366150216 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441812,330.085777915948,543.8205698619286,0.6069755287111592 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441798,312.7983086163206,543.8205698619286,0.5751866074057063 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441800,501071.71346086625,306516.0644612488,1.634732307885984 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441809,272256.6121741241,306516.0644612488,0.8882295048798138 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441793,230370.0613299633,306516.0644612488,0.7515758162133384 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441801,287492.8498700879,306516.0644612488,0.9379372998782389 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441812,671623.9019969889,306516.0644612488,2.1911540042035833 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441800,402403.31167660735,335923.8645439917,1.1979003403728397 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441809,388818.2040580847,335923.8645439917,1.1574593087808625 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441793,263372.0212781787,335923.8645439917,0.7840229560221919 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441801,389786.1923956216,335923.8645439917,1.160340879397618 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441812,853136.2776421353,335923.8645439917,2.5396715377761168 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441798,348797.3338199069,335923.8645439917,1.0383225803066736 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441800,98.48150389218414,33.931355493730415,2.90237458713905 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441809,46.15389398040162,33.931355493730415,1.360213681676513 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441793,50.943134263017974,33.931355493730415,1.5013586554899307 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441801,28.967911111765,33.931355493730415,0.8537210108543255 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441812,219.587617487157,33.931355493730415,6.4715250626439245 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441800,248.68424854292377,76.3332642617619,3.2578751996002184 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441809,104.91680866250304,76.3332642617619,1.374457252381118 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441793,74.77327128660701,76.3332642617619,0.9795633923134041 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441801,113.72225524718726,76.3332642617619,1.4898125521949528 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441812,10.654556784396318,76.3332642617619,0.13957947282143904 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441798,240.06055288617733,76.3332642617619,3.144900918464093 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441800,153.03679200773425,130.67426801703346,1.1711318098815433 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441809,140.93721964266092,130.67426801703346,1.0785384282718131 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441793,129.4648090881647,130.67426801703346,0.990744475196057 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441801,139.49454300413595,130.67426801703346,1.0674981778811476 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441812,204.5682716161112,130.67426801703346,1.5654824375174279 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441800,6332.736276859706,5444.214081294075,1.163204859746153 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441809,5517.445621057378,5444.214081294075,1.0134512601212582 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441793,4173.165681483905,5444.214081294075,0.7665322522533785 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441801,4734.5681390497,5444.214081294075,0.8696513524913234 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441812,7340.70051436888,5444.214081294075,1.3483489820121135 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441798,6512.127880056486,5444.214081294075,1.196155732088436 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441800,90.48080860772755,100.67607722942154,0.8987319639157084 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441809,56.63159556602124,100.67607722942154,0.5625129338022246 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441793,62.66641416312612,100.67607722942154,0.6224558593033114 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441801,42.48664766106602,100.67607722942154,0.4220133405103486 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441812,261.61192903761463,100.67607722942154,2.598551078241269 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441800,622.5130093761042,599.1099853739104,1.039062984382722 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441809,632.6094564109488,599.1099853739104,1.0559153942595885 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441793,629.0292739252448,599.1099853739104,1.0499395591489957 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441801,618.7706599478591,599.1099853739104,1.032816469519663 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441812,596.6699185910736,599.1099853739104,0.9959271805805174 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441798,636.2332930840327,599.1099853739104,1.0619640944341018 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441800,70.12544905337052,114.30018844822946,0.6135199775732021 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441809,98.49943063524873,114.30018844822946,0.8617608769723293 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441793,57.69255795825453,114.30018844822946,0.5047459566034356 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441801,77.96565523308246,114.30018844822946,0.6821130944013781 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441812,46.142548882228745,114.30018844822946,0.40369617503411476 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441800,2520.3941459300668,1759.6959467320276,1.432289567189576 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441809,2592.680412038859,1759.6959467320276,1.4733684059759222 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441793,1449.803203430916,1759.6959467320276,0.8238941540573412 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441801,1962.8398606735495,1759.6959467320276,1.1154426219590863 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441812,2389.7147238793164,1759.6959467320276,1.358027066162942 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441798,2258.5983574202673,1759.6959467320276,1.2835162583710913 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441800,30.103984957631816,38.77498679262034,0.7763764077763969 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441809,28.949474259905415,38.77498679262034,0.7466017826062827 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441793,27.373267836884292,38.77498679262034,0.7059516998235051 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441801,49.072594923032014,38.77498679262034,1.2655734787347888 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441812,31.930468569847942,38.77498679262034,0.8234810946711902 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441800,2217.238684718533,2284.874121495706,0.970398615774554 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441809,2627.7628362156324,2284.874121495706,1.1500689738196463 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441793,3126.299742751467,2284.874121495706,1.3682590709657798 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441801,1010.4202170694005,2284.874121495706,0.4422213931015015 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441812,2357.878541002787,2284.874121495706,1.0319511778877744 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441798,1947.4927178024425,2284.874121495706,0.8523413607256362 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441800,673.0841861869478,306.4947439651267,2.1960708933512154 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441809,355.6660515275976,306.4947439651267,1.160431160829517 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441793,435.0472201379905,306.4947439651267,1.4194279957619458 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441801,317.41239199266994,306.4947439651267,1.0356209959306364 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441812,625.1108100655439,306.4947439651267,2.0395482218666356 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441800,47204.84092331685,53872.22448470133,0.8762370845986156 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441809,59061.74442411738,53872.22448470133,1.0963301587980607 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441793,56978.509342410805,53872.22448470133,1.057660230061441 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441801,35352.35747008495,53872.22448470133,0.6562260572723211 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441812,55506.199038861974,53872.22448470133,1.030330556604817 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441798,52623.25017989367,53872.22448470133,0.9768159878907109 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441800,103.57713062262656,320.29657233769314,0.3233788293975989 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441809,86.74431971313112,320.29657233769314,0.270825001591573 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441793,89.3851789482972,320.29657233769314,0.27907004528933005 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441801,85.19045238436233,320.29657233769314,0.265973662354853 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441812,105.46941277451458,320.29657233769314,0.32928673574226297 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441800,5478.005203202924,6299.521117687065,0.8695907356866248 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441809,8611.737990096812,6299.521117687065,1.3670464515021263 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441793,6797.140866617686,6299.521117687065,1.0789932662553445 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441801,3221.6089536273166,6299.521117687065,0.5114053740659836 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441812,12523.5773146983,6299.521117687065,1.9880205305663712 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441798,5440.80732265815,6299.521117687065,0.8636858613557278 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441800,3327.2798342874203,1965.7827420843205,1.6925979474005879 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441809,2524.482823562973,1965.7827420843205,1.2842125274160574 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441793,2961.347575988698,1965.7827420843205,1.5064470312974563 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441801,1346.8686138533217,1965.7827420843205,0.6851563934401195 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441812,1926.3406380435067,1965.7827420843205,0.9799356748859269 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441800,2421.679109784028,6243.797224888628,0.38785358053123253 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441809,3840.584507733128,6243.797224888628,0.6151039775001074 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441793,6173.657109833808,6243.797224888628,0.9887664329047664 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441801,3773.7219761092697,6243.797224888628,0.6043953447217502 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441812,11482.54867477801,6243.797224888628,1.8390329251896593 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441798,2485.3121126433784,6243.797224888628,0.39804497537757716 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441800,787.5242194721534,477.14850073021523,1.6504803394895877 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441809,601.5795923243775,477.14850073021523,1.2607806404164243 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441793,691.2873088711755,477.14850073021523,1.4487886010607767 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441801,321.45926054581406,477.14850073021523,0.6737090445717873 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441812,446.2474062290564,477.14850073021523,0.9352379930904768 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441800,172.38211956747148,205.1372392304115,0.8403258238931974 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441809,163.25756386583836,205.1372392304115,0.7958455738134722 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441793,104.84030005266638,205.1372392304115,0.5110739544218447 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441801,239.12070289772856,205.1372392304115,1.1656620894129643 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441812,365.27713364813866,205.1372392304115,1.7806476045914656 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441798,178.2314865629667,205.1372392304115,0.8688402321861021 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441800,105.65087022272763,44.32085041603382,2.3837735339235873 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441809,29.343946574832806,44.32085041603382,0.6620799533263725 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441793,25.538451026207618,44.32085041603382,0.576217531624092 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441801,54.7295260291876,44.32085041603382,1.2348482828160776 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441812,57.18277117144258,44.32085041603382,1.2902002248304274 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441800,100.54947610571418,73.02499011367847,1.3769187226069892 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441809,329.4018980414478,73.02499011367847,4.510810580441925 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441793,47.00826836854009,73.02499011367847,0.6437285139698343 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441801,77.33090724330881,73.02499011367847,1.058964980658365 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441812,42.088372769062815,73.02499011367847,0.5763557475809798 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441798,68.33205326117074,73.02499011367847,0.9357351935932863 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441800,112.24169171798532,446.9213615105917,0.2511441640171529 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441809,100.48422728721894,446.9213615105917,0.22483648341977394 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441793,86.33361595352459,446.9213615105917,0.19317406458647993 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441801,65.41664269733378,446.9213615105917,0.14637170726462012 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441812,66.99277522190279,446.9213615105917,0.1498983512344713 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441800,2435.2042120179917,2631.000022355788,0.9255812205723657 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441809,2293.8343278033667,2631.000022355788,0.8718488439044084 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441793,3244.956016233101,2631.000022355788,1.233354613706 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441801,1941.436095637695,2631.000022355788,0.7379080498446138 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441812,1944.2683880068,2631.000022355788,0.7389845577674716 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441798,2417.436680423537,2631.000022355788,0.9188280729313612 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441800,32.51081831461623,48.89133349009634,0.6649607608105386 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441809,41.06199427454982,48.89133349009634,0.8398624325284056 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441793,29.405860052271947,48.89133349009634,0.6014534264693053 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441801,29.94450054276605,48.89133349009634,0.6124705219756739 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441812,79.18132720951256,48.89133349009634,1.6195370745114142 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441800,199.5392636705925,307.70649021557807,0.6484727167463904 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441809,183.37901841672235,307.70649021557807,0.5959543404113695 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441793,223.06619229566357,307.70649021557807,0.7249317105381307 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441801,256.78078849500776,307.70649021557807,0.8344990978744323 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441812,165.33177323106514,307.70649021557807,0.5373034969630777 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441798,156.8099582880691,307.70649021557807,0.5096088749321102 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441800,229.06261181651251,154.19153082843468,1.4855719415055626 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441809,170.4584015893661,154.19153082843468,1.1054978225686805 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441793,214.43996129149633,154.19153082843468,1.3907376114586907 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441801,150.47783579650223,154.19153082843468,0.9759150518061553 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441812,114.73038711196922,154.19153082843468,0.7440771000556902 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441800,6780.073430841338,6593.957266089812,1.0282252609838178 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441809,7175.613179186064,6593.957266089812,1.088210446265323 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441793,6538.135475337439,6593.957266089812,0.9915344021048721 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441801,6412.722223461658,6593.957266089812,0.9725149807142099 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441812,7139.507978080347,6593.957266089812,1.0827349480707271 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441798,6825.752374180634,6593.957266089812,1.035152655490028 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441800,163.87122197219074,127.96554716912783,1.2805886083979117 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441809,108.67020638088268,127.96554716912783,0.8492145642706225 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441793,107.51179451066744,127.96554716912783,0.8401620349309542 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441801,89.17648690338687,127.96554716912783,0.6968788777617249 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441812,236.99013420424424,127.96554716912783,1.8519839085361174 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441800,1434.3761585685804,1681.9358703135756,0.8528126332790318 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441809,1661.166147034653,1681.9358703135756,0.9876512989314805 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441793,1308.501613410992,1681.9358703135756,0.7779735461418267 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441801,1485.5129490714787,1681.9358703135756,0.8832161649507622 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441812,1868.4817262941751,1681.9358703135756,1.1109113963696013 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441798,1892.462078162691,1681.9358703135756,1.1251689862645389 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441800,47.35539356260724,45.403354316773296,1.0429932826595767 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441809,46.879448069059166,45.403354316773296,1.0325106762374285 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441793,48.22312815173146,45.403354316773296,1.0621049672956973 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441801,43.49110438518453,45.403354316773296,0.9578830692056968 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441812,48.699293841422694,45.403354316773296,1.0725924234948383 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441800,149.40026190717026,171.72890790902974,0.8699773598182569 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441809,164.08470386289696,171.72890790902974,0.9554867952099121 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441793,154.30933968970507,171.72890790902974,0.8985635649150441 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441801,169.1456017456969,171.72890790902974,0.9849570687033 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441812,161.26010621737927,171.72890790902974,0.9390387919010343 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441798,155.48216630512457,171.72890790902974,0.9053930884338263 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441800,29.94073609057763,385.5886159476326,0.07764942960516222 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441809,732.1558360118771,385.5886159476326,1.8988004462022612 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441793,372.7633958153404,385.5886159476326,0.9667385923705952 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441801,111.15575766359662,385.5886159476326,0.2882755171348027 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441812,20.98991614375098,385.5886159476326,0.054436036946178025 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441800,259.08705016675395,430.1288265554666,0.6023475623374519 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441809,415.9035042749699,430.1288265554666,0.966927763492591 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441793,325.67157782195335,430.1288265554666,0.757148923102825 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441801,358.379338338215,430.1288265554666,0.8331907005818889 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441812,275.43422933110486,430.1288265554666,0.6403528718054582 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441798,369.2617842136464,430.1288265554666,0.8584911343207285 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441800,103324.07227124766,54695.927744901994,1.8890633458699877 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441809,55388.06086825049,54695.927744901994,1.0126541984364277 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441793,44390.20261143996,54695.927744901994,0.8115814913767033 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441801,51605.19725626822,54695.927744901994,0.94349249357193965 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441812,142954.2876281886,54695.927744901994,2.613618481707038 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441800,150943.29416410028,97212.60478924697,1.5527131948715838 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441809,103702.19803207272,97212.60478924697,1.0667567056442415 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441793,71586.57416470756,97212.60478924697,0.7363918940337458 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441801,86808.94200504188,97212.60478924697,0.8929803104570667 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441812,378357.3541774057,97212.60478924697,3.8920606540444966 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441798,110535.39995128971,97212.60478924697,1.1370480216112513 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441800,123370.40451826827,62941.57202670208,1.9600782208923875 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441809,69235.13044418339,62941.57202670208,1.0999904866502437 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441793,60216.639736125726,62941.57202670208,0.9567069553105483 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441801,64305.96924116891,62941.57202670208,1.0216772026902665 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441812,174089.9483795148,62941.57202670208,2.7658976853272677 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441800,22110.185631871984,14728.399701289269,1.5011940251687046 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441809,14723.631866049962,14728.399701289269,0.9996762828728168 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441793,10467.66204642906,14728.399701289269,0.7107127901691017 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441801,12573.688209775062,14728.399701289269,0.8537036246154026 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441812,74650.28470987077,14728.399701289269,5.068458639354835 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441798,16316.007908384896,14728.399701289269,1.107792308688951 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441800,10530.710870596997,3575.9352491809864,2.944882984950272 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441809,4534.269912212454,3575.9352491809864,1.2679955301905872 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441793,6359.13596521254,3575.9352491809864,1.7783140694924506 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441801,3310.148765642267,3575.9352491809864,0.9256735748781821 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441812,34777.142375506424,3575.9352491809864,9.725327768021415 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441800,14962.680965390377,12966.336321671553,1.1539636636126884 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441809,11358.834309776144,12966.336321671553,0.8760249640286842 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441793,10722.993115609488,12966.336321671553,0.8269871187659534 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441801,14264.087543211688,12966.336321671553,1.1000861916076565 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441812,29391.83556237996,12966.336321671553,2.2667802865220543 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441798,9914.161053377398,12966.336321671553,0.7646077355565088 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441800,214.07616566795656,103.34580193186551,2.071454879309893 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441809,136.65915783906203,103.34580193186551,1.3223484194274244 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441793,163.61965419168703,103.34580193186551,1.5832249702756118 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441801,81.08097707863126,103.34580193186551,0.7845599488606887 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441812,666.4709890552555,103.34580193186551,6.448941094817289 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441800,269.63625420099845,211.8154700640626,1.2729771537435308 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441809,279.00017114085097,211.8154700640626,1.3171850528975464 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441793,223.2943616517199,211.8154700640626,1.054192885836835 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441801,251.4515386133901,211.8154700640626,1.1871254660357895 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441812,337.28723765268745,211.8154700640626,1.5923635679238939 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441798,193.06095879201445,211.8154700640626,0.91145825530885 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441800,56.18737779417096,76.10596635595309,0.7382782255385675 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441809,66.09502234395067,76.10596635595309,0.8684604572895047 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441793,51.77009573795965,76.10596635595309,0.6802370197341321 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441801,37.94948227936208,76.10596635595309,0.4986400422520045 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441812,149.7254192201565,76.10596635595309,1.9673282712143743 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441800,1358.19304507642,1382.686999693948,0.9822852499351266 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441809,2511.767826802767,1382.686999693948,1.816584539638209 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441793,1261.563454150618,1382.686999693948,0.912399881122669 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441801,1196.3100144261166,1382.686999693948,0.8652066698326626 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441812,2221.7770634029143,1382.686999693948,1.6068546705759839 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441798,3660.122798965878,1382.686999693948,2.6471087091843857 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441800,33.058387406854095,30.899530320120164,1.0698669871149529 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441809,33.15527824954591,30.899530320120164,1.0730026607542613 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441793,34.74232876306584,30.899530320120164,1.1243642994936867 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441801,30.30251393998249,30.899530320120164,0.9806787878665932 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441812,32.33103400412862,30.899530320120164,1.0463276842456188 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441800,29.60702995488144,31.68183515511672,0.9345112052355278 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441809,31.32166313560588,31.68183515511672,0.9886315922752767 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441793,31.35461862111854,31.68183515511672,0.9896717935562728 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441801,30.721908629573047,31.68183515511672,0.9697010441205884 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441812,33.683620205691895,31.68183515511672,1.0631839993098342 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441798,30.537934501797075,31.68183515511672,0.9638941163692375 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441800,570.1084600908886,628.1906149122311,0.9075405562538409 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441809,404.6245237293365,628.1906149122311,0.6441110613947478 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441793,298.9246073024245,628.1906149122311,0.47585016427567817 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441801,342.5540015347012,628.1906149122311,0.5453026412732412 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441812,966.8756358531268,628.1906149122311,1.539143713549773 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441800,14355.660464691911,10551.186365326936,1.3605731116518944 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441809,15198.493895672722,10551.186365326936,1.4404535536987253 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441793,10279.754505480616,10551.186365326936,0.9742747544732702 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441801,12118.950557490149,10551.186365326936,1.1485865321567217 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441812,20411.180535059368,10551.186365326936,1.9344915186157754 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441798,15055.771795954768,10551.186365326936,1.4269269136815455 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441800,38.57883006299915,102.14043933131707,0.37770378035930946 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441809,107.2481581855354,102.14043933131707,1.0500068228378205 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441793,74.72307167558004,102.14043933131707,0.7315718648242524 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441801,169.90169251369284,102.14043933131707,1.6634125878642039 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441812,60.8923428418359,102.14043933131707,0.5961629227412754 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441800,3944.070762933475,2995.2816068385046,1.3167612534089608 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441809,5036.32086336854,2995.2816068385046,1.6814181517591382 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441793,5933.83114455092,2995.2816068385046,1.981059520748712 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441801,3108.2581232989382,2995.2816068385046,1.037718161859138 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441812,4259.010078423974,2995.2816068385046,1.4219063972817316 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441798,4191.211070577609,2995.2816068385046,1.3992711272985774 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441800,51.309407282775965,35.73806763844074,1.435707375168385 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441809,39.388601932528786,35.73806763844074,1.1021469412118254 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441793,40.926937906606575,35.73806763844074,1.1451916852545367 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441801,36.346219112892,35.73806763844074,1.0170169098285862 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441812,67.40360166354354,35.73806763844074,1.8860449408026352 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441800,248.03314027088285,271.6614200921023,0.9130230571083349 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441809,311.34409809876706,271.6614200921023,1.1460740284476576 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441793,245.6123221318854,271.6614200921023,0.9041118979964643 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441801,228.65984310756383,271.6614200921023,0.8417089295566538 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441812,318.58725580772096,271.6614200921023,1.1727364735843215 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441798,323.6688286403662,271.6614200921023,1.1914420109069286 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441800,174.38927752465355,166.02715311669658,1.050366004903303 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441809,171.9263819294141,166.02715311669658,1.0355317109399034 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441793,188.6015280669889,166.02715311669658,1.135967969856264 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441801,164.2968556703257,166.02715311669658,0.9895782261281401 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441812,171.06936374715818,166.02715311669658,1.0303697951558415 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441800,1645.7955198103418,1793.9624976146763,0.9174079848372844 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441809,1633.443045494438,1793.9624976146763,0.9105224037104056 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441793,1913.3757418975308,1793.9624976146763,1.0665639579654709 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441801,1591.6287771027542,1793.9624976146763,0.8872140745523092 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441812,1615.3924007197577,1793.9624976146763,0.9004605184710648 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441798,1571.3380711081556,1793.9624976146763,0.8759035226196027 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441800,43.86332880847425,59.13775760336051,0.7417144407582629 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441809,47.70919494688249,59.13775760336051,0.8067467702591992 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441793,53.548956386034455,59.13775760336051,0.9054952124696647 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441801,47.43590969011328,59.13775760336051,0.8021256065924577 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441812,112.86618655159964,59.13775760336051,1.9085300343749592 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441800,331.9984575533297,238.79765196261823,1.3902919682196089 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441809,365.43758466896713,238.79765196261823,1.530323190640808 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441793,331.85788732142026,238.79765196261823,1.3897033098691014 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441801,212.09473756066652,238.79765196261823,0.8881776509003035 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441812,474.7678982971875,238.79765196261823,1.9881598265108087 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441798,341.5335198842476,238.79765196261823,1.4302214325696627 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441800,365.3549264945014,386.8144501381946,0.9445224354053307 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441809,321.80748102909035,386.8144501381946,0.8319427594137715 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441793,283.1311441535923,386.8144501381946,0.7319559650691434 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441801,280.2945768024405,386.8144501381946,0.724622817741947 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441812,1119.3328166478454,386.8144501381946,2.8937202740175527 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441800,6815.811322573465,5555.372966797932,1.2268863608813718 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441809,6606.363751917519,5555.372966797932,1.1891845590567736 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441793,8667.8489322112,5555.372966797932,1.5602640874006468 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441801,7235.419900765809,5555.372966797932,1.3024183873897923 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441812,8459.949061968558,5555.372966797932,1.5228408808067477 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441798,8594.350651196888,5555.372966797932,1.5470339619970819 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441800,1.4846157250613934,84.54153084580483,0.017560785926258916 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441809,15.286071373251438,84.54153084580483,0.1808113860764088 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441793,41.92951255882671,84.54153084580483,0.4959634884693759 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441801,37.964133477841784,84.54153084580483,0.44905897844557024 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441812,63.4982860442711,84.54153084580483,0.7510898538149909 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441800,142.31690225197937,122.00200397429413,1.166512824510371 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441809,225.51682194492955,122.00200397429413,1.8484681775591656 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441793,11.919991850780631,122.00200397429413,0.09770324636054485 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441801,217.0014059377648,122.00200397429413,1.778670832189667 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441812,210.1579148188187,122.00200397429413,1.7225775640791856 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441798,109.4387706934472,122.00200397429413,0.8970243695054877 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441800,164.76442615037033,143.84455848940917,1.1454338480416095 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441809,115.95498857644237,143.84455848940917,0.8061131390311145 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441793,60.906716779807326,143.84455848940917,0.42342037418323125 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441801,66.5136221282912,143.84455848940917,0.462399292867157 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441812,73.3658503558874,143.84455848940917,0.5100356323961265 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441800,4300.476136643299,5334.764851653101,0.8061229044258054 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441809,4426.954980416411,5334.764851653101,0.8298313240638181 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441793,5640.2765845433105,5334.764851653101,1.0572680786099766 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441801,18074.255374399523,5334.764851653101,3.388013507061852 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441812,3971.023630539368,5334.764851653101,0.7443671353778328 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441798,4886.548371274506,5334.764851653101,0.9159819611843427 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441800,168.552565115725,159.70733471984832,1.0553839960537355 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441809,181.66898946523105,159.70733471984832,1.1375118731015512 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441793,130.54340162716608,159.70733471984832,0.8173913981856854 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441801,192.09180131334952,159.70733471984832,1.2027738215674855 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441812,317.2769167641083,159.70733471984832,1.986614561696003 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441800,61661.56345428533,82077.5827732141,0.7512594958438333 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441809,109461.1244692666,82077.5827732141,1.3336299726530088 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441793,115769.48723628474,82077.5827732141,1.4104885076375073 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441801,37477.54260228206,82077.5827732141,0.4566111882928502 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441812,93279.95889944788,82077.5827732141,1.1364852100626148 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441798,126713.14295459908,82077.5827732141,1.5438215731171816 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441800,351435.5551038355,170961.68742491837,2.055639251093472 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441809,491977.06286872306,170961.68742491837,2.8777035970985354 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441793,294155.0817137308,170961.68742491837,1.7205906548092278 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441801,332713.00931934535,170961.68742491837,1.9461261428263783 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441812,460163.6528371273,170961.68742491837,2.6916185712030853 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441800,75540.87043699095,55195.40432138408,1.3686079731772982 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441809,76682.58194419355,55195.40432138408,1.389292874778069 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441793,41545.06998791248,55195.40432138408,0.7526907447947959 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441801,58628.3378428985,55195.40432138408,1.0621960027962767 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441812,209634.7728084175,55195.40432138408,3.7980475980896067 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441798,47991.021349674345,55195.40432138408,0.869474948860578 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441800,819.7204378865496,546.121028905539,1.5009867675839568 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441809,511.10073178548464,546.121028905539,0.9358744760474849 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441793,612.9381287507568,546.121028905539,1.1223485203987174 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441801,353.8834530062925,546.121028905539,0.6479945548251406 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441812,2804.976261834179,546.121028905539,5.1361806511196395 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441800,2180.905664506316,1228.731327313693,1.7749247667301757 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441809,984.3435961425334,1228.731327313693,0.8011056398265266 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441793,824.6351552085712,1228.731327313693,0.6711273139030525 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441801,1589.2,1228.731327313693,1.2933665518843567 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441812,1716.7381107277647,1228.731327313693,1.397163132872158 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441798,2123.3832111481443,1228.731327313693,1.7281102580743821 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441800,73.18154864247087,76.68368758811918,0.9543300660701285 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441809,73.10295571056865,76.68368758811918,0.9533051684110023 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441793,42.558955122326886,76.68368758811918,0.5549935906958218 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441801,53.46008875157811,76.68368758811918,0.6971507296143754 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441812,107.25984705067864,76.68368758811918,1.3987309481879522 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441800,87.99162500196175,81.06808963980528,1.0854039535521132 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441809,84.03121405337782,81.06808963980528,1.0365510575953873 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441793,171.6605019480862,81.06808963980528,2.117485470680181 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441801,103.43504000238308,81.06808963980528,1.275903261837755 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441812,157.5549330191419,81.06808963980528,1.9434889081410005 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441798,121.0295087770986,81.06808963980528,1.4929364848098239 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441800,37.32333471367989,34.254424530644805,1.089591643271939 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441809,24.484441181774017,34.254424530644805,0.714781857154531 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441793,43.951611133743235,34.254424530644805,1.2830929649518152 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441801,39.461465912667,34.254424530644805,1.152010768050237 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441812,62.81186086909484,34.254424530644805,1.8336860633259768 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441800,46.82323831617703,60.87738129746832,0.7691401521918659 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441809,150.320305323452,60.87738129746832,2.4692308065771433 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441793,34.67785643894844,60.87738129746832,0.5696344964232318 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441801,80.36022450640706,60.87738129746832,1.320034186650354 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441812,57.18296569156275,60.87738129746832,0.939313821863438 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441798,145.48563957472211,60.87738129746832,2.389814352621839 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441800,100.77748003218028,81.37032235510941,1.2385041267549097 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441809,70.16249139748275,81.37032235510941,0.862261440863975 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441793,64.5017290173439,81.37032235510941,0.7926935417049348 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441801,64.22867279712051,81.37032235510941,0.7893378192213523 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441812,122.65246813957113,81.37032235510941,1.5073366380964022 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441800,485.7109654780291,592.3362991324378,0.8199918968150746 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441809,539.390533989121,592.3362991324378,0.9106153628928978 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441793,385.3262959751294,592.3362991324378,0.6505194710158664 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441801,292.2246954690431,592.3362991324378,0.4933425418922468 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441812,733.1597668809965,592.3362991324378,1.237742424286364 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441798,920.4352992190178,592.3362991324378,1.5539066246102566 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441800,2822.4440039286537,1509.2244087879828,1.8701287810440874 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441809,2643.0592871119006,1509.2244087879828,1.7512699050729439 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441793,2172.5514404261908,1509.2244087879828,1.439515175990897 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441801,1321.0014779377811,1509.2244087879828,0.8752849942300109 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441812,2882.39862773243,1509.2244087879828,1.909854234366118 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441800,1017690.7220831204,911297.6405793307,1.1167489926081158 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441809,1050696.7749728984,911297.6405793307,1.1529677332478867 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441793,971595.5184176888,911297.6405793307,1.0661670514147557 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441801,949524.339258376,911297.6405793307,1.0419475448819815 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441812,1151418.2455783896,911297.6405793307,1.263493061220272 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441798,989953.2862860494,911297.6405793307,1.0863116968641724 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441800,2021.5370998946776,749.6106308195243,2.6967828587017215 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441809,711.6920404438781,749.6106308195243,0.9494156181667394 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441793,1326.3694012783342,749.6106308195243,1.7694111405920947 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441801,663.9334593706313,749.6106308195243,0.8857044338402392 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441812,3991.104227491409,749.6106308195243,5.3242364280880965 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441800,2792.1724981520965,2138.7943755926544,1.3054889848297795 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441809,2592.2422381609435,2138.7943755926544,1.2120109664317964 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441793,1789.7725566788956,2138.7943755926544,0.8368137569012235 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441801,1868.1130379461188,2138.7943755926544,0.8734420939499944 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441812,5425.046778107443,2138.7943755926544,2.536497589490891 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441798,2672.8819765230696,2138.7943755926544,1.249714328326874 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441800,912.9217515136172,613.8984432679271,1.487089210804833 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441809,763.9642522872919,613.8984432679271,1.2444472871123908 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441793,482.2635418649184,613.8984432679271,0.7855754435501011 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441801,424.6770267216611,613.8984432679271,0.6917708154804962 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441812,3897.92507159078,613.8984432679271,6.349462381499455 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441800,9936.40661023629,6365.76448478505,1.5609133253335885 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441809,5408.975284241946,6365.76448478505,0.8496976753020087 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441793,4832.956677249336,6365.76448478505,0.7592107261901834 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441801,8549.245426798056,6365.76448478505,1.3430037267686843 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441812,5393.5151102123255,6365.76448478505,0.8472690315677688 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441798,8697.515329850221,6365.76448478505,1.3662954937522962 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441800,40.78201839517924,70.21289390855102,0.5808337489734563 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441809,62.02245104619393,70.21289390855102,0.8833484505990487 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441793,58.463391128893235,70.21289390855102,0.8326589017259286 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441801,44.37219518555121,70.21289390855102,0.6319664767463352 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441812,101.90602815211147,70.21289390855102,1.4513862408924387 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441800,1607.7562829428543,2003.7789126851078,0.8023621132874512 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441809,1682.0694821585207,2003.7789126851078,0.8394486395230653 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441793,2114.099338167322,2003.7789126851078,1.055056186480365 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441801,2200.3142198505625,2003.7789126851078,1.0980823312997605 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441812,1403.7756529904914,2003.7789126851078,0.7005641411354115 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441798,1726.8062922878971,2003.7789126851078,0.8617748601685497 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441800,698.9760710260049,700.7857837159185,0.9974175950312268 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441809,681.5869207580105,700.7857837159185,0.9726038064640724 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441793,483.28333109439586,700.7857837159185,0.6896306151243319 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441801,455.3041732122976,700.7857837159185,0.6497052077712622 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441812,2404.76553051884,700.7857837159185,3.4315272746652545 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441800,7839.398117683048,4688.560133729121,1.6720267830814528 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441809,3789.455138541457,4688.560133729121,0.8082343044467798 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441793,4295.111372089002,4688.560133729121,0.9160832429534856 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441801,7230.977337067308,4688.560133729121,1.5422596982489878 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441812,4691.13,4688.560133729121,1.000548114175265 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441798,8415.49499778299,4688.560133729121,1.7948996616770683 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441800,392.25947756601744,384.65137963543384,1.0197792035421644 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441809,372.3778589849727,384.65137963543384,0.9680918325001362 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441793,440.24056553147415,384.65137963543384,1.1445183582825746 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441801,309.8912962046532,384.65137963543384,0.8056419724748238 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441812,981.5958440532702,384.65137963543384,2.5519103687697946 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441800,318.993609041316,772.5530415852671,0.4129083595176144 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441809,526.2142027439137,772.5530415852671,0.6811366655992062 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441793,363.82085749313353,772.5530415852671,0.4709331759882514 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441801,95.01992072814711,772.5530415852671,0.12299468853707142 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441812,796.3045860860807,772.5530415852671,1.030744224955837 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441798,304.83982618418145,772.5530415852671,0.39458756845828313 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441800,279.7217569541112,216.68366112664066,1.2909222388975048 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441809,166.48298748423116,216.68366112664066,0.7683227550181103 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441793,186.4418363295679,216.68366112664066,0.8604332941402631 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441801,214.86407000793747,216.68366112664066,0.9916025458069045 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441812,312.9509744295904,216.68366112664066,1.4442758295775997 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441800,676.3552849559718,615.8359185894908,1.0982719009068105 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441809,428.83693231941487,615.8359185894908,0.6963493349033977 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441793,528.2232411936337,615.8359185894908,0.8577337327180835 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441801,473.9520837785619,615.8359185894908,0.7696077306827128 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441812,948.035369688798,615.8359185894908,1.5394285085874433 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441798,521.1191756272673,615.8359185894908,0.8461980860434991 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441800,60.66314293464758,101.73138829665541,0.5963070390600576 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441809,84.72863200991068,101.73138829665541,0.832866172658889 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441793,139.03702047819246,101.73138829665541,1.3667071963350326 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441801,57.13995571380649,101.73138829665541,0.5616747856343278 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441812,72.91678388747872,101.73138829665541,0.7167579751772244 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441800,22.65673963758315,93.53234569214308,0.2422342716834735 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441809,159.6465423561154,93.53234569214308,1.7068591744890458 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441793,59.72306110666387,93.53234569214308,0.6385284220630931 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441801,164.3970462864183,93.53234569214308,1.7576491327131123 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441812,146.7202713331073,93.53234569214308,1.5686580962700276 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441798,102.13828958180636,93.53234569214308,1.0920103502802048 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441800,73.84069271290879,42.30806113801961,1.7453102488441092 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441809,43.66392457836356,42.30806113801961,1.0320474019341321 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441793,68.24392665383361,42.30806113801961,1.6130242043284526 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441801,31.898907824699975,42.30806113801961,0.7539676120027732 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441812,175.91584381638478,42.30806113801961,4.15797460541864 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441800,145.72719205367378,205.3077634331321,0.7097987412499213 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441809,131.36418437998765,205.3077634331321,0.6398403167193063 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441793,398.81586918091426,205.3077634331321,1.942526977606509 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441801,289.19107081539266,205.3077634331321,1.4085734800261511 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441812,579.7196517610549,205.3077634331321,2.8236616193516095 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441798,95.78545989760327,205.3077634331321,0.46654572772061886 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441800,1626.789469587233,761.179367641068,2.1371959603013586 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441809,970.7592694109621,761.179367641068,1.275335762738016 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441793,1224.020797195349,761.179367641068,1.6080582964152708 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441801,1300.703718001059,761.179367641068,1.7088005446495527 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441812,2607.2029501231104,761.179367641068,3.4252149505877436 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441800,445954.8740274869,258075.7105503754,1.7280001790034332 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441809,366600.8516341485,258075.7105503754,1.4205166803661262 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441793,176120.55547791935,258075.7105503754,0.6824375494397459 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441801,220157.18024557,258075.7105503754,0.8530720685649189 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441812,471889.7857487991,258075.7105503754,1.8284936026813263 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441798,534017.8904780633,258075.7105503754,2.0692295657704873 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441800,151.84582274621573,131.47736122215045,1.1549199142326088 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441809,118.89607455050808,131.47736122215045,0.9043083421001702 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441793,124.70858322854232,131.47736122215045,0.9485175399727466 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441801,98.68895486504412,131.47736122215045,0.7506155732643168 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441812,313.0037652800915,131.47736122215045,2.38066662101033 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441800,2717.503920015728,3004.2024881525895,0.9045674952778684 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441809,2876.6675929601593,3004.2024881525895,0.9575478365072333 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441793,2727.056453639467,3004.2024881525895,0.9077472189021615 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441801,3310.0123035753277,3004.2024881525895,1.1017940091018277 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441812,2387.6304761167553,3004.2024881525895,0.7947634973117307 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441798,2285.2046699936736,3004.2024881525895,0.7606693220598929 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441800,71.86325557861691,96.13121274223809,0.747553822828677 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441809,83.00030723102819,96.13121274223809,0.8634064302671545 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441793,47.80107579629129,96.13121274223809,0.4972482342905935 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441801,93.74303859835794,96.13121274223809,0.9751571412057009 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441812,208.2065805503425,96.13121274223809,2.1658582536414914 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441800,422.25831538812497,490.807523353751,0.8603338280203603 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441809,280.2972126398093,490.807523353751,0.5710939610796965 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441793,325.5637270568685,490.807523353751,0.6633226093036424 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441801,611.653708652931,490.807523353751,1.2462190972001048 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441812,399.61,490.807523353751,0.814188823491159 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441798,365.9914301805408,490.807523353751,0.7456923799367913 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441800,105.25850040381953,78.64120835950264,1.3384649422302597 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441809,82.05708382393972,78.64120835950264,1.043436202668983 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441793,101.23417970271696,78.64120835950264,1.287291762353551 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441801,73.7191132940181,78.64120835950264,0.9374107396343208 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441812,60.00746534226386,78.64120835950264,0.7630537042099359 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441800,1699.8899207170005,1710.8868039225827,0.9935724074904492 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441809,1687.6276054629202,1710.8868039225827,0.986405179812986 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441793,1994.3307679554405,1710.8868039225827,1.1656707874436816 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441801,1580.7891830576368,1710.8868039225827,0.9239589547557041 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441812,1685.5930316648532,1710.8868039225827,0.9852159872881491 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441798,1714.8038463269106,1710.8868039225827,1.0022894807507705 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441800,252.8191510850704,158.21676846284709,1.5979289271379482 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441809,141.74446988205295,158.21676846284709,0.895887782686813 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441793,157.75290216600382,158.21676846284709,0.9970681597067748 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441801,112.77853286035,158.21676846284709,0.7128102410133157 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441812,519.8915514473036,158.21676846284709,3.2859446978869755 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441800,1476.806684051795,1068.4447009417866,1.3822022634864073 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441809,1054.9915766535048,1068.4447009417866,0.9874086845333002 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441793,797.0259427196002,1068.4447009417866,0.7459683613172092 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441801,1100.5378916266195,1068.4447009417866,1.0300372968826035 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441812,914.439979422082,1068.4447009417866,0.8558608401689333 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441798,1449.0235158022767,1068.4447009417866,1.3561988884637894 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441800,113.83789457100109,101.193417409009,1.1249535541515014 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441809,107.71417006177896,101.193417409009,1.0644385061768793 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441793,96.67779084835396,101.193417409009,0.9553762816171774 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441801,101.47184422569984,101.193417409009,1.0027514320972626 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441812,124.69864446110778,101.193417409009,1.232280198198012 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441800,7673.889172258734,8195.704907369402,0.936330585226237 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441809,9492.382380779718,8195.704907369402,1.1582142705314307 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441793,7508.988311205419,8195.704907369402,0.9162101852219567 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441801,8067.747542253278,8195.704907369402,0.9843872654564384 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441812,7882.617952585304,8195.704907369402,0.9617986544998007 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441798,7345.581021024521,8195.704907369402,0.8962720234618907 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441800,141.20660387663162,54.484574340672744,2.591680408361397 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441809,69.16728581923624,54.484574340672744,1.2694838246648987 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441793,116.32228461716656,54.484574340672744,2.1349581239241133 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441801,24.590316806915062,54.484574340672744,0.451326216722563 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441812,90.76071853896276,54.484574340672744,1.6658057741530317 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441800,156.6617001321359,181.8259570369428,0.8616025054129421 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441809,130.19286408872657,181.8259570369428,0.7160301323879428 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441793,180.65228899867176,181.8259570369428,0.9935451018248589 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441801,22.209748797493553,181.8259570369428,0.12214839486851181 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441812,201.05159935305943,181.8259570369428,1.1057365110538668 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441798,139.490429930345,181.8259570369428,0.7671645578194525 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441800,516.4343907824752,598.5025834222519,0.8628774630002284 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441809,648.5813451005343,598.5025834222519,1.0836734260893761 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441793,671.9899014214105,598.5025834222519,1.122785297899562 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441801,617.5541820923181,598.5025834222519,1.0318321076596342 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441812,605.5578058236755,598.5025834222519,1.0117881235550927 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441800,13386.143811933409,15066.853658787537,0.8884498459388781 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441809,14017.651811698988,15066.853658787537,0.9303635735204333 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441793,13977.037782046413,15066.853658787537,0.927667985538208 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441801,14848.464209473388,15066.853658787537,0.985505304938913 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441812,14346.16200315574,15066.853658787537,0.9521670766868129 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441798,14508.25762910514,15066.853658787537,0.9629255024086197 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441800,66.18734338334444,62.8704966822211,1.0527568076627156 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441809,65.81978191538676,62.8704966822211,1.0469104808901513 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441793,68.21144923134536,62.8704966822211,1.084951651903119 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441801,60.014305561545406,62.8704966822211,0.9545702472319837 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441812,66.12338796487627,62.8704966822211,1.0517395512094792 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441800,96.5527634202836,100.49015468400951,0.9608181390892768 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441809,101.33397528508694,100.49015468400951,1.0083970474891875 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441793,97.50090924401704,100.49015468400951,0.9702533501974185 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441801,96.45789369571447,100.49015468400951,0.959874069246142 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441812,103.77852926823128,100.49015468400951,1.0327233508054798 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441798,95.71999212370412,100.49015468400951,0.9525310456998983 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441800,123.1711560063143,109.95671552102958,1.1201785668357602 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441809,111.68582933117074,109.95671552102958,1.0157254043279462 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441793,120.1931662303887,109.95671552102958,1.0930952753622525 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441801,100.85541375311372,109.95671552102958,0.9172283227560103 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441812,188.21627179434552,109.95671552102958,1.7117305741853353 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441800,231.98350901331725,243.54938966397899,0.9525111491077067 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441809,242.16959810942495,243.54938966397899,0.9943346540245586 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441793,237.18051386002443,243.54938966397899,0.973849756664381 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441801,238.8268230939559,243.54938966397899,0.9806094091365257 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441812,259.42987194037437,243.54938966397899,1.0652043608005153 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441798,235.64992293283785,243.54938966397899,0.9675652370057676 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441800,71.04856111206121,49.66723175069083,1.4304916663907483 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441809,58.348351700850095,49.66723175069083,1.1747856613739807 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441793,58.611887538633525,49.66723175069083,1.180091691698084 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441801,41.46918463671636,49.66723175069083,0.8349405266811465 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441812,233.53579340325433,49.66723175069083,4.702009457171046 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441800,314.66842537939806,318.9289567276793,0.9866411272529289 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441809,269.4038068468225,318.9289567276793,0.844714163339065 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441793,261.26201010108537,318.9289567276793,0.8191856041600091 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441801,303.8010841199651,318.9289567276793,0.95256663815374 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441812,392.93623997873794,318.9289567276793,1.2320494319813378 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441798,303.6730411116999,318.9289567276793,0.9521651600014299 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441800,53.78742344477178,52.85511393128503,1.0176389651661486 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441809,50.371854674666494,52.85511393128503,0.953017616046634 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441793,50.214010411195254,52.85511393128503,0.950031258592624 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441801,46.93453777238913,52.85511393128503,0.8879847999837248 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441812,47.68068848021102,52.85511393128503,0.9021017066049447 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441800,127.9013863024022,145.91831693350866,0.8765272858834006 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441809,136.59816229243978,145.91831693350866,0.9361275894833968 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441793,167.70460074442164,145.91831693350866,1.149304653923883 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441801,135.325365597614,145.91831693350866,0.9274049238059564 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441812,135.4244107239058,145.91831693350866,0.9280836948360316 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441798,125.37805989668848,145.91831693350866,0.8592345534921441 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441800,276.8613979756444,261.347965154705,1.059359302115692 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441809,273.8316358797613,261.347965154705,1.0477664737801444 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441793,297.8273863119543,261.347965154705,1.1395818067137247 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441801,210.3810804824656,261.347965154705,0.8049845743315065 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441812,1189.8186927208774,261.347965154705,4.552622753410626 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441800,8454.353214031189,7540.877985370558,1.1211364552553151 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441809,9083.101997016607,7540.877985370558,1.204515179086307 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441793,8539.869592546505,7540.877985370558,1.1324768295036745 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441801,8367.956756410213,7540.877985370558,1.1096793732300407 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441812,8871.87579736797,7540.877985370558,1.1765043559356843 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441798,10557.73423826806,7540.877985370558,1.4000669761200564 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441800,16361.316585735176,5107.556668860965,3.2033548811087216 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441809,5635.049360782748,5107.556668860965,1.1032769142117849 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441793,8397.00473780087,5107.556668860965,1.6440355501084403 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441801,4626.414994080374,5107.556668860965,0.9057980741136072 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441812,21299.11569936409,5107.556668860965,4.170118332551756 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441800,102200.00677742636,180330.65339424144,0.5667367408357095 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441809,87437.21395468812,180330.65339424144,0.48487160839777826 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441793,52385.74698003002,180330.65339424144,0.29049829296355706 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441801,44337.69979324551,180330.65339424144,0.24586890225653318 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441812,80846.57491387603,180330.65339424144,0.4483240835218852 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441798,306398.252682083,180330.65339424144,1.6990913464514033 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441800,250.15259948480497,98.01831453553807,2.5521006015065506 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441809,146.1077344322187,98.01831453553807,1.4906166783682562 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441793,162.55402358006057,98.01831453553807,1.6584045986745066 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441801,81.79129575831205,98.01831453553807,0.8344491143913451 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441812,793.4536324874698,98.01831453553807,8.09495282843076 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441800,1721.4156059510092,1812.4793707702274,0.9497573510144174 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441809,2109.2385177365363,1812.4793707702274,1.1637310480616387 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441793,1415.220159823392,1812.4793707702274,0.7808200096765697 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441801,934.2789131167708,1812.4793707702274,0.5154700948236126 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441812,3201.813680225288,1812.4793707702274,1.766537998644725 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441798,4594.909603813002,1812.4793707702274,2.5351513942254464 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441800,1757.5386815643503,434.5650550234931,4.044362659278565 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441809,320.68692928024353,434.5650550234931,0.7379491875224685 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441793,320.0311765907147,434.5650550234931,0.7364402012799062 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441801,263.53771970163615,434.5650550234931,0.6064402018873538 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441812,6011.006082000699,434.5650550234931,13.832235271829985 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441800,13615.617934187989,9833.502392298877,1.3846153070396445 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441809,18385.25339001787,9833.502392298877,1.8696546415055852 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441793,9684.652954606769,9833.502392298877,0.9848630292896782 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441801,7358.84937394625,9833.502392298877,0.7483446975829634 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441812,33207.06302861287,9833.502392298877,3.3769314028559183 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441798,12277.064058820748,9833.502392298877,1.2484935243861384 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441800,56.9857494014863,42.4088060383901,1.3437244460478466 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441809,45.29956375737643,42.4088060383901,1.0681640911175265 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441793,46.420099442480456,42.4088060383901,1.094586331915574 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441801,39.76147673314798,42.4088060383901,0.9375759529083264 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441812,48.561346694880214,42.4088060383901,1.1450769599813915 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441800,360.1553677324521,385.8715169071063,0.9333556687967589 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441809,398.0871188966575,385.8715169071063,1.031657174614658 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441793,366.5880263196363,385.8715169071063,0.9500261363107756 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441801,374.84123750021803,385.8715169071063,0.9714146317528182 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441812,427.96341123510285,385.8715169071063,1.1090826673743055 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441798,358.6287511977175,385.8715169071063,0.9293993868017288 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441800,344.89651584006,1002.6445024002205,0.34398684181124584 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441809,1146.0703511179397,1002.6445024002205,1.143047559104322 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441793,872.794928093446,1002.6445024002205,0.8704929075101604 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441801,837.244401665181,1002.6445024002205,0.8350361465713023 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441812,1057.23649524185,1002.6445024002205,1.0544480049618208 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441800,8532.997445461278,6245.085755978491,1.3663539267323181 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441809,13603.035314175862,6245.085755978491,2.1781983219611556 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441793,12051.874878467312,6245.085755978491,1.9298173554990683 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441801,9578.958134928564,6245.085755978491,1.5338393273076385 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441812,18671.253431749017,6245.085755978491,2.989751327894067 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441798,9929.490664229914,6245.085755978491,1.5899686653180545 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441800,317.4373736974361,289.8012081128336,1.0953624926706393 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441809,227.1737745106439,289.8012081128336,0.7838951948819833 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441793,148.79406299000888,289.8012081128336,0.5134349299609413 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441801,255.5690246392487,289.8012081128336,0.8818770159844999 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441812,288.68624043268875,289.8012081128336,0.9961526465420713 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441800,22764.5112386771,19122.271903916942,1.190471056632873 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441809,24632.89258037187,19122.271903916942,1.2881781361620608 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441793,16300.718590755374,19122.271903916942,0.8524467528053709 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441801,21460.674981132248,19122.271903916942,1.122286885625568 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441812,43912.00642790776,19122.271903916942,2.296380192089674 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441798,19488.82504787476,19122.271903916942,1.0191689118217557 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441800,90.36201347637116,111.01681566749893,0.8139488863291668 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441809,64.83905550561678,111.01681566749893,0.5840471564218982 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441793,46.265667806620066,111.01681566749893,0.41674468438356327 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441801,74.22423469987653,111.01681566749893,0.6685855134071034 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441812,97.47069630430056,111.01681566749893,0.8779813735266043 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441800,1141.1171279368805,1048.3386659324408,1.0885004674724252 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441809,1254.726405445815,1048.3386659324408,1.196871246115685 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441793,993.3738881705552,1048.3386659324408,0.9475696360841586 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441801,883.3030020143841,1048.3386659324408,0.8425740943445348 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441812,1764.0131378201547,1048.3386659324408,1.6826748789725885 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441798,1039.68981999999,1048.3386659324408,0.9917499504563652 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441800,20832.403216836236,5453.602601951663,3.819934222816494 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441809,8264.28630821416,5453.602601951663,1.5153810996893404 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441793,13586.28628540666,5453.602601951663,2.491249780566076 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441801,4850.8562065739525,5453.602601951663,0.8894773896502822 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441812,74172.46332229224,5453.602601951663,13.60063589813977 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441800,70826.39198460046,64173.361133824874,1.1036727815596503 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441809,54437.925472322015,64173.361133824874,0.8482947520669687 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441793,43574.79311205173,64173.361133824874,0.679016843471583 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441801,57275.11089732099,64173.361133824874,0.8925060162873734 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441812,127513.69541029794,64173.361133824874,1.987019117549186 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441798,58758.18914476091,64173.361133824874,0.9156165129363981 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441800,66.50337738375892,44.60879663763593,1.4908130771600052 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441809,43.579075787487625,44.60879663763593,0.9769166413854897 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441793,39.72605987130964,44.60879663763593,0.8905431857759017 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441801,27.36898336175145,44.60879663763593,0.6135333258162932 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441812,57.14926152447647,44.60879663763593,1.281120896147651 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441800,128.57504094324707,136.29080299882398,0.9433875075514562 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441809,136.38996062635118,136.29080299882398,1.0007275445249821 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441793,135.40810006198583,136.29080299882398,0.9935233858968037 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441801,128.8072353274523,136.29080299882398,0.9450911763177722 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441812,141.5953623416484,136.29080299882398,1.038920889936133 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441798,128.38379600507193,136.29080299882398,0.9419842951998729 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441800,28.986048524772173,82.77341642135346,0.350185479565327 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441809,58.83896539062517,82.77341642135346,0.7108437459088157 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441793,74.73973525729257,82.77341642135346,0.9029437044960681 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441801,59.14200600264864,82.77341642135346,0.7145048321020068 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441812,72.75145307801296,82.77341642135346,0.8789229226407153 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441800,2361.398015586592,2141.365658987758,1.1027532853510154 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441809,3411.2227583013655,2141.365658987758,1.5930127318441636 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441793,2872.1716371728003,2141.365658987758,1.341280329736165 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441801,1905.7358850841952,2141.365658987758,0.8899628501491208 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441812,3336.7467567159024,2141.365658987758,1.5582330568863292 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441798,2726.205784487304,2141.365658987758,1.2731154873269075 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441800,327.0334211992158,285.0677067828484,1.1472131476762992 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441809,287.2954592130771,285.0677067828484,1.0078148186456128 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441793,340.8019560720101,285.0677067828484,1.1955123220309816 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441801,336.9883784949239,285.0677067828484,1.182134526207931 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441812,400.9703691430039,285.0677067828484,1.4065794181606297 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441800,752236.2584821897,724296.655045942,1.038574806664647 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441809,868868.9246864956,724296.655045942,1.1996036687914613 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441793,845878.7692345033,724296.655045942,1.1678623162781958 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441801,686436.3941985336,724296.655045942,0.9477282401021071 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441812,704355.83,724296.655045942,0.9724687047675552 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441798,603057.7073194952,724296.655045942,0.8326114764139609 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441800,123.7888242261714,126.94877083842833,0.9751084898940952 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441809,72.71180944577338,126.94877083842833,0.5727649741352437 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441793,51.772876708039725,126.94877083842833,0.4078249546341231 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441801,72.12900380281056,126.94877083842833,0.5681741014618519 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441812,136.7378044457722,126.94877083842833,1.0771101093984021 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441800,119303.67910048724,94593.87687362579,1.2612198912184656 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441809,56884.2747954594,94593.87687362579,0.6013526105019975 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441793,64395.909756349014,94593.87687362579,0.6807619254508382 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441801,65473.16782647015,94593.87687362579,0.6921501685985455 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441812,62624.79242304491,94593.87687362579,0.6620385430096021 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441798,85615.32336018169,94593.87687362579,0.9050831426917924 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441800,36.84304245153104,34.2642969985689,1.075260422038422 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441809,600.0136438182174,34.2642969985689,17.511336766759808 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441793,198.34571836910257,34.2642969985689,5.78869948440462 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441801,286.183503430575,34.2642969985689,8.352236248784788 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441812,63.541575767780394,34.2642969985689,1.8544543835361427 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441800,11.796228382136912,74.66086218948179,0.1579974840392181 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441809,79.40639215936288,74.66086218948179,1.0635611461040646 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441793,39.92819726731425,74.66086218948179,0.5347942160911628 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441801,20.940957245084025,74.66086218948179,0.2804810530038881 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441812,80.98842970686289,74.66086218948179,1.084750796224699 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441798,40.421540670593856,74.66086218948179,0.5414020074936723 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441800,531.1044847663087,347.6986105145094,1.5274852090447044 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441809,382.19570098135773,347.6986105145094,1.0992154970530397 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441793,266.39808812090536,347.6986105145094,0.7661753025895068 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441801,533.6868657912921,347.6986105145094,1.5349122764729064 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441812,600.5924485474619,347.6986105145094,1.727336349313364 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441800,3188.0396091487664,2521.321340016667,1.2644320890599736 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441809,3345.952324621706,2521.321340016667,1.3270630250563729 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441793,2954.0300990925543,2521.321340016667,1.1716198376653675 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441801,2567.2545588300836,2521.321340016667,1.0182179153780981 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441812,3661.1990564339167,2521.321340016667,1.4520953748837562 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441798,2727.3414316107173,2521.321340016667,1.0817111600668436 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441800,118.44794620521512,79.44971561377609,1.4908542502659 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441809,66.50298119885225,79.44971561377609,0.8370449243914102 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441793,82.4164233157379,79.44971561377609,1.0373406963013396 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441801,47.93506764422437,79.44971561377609,0.6033384421065533 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441812,127.9637803300966,79.44971561377609,1.6106260336054428 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441800,56.93592143463375,42.37178439720435,1.3437225324499273 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441809,242.2565828481609,42.37178439720435,5.717403368647008 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441793,36.199995664146314,42.37178439720435,0.8543420150730011 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441801,279.8184102996236,42.37178439720435,6.603885445949871 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441812,77.11637011007033,42.37178439720435,1.8199934509993967 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441798,161.98020724668416,42.37178439720435,3.822831857356743 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441800,1338.8432811389298,1321.2949146990686,1.0132811882075985 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441809,1108.2988893252857,1321.2949146990686,0.838797513708517 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441793,1103.374097480367,1321.2949146990686,0.8350702672095471 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441801,821.2473171427192,1321.2949146990686,0.6215473230136228 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441812,8733.964853313593,1321.2949146990686,6.610155504384724 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441800,17469.918253603082,23354.026662177774,0.748047371286764 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441809,20717.067905367203,23354.026662177774,0.8870876189808772 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441793,25033.701136058768,23354.026662177774,1.0719222641207846 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441801,15985.063256668524,23354.026662177774,0.6844671151530624 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441812,36203.75927181524,23354.026662177774,1.5502148642507039 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441798,30852.39785436796,23354.026662177774,1.3210740186545182 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441800,22346.856321712687,13473.54115415771,1.6585733524713968 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441809,11680.488547793102,13473.54115415771,0.866920463904079 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441793,9482.51760394838,13473.54115415771,0.7037880758632064 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441801,12687.928790975484,13473.54115415771,0.9416922133391933 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441812,26925.188267698897,13473.54115415771,1.9983750344199773 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441800,63321.19356417703,49612.48263442616,1.2763157617159513 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441809,79217.74611917746,49612.48263442616,1.5967301354963475 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441793,64015.24201951626,49612.48263442616,1.2903051534674868 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441801,49565.134829199334,49612.48263442616,0.9990456473308197 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441812,99420.29203963872,49612.48263442616,2.0039370489121797 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441798,58840.50622803312,49612.48263442616,1.1860020523787218 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441805,16.305115086667904,73.06854961986588,0.22314819674804204 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441810,34.99430670323506,73.06854961986588,0.4789243372872535 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441806,36.43280737549097,73.06854961986588,0.49861133914700856 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441799,20.37029628107225,73.06854961986588,0.27878336694853423 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441794,23.669471365698787,73.06854961986588,0.3239351470480472 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441795,39.19470939514143,73.06854961986588,0.5364101189779902 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441805,2708.380439571611,990.9231863649335,2.733189087548688 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441810,100.0195211242718,990.9231863649335,0.10093569562256362 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441806,43.15937543138263,990.9231863649335,0.04355471344828141 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441799,1742.4514640897569,990.9231863649335,1.758412244325115 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441794,1585.9029620116405,990.9231863649335,1.6004297647220358 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441795,6550.992580078869,990.9231863649335,6.610999389478706 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441805,58.522196260657786,50.719124328797626,1.1538487116077767 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441810,54.69425432550556,50.719124328797626,1.078375367266562 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441806,56.718984334209566,50.719124328797626,1.118295812177603 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441799,47.46477662316811,50.719124328797626,0.9358358854042411 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441794,62.49685432472368,50.719124328797626,1.2322147740480374 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441795,40.94196460140401,50.719124328797626,0.8072293270678121 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441805,355.0988679517352,319.2477137201226,1.1122988597595487 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441810,326.5855672023596,319.2477137201226,1.0229848270383228 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441806,358.6231094252622,319.2477137201226,1.1233380663758148 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441799,361.70901241282434,319.2477137201226,1.1330042373613571 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441794,314.76484760521714,319.2477137201226,0.9859580322043106 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441795,376.0410186965872,319.2477137201226,1.1778972958479947 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441805,91.60297135455517,44.58166891160943,2.054722795061201 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441810,137.6695339755933,44.58166891160943,3.088030065643035 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441806,188.35871581343153,44.58166891160943,4.225026124232451 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441799,16.70881892674785,44.58166891160943,0.3747912389703459 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441794,42.18603016003803,44.58166891160943,0.9462640405786255 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441795,24.383126601263193,44.58166891160943,0.546931669373051 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441805,2187.332835771512,1543.2839395802719,1.4173236561811189 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441810,2752.3659823415237,1543.2839395802719,1.7834475638294316 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441806,2098.667340616943,1543.2839395802719,1.3598711726292694 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441799,2945.3390346154947,1543.2839395802719,1.9084881006514853 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441794,2159.636174308274,1543.2839395802719,1.3993770808602024 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441795,5010.123195585549,1543.2839395802719,3.24640402656439 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441805,35.582181605282116,31.276034215973343,1.137682014272434 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441810,31.350310782051096,31.276034215973343,1.002374871621026 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441806,42.04224365033718,31.276034215973343,1.3442319240354743 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441799,62.21566534479795,31.276034215973343,1.9892440619285123 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441794,32.94726934257638,31.276034215973343,1.0534350076183732 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441795,40.44765356094609,31.276034215973343,1.29324751602582 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441805,25.9776899945975,130.468422036268,0.19911093879388028 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441810,90.63675989053124,130.468422036268,0.6947026604287109 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441806,43.48542819010957,130.468422036268,0.333302323362364 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441799,54.182503186134376,130.468422036268,0.4152920863185772 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441794,241.84077945279137,130.468422036268,1.8536345858890186 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441795,196.170255601723,130.468422036268,1.5035841818274693 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441805,100.039523312036,95.42663227533711,1.0483396608128135 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441810,85.39660653973459,95.42663227533711,0.8948928040689668 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441806,94.12154584856546,95.42663227533711,0.9863236667201453 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441799,109.34318194350094,95.42663227533711,1.1458350707380096 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441794,111.02999660782918,95.42663227533711,1.1635116315062994 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441795,87.16976107521732,95.42663227533711,0.9134741423516235 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441805,586.0816772113378,569.3868516791151,1.0293207078508924 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441810,559.8154440620841,569.3868516791151,0.9831899742875955 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441806,632.2248455934733,569.3868516791151,1.1103608095779691 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441799,635.9751487375212,569.3868516791151,1.1169473739374873 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441794,630.0820380191366,569.3868516791151,1.1065974498024183 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441795,647.8094199840882,569.3868516791151,1.137731610896363 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441805,10972.853543611369,5328.634617598269,2.0592242349236307 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441810,5312.297738616189,5328.634617598269,0.9969341341348259 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441806,3082.2925663823808,5328.634617598269,0.57843946668868 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441799,5070.481616772234,5328.634617598269,0.9515536306479969 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441794,5290.242261383811,5328.634617598269,0.9927950856139274 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441795,4133.104920449178,5328.634617598269,0.77564051901762 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441805,802348.3788502318,656386.6079991342,1.222371646636779 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441810,763613.6873053289,656386.6079991342,1.1633596389680396 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441806,794803.6543939728,656386.6079991342,1.2108773163681321 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441799,775796.7695327821,656386.6079991342,1.181920471987761 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441794,467929.6737844976,656386.6079991342,0.7128872955084952 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441795,987526.3828531714,656386.6079991342,1.5044889259143355 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441805,10757.053127351171,5223.837669019135,2.0592242349236307 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441810,5207.82208342448,5223.837669019135,0.9969341341348261 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441806,150.555792451451,5223.837669019135,0.0288209171093405 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441799,4970.761699870928,5223.837669019135,0.951553630647997 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441794,5186.200365847112,5223.837669019135,0.9927950856139276 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441795,4051.820160861797,5223.837669019135,0.7756405190176201 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441805,802348.3788502318,656386.6079991342,1.222371646636779 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441810,763613.6873053289,656386.6079991342,1.1633596389680396 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441806,794803.6543939728,656386.6079991342,1.2108773163681321 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441799,775796.7695327821,656386.6079991342,1.181920471987761 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441794,467929.6737844976,656386.6079991342,0.7128872955084952 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441795,987526.3828531714,656386.6079991342,1.5044889259143355 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441805,54.45984597191173,50.79723336807032,1.0721026001023044 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441810,50.37231140355625,50.79723336807032,0.9916349388275708 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441806,49.92842678919421,50.79723336807032,0.9828965768158898 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441799,42.60269904884373,50.79723336807032,0.8386814836971527 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441794,48.65357793085071,50.79723336807032,0.9577997600442734 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441795,51.28984262927456,50.79723336807032,1.0096975608422383 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441805,75.52227249433626,124.85055234194422,0.6049013887218835 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441810,93.93274044745876,124.85055234194422,0.752361432812833 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441806,200.07394278819305,124.85055234194422,1.6025074702130662 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441799,96.04159733830976,124.85055234194422,0.7692524825622582 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441794,71.41377031804707,124.85055234194422,0.571994027887494 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441795,142.99346318069547,124.85055234194422,1.145317025022532 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441805,181.83388883859044,149.81706398084205,1.2137061293755067 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441810,164.12523690017576,149.81706398084205,1.0955042939645605 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441806,152.75796042287183,149.81706398084205,1.019629916405289 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441799,143.8820873197164,149.81706398084205,0.9603851757374942 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441794,140.2396678081045,149.81706398084205,0.9360727281775977 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441795,200.1121500352781,149.81706398084205,1.3357099966988244 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441805,2762.2396695320554,2791.14294318225,0.9896446458534864 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441810,3023.154617133117,2791.14294318225,1.0831242536386707 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441806,3312.7990545339862,2791.14294318225,1.1868969529582687 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441799,3413.4424996284156,2791.14294318225,1.2229551008722852 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441794,2863.2329215825657,2791.14294318225,1.0258281212635152 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441795,3477.3157920665176,2791.14294318225,1.2458393793697808 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441805,442.86141767141527,222.01180748199775,1.99476515548537 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441810,419.4428020002054,222.01180748199775,1.889281506048802 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441806,348.4747488337571,222.01180748199775,1.5696225925371732 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441799,276.99083327054274,222.01180748199775,1.2476400981195699 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441794,297.4342381950292,222.01180748199775,1.3397226101100377 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441795,459.2316895617784,222.01180748199775,2.0685011971672544 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441805,8742.16868284418,4330.453784028004,2.0187650345300736 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441810,13466.840425119295,4330.453784028004,3.1097989025512733 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441806,8483.477781889047,4330.453784028004,1.9590274379970585 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441799,18888.034405345737,4330.453784028004,4.361675553497512 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441794,7197.894073452557,4330.453784028004,1.6621570007283122 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441795,17164.650178722335,4330.453784028004,3.963707046598823 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441805,197.41458416927557,100.4664893584531,1.964979421794292 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441810,109.68087017602308,100.4664893584531,1.0917159629684492 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441806,84.6546092458014,100.4664893584531,0.8426153813712282 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441799,124.2007980453342,100.4664893584531,1.2362410475218235 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441794,171.6090939127825,100.4664893584531,1.708122728370657 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441795,196.18351244682916,100.4664893584531,1.9527258661031592 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441805,532.3052694431265,219.8603821991507,2.4211059042049765 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441810,189.7885764739511,219.8603821991507,0.8632231717947239 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441806,351.75488720403547,219.8603821991507,1.5999011904082565 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441799,351.7089720173826,219.8603821991507,1.5996923524803244 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441794,816.3605868435754,219.8603821991507,3.713086362708638 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441795,392.3660675303057,219.8603821991507,1.7846146886750085 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441805,65.11762869333806,115.26780159034894,0.5649247039928814 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441810,107.11546235811636,115.26780159034894,0.9292747920949752 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441806,83.117373270600865,115.26780159034894,0.7210805803861193 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441799,90.19488096041944,115.26780159034894,0.7824811414462789 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441794,99.46814423666518,115.26780159034894,0.8629308693694508 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441795,47.63633465067956,115.26780159034894,0.4132666190683038 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441805,899.3819343571662,1760.6737631139824,0.5108169117977264 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441810,847.0938146511069,1760.6737631139824,0.48111912178035204 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441806,1321.375754435894,1760.6737631139824,0.7504943744370153 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441799,1036.5550321894598,1760.6737631139824,0.5887263466436714 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441794,1317.8475172686456,1760.6737631139824,0.7484904613662553 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441795,1031.1046294438866,1760.6737631139824,0.5856307119725819 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441805,889.4197159735006,518.6000624505415,1.7150397394298886 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441810,765.6133344887463,518.6000624505415,1.4763078331903638 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441806,664.3623221857061,518.6000624505415,1.2810687276943125 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441799,477.36323579123615,518.6000624505415,0.9204843391949301 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441794,512.1636831569325,518.6000624505415,0.9875889345959675 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441795,1462.1027885494286,518.6000624505415,2.8193262870824825 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441805,2065.7510478656477,841.89306662726494,2.4536976603707163 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441810,2000.880477115234,841.89306662726494,2.3766444414740535 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441806,3.984728201281557,841.89306662726494,0.004733057390821503 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441799,5720.791419415796,841.89306662726494,6.795152075944803 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441794,1240.3218513989762,841.89306662726494,1.4732534339163401 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441795,5.633552638716408,841.89306662726494,0.006691529912801355 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441805,306.91159310677386,246.94010350613598,1.2428584452227207 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441810,362.2135991975139,246.94010350613598,1.4668075134605003 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441806,237.0439731989167,246.94010350613598,0.9599249770826577 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441799,261.30458899625864,246.94010350613598,1.0581699176689854 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441794,170.76321840944422,246.94010350613598,0.6915167523820248 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441795,341.486080004363,246.94010350613598,1.3828700772204776 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441805,4210.730907921645,6405.278640912654,0.657384501749276 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441810,3957.0254841299993,6405.278640912654,0.6177756981335919 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441806,3702.790037203713,6405.278640912654,0.5780841466525369 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441799,4854.751664045947,6405.278640912654,0.7579298163606852 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441794,4942.183911586801,6405.278640912654,0.7715798466626294 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441795,3687.803486146478,6405.278640912654,0.5757444278210233 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441805,106.55762784277393,184.84349394551683,0.5764748629680313 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441810,87.35766718546064,184.84349394551683,0.47260341882094903 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441806,88.04514863850491,184.84349394551683,0.476322681200002 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441799,134.42625825530467,184.84349394551683,0.7272436556242938 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441794,86.43156179849886,184.84349394551683,0.4675932052224398 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441795,227.95781221915513,184.84349394551683,1.2332476916193025 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441805,47715.31654019181,66689.05961878091,0.7154894192983082 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441810,35262.2445885517,66689.05961878091,0.5287560626903963 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441806,42018.89645488248,66689.05961878091,0.6300718093054225 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441799,40764.68633077801,66689.05961878091,0.6112649745521062 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441794,69347.82239555728,66689.05961878091,1.0398680502015596 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441795,27211.829817589303,66689.05961878091,0.4080403888305231 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441805,288.1830963930406,426.591426110135,0.6755482617661404 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441810,316.01841189618494,426.591426110135,0.7407987890844226 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441806,528.4011519552596,426.591426110135,1.2386586312188093 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441799,235.21435364896908,426.591426110135,0.5513808746550916 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441794,190.98166772000872,426.591426110135,0.44769223202976927 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441795,308.2765993981494,426.591426110135,0.7226507157191675 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441805,282448.19842631405,6086.038398766024,46.40920413574484 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441810,268341.63754437177,6086.038398766024,44.09134809250948 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441806,437612.04814001534,6086.038398766024,71.9042535500176 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441799,5250.216162894836,6086.038398766024,0.8626656322049077 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441794,476585.42268940795,6086.038398766024,78.30798813001871 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441795,638873.9935659237,6086.038398766024,104.97370402649096 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441805,164.38646428009153,118.38689307733607,1.3885529048617427 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441810,151.63301890423278,118.38689307733607,1.2808260691931388 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441806,128.92990128135153,118.38689307733607,1.089055535878691 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441799,72.83313912633787,118.38689307733607,0.6152128604199429 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441794,93.74275481338852,118.38689307733607,0.7918338962755885 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441795,254.88953308013055,118.38689307733607,2.1530215588445616 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441805,112.35099129705412,43.003791743375764,2.6125833732873214 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441810,88.93109490031938,43.003791743375764,2.067982642810054 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441806,19.711887834425053,43.003791743375764,0.4583755765550939 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441799,322.586922606997,43.003791743375764,7.501359985464253 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441794,44.45795408792581,43.003791743375764,1.0338147471559656 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441795,203.59922860105848,43.003791743375764,4.734448297397417 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441805,83.19274488913987,56.77751951238643,1.4652409193570137 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441810,70.27973968414395,56.77751951238643,1.2378092647885386 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441806,73.91540309949345,56.77751951238643,1.3018427668959414 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441799,51.050303037693936,56.77751951238643,0.8991288009078477 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441794,84.70689924222646,56.77751951238643,1.491909121245549 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441795,19.69608013674457,56.77751951238643,0.34689927115339597 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441805,350.9136945039746,232.93832449773902,1.5064661225696276 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441810,109.82239206657589,232.93832449773902,0.47146553622455484 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441806,118.8709997698477,232.93832449773902,0.5103110448920632 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441799,299.67113134249206,232.93832449773902,1.286482728802322 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441794,170.56616543666092,232.93832449773902,0.7322374530014982 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441795,101.22003634553116,232.93832449773902,0.4345357792187332 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441805,46.979085870291435,55.88566907011774,0.8406284947818816 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441810,70.7727656079177,55.88566907011774,1.2663848672746794 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441806,36.35651419835384,55.88566907011774,0.6505516495246506 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441799,180.82929058506713,55.88566907011774,3.235700557833299 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441794,37.74679450956628,55.88566907011774,0.6754288735848671 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441795,16.924483686573478,55.88566907011774,0.30284121078230153 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441805,201.9613032195095,226.42114305345407,0.891971926719891 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441810,384.7332104257956,226.42114305345407,1.6991929518479942 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441806,163.75601457113112,226.42114305345407,0.7232364096513336 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441799,1108.2250775105929,226.42114305345407,4.894530000888478 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441794,161.3516681814545,226.42114305345407,0.712617496782808 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441795,121.04623036785132,226.42114305345407,0.5346065686951965 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441805,240.0621334060983,212.71806341276286,1.1285460649398467 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441810,233.71869903243385,212.71806341276286,1.098725210650874 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441806,288.9659641506682,212.71806341276286,1.3584458203248693 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441799,180.5430235271742,212.71806341276286,0.8487432643500731 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441794,179.4058412781371,212.71806341276286,0.8433973043935343 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441795,312.3896461380483,212.71806341276286,1.4685619130138492 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441805,9234.784925253629,10996.969545575432,0.8397572519393938 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441810,9091.86996418024,10996.969545575432,0.8267614024482137 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441806,9524.1503839815,10996.969545575432,0.8660704519104072 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441799,10926.358375088,10996.969545575432,0.9935790337333579 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441794,9986.750437015333,10996.969545575432,0.9081365912333044 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441795,9758.571595700509,10996.969545575432,0.887387343873005 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441805,112.41214147990692,147.8550055811589,0.7602863429483482 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441810,140.08527173890474,147.8550055811589,0.9474503158569813 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441806,109.81568602652766,147.8550055811589,0.7427255208228231 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441799,229.57249677452907,147.8550055811589,1.5526866734891482 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441794,102.65444540612089,147.8550055811589,0.694291309263608 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441795,101.64183653438484,147.8550055811589,0.6874426478486232 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441805,258.9029127666071,92.19915296117537,2.808083419981416 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441810,246.94712366133675,92.19915296117537,2.678409895645408 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441806,232.68995213903355,92.19915296117537,2.5237753782512318 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441799,214.80696623856556,92.19915296117537,2.329814964016207 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441794,418.9253988693541,92.19915296117537,4.543701166601407 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441795,194.7345911789508,92.19915296117537,2.112108245299744 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441805,4684.927987237761,1229.7970051816276,3.809513250966039 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441810,3721.808044169967,1229.7970051816276,3.0263596581293486 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441806,2347.638153021609,1229.7970051816276,1.9089639535062037 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441799,2192.6215121055675,1229.7970051816276,1.7829133612028445 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441794,1711.8143818991236,1229.7970051816276,1.3919487319342654 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441795,4799.140797592293,1229.7970051816276,3.902384521487359 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441805,81129.14219503629,50083.06853493704,1.6198916034556083 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441810,120322.52747385293,50083.06853493704,2.4024591742001213 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441806,106346.63547195944,50083.06853493704,2.123404946679215 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441799,152631.56209678823,50083.06853493704,3.0475681015893668 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441794,85199.93776644331,50083.06853493704,1.7011724772217058 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441795,153371.50770678435,50083.06853493704,3.0623424680896933 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441805,5.40500406010209,35.678906774941794,0.15149018141716614 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441810,62.66265004616789,35.678906774941794,1.7562940042259778 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441806,21.184753885748577,35.678906774941794,0.5937612948563539 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441799,8.59458826164997,35.678906774941794,0.24088709656558668 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441794,87.06480548767456,35.678906774941794,2.440231872486138 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441795,37.32647356981897,35.678906774941794,1.0461776142769685 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441805,150.14968937720417,67.70693010562654,2.217641372056928 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441810,195.2346733432033,67.70693010562654,2.883525704660165 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441806,106.52738516788338,67.70693010562654,1.5733601420370824 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441799,8.841623375568574,67.70693010562654,0.13058668236434814 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441794,13.10371631897222,67.70693010562654,0.19353582120072052 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441795,142.12078993640094,67.70693010562654,2.0990582458056313 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441805,64.90808920161132,64.01321127549492,1.0139795818438961 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441810,56.80966899660408,64.01321127549492,0.8874678814676424 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441806,74.43425096948198,64.01321127549492,1.1627951400397305 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441799,20.982185090348658,64.01321127549492,0.32777897987412646 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441794,183.0712364417005,64.01321127549492,2.8598977116428856 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441795,66.22553669805647,64.01321127549492,1.0345604505457524 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441805,689.4112300148014,1060.427767412219,0.6501255919553899 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441810,537.55325066846,1060.427767412219,0.506921138042491 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441806,511.02629974353704,1060.427767412219,0.48190580768231267 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441799,836.4389317400179,1060.427767412219,0.788775018388282 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441794,510.7661323025992,1060.427767412219,0.4816604657090704 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441795,639.19,1060.427767412219,0.6027661851592465 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441805,61.58608324857719,57.09593719876665,1.0786421288467358 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441810,549.0154277973523,57.09593719876665,9.615665399905405 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441806,31.15040139858171,57.09593719876665,0.5455799996791121 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441799,23.960454749815312,57.09593719876665,0.4196525344071748 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441794,36.421242861517705,57.09593719876665,0.6378955254683946 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441795,3.877324865717096,57.09593719876665,0.06790894511844271 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441805,12.457788777816422,50.205845180981015,0.24813423084321828 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441810,28.476441501175287,50.205845180981015,0.5671937480292183 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441806,46.96306213741477,50.205845180981015,0.935410248908733 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441799,57.17377516579608,50.205845180981015,1.1387872260629657 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441794,105.40734482165983,50.205845180981015,2.0995034431088566 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441795,32.29779078115748,50.205845180981015,0.6433073811372173 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441805,15431.451734773576,1506.8779059558976,10.240678208752776 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441810,6983.5642047365445,1506.8779059558976,4.634459220043097 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441806,4623.922697718996,1506.8779059558976,3.0685450224222253 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441799,2600.453837831325,1506.8779059558976,1.7257229849565752 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441794,3533.597677357125,1506.8779059558976,2.344979419626944 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441795,13937.006367939994,1506.8779059558976,9.24892873726154 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441805,28827.29384479574,16162.128318216166,1.7836322838932541 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441810,33250.33323846872,16162.128318216166,2.0572991739579627 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441806,21831.467078161484,16162.128318216166,1.3507792196870176 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441799,29847.440260749707,16162.128318216166,1.846751843141164 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441794,25961.99422555369,16162.128318216166,1.606347488052808 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441795,27877.49422237028,16162.128318216166,1.724865294563331 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441805,73.74177644776904,24.995311385825953,2.9502243564601343 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441810,85.49932920673609,24.995311385825953,3.420614685969467 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441806,32.18388093948574,24.995311385825953,1.2875967193485813 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441799,79.312024475893793,24.995311385825953,3.173076072213652 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441794,14.516623278601523,24.995311385825953,0.5807738521246604 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441795,122.60917996391775,24.995311385825953,4.905287158512677 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441805,859.0078622015089,522.7489803443298,1.6432511482579817 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441810,550.0121046372637,522.7489803443298,1.0521533763202675 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441806,925.7122872051712,522.7489803443298,1.7708543144271909 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441799,2339.639218732923,522.7489803443298,4.475645685988378 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441794,1376.3331075016083,522.7489803443298,2.6328757381698398 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441795,895.7892076751405,522.7489803443298,1.7136125393971935 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441805,3.5015154409405316,2.8430683750443606,1.2315973374667422 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441810,3.1549733418118273,2.8430683750443606,1.109707163396167 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441806,2.5961650349948475,2.8430683750443606,0.9131560316252821 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441799,4.3630008032049865,2.8430683750443606,1.534609874845838 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441794,3.3871276050346135,2.8430683750443606,1.1913633997570543 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441795,5.007718045463307,2.8430683750443606,1.7613779849333278 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441805,1725.0645008101735,1771.7543971110147,0.9736476475650504 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441810,1219.804737238023,1771.7543971110147,0.6884728149832793 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441806,1746.142010044747,1771.7543971110147,0.9855440533360432 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441799,2144.9462025892153,1771.7543971110147,1.2106340506825999 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441794,2003.785963462517,1771.7543971110147,1.1309614734016453 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441795,1568.5940087567196,1771.7543971110147,0.8853337749941165 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441805,3.3222043848502856,73.62821549612136,0.045121348690371224 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441810,7.4429505940274705,73.62821549612136,0.10108829263177722 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441806,43.413075536973864,73.62821549612136,0.5896255293496936 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441799,211.34534760824636,73.62821549612136,2.870439629483887 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441794,12.177551926691049,73.62821549612136,0.16539246326474594 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441795,3.451926134868037,73.62821549612136,0.04688319704081216 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441805,427.13275034893377,1923.334023596175,0.22207933989037307 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441810,1780.0595236924144,1923.334023596175,0.9255072191590145 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441806,94.53405763153016,1923.334023596175,0.04915113884107039 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441799,1723.502216708073,1923.334023596175,0.896101350864441 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441794,5431.838098449186,1923.334023596175,2.8241782403937026 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441795,121.40236755182102,1923.334023596175,0.06312079236493076 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441805,167.19333704235711,51.40813337414527,3.252274028810464 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441810,64.4617024778105,51.40813337414527,1.2539203088480602 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441806,18.3044384997831,51.40813337414527,0.35606113854717325 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441799,12.003926045723354,51.40813337414527,0.2335024685366323 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441794,42.435842376678536,51.40813337414527,0.8254694265561648 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441795,9.12829011923998,51.40813337414527,0.17756509563972764 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441805,43.73283670347153,89.1451395839603,0.49058015846486247 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441810,21.84545085232809,89.1451395839603,0.24505487292162695 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441806,38.88880801245523,89.1451395839603,0.4362414843248774 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441799,49.80258517560167,89.1451395839603,0.5586685422001689 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441794,46.594161713471586,89.1451395839603,0.5226775338613657 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441795,50.69296143298772,89.1451395839603,0.568656481660934 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441805,7809.37807342506,4771.656231796832,1.6366179150513391 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441810,7574.17390989136,4771.656231796832,1.587325981159209 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441806,3145.3185140933965,4771.656231796832,0.6591670399753388 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441799,4731.316258336254,4771.656231796832,0.9915459179159293 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441794,7216.1151168180595,4771.656231796832,1.5122872994772998 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441795,6393.190542237761,4771.656231796832,1.339826305934516 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441805,351868.8372140934,209884.98459768714,1.6764840890765222 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441810,359944.8176200595,209884.98459768714,1.7149622128043644 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441806,255302.0808398116,209884.98459768714,1.2163904022442629 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441799,275890.68968214846,209884.98459768714,1.3144851224635374 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441794,148313.69012651243,209884.98459768714,0.7066426900943098 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441795,302411.1311947453,209884.98459768714,1.4408421439695394 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441805,26.323097920624857,22.903585106474594,1.1493003299812483 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441810,31.703641523962073,22.903585106474594,1.3842217878370404 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441806,95.50426894946052,22.903585106474594,4.1698392852245 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441799,21.99893717102261,22.903585106474594,0.9605019069614456 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441794,16.419314404273255,22.903585106474594,0.7168883966393407 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441795,9.752443278926044,22.903585106474594,0.4258042238186167 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441805,22.016581174994556,83.56495705722055,0.26346667251822853 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441810,22.140212295385624,83.56495705722055,0.26494613382288057 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441806,19.67730911730809,83.56495705722055,0.23547321521190018 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441799,111.93270099806544,83.56495705722055,1.3394693773541972 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441794,14.959832953809151,83.56495705722055,0.1790204109548636 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441795,38.41420397776422,83.56495705722055,0.4596927388050992 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441805,1829.7137981780036,1829.6496491832456,1.0000350608078363 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441810,1579.870798483306,1829.6496491832456,0.863482688715055 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441806,2025.647617645269,1829.6496491832456,1.1071232235906567 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441799,2002.5410404513525,1829.6496491832456,1.0944942608795545 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441794,1207.5499081668645,1829.6496491832456,0.6599896918548936 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441795,1184.4885565839584,1829.6496491832456,0.6473854473246904 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441805,171719.2049044405,96234.19538703516,1.7843886387143297 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441810,166071.82985603728,96234.19538703516,1.7257049761587218 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441806,157633.4540955169,96234.19538703516,1.638019141341037 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441799,125892.64262235384,96234.19538703516,1.308190317548125 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441794,268695.22015477356,96234.19538703516,2.792097123835595 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441795,174264.82472879798,96234.19538703516,1.810840980463741 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441805,43.49709226809168,77.99112650544876,0.5577184766660961 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441810,49.644920257916105,77.99112650544876,0.6365457518355978 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441806,57.76816224385905,77.99112650544876,0.7407017289309592 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441799,74.50665877146116,77.99112650544876,0.9553222540804798 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441794,48.85885708384749,77.99112650544876,0.626466872233651 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441795,51.6680518491072,77.99112650544876,0.6624862874047277 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441805,109.08548841200616,110.33780757772625,0.9886501354955969 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441810,122.46710840904537,110.33780757772625,1.1099287823239987 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441806,101.54055856717392,110.33780757772625,0.9202698585038024 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441799,158.56166904154898,110.33780757772625,1.437056549540845 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441794,86.90325899884431,110.33780757772625,0.7876108915579664 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441795,168.36230669730196,110.33780757772625,1.525880479170306 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441805,72.49258591744882,67.31067174214355,1.0769850313655516 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441810,68.72014971986167,67.31067174214355,1.0209398887462837 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441806,66.89897753160453,67.31067174214355,0.9938836710452666 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441799,72.08385979799903,67.31067174214355,1.070912797812222 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441794,53.55353628919603,67.31067174214355,0.7956173204503305 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441795,59.88578631641064,67.31067174214355,0.8896922993997672 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441805,3306.74944187056,2375.529574917848,1.3920051666731683 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441810,4500.021534635448,2375.529574917848,1.8943235151223365 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441806,3537.4168716148088,2375.529574917848,1.4891066434048255 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441799,3286.798696931888,2375.529574917848,1.3836067256900197 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441794,2568.1670754644074,2375.529574917848,1.0810924446407792 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441795,4243.517207145935,2375.529574917848,1.786345769781749 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441805,178.33687808848995,194.62377093849457,0.9163160143724086 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441810,194.2754928475902,194.62377093849457,0.9982105058943984 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441806,120.45239787163295,194.62377093849457,0.6188986951121124 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441799,129.2407996537039,194.62377093849457,0.6640545449843681 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441794,154.04732108028492,194.62377093849457,0.7915133919019958 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441795,240.89296559284685,194.62377093849457,1.2377366055093773 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441805,3708.974659929193,3728.1507253933823,0.9948564135742752 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441810,3979.499795240337,3728.1507253933823,1.0674192349936262 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441806,3632.739729735972,3728.1507253933823,0.9744079564681917 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441799,3793.672047183498,3728.1507253933823,1.0175747512952824 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441794,3926.787976011366,3728.1507253933823,1.0532803701483995 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441795,4990.875022672655,3728.1507253933823,1.3386999052046198 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441805,67.25817786686461,68.78582331086372,0.9777912748518657 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441810,59.20400391489841,68.78582331086372,0.8607006657074933 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441806,96.421885489194,68.78582331086372,1.40176973754366 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441799,121.81966817403335,68.78582331086372,1.770999637868603 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441794,41.21739731177672,68.78582331086372,0.5992135490695949 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441795,69.77538533747853,68.78582331086372,1.0143861333481854 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441805,505.1274290793284,696.3940975413478,0.7253470855980896 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441810,598.3117443475337,696.3940975413478,0.8591568286691422 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441806,795.642894598926,696.3940975413478,1.1425181479969182 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441799,735.54180495546575,696.3940975413478,1.0562148753878453 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441794,1194.1744971871865,696.3940975413478,1.7147969826327876 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441795,752.3916470674499,696.3940975413478,1.0804107181893183 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441805,54.39425858733879,81.2393188807366,0.6695558177585449 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441810,70.47965429911758,81.2393188807366,0.8675559479097216 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441806,210.5582001769147,81.2393188807366,2.59182626193635 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441799,134.6071295739149,81.2393188807366,1.6569209519287689 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441794,27.143256525704597,81.2393188807366,0.3341147722515037 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441795,23.934702772739634,81.2393188807366,0.2946196878863174 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441805,228.0454089452201,543.8205698619286,0.4193394321276205 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441810,466.2991934411592,543.8205698619286,0.8574504520113108 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441806,236.8384836210836,543.8205698619286,0.4355085054638792 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441799,334.3238514564756,543.8205698619286,0.6147686755235419 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441794,655.162159339741,543.8205698619286,1.2047395697188894 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441795,233.3240868858583,543.8205698619286,0.4290460858166827 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441805,409594.2546188641,306516.0644612488,1.3362896830180557 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441810,372260.10667570255,306516.0644612488,1.2144880801924998 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441806,127273.75969496928,306516.0644612488,0.4152270450120562 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441799,217621.4064643266,306516.0644612488,0.7099836899146906 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441794,379034.14784774225,306516.0644612488,1.2365881981225213 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441795,198584.86181664895,306516.0644612488,0.6478775008601709 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441805,1402335.6098929537,335923.8645439917,4.174563816109313 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441810,1219103.5632894528,335923.8645439917,3.6291067469837417 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441806,942960.4167027704,335923.8645439917,2.8070658748309407 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441799,1136344.506002633,335923.8645439917,3.382744204688144 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441794,1047722.8053316608,335923.8645439917,3.118929364407969 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441795,1497561.2627681857,335923.8645439917,4.4580377306658105 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441805,40.74592388131196,33.931355493730415,1.200833956923433 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441810,77.58954351637226,33.931355493730415,2.286662067794748 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441806,30.454846315390515,33.931355493730415,0.8975428736119233 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441799,50.01488682995234,33.931355493730415,1.4740020285718831 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441794,21.03034052279638,33.931355493730415,0.6197907574509427 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441795,41.73610896882743,33.931355493730415,1.230015964924806 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441805,7.3442645992862845,76.3332642617619,0.09621316041328123 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441810,83.8031024711511,76.3332642617619,1.0978582310298386 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441806,60.37,76.3332642617619,0.7908740780818608 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441799,63.51842499478039,76.3332642617619,0.832119857693536 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441794,56.68075354295659,76.3332642617619,0.7425432947369713 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441795,8.020102201239995,76.3332642617619,0.10506693613596131 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441805,133.85797990077228,130.67426801703346,1.0243637246418233 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441810,132.622549212368,130.67426801703346,1.014909447934161 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441806,134.510200063262,130.67426801703346,1.0293549151216868 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441799,186.02391436962324,130.67426801703346,1.4235695917223345 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441794,100.6146450498236,130.67426801703346,0.7699652469965121 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441795,114.93945485227944,130.67426801703346,0.8795875163218594 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441805,9307.260722012825,5444.214081294075,1.7095692019150932 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441810,7488.024959215876,5444.214081294075,1.3754097189058356 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441806,6513.498899161333,5444.214081294075,1.1964075625793706 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441799,7004.859708165984,5444.214081294075,1.286661325871474 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441794,10458.736888379764,5444.214081294075,1.9210737734056464 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441795,6672.035421420376,5444.214081294075,1.2255277477689583 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441805,89.36873655853101,100.67607722942154,0.8876859231898432 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441810,76.23376850102515,100.67607722942154,0.7572183044766729 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441806,70.80077083582887,100.67607722942154,0.7032531737851431 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441799,101.49115465399392,100.67607722942154,1.008096038771107 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441794,118.7401495182504,100.67607722942154,1.1794276533804977 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441795,87.17140788974028,100.67607722942154,0.8658601952785 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441805,543.0869475593206,599.1099853739104,0.9064895608781662 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441810,633.6335891425698,599.1099853739104,1.0576248178322598 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441806,550.6390229729814,599.1099853739104,0.9190950516862478 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441799,715.3401233561949,599.1099853739104,1.194004674967559 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441794,569.8635227971597,599.1099853739104,0.9511834833490588 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441795,678.4733349308633,599.1099853739104,1.132468747799991 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441805,48.27078276182397,114.30018844822946,0.42231586331712384 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441810,46.18921669865746,114.30018844822946,0.4041044667181644 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441806,98.01695030452866,114.30018844822946,0.857539708684942 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441799,127.14948999460717,114.30018844822946,1.112417151019813 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441794,71.96939019446523,114.30018844822946,0.629652419401414 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441795,64.95992296732946,114.30018844822946,0.5683273479181714 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441805,2388.554902410637,1759.6959467320276,1.3573679628270316 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441810,3302.352866879327,1759.6959467320276,1.8766610635275962 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441806,2319.1946388666947,1759.6959467320276,1.3179519127572723 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441799,3051.230424958153,1759.6959467320276,1.7339532040320171 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441794,1683.1039211568689,1759.6959467320276,0.9564742842549592 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441795,3767.954161614226,1759.6959467320276,2.1412529639633378 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441805,45.259337136129126,38.77498679262034,1.167230239901536 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441810,33.83942085532377,38.77498679262034,0.8727126339541165 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441806,53.65878962169258,38.77498679262034,1.3838506227913125 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441799,32.315187306878414,38.77498679262034,0.8334029223455118 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441794,24.374803107937264,38.77498679262034,0.6286218287655556 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441795,15.412114148682273,38.77498679262034,0.39747567758335145 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441805,4335.002182054602,2284.874121495706,1.8972608343153965 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441810,2109.0097826525025,2284.874121495706,0.9230310601408184 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441806,2106.774577738098,2284.874121495706,0.9220527984092962 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441799,2575.022867807286,2284.874121495706,1.126986753266585 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441794,4773.3629582518115,2284.874121495706,2.08911419379511 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441795,2775.3133867872593,2284.874121495706,1.214646076419521 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441805,523.5439861291931,306.4947439651267,1.708166278338406 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441810,460.78270926199536,306.4947439651267,1.5033951424446734 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441806,437.4490425671307,306.4947439651267,1.4272644186580377 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441799,481.53422803130206,306.4947439651267,1.5711010955740616 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441794,432.08497580027705,306.4947439651267,1.4097630850382221 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441795,493.29038543105656,306.4947439651267,1.6094578949359852 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441805,41877.24004231618,53872.22448470133,0.7773438064397825 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441810,32386.99354119714,53872.22448470133,0.6011816636677852 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441806,39646.47841653415,53872.22448470133,0.7359354249014347 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441799,37765.5994390378,53872.22448470133,0.7010217194532685 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441794,73515.68447466595,53872.22448470133,1.3646305712796951 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441795,37414.30724333723,53872.22448470133,0.6945008787220615 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441805,476.80108428189527,320.29657233769314,1.4886237489272824 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441810,310.9894204493803,320.29657233769314,0.9709420808958886 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441806,156.49007047998904,320.29657233769314,0.4885786611384632 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441799,94.89937929517885,320.29657233769314,0.29628596585518596 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441794,806.1774483422399,320.29657233769314,2.5169718253877402 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441795,134.08936868973723,320.29657233769314,0.4186412852035299 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441805,11151.22889487467,6299.521117687065,1.770170888635573 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441810,6749.9415214842675,6299.521117687065,1.0715007371802538 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441806,9013.09148575105,6299.521117687065,1.4307581984994284 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441799,6264.638142444359,6299.521117687065,0.9944625988879113 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441794,34425.61919505008,6299.521117687065,5.46479939536893 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441795,5924.757059710493,6299.521117687065,0.940509119506822 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441805,2712.610607197717,1965.7827420843205,1.3799137356967202 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441810,2986.6458259792944,1965.7827420843205,1.5193163323900953 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441806,2040.449221541476,1965.7827420843205,1.0379830781187886 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441799,4550.797760356294,1965.7827420843205,2.3150054494481322 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441794,2333.482264665795,1965.7827420843205,1.1870499291247223 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441795,2606.836138511421,1965.7827420843205,1.3261059234589632 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441805,9406.95,6243.797224888628,1.5066072233259937 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441810,6583.841981590353,6243.797224888628,1.0544612107751128 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441806,7870.420201317652,6243.797224888628,1.2605182259835541 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441799,2633.4324694532243,6243.797224888628,0.4217677760187347 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441794,25259.392556574163,6243.797224888628,4.045517758950719 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441795,6276.488661865373,6243.797224888628,1.0052358261806504 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441805,676.5827524733746,477.14850073021523,1.4179710329969613 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441810,703.84410201167,477.14850073021523,1.4751049221249273 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441806,485.7035398343694,477.14850073021523,1.0179295106053183 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441799,1061.6063913031116,477.14850073021523,2.2248972587746954 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441794,537.8535168403818,477.14850073021523,1.1272245768712785 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441795,562.8950687704055,477.14850073021523,1.179706250588582 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441805,250.02989351066967,205.1372392304115,1.2188420515391378 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441810,168.4354383916865,205.1372392304115,0.8210866004806602 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441806,170.21284548084878,205.1372392304115,0.8297510784459012 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441799,245.5364573406146,205.1372392304115,1.1969375149132548 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441794,634.4848989894163,205.1372392304115,3.0929776639762547 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441795,136.77025393021276,205.1372392304115,0.6667256244810408 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441805,82.81014568730579,44.32085041603382,1.8684241143835953 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441810,106.46074113668872,44.32085041603382,2.4020464439954594 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441806,19.254853328249155,44.32085041603382,0.434442325621157 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441799,48.81440065004097,44.32085041603382,1.1013868233986217 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441794,2.368792919664622,44.32085041603382,0.05344646813924109 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441795,30.270465662584645,44.32085041603382,0.6829847662768174 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441805,20.12013502592128,73.02499011367847,0.2755239678170464 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441810,68.28535845365967,73.02499011367847,0.9350957575942073 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441806,97.65273661892596,73.02499011367847,1.337250939259414 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441799,61.92,73.02499011367847,0.8479289063046601 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441794,100.94852828081002,73.02499011367847,1.382383320061568 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441795,1.846290437140097,73.02499011367847,0.02528299468806452 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441805,121.93941931274748,446.9213615105917,0.27284312143996187 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441810,114.50706934811537,446.9213615105917,0.2562130146589595 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441806,126.16049384779664,446.9213615105917,0.282287902778634 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441799,536.9305583993629,446.9213615105917,1.2013982875746656 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441794,1901.3616411280889,446.9213615105917,4.254353908485147 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441795,114.42182992940302,446.9213615105917,0.25602228889363865 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441805,2037.4934951270077,2631.000022355788,0.7744178935059998 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441810,1632.2739379306372,2631.000022355788,0.620400579270655 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441806,1877.523003705225,2631.000022355788,0.7136157308064549 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441799,1533.2562811790003,2631.000022355788,0.5827655903271821 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441794,2063.966830304438,2631.000022355788,0.7844799744457507 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441795,2556.4803692607675,2631.000022355788,0.9716763008506948 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441805,38.77718537992022,48.89133349009634,0.7931300419076339 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441810,27.57986107733684,48.89133349009634,0.5641053149618744 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441806,30.28394376519659,48.89133349009634,0.6194133316353715 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441799,89.28000463116078,48.89133349009634,1.8260906025245918 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441794,18.571050396101707,48.89133349009634,0.3798434010776889 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441795,11.994064682546012,48.89133349009634,0.2453208744035502 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441805,214.8864024632073,307.70649021557807,0.6983486188824248 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441810,140.40430232687103,307.70649021557807,0.4562929505598152 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441806,136.254741197621,307.70649021557807,0.44280749847740103 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441799,231.40547892181493,307.70649021557807,0.7520331428813642 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441794,173.1895653908398,307.70649021557807,0.5628401444165309 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441795,45.852308942415895,307.70649021557807,0.1490131355704975 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441805,254.8533212831864,154.19153082843468,1.6528360534065631 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441810,227.8880092818544,154.19153082843468,1.4779541266466838 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441806,201.07114476772233,154.19153082843468,1.3040349472335773 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441799,203.7481365200538,154.19153082843468,1.3213964179832913 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441794,171.53248159701678,154.19153082843468,1.1124637045589552 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441795,240.44031870086403,154.19153082843468,1.5593613826196224 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441805,7571.931375969845,6593.957266089812,1.1483136863669678 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441810,6957.752179423398,6593.957266089812,1.0551709540497698 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441806,7065.847806615062,6593.957266089812,1.0715640883740636 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441799,7785.716003676229,6593.957266089812,1.18073498045175 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441794,7587.542795388736,6593.957266089812,1.1506812205788097 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441795,8089.303850138744,6593.957266089812,1.2267752919387156 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441805,146.09982095781018,127.96554716912783,1.141712157606882 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441810,125.1585152927657,127.96554716912783,0.9780641591548687 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441806,116.11795437270244,127.96554716912783,0.9074157610503801 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441799,298.18139234601875,127.96554716912783,2.3301693224655406 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441794,102.28385933007912,127.96554716912783,0.7993077948933702 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441795,132.23405954930777,127.96554716912783,1.0333567313594056 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441805,1170.9946692741098,1681.9358703135756,0.6962183814153347 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441810,1123.0437027927449,1681.9358703135756,0.6677089909399266 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441806,2112.3766060492662,1681.9358703135756,1.2559198262746132 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441799,1756.4908527590255,1681.9358703135756,1.0443268877020562 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441794,2928.021581782548,1681.9358703135756,1.7408639850440049 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441795,1365.3816843742457,1681.9358703135756,0.8117917623813371 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441805,50.45903801035416,45.403354316773296,1.1113504446897915 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441810,45.08967774457494,45.403354316773296,0.9930913348381736 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441806,44.45347024228166,45.403354316773296,0.9790789890133575 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441799,41.773887079676655,45.403354316773296,0.920061693861332 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441794,53.81945652380048,45.403354316773296,1.18536300530373 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441795,47.633805622685486,45.403354316773296,1.049125253838089 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441805,164.2549803150713,171.72890790902974,0.9564783373692819 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441810,141.62564907379877,171.72890790902974,0.8247047675212748 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441806,169.05392774117524,171.72890790902974,0.984423238926835 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441799,190.0172802403675,171.72890790902974,1.1064955956106453 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441794,162.29868953874626,171.72890790902974,0.9450865990758005 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441795,196.16276646523175,171.72890790902974,1.1422815695604691 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441805,891.365876299991,385.5886159476326,2.311701744900707 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441810,255.0895048432223,385.5886159476326,0.6615587034806713 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441806,98.5812447803996,385.5886159476326,0.2556643031022163 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441799,314.0259985117287,385.5886159476326,0.8144068199212008 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441794,0.2381553612212898,385.5886159476326,6.176410593346824e-4 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441795,213.3692663406447,385.5886159476326,0.5533598698609472 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441805,227.89296048359515,430.1288265554666,0.529824895272876 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441810,219.67003334452193,430.1288265554666,0.5107075363994343 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441806,279.8722766869549,430.1288265554666,0.6506708209449997 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441799,467.4789322647589,430.1288265554666,1.0868346955687609 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441794,325.03407457073035,430.1288265554666,0.7556668014409773 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441795,286.6166937512328,430.1288265554666,0.6663508141188779 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441805,115013.34082324736,54695.927744901994,2.1027770359735296 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441810,81736.31014323236,54695.927744901994,1.4943765196642214 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441806,34625.690672986595,54695.927744901994,0.633057927721391 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441799,58212.66922912165,54695.927744901994,1.0642962214777945 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441794,84794.03012375973,54695.927744901994,1.550280498380669 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441795,44711.30384216751,54695.927744901994,0.8174521520267088 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441805,523209.2678104092,97212.60478924697,5.382113450665229 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441810,451443.28050564195,97212.60478924697,4.6438759817654605 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441806,303831.55576587527,97212.60478924697,3.125433748273384 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441799,342282.50684953696,97212.60478924697,3.520968372276329 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441794,627411.4186707148,97212.60478924697,6.454013037001916 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441795,364037.68544053327,97212.60478924697,3.7447580612591587 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441805,130135.21229564887,62941.57202670208,2.067555799852613 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441810,99671.2399277982,62941.57202670208,1.5835518039732799 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441806,36815.075399903006,62941.57202670208,0.5849087370154137 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441799,60167.108296023864,62941.57202670208,0.9559200121423534 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441794,101677.64269080586,62941.57202670208,1.615429030715511 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441795,51844.095005930416,62941.57202670208,0.8236860525812143 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441805,140627.5414703269,14728.399701289269,9.548053035118057 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441810,119295.1720047218,14728.399701289269,8.099669646681244 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441806,53751.810772838246,14728.399701289269,3.649535038632406 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441799,66776.1293733632,14728.399701289269,4.5338346818166455 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441794,201577.72634575595,14728.399701289269,13.686329162299323 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441795,68135.26625618938,14728.399701289269,4.626114692570781 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441805,7448.481258677789,3575.9352491809864,2.082946345402577 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441810,6844.890676699866,3575.9352491809864,1.9141539764366775 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441806,2358.511175226397,3575.9352491809864,0.6595508617687018 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441799,2749.769976315911,3575.9352491809864,0.7689652593529774 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441794,7395.473599002919,3575.9352491809864,2.068122905943764 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441795,5166.151525615741,3575.9352491809864,1.4446994046659456 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441805,44158.33,12966.336321671553,3.4056134982550983 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441810,46609.41417932198,12966.336321671553,3.5946479424122586 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441806,22227.62546393796,12966.336321671553,1.7142564339309445 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441799,76594.95038690118,12966.336321671553,5.907216077596463 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441794,25364.921552050462,12966.336321671553,1.9562134532679272 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441795,58288.14330778033,12966.336321671553,4.495344086545036 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441805,218.7023346820251,103.34580193186551,2.1162188554713874 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441810,193.61313360967824,103.34580193186551,1.8734494289117305 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441806,182.45791545614787,103.34580193186551,1.7655087293864138 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441799,106.84312563206356,103.34580193186551,1.0338409846827044 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441794,131.43932238581374,103.34580193186551,1.2718399773265092 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441795,269.2157599710133,103.34580193186551,2.60499947688735 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441805,452.87107848734706,211.8154700640626,2.138045338947048 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441810,491.7244066200592,211.8154700640626,2.321475416650821 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441806,309.1315578888079,211.8154700640626,1.459438056131181 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441799,912.1593981092592,211.8154700640626,4.306387053945497 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441794,253.29308241772117,211.8154700640626,1.1958195609655606 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441795,845.3682474043309,211.8154700640626,3.991059987963359 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441805,117.07607330504312,76.10596635595309,1.5383297645478924 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441810,59.788447187279075,76.10596635595309,0.7855947444073464 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441806,86.96481108024533,76.10596635595309,1.142680597123025 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441799,2.8283441445178887,76.10596635595309,0.037163238047455034 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441794,19.829941369233556,76.10596635595309,0.2605569880879968 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441795,86.6793580733054,76.10596635595309,1.1389298661277067 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441805,2332.4879350054284,1382.686999693948,1.686924036692118 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441810,2085.7641976369,1382.686999693948,1.5084861563742011 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441806,2162.7921166570763,1382.686999693948,1.5641950182042654 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441799,2326.0821680278304,1382.686999693948,1.6822911971709424 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441794,3461.643189961379,1382.686999693948,2.503562404743517 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441795,2115.9979443630273,1382.686999693948,1.5303520933019508 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441805,33.56111000021287,30.899530320120164,1.0861365740035092 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441810,30.788763099826618,30.899530320120164,0.9964152458258753 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441806,31.07738428487145,30.899530320120164,1.0057558792288657 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441799,35.96019695433488,30.899530320120164,1.1637781086568646 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441794,32.89649139641634,30.899530320120164,1.0646275543869952 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441795,33.00750870411744,30.899530320120164,1.0682204021277524 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441805,32.18223372928155,31.68183515511672,1.0157944945965043 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441810,31.446765904375205,31.68183515511672,0.992580314568566 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441806,32.65307870061388,31.68183515511672,1.030656164352282 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441799,34.99945890981398,31.68183515511672,1.1047169060268738 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441794,32.19490553178928,31.68183515511672,1.016194465193084 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441795,34.335145211633495,31.68183515511672,1.0837486226263713 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441805,152.41678903113717,628.1906149122311,0.24262824915401257 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441810,314.71318359278354,628.1906149122311,0.5009835806552989 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441806,324.07154107793224,628.1906149122311,0.515880902046285 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441799,355.03589995729055,628.1906149122311,0.565172244744368 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441794,252.0299722218102,628.1906149122311,0.4011998368632474 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441795,218.06900544132927,628.1906149122311,0.34713827342326214 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441805,18125.301711588323,10551.186365326936,1.7178449023657918 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441810,19314.050809968812,10551.186365326936,1.8305098726564246 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441806,16530.464575271875,10551.186365326936,1.5666925029012762 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441799,23912.937594006955,10551.186365326936,2.2663742982105877 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441794,18231.85269440437,10551.186365326936,1.7279433859985132 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441795,19084.69113952587,10551.186365326936,1.8087720639871872 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441805,79.04369640607588,102.14043933131707,0.7738726886583936 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441810,66.37344621065404,102.14043933131707,0.6498253448407032 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441806,92.99057120055602,102.14043933131707,0.9104187509799008 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441799,79.80591912480114,102.14043933131707,0.7813351856254647 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441794,47.828707186245026,102.14043933131707,0.4682641615736654 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441795,129.16871525315497,102.14043933131707,1.2646187553018564 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441805,4148.561233474663,2995.2816068385046,1.3850321198524755 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441810,5922.847539681001,2995.2816068385046,1.9773925517248838 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441806,3572.363879183047,2995.2816068385046,1.1926637785999856 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441799,5448.273146179954,2995.2816068385046,1.8189518921162682 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441794,5563.330987398387,2995.2816068385046,1.8573649217812405 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441795,9038.579637260487,2995.2816068385046,3.0176059628665883 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441805,40.922464253305506,35.73806763844074,1.1450665063179941 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441810,37.7681508759346,35.73806763844074,1.0568045048778814 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441806,35.38739550541614,35.73806763844074,0.9901877142163273 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441799,57.63365443639441,35.73806763844074,1.6126684581681814 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441794,40.29399238627256,35.73806763844074,1.1274810041192982 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441795,34.65120220504233,35.73806763844074,0.9695880190167487 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441805,249.8260752105776,271.6614200921023,0.9196229450831783 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441810,245.54521131530157,271.6614200921023,0.9038648595448465 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441806,273.5122716574102,271.6614200921023,1.006813082125097 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441799,288.705130884766,271.6614200921023,1.062738797385677 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441794,293.6467139142901,271.6614200921023,1.0809290248675505 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441795,266.2053154187741,271.6614200921023,0.9799157912394098 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441805,157.00515942572846,166.02715311669658,0.9456595290492829 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441810,182.3702295999453,166.02715311669658,1.0984361664730922 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441806,157.44644759452663,166.02715311669658,0.9483174567467361 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441799,212.84273980526,166.02715311669658,1.281975482984147 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441794,146.94345390149584,166.02715311669658,0.8850567581449328 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441795,149.6073345494591,166.02715311669658,0.9011016074238388 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441805,1518.7963326906677,1793.9624976146763,0.8466154307629727 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441810,1357.8052495185436,1793.9624976146763,0.7568749354147232 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441806,1482.943554952672,1793.9624976146763,0.8266301870437385 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441799,1492.6356219837871,1793.9624976146763,0.832032789965484 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441794,1601.2515376267204,1793.9624976146763,0.8925780442767383 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441795,2233.0709131640497,1793.9624976146763,1.2447701198510166 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441805,63.17747468461756,59.13775760336051,1.0683102850864181 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441810,53.09234235824259,59.13775760336051,0.8977740196768234 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441806,52.35750837203107,59.13775760336051,0.8853482190379137 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441799,76.4308534802022,59.13775760336051,1.2924205546112728 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441794,89.32512222264485,59.13775760336051,1.5104583914349998 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441795,134.902655348537,59.13775760336051,2.2811594625101432 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441805,316.69323527040837,238.79765196261823,1.3261991174016403 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441810,441.0357336677798,238.79765196261823,1.8469014667565502 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441806,337.5128662414694,238.79765196261823,1.4133843589647364 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441799,787.5799259278972,238.79765196261823,3.2981058207858185 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441794,407.73218960498417,238.79765196261823,1.7074380181460547 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441795,196.82400117555196,238.79765196261823,0.824229214809713 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441805,358.3769263007732,386.8144501381946,0.9264827779126098 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441810,381.71588493145225,386.8144501381946,0.986819093224359 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441806,311.76155998702785,386.8144501381946,0.8059718551766794 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441799,293.2705505361033,386.8144501381946,0.7581685493686404 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441794,296.0043005851903,386.8144501381946,0.7652358914705457 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441795,415.3680166124732,386.8144501381946,1.0738172176972123 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441805,8788.95965742532,5555.372966797932,1.5820647344387389 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441810,8333.603634341122,5555.372966797932,1.5000979563653918 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441806,6419.728012118192,5555.372966797932,1.1555890217427591 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441799,15767.2398347067,5555.372966797932,2.8381964503446824 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441794,14045.297608563184,5555.372966797932,2.528236662507786 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441795,12330.95619252369,5555.372966797932,2.21964506545654 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441805,61.79535566779268,84.54153084580483,0.7309467317371049 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441810,95.87929577497052,84.54153084580483,1.1341088198396196 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441806,4.340165705447098,84.54153084580483,0.051337675838436375 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441799,60.052819365958754,84.54153084580483,0.7103351307357919 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441794,46.99892157245976,84.54153084580483,0.5559270231122384 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441795,15.75539923469796,84.54153084580483,0.18636283347452282 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441805,61.66647823861971,122.00200397429413,0.5054546337748097 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441810,262.71627479844244,122.00200397429413,2.1533767171053753 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441806,87.27278485555523,122.00200397429413,0.7153389453663699 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441799,133.5686860237129,122.00200397429413,1.0948073119508421 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441794,140.8427768828243,122.00200397429413,1.1544300281534714 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441795,205.43581237064876,122.00200397429413,1.6838724420783626 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441805,101.2034487570311,143.84455848940917,0.7035611900778465 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441810,79.43698088809282,143.84455848940917,0.552241820770311 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441806,71.53010172095348,143.84455848940917,0.4972736019501219 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441799,148.901164042711,143.84455848940917,1.0351532627052704 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441794,189.0140430160281,143.84455848940917,1.3140159419373838 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441795,195.3567566150383,143.84455848940917,1.3581101618760352 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441805,4296.121473338203,5334.764851653101,0.8053066241536307 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441810,704.8632161151512,5334.764851653101,0.13212638901913978 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441806,3566.7671701866775,5334.764851653101,0.6685893885428581 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441799,1470.2663441041054,5334.764851653101,0.2756009655511825 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441794,2976.6405791832835,5334.764851653101,0.5579703439526303 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441795,7240.4517091052785,5334.764851653101,1.35722040435609 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441805,129.8003458397481,159.70733471984832,0.8127387891572935 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441810,134.04013045364104,159.70733471984832,0.8392860020409734 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441806,133.00846820976187,159.70733471984832,0.8328262971959275 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441799,198.60517721991545,159.70733471984832,1.2435570198970514 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441794,109.1460234754178,159.70733471984832,0.6834127165598063 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441795,169.4436011274732,159.70733471984832,1.0609631763294016 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441805,87118.79110756244,82077.5827732141,1.0614200389925899 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441810,72121.82,82077.5827732141,0.878703021740753 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441806,117881.2925945618,82077.5827732141,1.4362178881446321 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441799,182319.14901399988,82077.5827732141,2.2213026121609842 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441794,180224.42666182568,82077.5827732141,2.195781364075961 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441795,109714.8428765844,82077.5827732141,1.33672117488808 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441805,278857.85429478297,170961.68742491837,1.6311131370720098 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441810,202187.68806249043,170961.68742491837,1.1826491134236474 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441806,123475.97614928574,170961.68742491837,0.722243550640625 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441799,97273.35209497868,170961.68742491837,0.5689774917418174 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441794,87431.37657782233,170961.68742491837,0.5114091811723592 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441795,62534.10330706525,170961.68742491837,0.36577846328598324 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441805,402289.9416564174,55195.40432138408,7.288468063645658 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441810,325995.5787378898,55195.40432138408,5.906208727808721 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441806,233405.68785587593,55195.40432138408,4.228715972381214 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441799,255875.13623358405,55195.40432138408,4.635805088838739 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441794,416772.9121310749,55195.40432138408,7.550862562838526 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441795,328597.654733941,55195.40432138408,5.953351710599465 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441805,986.6147927480124,546.121028905539,1.8065863435532792 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441810,737.2177733195448,546.121028905539,1.3499164732714573 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441806,550.6596041428019,546.121028905539,1.008310566700496 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441799,546.5015298328223,546.121028905539,1.0006967337039663 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441794,504.1223793478306,546.121028905539,0.923096443215387 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441795,885.5037957473714,546.121028905539,1.621442407229725 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441805,1570.6486112378695,1228.731327313693,1.2782685492944101 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441810,1216.2566666908565,1228.731327313693,0.9898475278154507 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441806,1495.9588909215615,1228.731327313693,1.2174825022098958 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441799,1460.2343412966425,1228.731327313693,1.1884081644512732 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441794,2718.002113443254,1228.731327313693,2.212039404403785 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441795,1301.548508842474,1228.731327313693,1.0592620859500481 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441805,20.18790940585949,76.68368758811918,0.2632621101151539 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441810,49.98823456285803,76.68368758811918,0.6518757265737289 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441806,52.76699526400317,76.68368758811918,0.6881123863972669 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441799,33.730977019735704,76.68368758811918,0.4398716086908911 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441794,32.5507009115081,76.68368758811918,0.4244801200268735 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441795,38.329497205552755,76.68368758811918,0.49983899328664066 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441805,117.84631517365526,81.06808963980528,1.4536708055815772 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441810,213.13435750781665,81.06808963980528,2.6290783273023552 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441806,123.70863454925065,81.06808963980528,1.5259843311826162 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441799,52.04538033180414,81.06808963980528,0.6419958896656831 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441794,176.64675240905206,81.06808963980528,2.1789924148196116 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441795,123.50015990043268,81.06808963980528,1.5234127318055464 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441805,49.13010771043094,34.254424530644805,1.4342704156795278 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441810,28.82265393341759,34.254424530644805,0.8414286425285638 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441806,49.05616913046629,34.254424530644805,1.4321119038674697 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441799,297.87874197540026,34.254424530644805,8.69606615953834 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441794,58.84758017675633,34.254424530644805,1.7179555921048948 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441795,101.28901571617358,34.254424530644805,2.9569615342846607 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441805,68.59,60.87738129746832,1.1266910392358225 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441810,66.80159570646646,60.87738129746832,1.0973138837896188 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441806,48.727350592884584,60.87738129746832,0.80041798044475 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441799,76.2086539675539,60.87738129746832,1.2518385703085944 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441794,81.28858804880683,60.87738129746832,1.3352839152459954 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441795,80.6717069220219,60.87738129746832,1.3251507407625098 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441805,77.84038065029638,81.37032235510941,0.9566188064315642 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441810,64.91118887119013,81.37032235510941,0.7977255956773807 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441806,45.03894909550501,81.37032235510941,0.553505845767083 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441799,51.69837120355597,81.37032235510941,0.6353467665758821 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441794,13.500204370181558,81.37032235510941,0.16591066594605733 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441795,61.93053335997565,81.37032235510941,0.7610948508929792 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441805,461.74746298321503,592.3362991324378,0.7795359893687268 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441810,498.24839635784537,592.3362991324378,0.8411579656482343 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441806,929.2517486026328,592.3362991324378,1.5687908202885024 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441799,509.204166219694,592.3362991324378,0.859653826661471 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441794,1071.8321093612467,592.3362991324378,1.809499284327332 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441795,717.7111803918534,592.3362991324378,1.2116616547779449 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441805,6280.179576910279,1509.2244087879828,4.161196665215427 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441810,3822.0562594522858,1509.2244087879828,2.5324638517618965 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441806,2540.1108524989945,1509.2244087879828,1.683057097213852 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441799,2299.6895545910347,1509.2244087879828,1.5237558716916413 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441794,2451.769147501006,1509.2244087879828,1.624522591355354 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441795,3711.058522853582,1509.2244087879828,2.4589176409052595 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441805,1069512.1071889407,911297.6405793307,1.1736144806750841 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441810,852378.7014733823,911297.6405793307,0.9353461081403739 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441806,1161981.7722222104,911297.6405793307,1.2750848026814978 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441799,970564.64,911297.6405793307,1.0650358310847727 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441794,1123601.154712916,911297.6405793307,1.23296835707664 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441795,1444499.0955714085,911297.6405793307,1.5851013228269861 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441805,1779.0141186508756,749.6106308195243,2.373250919221808 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441810,1424.0338385090477,749.6106308195243,1.8996980298320996 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441806,1403.5791417936064,749.6106308195243,1.8724109345396023 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441799,1048.7152750802577,749.6106308195243,1.3990133436791474 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441794,1714.265900612355,749.6106308195243,2.2868751190710905 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441795,1501.0678787738252,749.6106308195243,2.002463435093974 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441805,9271.972715021158,2138.7943755926544,4.335139843656975 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441810,9921.846232424628,2138.7943755926544,4.638990239384424 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441806,4584.497763016979,2138.7943755926544,2.1434962684276866 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441799,10145.010529988083,2138.7943755926544,4.743331404720441 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441794,7201.828577390143,2138.7943755926544,3.3672374771392106 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441795,8640.703161237136,2138.7943755926544,4.039987789309021 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441805,850.7992529255824,613.8984432679271,1.3858957654242876 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441810,1081.9157318410485,613.8984432679271,1.762369238276211 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441806,883.0157951256639,613.8984432679271,1.4383743839211602 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441799,664.3210178052099,613.8984432679271,1.0821350421885279 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441794,606.2273004496035,613.8984432679271,0.9875042152290071 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441795,982.5084589905764,613.8984432679271,1.60044135925879 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441805,5289.999861688679,6365.76448478505,0.8310077877264264 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441810,5228.634460714937,6365.76448478505,0.8213678770573445 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441806,5089.810766939209,6365.76448478505,0.7995600181414935 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441799,5930.942230459539,6365.76448478505,0.9316936315559916 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441794,5692.370731987832,6365.76448478505,0.894216357767129 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441795,5109.476057652976,6365.76448478505,0.8026492450145217 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441805,63.00612705472673,70.21289390855102,0.8973583560989415 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441810,45.698267322134456,70.21289390855102,0.6508529242741979 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441806,105.57595064101392,70.21289390855102,1.5036547386655448 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441799,88.94816741540468,70.21289390855102,1.2668352273195784 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441794,58.15514617486078,70.21289390855102,0.8282687543203263 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441795,84.73303866659383,70.21289390855102,1.2068016848437355 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441805,1457.2635910292497,2003.7789126851078,0.7272576738900224 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441810,1435.8681318072056,2003.7789126851078,0.7165801190527106 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441806,1424.0976522234002,2003.7789126851078,0.7107059781935114 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441799,2190.069521552906,2003.7789126851078,1.0929696423534891 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441794,1887.8692497655748,2003.7789126851078,0.9421544651529387 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441795,3121.639257366085,2003.7789126851078,1.5578760898242112 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441805,629.9523173182947,700.7857837159185,0.8989227977456548 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441810,797.234426753963,700.7857837159185,1.1376292802725325 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441806,811.2601619528783,700.7857837159185,1.1576435778294034 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441799,513.9964125277767,700.7857837159185,0.7334572482368426 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441794,515.2407265150193,700.7857837159185,0.7352328464526692 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441795,905.0814187741744,700.7857837159185,1.2915236578786997 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441805,4247.91587326986,4688.560133729121,0.9060171464392016 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441810,3656.332425979168,4688.560133729121,0.7798412138677309 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441806,4214.764247093125,4688.560133729121,0.8989463986549844 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441799,4015.094467211244,4688.560133729121,0.8563598104089527 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441794,5119.732466643741,4688.560133729121,1.091962632581547 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441795,3654.603828955072,4688.560133729121,0.7794725298848465 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441805,614.806640883566,384.65137963543384,1.5983476816494706 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441810,386.45071065924105,384.65137963543384,1.0046778228782451 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441806,474.2125262570692,384.65137963543384,1.2328371906699513 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441799,362.4885863734122,384.65137963543384,0.9423821298053652 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441794,367.6932054027372,384.65137963543384,0.9559128729792433 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441795,613.310798220686,384.65137963543384,1.5944588546698357 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441805,616.3818537360474,772.5530415852671,0.7978505300700665 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441810,431.7128659219849,772.5530415852671,0.5588132369993867 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441806,637.0217826111541,772.5530415852671,0.8245670501846645 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441799,320.94635240129685,772.5530415852671,0.4154360090832337 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441794,2144.7369746967793,772.5530415852671,2.776167925370938 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441795,276.2126135926237,772.5530415852671,0.3575322323834744 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441805,135.35970141574097,216.68366112664066,0.6246880854418925 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441810,192.6701364129889,216.68366112664066,0.8891770399817223 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441806,164.76778636752564,216.68366112664066,0.7604070630467481 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441799,179.1084044944918,216.68366112664066,0.8265893402540027 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441794,166.02844000446166,216.68366112664066,0.7662250081118318 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441795,159.01698759520804,216.68366112664066,0.7338669965626556 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441805,1730.7836114377217,615.8359185894908,2.810462266315847 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441810,1087.0226308163735,615.8359185894908,1.7651172950517204 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441806,930.6353389694688,615.8359185894908,1.5111741794811089 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441799,981.4998313118392,615.8359185894908,1.5937684075976994 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441794,2041.843506505348,615.8359185894908,3.3155641703750924 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441795,897.4163416835487,615.8359185894908,1.4572328677076665 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441805,57.84969252652973,101.73138829665541,0.5686513621325625 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441810,64.60223741677622,101.73138829665541,0.6350275809506487 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441806,72.94842312559764,101.73138829665541,0.7170689828086809 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441799,92.30137336915006,101.73138829665541,0.9073047651723103 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441794,9.77812292862898,101.73138829665541,0.0961170695922809 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441795,53.7495267955676,101.73138829665541,0.5283475208146226 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441805,125.52179161078432,93.53234569214308,1.3420147937263636 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441810,165.36714831979748,93.53234569214308,1.768020967463972 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441806,99.4891328610042,93.53234569214308,1.0636869216181914 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441799,208.89381195520963,93.53234569214308,2.2333857919352615 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441794,98.97364751468996,93.53234569214308,1.0581756159570364 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441795,185.0162738970251,93.53234569214308,1.9780993679555163 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441805,68.3719918673407,42.30806113801961,1.6160511738955359 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441810,61.9867545240793,42.30806113801961,1.4651286978588502 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441806,75.02930728709123,42.30806113801961,1.7734045302224233 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441799,89.61357788902194,42.30806113801961,2.118120648371944 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441794,130.44185271365,42.30806113801961,3.0831441858825825 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441795,147.26497840102115,42.30806113801961,3.480778235632342 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441805,215.76988043904103,205.3077634331321,1.0509582142972222 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441810,378.2769269407202,205.3077634331321,1.842487203675196 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441806,214.95771016072743,205.3077634331321,1.0470023469460192 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441799,671.414681247043,205.3077634331321,3.270283938706098 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441794,465.8992383734256,205.3077634331321,2.269272386892311 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441795,435.0964299337605,205.3077634331321,2.1192400260863473 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441805,1466.7178323274045,761.179367641068,1.926901719463094 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441810,1232.4815037534702,761.179367641068,1.6191735563891998 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441806,642.3297671588612,761.179367641068,0.8438612427836457 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441799,1034.4695552233725,761.179367641068,1.3590352014259715 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441794,910.2005750763798,761.179367641068,1.1957767298621556 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441795,1036.4287668819452,761.179367641068,1.3616091173016007 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441805,575597.9629522582,258075.7105503754,2.230345357665512 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441810,579033.8003920583,258075.7105503754,2.2436586502356373 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441806,461745.3683261228,258075.7105503754,1.789185690282123 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441799,508888.82967676385,258075.7105503754,1.9718586789570447 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441794,325218.56294212386,258075.7105503754,1.2601672673827335 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441795,633030.458160407,258075.7105503754,2.4528866231169086 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441805,307.6847134056798,131.47736122215045,2.340210592497373 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441810,149.0615400363826,131.47736122215045,1.1337430159137518 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441806,175.04300071278527,131.47736122215045,1.3313546840738935 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441799,137.40405936727026,131.47736122215045,1.0450777083600407 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441794,131.71459596831212,131.47736122215045,1.001804377148708 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441795,108.54451546138294,131.47736122215045,0.8255757071210224 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441805,2203.2664918363566,3004.2024881525895,0.7333948029552555 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441810,2005.2970132163944,3004.2024881525895,0.6674972879240028 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441806,1885.427227273816,3004.2024881525895,0.6275965866845562 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441799,1532.49313238105,3004.2024881525895,0.5101164580032834 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441794,2835.347163370796,3004.2024881525895,0.9437936272778904 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441795,2423.8616508722444,3004.2024881525895,0.8068236613314234 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441805,256.249687631798,96.13121274223809,2.665624205937091 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441810,80.73394115285348,96.13121274223809,0.8398306736161733 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441806,147.77342089167195,96.13121274223809,1.5372054161836588 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441799,271.12340080806405,96.13121274223809,2.8203472428361236 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441794,114.5666613131383,96.13121274223809,1.1917738062904937 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441795,55.369959056732846,96.13121274223809,0.575983153413443 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441805,318.2157385470853,490.807523353751,0.6483513870624399 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441810,224.47994828738655,490.807523353751,0.45736859686560255 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441806,234.9624552021959,490.807523353751,0.47872627052793976 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441799,228.96136974908632,490.807523353751,0.4664993074771222 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441794,537.3752122813257,490.807523353751,1.0948797373955717 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441795,304.8266658036754,490.807523353751,0.6210717059118319 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441805,115.73213504736952,78.64120835950264,1.471647466533174 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441810,104.86132907173132,78.64120835950264,1.3334145196798768 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441806,95.96558856478111,78.64120835950264,1.2202964650044708 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441799,100.20540540822998,78.64120835950264,1.274209889427794 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441794,85.49174935624158,78.64120835950264,1.087111339457326 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441795,107.8056937118428,78.64120835950264,1.370855000332864 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441805,1674.922696671203,1710.8868039225827,0.978979259662928 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441810,1470.6604705013276,1710.8868039225827,0.8595895807539788 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441806,1683.734790256675,1710.8868039225827,0.9841298596706365 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441799,1709.8549888492462,1710.8868039225827,0.999396912132953 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441794,1586.22221514923,1710.8868039225827,0.9271345196610717 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441795,1978.1037269841445,1710.8868039225827,1.1561862084907713 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441805,158.3501379324222,158.21676846284709,1.0008429540741532 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441810,201.83880784104116,158.21676846284709,1.2757105950399785 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441806,153.58249971075674,158.21676846284709,0.9707093704598159 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441799,144.0197964277634,158.21676846284709,0.9102688534659494 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441794,146.28461458675565,158.21676846284709,0.9245835065902425 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441795,223.5535933104391,158.21676846284709,1.4129576497002883 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441805,1119.656437620121,1068.4447009417866,1.047931106432737 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441810,945.29,1068.4447009417866,0.8847346045768852 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441806,948.5295481091808,1068.4447009417866,0.88776662682972185 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441799,1326.1791370963329,1068.4447009417866,1.2412239359953443 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441794,806.8599754624069,1068.4447009417866,0.7551724246946947 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441795,977.7639911003974,1068.4447009417866,0.9151283077528878 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441805,109.9692622561485,101.193417409009,1.0867234754180581 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441810,102.24999201207306,101.193417409009,1.0104411396523307 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441806,100.87174870367473,101.193417409009,0.9968212487178475 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441799,102.4322793797772,101.193417409009,1.012242515397626 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441794,80.3420451500154,101.193417409009,0.7939453692455567 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441795,164.28709159699048,101.193417409009,1.6234958340517949 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441805,8075.096491442677,8195.704907369402,0.9852839484474024 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441810,8934.632536810557,8195.704907369402,1.0901603507926119 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441806,8474.78185828721,8195.704907369402,1.034051610455968 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441799,9607.538114071704,8195.704907369402,1.1722650123033116 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441794,7869.308474354525,8195.704907369402,0.9601746967827761 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441795,8960.412970904923,8195.704907369402,1.093305953810991 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441805,68.05478076827933,54.484574340672744,1.2490651086444557 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441810,38.29022380935787,54.484574340672744,0.7027718262042879 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441806,62.20627290929082,54.484574340672744,1.141722655670154 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441799,13.52709260214147,54.484574340672744,0.2482738053079272 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441794,16.32573531621393,54.484574340672744,0.29963958631914583 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441795,56.84503532951592,54.484574340672744,1.0433234730638448 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441805,97.03903282948843,181.8259570369428,0.5336918579219817 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441810,199.89586904855665,181.8259570369428,1.09938026619567 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441806,141.41465576641127,181.8259570369428,0.7777473473585462 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441799,125.6804824143114,181.8259570369428,0.6912130944471039 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441794,182.29,181.8259570369428,1.0025521271584061 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441795,69.4214799601535,181.8259570369428,0.38180181252145795 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441805,638.3058475324963,598.5025834222519,1.0665047490399262 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441810,585.1718250662095,598.5025834222519,0.9777264815135521 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441806,525.444768206401,598.5025834222519,0.8779323310551067 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441799,733.2507382241248,598.5025834222519,1.2251421439676664 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441794,558.3076764859401,598.5025834222519,0.932840879806272 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441795,543.5302867116576,598.5025834222519,0.9081502766516706 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441805,12361.890861170104,15066.853658787537,0.8204692991067979 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441810,12250.411141512055,15066.853658787537,0.8130702944982259 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441806,17479.62824354982,15066.853658787537,1.1601379185995522 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441799,18115.48152998573,15066.853658787537,1.2023400465843193 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441794,13452.26595294809,15066.853658787537,0.8928384291502187 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441795,17674.614120162852,15066.853658787537,1.1730792984674923 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441805,67.1370245326135,62.8704966822211,1.0678621623105278 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441810,61.46390613760508,62.8704966822211,0.9776271761979927 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441806,61.803721926875504,62.8704966822211,0.9830321882020813 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441799,65.75382084952854,62.8704966822211,1.0458613231875866 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441794,63.53525599680776,62.8704966822211,1.0105734700641333 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441795,60.38808772828883,62.8704966822211,0.9605155186465345 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441805,102.15625277471364,100.49015468400951,1.0165797146590445 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441810,96.15001389414462,100.49015468400951,0.9568102884953016 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441806,103.48870945089578,100.49015468400951,1.029839288996173 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441799,108.06132817677822,100.49015468400951,1.0753424404268876 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441794,94.48829770817852,100.49015468400951,0.9402741791501488 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441795,112.42708734809284,100.49015468400951,1.1187870861739533 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441805,122.0935246437483,109.95671552102958,1.110378061632784 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441810,115.65386316172504,109.95671552102958,1.0518126393071996 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441806,111.6704268257835,109.95671552102958,1.0155853264317098 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441799,107.17443543214353,109.95671552102958,0.9746965878736716 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441794,114.92337686952204,109.95671552102958,1.045169240686737 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441795,118.99079378256242,109.95671552102958,1.0821603138901057 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441805,259.48849838557555,243.54938966397899,1.0654450776640725 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441810,240.85508780384157,243.54938966397899,0.9889373491600423 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441806,258.39354654496736,243.54938966397899,1.0609492674215633 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441799,284.5225268750531,243.54938966397899,1.168233380784095 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441794,236.5120686890369,243.54938966397899,0.9711051586511822 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441795,294.9539162603785,243.54938966397899,1.2110640747953483 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441805,115.97588707178213,49.66723175069083,2.3350584074009517 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441810,77.69158660062021,49.66723175069083,1.564242335683216 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441806,63.5299996839007,49.66723175069083,1.2791129572671835 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441799,35.46461943120599,49.66723175069083,0.714044616161091 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441794,42.108884400851885,49.66723175069083,0.8478202411646625 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441795,77.59676374118006,49.66723175069083,1.5623331723153817 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441805,480.6628335060826,318.9289567276793,1.507115686320391 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441810,399.66120141748934,318.9289567276793,1.2531355118022227 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441806,373.50315252589365,318.9289567276793,1.1711170925279548 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441799,612.1552076708005,318.9289567276793,1.919409306548152 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441794,479.5219928429838,318.9289567276793,1.5035385866590611 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441795,430.1900379833002,318.9289567276793,1.3488585119306753 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441805,51.81993375208193,52.85511393128503,0.9804147583420423 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441810,48.81426201622131,52.85511393128503,0.9235485156589185 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441806,46.61427630263303,52.85511393128503,0.881925566620375 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441799,46.9606240890776,52.85511393128503,0.8884783438387694 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441794,46.55180927317544,52.85511393128503,0.8807437125893951 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441795,44.28806244682238,52.85511393128503,0.8379144259229039 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441805,138.15,145.91831693350866,0.9467625648598422 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441810,115.26594825490584,145.91831693350866,0.789934743473156 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441806,127.25103801790809,145.91831693350866,0.8720703520442413 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441799,142.40945305613286,145.91831693350866,0.9759532322527081 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441794,122.56479917648464,145.91831693350866,0.8399548579794431 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441795,151.6670770924733,145.91831693350866,1.0393971112042377 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441805,529.5472239325211,261.347965154705,2.026215217015581 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441810,504.8239402073427,261.347965154705,1.9316161115259192 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441806,397.4417141047014,261.347965154705,1.5207377408484344 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441799,250.8650288937453,261.347965154705,0.9598889692722332 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441794,269.08446187293043,261.347965154705,1.0296022841182093 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441795,535.2169206878153,261.347965154705,2.047909270581057 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441805,7830.832616660473,7540.877985370558,1.0384510440100518 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441810,9206.449719009865,7540.877985370558,1.2208723887152857 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441806,7524.437274683897,7540.877985370558,0.997819788263574 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441799,9865.617891069222,7540.877985370558,1.3082850445543213 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441794,7900.866378305842,7540.877985370558,1.047738259872878 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441795,8802.314826278889,7540.877985370558,1.1672798370899968 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441805,7115.770106263366,5107.556668860965,1.3931847588976927 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441810,6430.472193567858,5107.556668860965,1.2590114237541912 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441806,5833.293550723575,5107.556668860965,1.142090813458259 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441799,5483.028366737157,5107.556668860965,1.0735129773821825 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441794,4382.234763919215,5107.556668860965,0.8579904341808303 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441795,6166.9579040267345,5107.556668860965,1.2074184005876192 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441805,66150.1186687098,180330.65339424144,0.36682681187923977 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441810,58435.73698792257,180330.65339424144,0.324047719497636 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441806,115384.20608345406,180330.65339424144,0.6398479898545006 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441799,92814.7295444207,180330.65339424144,0.514691916196343 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441794,135575.0515179406,180330.65339424144,0.751813676522008 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441795,55531.661217556255,180330.65339424144,0.3079435479898814 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441805,160.93686881310666,98.01831453553807,1.6419061027085555 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441810,165.7666173048661,98.01831453553807,1.691180042121259 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441806,107.25858915564125,98.01831453553807,1.0942708989017862 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441799,115.27541251085084,98.01831453553807,1.1760599338713986 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441794,111.90715292762408,98.01831453553807,1.1416963600924845 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441795,297.2606338493422,98.01831453553807,3.032705012914354 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441805,2816.698709756952,1812.4793707702274,1.554058355191085 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441810,2231.965979749555,1812.4793707702274,1.231443521920508 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441806,2060.5472604309803,1812.4793707702274,1.136866600338372 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441799,1950.007006906708,1812.4793707702274,1.075878180107527 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441794,4249.357370938032,1812.4793707702274,2.344499716502833 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441795,1820.916486994144,1812.4793707702274,1.0046550136569725 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441805,559.1259887708587,434.5650550234931,1.2866335714468153 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441810,755.2987271571067,434.5650550234931,1.7380567499065804 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441806,599.1998477900648,434.5650550234931,1.3788495896377848 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441799,787.9078020954192,434.5650550234931,1.8130951694972899 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441794,279.9019297248655,434.5650550234931,0.6440967272661482 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441795,392.32118138070314,434.5650550234931,0.9027904495438406 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441805,204761.58830777783,9833.502392298877,20.822854374666875 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441810,736974.4076739665,9833.502392298877,74.94526144124694 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441806,76740.63940635265,9833.502392298877,7.8039986512285 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441799,913850.2641818536,9833.502392298877,92.93232743783506 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441794,71734.81597298455,9833.502392298877,7.294940613342789 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441795,485061.6451554524,9833.502392298877,49.327454837996406 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441805,45.74767797679235,42.4088060383901,1.0787306281478375 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441810,41.97324433666095,42.4088060383901,0.9897294514414091 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441806,41.62849278052542,42.4088060383901,0.9816002068731124 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441799,42.963790728034056,42.4088060383901,1.0130865436093996 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441794,37.63233063187282,42.4088060383901,0.8873706700869289 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441795,38.3583191386874,42.4088060383901,0.9044894851310824 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441805,570.7594381120933,385.8715169071063,1.4791437385348567 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441810,701.6832671340359,385.8715169071063,1.8184375793224388 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441806,463.07344039359054,385.8715169071063,1.2000715785017884 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441799,996.3433232757787,385.8715169071063,2.582059777984691 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441794,488.7044837503308,385.8715169071063,1.2664953548980922 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441795,764.655740769161,385.8715169071063,1.9816330235984798 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441805,828.4235273369137,1002.6445024002205,0.8262385375412312 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441810,914.547399738324,1002.6445024002205,0.9121352558648635 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441806,687.6892667134844,1002.6445024002205,0.6858754673937093 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441799,725.6507651396074,1002.6445024002205,0.7237368413255939 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441794,1181.8198495832996,1002.6445024002205,1.178702767286065 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441795,1059.1833783629456,1002.6445024002205,1.0563897531252375 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441805,16348.375400593111,6245.085755978491,2.617798384104274 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441810,17188.1580883713,6245.085755978491,2.7522693458479544 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441806,15102.811867930788,6245.085755978491,2.4183513978927667 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441799,19915.298755485976,6245.085755978491,3.1889552095294826 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441794,25141.5197475064,6245.085755978491,4.025808568511351 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441795,26798.188713336727,6245.085755978491,4.291084183701163 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441805,247.08434146604208,289.8012081128336,0.8525994183220942 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441810,232.49495352379765,289.8012081128336,0.8022566746280648 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441806,262.36796898858137,289.8012081128336,0.9053377337420514 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441799,284.3077830203079,289.8012081128336,0.9810441608290783 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441794,194.52748693475235,289.8012081128336,0.6712445686527759 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441795,180.5048631787999,289.8012081128336,0.622857524833094 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441805,34495.02236820998,19122.271903916942,1.8039186212567209 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441810,42763.08763101762,19122.271903916942,2.236297436093782 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441806,37860.79576145974,19122.271903916942,1.9799318800453025 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441799,32674.715672232705,19122.271903916942,1.7087256073134136 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441794,43424.88421784921,19122.271903916942,2.270906115970153 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441795,32675.95475641877,19122.271903916942,1.7087904052721652 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441805,58.270837532972834,111.01681566749893,0.524882984461534 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441810,68.52098484201808,111.01681566749893,0.6172126666580129 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441806,78.12905745906662,111.01681566749893,0.7037587683389078 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441799,70.88110439674261,111.01681566749893,0.6384717843919714 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441794,78.513861713097,111.01681566749893,0.7072249482299154 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441795,41.48047015903892,111.01681566749893,0.37364132550221096 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441805,1594.5734949872317,1048.3386659324408,1.521048060904006 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441810,1518.88,1048.3386659324408,1.448844776367223 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441806,1827.7359944446016,1048.3386659324408,1.7434594886557284 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441799,1712.0861137221411,1048.3386659324408,1.633142198565511 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441794,2294.8750734745554,1048.3386659324408,2.189058887218843 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441795,1881.987210294774,1048.3386659324408,1.7952091928430856 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441805,16956.67395866947,5453.602601951663,3.1092610144716524 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441810,14954.457845227107,5453.602601951663,2.7421245984948377 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441806,3834.459377388549,5453.602601951663,0.7031057554535278 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441799,6715.892791266491,5453.602601951663,1.2314598773410985 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441794,8388.32834515739,5453.602601951663,1.5381260714074556 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441795,12402.742584885587,5453.602601951663,2.274229255436958 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441805,125835.75625701176,64173.361133824874,1.960872144355947 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441810,72737.66477522238,64173.361133824874,1.1334557437865505 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441806,71760.27950024784,64173.361133824874,1.1182253544520049 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441799,105032.52006631912,64173.361133824874,1.6366996867639205 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441794,133079.851085788,64173.361133824874,2.073755351667929 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441795,158388.305068545,64173.361133824874,2.4681316713059114 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441805,28.094083863828224,44.60879663763593,0.6297879786366074 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441810,23.774101013848593,44.60879663763593,0.5329464770585328 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441806,96.01212678751828,44.60879663763593,2.152313759266798 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441799,9.44663255514952,44.60879663763593,0.21176613733578062 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441794,111.15927445966314,44.60879663763593,2.4918689325476966 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441795,68.03078772600409,44.60879663763593,1.5250531925043522 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441805,139.1732829517174,136.29080299882398,1.021149482499698 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441810,133.35872105477682,136.29080299882398,0.9784865751794531 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441806,137.82964955223912,136.29080299882398,1.0112909053256398 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441799,146.37528649235466,136.29080299882398,1.0739923991321534 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441794,128.5736378186559,136.29080299882398,0.9433772124724024 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441795,157.35608923590783,136.29080299882398,1.154561318691956 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441805,37.081069371306405,82.77341642135346,0.4479828304119681 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441810,42.03888605279021,82.77341642135346,0.5078790736242371 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441806,72.62830889579692,82.77341642135346,0.8774351964172479 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441799,12.150500289940558,82.77341642135346,0.14679230138440963 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441794,50.607621315008885,82.77341642135346,0.6113994504877461 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441795,61.933575460464816,82.77341642135346,0.7482302668914305 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441805,2593.717088760384,2141.365658987758,1.2112443654235383 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441810,2820.5385472854073,2141.365658987758,1.3171681050581059 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441806,2511.666277273118,2141.365658987758,1.1729273170750316 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441799,2250.821348560389,2141.365658987758,1.051114899089384 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441794,3510.459753360325,2141.365658987758,1.6393555853603023 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441795,3007.610913232929,2141.365658987758,1.4045293481799146 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441805,316.6875046541953,285.0677067828484,1.1109203081197598 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441810,213.5966330960508,285.0677067828484,0.7492838648986606 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441806,232.1194712412044,285.0677067828484,0.8142608430144718 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441799,455.9888897988716,285.0677067828484,1.599581008122478 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441794,262.3077508122582,285.0677067828484,0.9201594728934774 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441795,221.3697777792933,285.0677067828484,0.7765515788427158 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441805,551953.1817865652,724296.655045942,0.762054025710715 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441810,298178.3428655113,724296.655045942,0.411679856296724 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441806,597345.4556110908,724296.655045942,0.8247248574870213 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441799,272926.10887372924,724296.655045942,0.3768153655996348 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441794,662962.9394180258,724296.655045942,0.9153196204888923 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441795,363562.3045404207,724296.655045942,0.5019522070240128 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441805,56.56463867467759,126.94877083842833,0.4455705896252369 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441810,51.80672196245411,126.94877083842833,0.4080915602435422 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441806,89.7082834384163,126.94877083842833,0.7066494842442456 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441799,66.26083195273222,126.94877083842833,0.5219493778089782 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441794,85.93074225012033,126.94877083842833,0.6768930623163503 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441795,77.30492230726247,126.94877083842833,0.6089458117373256 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441805,36967.64886751068,94593.87687362579,0.3908038246164517 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441810,18636.1243615281,94593.87687362579,0.19701195233202384 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441806,49507.94464218304,94593.87687362579,0.5233736715149542 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441799,14918.291321707688,94593.87687362579,0.15770884770520632 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441794,122644.78490934455,94593.87687362579,1.2965404206151083 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441795,14006.34198519741,94593.87687362579,0.14806816728644506 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441805,11.105279448692771,34.2642969985689,0.32410644377605646 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441810,21.134200403760303,34.2642969985689,0.6167994751108713 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441806,4.734105239488568,34.2642969985689,0.13816437674720994 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441799,236.3497261348457,34.2642969985689,6.8978425602812505 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441794,83.50444489347117,34.2642969985689,2.4370686752148703 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441795,27.8457462772674,34.2642969985689,0.8126752543158967 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441805,6.980478542597093,74.66086218948179,0.09349582013774951 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441810,83.6844019860008,74.66086218948179,1.1208603749259975 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441806,92.13573897858886,74.66086218948179,1.2340567236520465 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441799,49.746998384058315,74.66086218948179,0.6663062403137726 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441794,38.40958406451251,74.66086218948179,0.5144540651972761 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441795,127.69855521683222,74.66086218948179,1.7103814699158721 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441805,247.9010977042895,347.6986105145094,0.7129769582267129 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441810,319.7940332826932,347.6986105145094,0.9197449273940893 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441806,301.23593970368375,347.6986105145094,0.8663708470330893 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441799,456.3815867296722,347.6986105145094,1.3125781148631523 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441794,208.94582606594085,347.6986105145094,0.600939491120634 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441795,234.4536261358033,347.6986105145094,0.6743013030419331 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441805,4246.555572710762,2521.321340016667,1.6842579743059212 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441810,4180.714281909302,2521.321340016667,1.6581441705013555 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441806,2857.8353468739524,2521.321340016667,1.1334673218825257 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441799,3540.0784351862944,2521.321340016667,1.4040568248880538 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441794,3182.387424135935,2521.321340016667,1.2621903339440652 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441795,4164.926799208423,2521.321340016667,1.6518825796242582 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441805,52.14010785747968,79.44971561377609,0.6562655064864562 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441810,84.09517826952415,79.44971561377609,1.0584704755688585 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441806,56.58104701319683,79.44971561377609,0.7121617311791362 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441799,115.83205379478484,79.44971561377609,1.4579291178066882 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441794,64.55918403555903,79.44971561377609,0.8125791708229206 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441795,77.75243488957777,79.44971561377609,0.9786370446881244 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441805,122.72492342686922,42.37178439720435,2.8963831750962674 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441810,111.42981701412047,42.37178439720435,2.6298117626944335 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441806,81.2214126474427,42.37178439720435,1.9168749629718596 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441799,179.53570538983226,42.37178439720435,4.2371523395573085 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441794,42.76022272823224,42.37178439720435,1.0091673819395135 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441795,85.61629409735998,42.37178439720435,2.020596850365567 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441805,2072.540264208439,1321.2949146990686,1.5685675023433132 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441810,2118.76473264022,1321.2949146990686,1.6035517196573628 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441806,1832.2765652723183,1321.2949146990686,1.3867279324916104 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441799,992.634790976982,1321.2949146990686,0.751259071638113 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441794,1316.210446241707,1321.2949146990686,0.9961519049223619 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441795,2011.576652270716,1321.2949146990686,1.5224282103052387 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441805,56442.62169942732,23354.026662177774,2.4168261223593217 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441810,60170.78849078049,23354.026662177774,2.576463123947189 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441806,34313.092642194155,23354.026662177774,1.4692580914864144 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441799,109836.59978392988,23354.026662177774,4.703111860440411 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441794,39449.33205046093,23354.026662177774,1.6891875915492451 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441795,100811.79593065174,23354.026662177774,4.316677264649958 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441805,18799.32983509997,13473.54115415771,1.3952775755094502 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441810,15146.061977344412,13473.54115415771,1.1241337228313277 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441806,6305.809640631612,13473.54115415771,0.468014278390781 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441799,8964.645480395206,13473.54115415771,0.6653518460979254 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441794,15404.38847394646,13473.54115415771,1.1433065960683189 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441795,7476.577422934939,13473.54115415771,0.5549081223259404 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441805,106549.62816112746,49612.48263442616,2.1476374997447225 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441810,104249.98737097878,49612.48263442616,2.101285439375283 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441806,87165.21671304543,49612.48263442616,1.7569210828518664 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441799,101030.47300984398,49612.48263442616,2.0363922070640106 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441794,116531.96662088863,49612.48263442616,2.3488436867706146 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441795,105241.76662137444,49612.48263442616,2.1212759578442673 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441804,96.198426995727,73.06854961986588,1.3165503831154817 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441792,87.59663580824369,73.06854961986588,1.1988281725032068 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441790,57.753376796973974,73.06854961986588,0.7903999339994013 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441811,63.87029938554627,73.06854961986588,0.8741147828693346 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441808,59.92400911283848,73.06854961986588,0.820106727512576 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441804,1212.2396010235989,990.9231863649335,1.2233436634685424 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441792,2026.8274620204377,990.9231863649335,2.0453931141278243 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441790,760.7694135181531,990.9231863649335,0.7677380285236154 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441811,63.29788037033262,990.9231863649335,0.0638776862236237 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441808,634.9827762676126,990.9231863649335,0.6407991911027537 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441813,1247.421984989466,990.9231863649335,1.2588483165536406 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441804,58.67010995010348,50.719124328797626,1.1567650413237003 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441792,47.48903177645221,50.719124328797626,0.9363141104052655 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441790,55.074510023033326,50.719124328797626,1.0858726516254693 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441811,46.691274945829086,50.719124328797626,0.9205851947116211 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441808,45.67069494857004,50.719124328797626,0.9004630019339439 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441804,320.25951603395265,319.2477137201226,1.003169332998629 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441792,350.16022795756834,319.2477137201226,1.0968292423373345 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441790,309.33562105843646,319.2477137201226,0.9689517191957846 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441811,321.1546528570498,319.2477137201226,1.0059732272306858 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441808,300.6545694998451,319.2477137201226,0.9417595070498211 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441813,313.92169491388324,319.2477137201226,0.983316971187745 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441804,71.16677488581401,44.58166891160943,1.5963237048598153 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441792,9.772497375239762,44.58166891160943,0.21920438632782824 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441790,62.606431717838454,44.58166891160943,1.4043088391770644 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441811,8.857101034457807,44.58166891160943,0.19867136539949823 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441808,70.5055395446971,44.58166891160943,1.5814917042357939 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441804,1822.172282702579,1543.2839395802719,1.1807109735089685 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441792,1446.9682188552451,1543.2839395802719,0.9375904081842374 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441790,1472.2081484407286,1543.2839395802719,0.9539450976475049 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441811,1407.1613634482485,1543.2839395802719,0.9117968037890392 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441808,1267.6792074432983,1543.2839395802719,0.82141670429621 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441813,1843.5144165915317,1543.2839395802719,1.1945400125740397 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441804,34.36241435281728,31.276034215973343,1.0986819529461844 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441792,29.396612660178427,31.276034215973343,0.9399085720773686 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441790,30.623537893712253,31.276034215973343,0.9791374981317853 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441811,21.67560923297386,31.276034215973343,0.6930421255871263 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441808,40.32199694018489,31.276034215973343,1.289229851257535 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441804,31.75394941719091,130.468422036268,0.24338417619831296 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441792,300.8839780908953,130.468422036268,2.3061823956700778 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441790,42.12871194646653,130.468422036268,0.32290351403771456 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441811,26.092926387603917,130.468422036268,0.1999941900144276 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441808,165.70390685088688,130.468422036268,1.2700690654848574 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441813,216.24705952456443,130.468422036268,1.6574666585946094 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441804,101.95036178892376,95.42663227533711,1.0683638242075184 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441792,84.52159700810338,95.42663227533711,0.8857233561824845 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441790,89.20536911400563,95.42663227533711,0.9348057977841961 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441811,70.05401224362448,95.42663227533711,0.734113848233643 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441808,131.40182122202827,95.42663227533711,1.3769931735921577 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441804,581.5291604885876,569.3868516791151,1.021325235687591 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441792,563.7310329705846,569.3868516791151,0.9900668259341577 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441790,541.7395112981764,569.3868516791151,0.9514436620736726 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441811,593.5598620865461,569.3868516791151,1.0424544583987934 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441808,467.7666843194319,569.3868516791151,0.8215270214617592 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441813,667.9948589113645,569.3868516791151,1.1731827964440267 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441804,3466.731067599049,5328.634617598269,0.6505852467628152 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441792,2652.348497010391,5328.634617598269,0.49775386892747053 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441790,3386.6667838503513,5328.634617598269,0.6355599561406586 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441811,3723.9635205810328,5328.634617598269,0.6988588611953851 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441808,13413.46321895052,5328.634617598269,2.51724206697367 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441804,717961.8304456825,656386.6079991342,1.093809382604938 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441792,645689.1750560913,656386.6079991342,0.9837025423543421 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441790,607848.1736500401,656386.6079991342,0.9260520648081867 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441811,674692.9961282703,656386.6079991342,1.0278896429421975 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441808,601506.9782726427,656386.6079991342,0.9163913019283234 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441813,690620.4944420784,656386.6079991342,1.052155065362012 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441804,3398.551718947703,5223.837669019135,0.6505852467628152 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441792,2600.1854104033346,5223.837669019135,0.49775386892747064 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441790,3320.0620398077226,5223.837669019135,0.6355599561406587 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441811,3650.725244440269,5223.837669019135,0.6988588611953853 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441808,13149.663931496649,5223.837669019135,2.5172420669736706 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441804,717961.8304456825,656386.6079991342,1.093809382604938 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441792,645689.1750560913,656386.6079991342,0.9837025423543421 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441790,607848.1736500401,656386.6079991342,0.9260520648081867 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441811,674692.9961282703,656386.6079991342,1.0278896429421975 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441808,601506.9782726427,656386.6079991342,0.9163913019283234 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441813,690620.4944420784,656386.6079991342,1.052155065362012 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441804,56.20554267791818,50.79723336807032,1.1064685801027772 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441792,51.276349974663965,50.79723336807032,1.0094319429391365 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441790,44.65377555871236,50.79723336807032,0.8790592045664526 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441811,29.386079310944886,50.79723336807032,0.5784976338773625 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441808,72.46441931811223,50.79723336807032,1.4265426385142714 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441804,82.19047337369847,124.85055234194422,0.6583108511093557 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441792,96.79185672677276,124.85055234194422,0.7752617422282321 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441790,138.4879983871969,124.85055234194422,1.109230161897098 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441811,195.58310584903344,124.85055234194422,1.566537770000127 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441808,50.84372669643722,124.85055234194422,0.4072366981379865 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441813,185.20615301852655,124.85055234194422,1.4834227766272006 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441804,157.0149211179481,149.81706398084205,1.0480443078101336 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441792,130.29234185339777,149.81706398084205,0.8696762464258343 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441790,150.83676814131007,149.81706398084205,1.0068063285541253 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441811,149.2762483628371,149.81706398084205,0.9963901600816706 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441808,161.66504042871722,149.81706398084205,1.0790829571282363 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441804,2829.3554333052102,2791.14294318225,1.0136906245580506 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441792,2618.2255553030104,2791.14294318225,0.9380478207676128 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441790,2597.6448079246316,2791.14294318225,0.9306742294477378 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441811,2609.516486909339,2791.14294318225,0.9349275691105114 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441808,3010.88176783557,2791.14294318225,1.0787271842132136 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441813,3081.233607815739,2791.14294318225,1.1039325719028743 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441804,376.8576331127515,222.01180748199775,1.6974666230007145 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441792,85.8036116186544,222.01180748199775,0.3864821992659645 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441790,75.82009438576536,222.01180748199775,0.34151379264777787 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441811,319.176448361718,222.01180748199775,1.4376552850127082 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441808,252.4012499310995,222.01180748199775,1.1368821000728349 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441804,4735.383789996041,4330.453784028004,1.0935075228054711 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441792,4666.509459651724,4330.453784028004,1.0776028777545654 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441790,3758.6622760285304,4330.453784028004,0.8679603717032128 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441811,4399.58945519651,4330.453784028004,1.015964994574818 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441808,4224.21135022766,4330.453784028004,0.975466212295765 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441813,4198.366373067556,4330.453784028004,0.9694980208661677 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441804,127.06952131900653,100.4664893584531,1.2647950787414977 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441792,71.18180941451661,100.4664893584531,0.7085129565993685 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441790,74.90917648609036,100.4664893584531,0.7456135569624899 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441811,132.5682959185001,100.4664893584531,1.3195275037979217 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441808,96.60364365415194,100.4664893584531,0.9615509038987222 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441804,77.8579252764202,219.8603821991507,0.35412439702709186 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441792,603.6712971012431,219.8603821991507,2.7457029368503254 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441790,53.511152072054294,219.8603821991507,0.24338696920659225 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441811,141.1159675241527,219.8603821991507,0.6418435468575193 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441808,184.55353668077817,219.8603821991507,0.8394124254437463 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441813,258.4524145402558,219.8603821991507,1.175529724614725 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441804,167.83958012440192,115.26780159034894,1.4560838135951286 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441792,91.80647568693226,115.26780159034894,0.7964624502270282 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441790,68.56837492829195,115.26780159034894,0.5948614789408198 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441811,119.24454882105748,115.26780159034894,1.0345000700615556 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441808,128.8800283910611,115.26780159034894,1.1180921871754677 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441804,1052.963191743557,1760.6737631139824,0.5980455969771785 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441792,1865.6908165558643,1760.6737631139824,1.0596459467063026 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441790,1264.03843948886,1760.6737631139824,0.717928821324197 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441811,1650.5614396789506,1760.6737631139824,0.937460121379736 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441808,2134.7023828515435,1760.6737631139824,1.2124349368823684 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441813,2596.0863083651197,1760.6737631139824,1.4744845767302175 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441804,810.8270446117269,518.6000624505415,1.5634919918449777 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441792,248.2338661669409,518.6000624505415,0.4786614660128677 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441790,199.92838984943103,518.6000624505415,0.3855155529768145 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441811,923.82913008984,518.6000624505415,1.7813903178577903 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441808,410.1818815347686,518.6000624505415,0.79094067130755 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441804,1043.2838343127469,841.89306662726494,1.239211814027974 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441792,1113.825816666216,841.89306662726494,1.3230015316889943 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441790,869.7724804578071,841.89306662726494,1.0331151483907937 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441811,584.3307856379682,841.89306662726494,0.694067701470538 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441808,840.2953929953919,841.89306662726494,0.9981022843693517 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441813,599.8500896934593,841.89306662726494,0.7125015200523483 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441804,330.3157058403648,246.94010350613598,1.3376349209805733 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441792,163.37701022764975,246.94010350613598,0.6616058222539384 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441790,133.24965622350626,246.94010350613598,0.5396031439672385 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441811,337.72112597367595,246.94010350613598,1.3676236511550837 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441808,270.0370192654832,246.94010350613598,1.0935324616431665 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441804,3128.274391563435,6405.278640912654,0.48839005559915877 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441792,5171.650176801321,6405.278640912654,0.8074044029510699 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441790,7641.760259075368,6405.278640912654,1.1930410349777592 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441811,9665.844048113771,6405.278640912654,1.5090434920933489 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441808,8353.201436059622,6405.278640912654,1.3041121088323833 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441813,4470.941533862407,6405.278640912654,0.6980089055462803 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441804,259.69809764579264,184.84349394551683,1.404962068734426 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441792,169.28781591516636,184.84349394551683,0.9158440597593576 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441790,177.60975464279304,184.84349394551683,0.9608655996036519 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441811,182.47803643141827,184.84349394551683,0.987202917107833 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441808,135.14376509241376,184.84349394551683,0.7311253547947313 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441804,42836.48163998956,66689.05961878091,0.642331469132397 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441792,111714.672823678,66689.05961878091,1.675157416557978 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441790,53044.64312414638,66689.05961878091,0.7954024757189407 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441811,49354.10952135168,66689.05961878091,0.7400630598703573 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441808,74874.15220417148,66689.05961878091,1.1227351627415283 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441813,68310.29839934835,66689.05961878091,1.0243104159787981 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441804,772.9178407689079,426.591426110135,1.8118456993304886 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441792,286.4580415503158,426.591426110135,0.6715044513725403 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441790,142.69811108497066,426.591426110135,0.3345076866315866 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441811,342.6466677271985,426.591426110135,0.8032197713198669 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441808,588.236469419282,426.591426110135,1.3789223913455175 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441804,3770.0262450846935,6086.038398766024,0.6194548897110287 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441792,6374.128314662084,6086.038398766024,1.0473361975426365 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441790,6836.257036642191,6086.038398766024,1.1232687979800255 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441811,4470.698861251997,6086.038398766024,0.7345827561913599 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441808,7821.410066520716,6086.038398766024,1.2851397829015583 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441813,7243.709868434463,6086.038398766024,1.1902175756733908 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441804,152.43070158968692,118.38689307733607,1.2875639999278619 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441792,38.1447695135887,118.38689307733607,0.3222043295677224 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441790,30.537242923513215,118.38689307733607,0.25794445761461793 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441811,262.40568936058406,118.38689307733607,2.216509636663646 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441808,108.41606199930746,118.38689307733607,0.9157775762261522 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441804,43.20007518251199,43.003791743375764,1.0045643286598434 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441792,70.8544184403411,43.003791743375764,1.6476318847222444 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441790,29.222317276254536,43.003791743375764,0.6795288529587835 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441811,52.95167233234266,43.003791743375764,1.2313256618935062 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441808,34.86369472943411,43.003791743375764,0.8107121097014534 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441813,26.93057249937019,43.003791743375764,0.6262371620641692 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441804,78.57228409831863,56.77751951238643,1.3838625704875593 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441792,50.776775584048494,56.77751951238643,0.8943112700260034 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441790,62.39583424361941,56.77751951238643,1.0989531557469203 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441811,22.287326019589784,56.77751951238643,0.39253786024815057 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441808,69.85537761635581,56.77751951238643,1.2303351434913663 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441804,235.61559066525123,232.93832449773902,1.0114934550735046 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441792,305.1663552603102,232.93832449773902,1.3100736253611724 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441790,228.64899173880815,232.93832449773902,0.9815859723032716 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441811,206.8884476787128,232.93832449773902,0.8881683515359918 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441808,200.5131474565729,232.93832449773902,0.8607993033731947 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441813,220.7974141867788,232.93832449773902,0.9478792923528646 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441804,66.11164109296529,55.88566907011774,1.1829802200277388 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441792,73.42178762323735,55.88566907011774,1.3137856063084379 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441790,47.97982148782418,55.88566907011774,0.8585353326919218 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441811,29.77789857213102,55.88566907011774,0.5328360395000328 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441808,62.137196574430895,55.88566907011774,1.111862801471869 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441804,269.2790589786773,226.42114305345407,1.1892840719168405 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441792,345.745984922484,226.42114305345407,1.527003972596585 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441790,257.84460666751556,226.42114305345407,1.1387832566795362 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441811,193.17583365311057,226.42114305345407,0.8531704727217331 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441808,182.02019479255992,226.42114305345407,0.8039010506611043 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441813,110.46117930637703,226.42114305345407,0.48785717542420093 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441804,384.0119458210284,212.71806341276286,1.8052625134889606 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441792,92.51684618731811,212.71806341276286,0.4349270800185707 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441790,63.14745530012714,212.71806341276286,0.29685986364775435 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441811,294.4842069851501,212.71806341276286,1.3843874011476232 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441808,229.4298627701906,212.71806341276286,1.0785631416970913 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441804,9111.809315752364,10996.969545575432,0.8285745702931812 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441792,9873.19453182168,10996.969545575432,0.8978104823245695 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441790,13385.886074433787,10996.969545575432,1.2172340769843746 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441811,12592.254073243384,10996.969545575432,1.1450658311870843 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441808,12726.72273531072,10996.969545575432,1.157293623717567 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441813,8291.950542890656,10996.969545575432,0.7540214154932233 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441804,159.57647851350106,147.8550055811589,1.0792768082911344 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441792,205.67237752430518,147.8550055811589,1.3910410182995787 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441790,169.26165889501712,147.8550055811589,1.144781390590851 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441811,77.23510250769701,147.8550055811589,0.5223705629993162 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441808,127.5294104652742,147.8550055811589,0.8625302198191199 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441804,51.11900602075665,92.19915296117537,0.5544411676133578 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441792,57.80113032162867,92.19915296117537,0.6269160666364089 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441790,90.44501593900756,92.19915296117537,0.9809744779010446 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441811,99.3459019986275,92.19915296117537,1.077514259165283 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441808,98.39039079597444,92.19915296117537,1.0671507018877513 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441813,156.09347269105737,92.19915296117537,1.693003326796154 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441804,1575.279915501381,1229.7970051816276,1.2809267780488125 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441792,453.7124947039784,1229.7970051816276,0.3689328342745232 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441790,533.107277015022,1229.7970051816276,0.43349209240941994 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441811,2615.3554808814847,1229.7970051816276,2.1266562447801904 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441808,971.5298578062713,1229.7970051816276,0.7899920504870532 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441804,78345.93573063108,50083.06853493704,1.5643197995342155 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441792,45804.454117880865,50083.06853493704,0.9145696431505291 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441790,40834.5000992286,50083.06853493704,0.8153354275955195 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441811,34128.57419942569,50083.06853493704,0.6814393606018412 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441808,40860.52026105829,50083.06853493704,0.8158549676834345 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441813,60524.42680139772,50083.06853493704,1.2084808014344603 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441804,61.221803639121525,35.678906774941794,1.715910300315568 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441792,25.18405478542685,35.678906774941794,0.7058527590064574 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441790,60.91627400516008,35.678906774941794,1.7073469876589138 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441811,8.036052734895833,35.678906774941794,0.2252325943052649 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441808,23.036348710104683,35.678906774941794,0.645657358713796 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441804,79.44692053276782,67.70693010562654,1.173394221371819 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441792,26.93449152773339,67.70693010562654,0.3978099654749388 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441790,65.95919188592781,67.70693010562654,0.9741867159392374 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441811,126.88994366913738,67.70693010562654,1.8741057004236064 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441808,85.92857835799909,67.70693010562654,1.2691253055476857 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441813,21.082454660193772,67.70693010562654,0.311378091242713 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441804,74.0117675227234,64.01321127549492,1.156195198584828 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441792,43.93668367671994,64.01321127549492,0.6863689979187072 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441790,73.34103873437998,64.01321127549492,1.1457172241951852 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441811,99.70403999578204,64.01321127549492,1.557554104990668 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441808,29.072526447869286,64.01321127549492,0.4541644743106119 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441804,781.7077974870645,1060.427767412219,0.737162701232051 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441792,2523.744376163654,1060.427767412219,2.3799304900534555 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441790,669.500023563587,1060.427767412219,0.6313490122928221 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441811,782.0574728878591,1060.427767412219,0.7374924506138952 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441808,689.5529923171538,1060.427767412219,0.6502592760277132 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441813,916.0039420539964,1060.427767412219,0.8638060697800637 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441804,84.93364143802405,57.09593719876665,1.4875601593568157 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441792,28.543663237276782,57.09593719876665,0.49992459424754593 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441790,73.00448200237366,57.09593719876665,1.2786283155003657 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441811,1.5636290546248195,57.09593719876665,0.02738599506969116 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441808,97.43427026153392,57.09593719876665,1.7065009358255816 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441804,2.8379755180477133,50.205845180981015,0.056526794994037774 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441792,32.83017807038122,50.205845180981015,0.6539114709061398 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441790,27.462757107572596,50.205845180981015,0.547003182768369 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441811,2.9915898389603077,50.205845180981015,0.05958648496357914 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441808,118.36890218769403,50.205845180981015,2.3576717364482205 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441813,116.7436683632302,50.205845180981015,2.3253003299196533 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441804,1902.3774175462588,1506.8779059558976,1.2624628777335969 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441792,298.1102970497528,1506.8779059558976,0.19783307982118473 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441790,257.0736591788679,1506.8779059558976,0.17060019140422103 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441811,4247.1540239674005,1506.8779059558976,2.818512373949229 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441808,829.6741320372079,1506.8779059558976,0.5505914770917679 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441804,19296.32336932095,16162.128318216166,1.1939221734536203 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441792,17698.890726413476,16162.128318216166,1.095084160819664 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441790,12118.599923660457,16162.128318216166,0.7498146088842588 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441811,12725.897566691649,16162.128318216166,0.7873899597956058 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441808,21003.07935217817,16162.128318216166,1.2995243533926049 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441813,14129.978971032297,16162.128318216166,0.8742647436542467 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441804,16.60154718156142,24.995311385825953,0.6641864518229458 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441792,43.48948818190947,24.995311385825953,1.7399058371631642 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441790,23.545220653823844,24.995311385825953,0.9419854904138377 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441811,19.35758264957638,24.995311385825953,0.7744485496009244 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441808,21.98271826225866,24.995311385825953,0.8794736709991283 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441804,138.3193520949672,522.7489803443298,0.26459994623778615 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441792,1729.4286813562426,522.7489803443298,3.308334872728177 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441790,224.2463735959832,522.7489803443298,0.428975248212391 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441811,360.10765476073203,522.7489803443298,0.6888729931592263 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441808,242.96103663865435,522.7489803443298,0.46477572558557306 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441813,441.43078361939894,522.7489803443298,0.8444412140768456 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441804,2.908509142465322,2.8430683750443606,1.0230176551487056 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441792,2.8553181968875814,2.8430683750443606,1.004308662412324 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441790,2.7059620439794054,2.8430683750443606,0.9517752255737374 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441811,2.3042550183460446,2.8430683750443606,0.8104817452060368 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441808,3.441297473543449,2.8430683750443606,1.2104167116591962 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441804,1056.605049212581,1771.7543971110147,0.5963609013390676 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441792,3416.2860957378416,1771.7543971110147,1.9281939422915306 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441790,1151.2747055827092,1771.7543971110147,0.6497936212039058 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441811,1401.110683220018,1771.7543971110147,0.7908041235876934 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441808,1395.3798489129388,1771.7543971110147,0.7875695701324155 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441813,2209.87,1771.7543971110147,1.2472778414453873 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441804,92.62425346387042,73.62821549612136,1.2579994345883576 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441792,93.23987168023623,73.62821549612136,1.2663606071662568 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441790,51.9731739944706,73.62821549612136,0.7058866447361947 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441811,7.508692844080213,73.62821549612136,0.10198118742231042 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441808,122.79508549794932,73.62821549612136,1.6677721260868805 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441804,403.30113067877096,1923.334023596175,0.2096885542141527 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441792,4052.896376441422,1923.334023596175,2.1072243961365973 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441790,3054.3393016093455,1923.334023596175,1.5880441276125614 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441811,2632.1142726216567,1923.334023596175,1.3685164616909506 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441808,693.1226338840717,1923.334023596175,0.36037559018900833 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441813,704.230426341783,1923.334023596175,0.36615087015672937 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441804,59.06172703954648,51.40813337414527,1.1488790423433355 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441792,17.794985371144108,51.40813337414527,0.34615116720214845 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441790,111.4736279073508,51.40813337414527,2.1684045031561934 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441811,41.145861693741416,51.40813337414527,0.8003764967361163 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441808,27.564464858943563,51.40813337414527,0.5361887905622066 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441804,60.893751379532226,89.1451395839603,0.6830854902883422 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441792,134.49920427164824,89.1451395839603,1.5087665452020718 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441790,74.49933074876621,89.1451395839603,0.8357082741297398 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441811,72.26396479211303,89.1451395839603,0.8106326955049755 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441808,106.66955364181489,89.1451395839603,1.196582944842993 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441813,86.04503266988719,89.1451395839603,0.9652240500318774 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441804,5112.233287421837,4771.656231796832,1.071375019297389 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441792,3018.9630621212846,4771.656231796832,0.6326866218911276 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441790,5281.250279450198,4771.656231796832,1.1067960521249602 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441811,2488.0256822544434,4771.656231796832,0.5214176297267633 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441808,7957.808847736395,4771.656231796832,1.6677246769597596 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441804,256893.59675944905,209884.98459768714,1.223973202522654 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441792,223067.84431519156,209884.98459768714,1.0628099229812635 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441790,56405.137144454304,209884.98459768714,0.2687430797042156 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441811,155524.52002339877,209884.98459768714,0.740998791893151 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441808,359041.07440239046,209884.98459768714,1.7106563153653391 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441813,208377.7349412387,209884.98459768714,0.9928186875333765 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441804,38.22354259381819,22.903585106474594,1.668889058901648 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441792,11.966364765034333,22.903585106474594,0.5224668849616724 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441790,46.7178804404891,22.903585106474594,2.039762780512578 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441811,0.3137707302843673,22.903585106474594,0.013699633870667163 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441808,17.296367002746994,22.903585106474594,0.7551816417534345 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441804,73.16590828157976,83.56495705722055,0.8755573012678016 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441792,111.14443672046288,83.56495705722055,1.3300364247702234 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441790,64.57355489102862,83.56495705722055,0.7727348539988156 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441811,34.25752782364689,83.56495705722055,0.4099508816858396 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441808,89.3211405605812,83.56495705722055,1.0688827435095687 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441813,128.927174066024,83.56495705722055,1.5428377947677514 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441804,2300.518181888749,1829.6496491832456,1.2573544792663989 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441792,1429.3184443240082,1829.6496491832456,0.7811978894221935 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441790,3094.1664112726453,1829.6496491832456,1.6911250810524732 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441811,981.4457176335656,1829.6496491832456,0.5364118305773361 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441808,1342.79949079726,1829.6496491832456,0.7339107196815985 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441804,70369.60876722557,96234.19538703516,0.7312328895587762 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441792,146517.6506278924,96234.19538703516,1.5225113073230052 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441790,91121.54563775276,96234.19538703516,0.9468728373659663 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441811,71643.27049540982,96234.19538703516,0.7444679119233507 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441808,93405.58551408704,96234.19538703516,0.9706070190375469 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441813,104347.51127984333,96234.19538703516,1.0843080347913545 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441804,90.39337724295144,77.99112650544876,1.15902130528447 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441792,59.597756341084455,77.99112650544876,0.7641607322715197 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441790,75.0934065552675,77.99112650544876,0.9628455174323093 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441811,104.93753695798765,77.99112650544876,1.345506106398608 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441808,59.93355542995274,77.99112650544876,0.7684663386130928 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441804,127.88824832498958,110.33780757772625,1.1590609885455636 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441792,178.66381484018376,110.33780757772625,1.6192438363824295 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441790,100.15839584407364,110.33780757772625,0.9077432118951445 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441811,94.46710945240442,110.33780757772625,0.8561626474756452 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441808,31.28659274530327,110.33780757772625,0.2835527860499111 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441813,129.56268425940283,110.33780757772625,1.1742365296513058 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441804,71.22032965620265,67.31067174214355,1.05808377502213 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441792,60.32974846918265,67.31067174214355,0.8962880165614197 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441790,64.98726606693829,67.31067174214355,0.9654823579222941 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441811,55.9450551451668,67.31067174214355,0.8311468849914821 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441808,84.0709593732274,67.31067174214355,1.2489989655026743 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441804,2788.0224735948755,2375.529574917848,1.1736425018793093 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441792,2123.478034587819,2375.529574917848,0.8938966944502277 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441790,1823.416102959837,2375.529574917848,0.7675829937932452 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441811,2372.8533493255795,2375.529574917848,0.9988734193753992 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441808,2618.5107437757315,2375.529574917848,1.102285053161793 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441813,2526.8967452632455,2375.529574917848,1.0637193373400253 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441804,191.7902632686757,194.62377093849457,0.9854411017926771 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441792,157.83858704809646,194.62377093849457,0.8109933657486113 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441790,258.0460724656925,194.62377093849457,1.325871301441594 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441811,253.53404258985935,194.62377093849457,1.3026879572176295 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441808,111.90988932014884,194.62377093849457,0.575006273799488 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441804,3085.599739664849,3728.1507253933823,0.8276488712347505 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441792,4370.151779842597,3728.1507253933823,1.1722036209739004 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441790,3959.5277579818335,3728.1507253933823,1.0620621454525654 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441811,3566.7709776726783,3728.1507253933823,0.9567131911750495 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441808,3643.6989788184624,3728.1507253933823,0.9773475503552747 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441813,3743.1551183798742,3728.1507253933823,1.0040246208084596 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441804,83.04017136800873,68.78582331086372,1.207227992208879 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441792,99.71453014319738,68.78582331086372,1.4496378082524009 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441790,71.33299407385407,68.78582331086372,1.0370304612256935 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441811,60.004114539990574,68.78582331086372,0.8723325774384356 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441808,29.837306429267866,68.78582331086372,0.4337711608745911 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441804,281.559855668617,696.3940975413478,0.40431108859577836 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441792,1128.614147384529,696.3940975413478,1.6206543843050283 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441790,566.8164148869114,696.3940975413478,0.8139305271082616 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441811,879.3931780013158,696.3940975413478,1.2627809183134304 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441808,589.4019579501892,696.3940975413478,0.8463626559028868 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441813,732.5790313565245,696.3940975413478,1.0519604257746142 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441804,79.84543834467918,81.2393188807366,0.982842291697402 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441792,101.70081204106485,81.2393188807366,1.25186687237453 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441790,154.81715424798512,81.2393188807366,1.9056924206278054 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441811,57.1236296768908,81.2393188807366,0.7031524939389405 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441808,12.70956009306308,81.2393188807366,0.156445921361322 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441804,215.0090929063996,543.8205698619286,0.39536770917103886 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441792,344.2934831854631,543.8205698619286,0.6331012511587716 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441790,330.92433746913866,543.8205698619286,0.608517507076199 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441811,950.6354355163232,543.8205698619286,1.748068183146661 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441808,1064.6147159656146,543.8205698619286,1.9576580493009141 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441813,357.44635412863227,543.8205698619286,0.6572873001464157 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441804,261136.7459921541,306516.0644612488,0.8519512556418335 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441792,234850.51693210047,306516.0644612488,0.7661931760245191 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441790,364296.9991527764,306516.0644612488,1.1885086668885914 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441811,149116.61006002646,306516.0644612488,0.4864887271801654 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441808,523179.4501691865,306516.0644612488,1.70685817426489 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441804,717263.8456485727,335923.8645439917,2.1351976484976456 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441792,267189.9709553461,335923.8645439917,0.7953884768444477 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441790,227709.82120014948,335923.8645439917,0.6778614002588352 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441811,311109.2942371919,335923.8645439917,0.9261303737962024 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441808,231436.81277651983,335923.8645439917,0.688956151093015 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441813,260833.44244617,335923.8645439917,0.7764659495098537 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441804,44.54414435386128,33.931355493730415,1.3127723224052106 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441792,43.55805868791294,33.931355493730415,1.2837111295468664 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441790,5.8517628695958654,33.931355493730415,0.17245885949581682 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441811,22.04122595390885,33.931355493730415,0.6495828307826212 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441808,53.66158560337315,33.931355493730415,1.5814748577694853 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441804,75.62710464668777,76.3332642617619,0.9907489923049463 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441792,163.78606507454526,76.3332642617619,2.145670916324112 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441790,83.8662718129735,76.3332642617619,1.0986857777413974 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441811,22.26802352596008,76.3332642617619,0.291721096186829 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441808,39.15273912570767,76.3332642617619,0.5129184439361215 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441813,73.29938138469714,76.3332642617619,0.9602547735065938 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441804,155.99729234084424,130.67426801703346,1.1937873822297587 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441792,157.0589025652132,130.67426801703346,1.2019114776655224 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441790,158.65551513618038,130.67426801703346,1.2141297406425844 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441811,60.563033061549355,130.67426801703346,0.4634656384962871 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441808,121.09659698138006,130.67426801703346,0.9267057609658472 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441804,6959.749745470899,5444.214081294075,1.278375471931586 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441792,5984.314800945994,5444.214081294075,1.099206370577466 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441790,4761.115067543276,5444.214081294075,0.8745275252679946 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441811,4632.376015970598,5444.214081294075,0.8508805764797358 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441808,4585.912682906878,5444.214081294075,0.8423461337906865 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441813,5741.816174926805,5444.214081294075,1.054663921952531 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441804,71.09974259982943,100.67607722942154,0.7062228143614168 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441792,79.7215010866364,100.67607722942154,0.7918614161432446 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441790,74.82568550654474,100.67607722942154,0.7432320325317335 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441811,145.91963908643845,100.67607722942154,1.4493973454479705 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441808,131.81381786765866,100.67607722942154,1.3092863915156345 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441804,577.8607697388837,599.1099853739104,0.964532028919924 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441792,567.5261288238203,599.1099853739104,0.9472820394899973 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441790,698.9811447699321,599.1099853739104,1.1666992068805049 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441811,618.271358781359,599.1099853739104,1.0319830646713222 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441808,541.1469094164789,599.1099853739104,0.9032513605640271 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441813,590.8736007129885,599.1099853739104,0.9862522994742251 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441804,97.95049007303687,114.30018844822946,0.8569582552998333 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441792,61.29716459881987,114.30018844822946,0.5362822706682018 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441790,71.12407381498144,114.30018844822946,0.622256837723378 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441811,125.44027446572817,114.30018844822946,1.0974634090174265 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441808,215.68893928858097,114.30018844822946,1.8870392272911607 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441804,2115.549589586031,1759.6959467320276,1.202224505611249 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441792,2075.0329189704275,1759.6959467320276,1.1791996923241312 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441790,1430.876747075511,1759.6959467320276,0.8131386275753067 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441811,1839.4982135217508,1759.6959467320276,1.045350031599451 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441808,1384.2108323559758,1759.6959467320276,0.7866193218928679 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441813,1713.0073788824695,1759.6959467320276,0.9734678209969941 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441804,17.667387062931336,38.77498679262034,0.45563876417086996 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441792,83.7186410871051,38.77498679262034,2.159088835667597 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441790,15.980080195804234,38.77498679262034,0.4121234207317787 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441811,13.192535170695116,38.77498679262034,0.34023313125166355 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441808,63.316290446565894,38.77498679262034,1.6329158481780903 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441804,1077.441282997427,2284.874121495706,0.4715538912454928 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441792,3920.254464659909,2284.874121495706,1.715741986737398 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441790,1611.4727717137482,2284.874121495706,0.7052785781734264 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441811,2143.880715806693,2284.874121495706,0.9382927031460635 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441808,2860.615355668523,2284.874121495706,1.251979410487581 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441813,2095.5801381279352,2284.874121495706,0.9171534302100387 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441804,353.2391534277451,306.4947439651267,1.1525129235754106 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441792,336.70996219216283,306.4947439651267,1.0985831529641958 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441790,250.82624842183588,306.4947439651267,0.8183704724488691 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441811,283.52053841648967,306.4947439651267,0.9250420896247048 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441808,308.17781736740005,306.4947439651267,1.00549136138682 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441804,40184.48284695527,53872.22448470133,0.7459221005133524 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441792,89254.4274868242,53872.22448470133,1.6567800632062397 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441790,41388.516476119396,53872.22448470133,0.768271903972945 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441811,40392.79970630936,53872.22448470133,0.7497889699687477 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441808,47188.05405448705,53872.22448470133,0.8759254793328155 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441813,64825.06633751269,53872.22448470133,1.2033114830058995 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441804,369.57257552246153,320.29657233769314,1.1538449282336247 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441792,537.4443276187013,320.29657233769314,1.6779584111567272 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441790,133.7618340735191,320.29657233769314,0.4176186872599191 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441811,37.16870400262146,320.29657233769314,0.11604465115360016 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441808,523.5354204711622,320.29657233769314,1.6345333221961287 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441804,3992.2799507855657,6299.521117687065,0.633743403062259 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441792,14718.685560945773,6299.521117687065,2.3364768981598227 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441790,2699.6301355413107,6299.521117687065,0.42854529496878774 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441811,2069.6428328014067,6299.521117687065,0.3285397086757124 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441808,4195.632729523559,6299.521117687065,0.6660240756624416 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441813,10121.25549652478,6299.521117687065,1.6066706194709772 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441804,2584.508637942818,1965.7827420843205,1.3147478521469071 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441792,1877.4044197438238,1965.7827420843205,0.9550416633290874 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441790,1697.1030736997022,1965.7827420843205,0.8633217890092284 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441811,1922.8308107885043,1965.7827420843205,0.9781502144788013 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441808,1747.0667682467542,1965.7827420843205,0.8887384810359757 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441804,4694.234531701417,6243.797224888628,0.7518236679739626 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441792,13006.506437386834,6243.797224888628,2.083108398450405 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441790,2925.964442852711,6243.797224888628,0.4686193893660443 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441811,2279.7796666641057,6243.797224888628,0.36512711488717037 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441808,5395.749944089764,6243.797224888628,0.8641776389825038 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441813,9160.548326636936,6243.797224888628,1.4671437903399136 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441804,630.5732461043939,477.14850073021523,1.3215450643549786 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441792,471.70666353935616,477.14850073021523,0.988595086891123 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441790,397.215574459102,477.14850073021523,0.8324778844557071 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441811,457.7036816840933,477.14850073021523,0.9592478672439206 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441808,428.5433378641309,477.14850073021523,0.8981340970542707 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441804,174.29083804829372,205.1372392304115,0.8496304167013241 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441792,231.87406534488693,205.1372392304115,1.1303362871352893 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441790,148.36240232541823,205.1372392304115,0.7232348591704337 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441811,54.824986368578834,205.1372392304115,0.26726003808113574 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441808,281.47393330876565,205.1372392304115,1.372124994782699 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441813,339.99720998652566,205.1372392304115,1.6574134041291184 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441804,52.969082036362195,44.32085041603382,1.1951278357510877 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441792,67.34692402198112,44.32085041603382,1.5195314031613714 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441790,53.35293141834068,44.32085041603382,1.2037885310756435 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441811,37.9739590029011,44.32085041603382,0.8567967141073487 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441808,9.961355600584016,44.32085041603382,0.22475551590454876 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441804,201.66286758896504,73.02499011367847,2.761559669847749 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441792,97.29598123516656,73.02499011367847,1.3323655516242492 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441790,64.93596318866007,73.02499011367847,0.889229332144706 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441811,12.764569187903865,73.02499011367847,0.17479727375564416 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441808,3.808235334717095,73.02499011367847,0.0521497548823874 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441813,57.68232414665818,73.02499011367847,0.7898984177452641 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441804,151.03253415694155,446.9213615105917,0.33793984169038693 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441792,196.05853561416777,446.9213615105917,0.4386868753632429 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441790,66.35606904689634,446.9213615105917,0.14847370200120485 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441811,23.70078525037829,446.9213615105917,0.05303122045961233 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441808,1797.4588834845745,446.9213615105917,4.021868360485553 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441804,2345.9392518021423,2631.000022355788,0.8916530717858362 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441792,2279.0530061391105,2631.000022355788,0.8662307057293198 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441790,2732.3487481711218,2631.000022355788,1.0385209901004053 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441811,2148.341266337401,2631.000022355788,0.8165493151207897 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441808,2702.600611848015,2631.000022355788,1.0272142109022546 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441813,3577.7172498369387,2631.000022355788,1.3598317063613945 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441804,21.22559126666845,48.89133349009634,0.4341381130659487 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441792,54.637064951385824,48.89133349009634,1.117520448945279 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441790,48.389013329210776,48.89133349009634,0.989725783180217 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441811,43.1670667871357,48.89133349009634,0.8829185809767252 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441808,77.03793111608098,48.89133349009634,1.5756970738318306 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441804,297.4853420289319,307.70649021557807,0.9667827994804877 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441792,500.2388338382569,307.70649021557807,1.6257012761992486 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441790,244.92429166186992,307.70649021557807,0.795967259222504 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441811,247.53564202022076,307.70649021557807,0.8044537567173126 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441808,326.96732058386596,307.70649021557807,1.0625948135016385 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441813,229.08751116032315,307.70649021557807,0.7445000948788089 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441804,185.23102603947197,154.19153082843468,1.2013047995844481 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441792,109.07664653421973,154.19153082843468,0.7074101018919565 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441790,177.82680749950882,154.19153082843468,1.1532851807364994 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441811,188.68476469184913,154.19153082843468,1.2237038161440543 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441808,110.13840937712378,154.19153082843468,0.7142961016430417 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441804,6525.4656922724,6593.957266089812,0.9896129788147645 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441792,6640.965338267096,6593.957266089812,1.0071289622119677 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441790,6752.584988384559,6593.957266089812,1.0240565287115992 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441811,6579.5998709576315,6593.957266089812,0.9978226435882418 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441808,6169.379021919591,6593.957266089812,0.9356110106515758 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441813,6895.748684737594,6593.957266089812,1.045767876021851 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441804,162.2069390743401,127.96554716912783,1.2675828976056858 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441792,105.76141241956837,127.96554716912783,0.8264834930904255 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441790,81.58550797654244,127.96554716912783,0.637558388030128 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441811,78.52732291585623,127.96554716912783,0.6136598846568386 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441808,211.746553459332,127.96554716912783,1.6547153366169223 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441804,1287.5089685498588,1681.9358703135756,0.7654923063801589 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441792,2603.7063676235134,1681.9358703135756,1.5480414048949949 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441790,1465.8519392077278,1681.9358703135756,0.8715266527578357 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441811,1532.5526054561017,1681.9358703135756,0.9111837332837052 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441808,1352.556477176888,1681.9358703135756,0.8041664970999881 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441813,1849.4388638673645,1681.9358703135756,1.0995894055833175 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441804,46.999004547507326,45.403354316773296,1.0351438842954506 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441792,38.94157858807799,45.403354316773296,0.8576806532043351 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441790,45.50478870860701,45.403354316773296,1.0022340726441932 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441811,39.14962006942073,45.403354316773296,0.8622627261474762 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441808,56.421779670253414,45.403354316773296,1.2426786637085445 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441804,160.41918701335803,171.72890790902974,0.934142008859319 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441792,189.64064697712092,171.72890790902974,1.1043024106202295 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441790,182.31111885282073,171.72890790902974,1.0616216050788416 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441811,183.4244184561534,171.72890790902974,1.068104494982983 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441808,149.60324810788697,171.72890790902974,0.8711593751422245 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441813,164.97482804683844,171.72890790902974,0.9606701053164027 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441804,1497.3250065458224,385.5886159476326,3.8832189141942313 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441792,241.0028686504336,385.5886159476326,0.6250258920589206 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441790,144.55524279139226,385.5886159476326,0.37489499640991614 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441811,44.7935555711911,385.5886159476326,0.11616928954477894 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441808,0.2664061793236135,385.5886159476326,6.9090779215275e-4 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441804,467.3509827077694,430.1288265554666,1.086537227579893 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441792,583.992260270432,430.1288265554666,1.3577147687290012 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441790,434.8247253872757,430.1288265554666,1.0109174241341008 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441811,342.63732966435674,430.1288265554666,0.7965923428295789 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441808,360.55457198847273,430.1288265554666,0.8382478683789819 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441813,391.4130893144933,430.1288265554666,0.9099903683484445 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441804,53790.09671168416,54695.927744901994,0.9834387847401991 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441792,34694.77113001537,54695.927744901994,0.6343209185851891 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441790,54886.90720791044,54695.927744901994,1.0034916578049313 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441811,37745.50458974697,54695.927744901994,0.6900971634632358 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441808,92362.35908515305,54695.927744901994,1.6886514754064448 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441804,209842.91998823915,97212.60478924697,2.1585978530579464 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441792,113643.56279005676,97212.60478924697,1.1690208593467015 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441790,30697.63626589537,97212.60478924697,0.31577835335702215 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441811,59078.575052811815,97212.60478924697,0.6077254609203385 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441808,64028.57255948496,97212.60478924697,0.6586447580362272 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441813,105984.36207899376,97212.60478924697,1.0902327152817641 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441804,66220.00137435179,62941.57202670208,1.052086867901216 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441792,47339.59014331685,62941.57202670208,0.7521196026567892 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441790,47005.85410154791,62941.57202670208,0.7468172876522108 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441811,44989.52065557531,62941.57202670208,0.7147822846955448 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441808,109152.89385871855,62941.57202670208,1.7341939570942393 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441804,30605.97879230046,14728.399701289269,2.0780247286214895 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441792,16582.617912351612,14728.399701289269,1.125894071906538 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441790,5106.9094301989735,14728.399701289269,0.34673892165976006 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441811,9173.525672781798,14728.399701289269,0.622846056518875 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441808,10932.991200997158,14728.399701289269,0.7423067965788656 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441813,15968.375199105609,14728.399701289269,1.0841894247144717 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441804,4919.280995002424,3575.9352491809864,1.3756627713348866 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441792,1468.7839057514166,3575.9352491809864,0.41074119171699747 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441790,1743.9243333253064,3575.9352491809864,0.4876834203652669 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441811,4247.722826290698,3575.9352491809864,1.1878634623665445 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441808,5499.9641855350865,3575.9352491809864,1.5380491542163046 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441804,24285.90974789409,12966.336321671553,1.8729970552517086 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441792,11176.479005044424,12966.336321671553,0.8619612146234696 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441790,7040.583483170614,12966.336321671553,0.5429894234197203 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441811,5336.846088764616,12966.336321671553,0.41159244649892107 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441808,12882.536647798064,12966.336321671553,0.99353713556439 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441813,17075.66295735751,12966.336321671553,1.31692272464179 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441804,151.6386456365754,103.34580193186551,1.4672937149062786 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441792,55.24430173131879,103.34580193186551,0.5345577730166593 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441790,43.74071927463278,103.34580193186551,0.42324621278250324 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441811,165.52359074159682,103.34580193186551,1.601647939707549 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441808,100.58175227520373,103.34580193186551,0.9732543595870098 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441804,324.0663185875527,211.8154700640626,1.5299464127409597 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441792,235.90927888837197,211.8154700640626,1.1137490515542718 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441790,162.80347663161095,211.8154700640626,0.7686099442234876 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441811,89.79479694553248,211.8154700640626,0.42392936133689607 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441808,188.12520269499808,211.8154700640626,0.8881561041698253 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441813,270.19374663630947,211.8154700640626,1.27560912597456 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441804,50.52346332718478,76.10596635595309,0.6638568005415357 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441792,83.6007569334935,76.10596635595309,1.0984783576952002 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441790,69.13715515737715,76.10596635595309,0.9084327874376852 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441811,110.65157817192264,76.10596635595309,1.4539146333731212 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441808,66.61687818978733,76.10596635595309,0.8753174209524571 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441804,1129.0656369168512,1382.686999693948,0.8165735536435687 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441792,2317.8794536765813,1382.686999693948,1.6763587523348624 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441790,1138.4543841713405,1382.686999693948,0.8233637724397008 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441811,1458.8467355844475,1382.686999693948,1.0550809661965124 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441808,670.3193166169855,1382.686999693948,0.484794690891979 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441813,1581.5564711974832,1382.686999693948,1.143828264493377 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441804,32.18165068818108,30.899530320120164,1.041493199242128 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441792,31.27986552367971,30.899530320120164,1.0123087697327195 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441790,30.32983381908052,30.899530320120164,0.9815629397878359 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441811,26.09723728585628,30.899530320120164,0.844583623617836 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441808,34.609064283803235,30.899530320120164,1.1200514676194808 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441804,31.195174813371462,31.68183515511672,0.9846391366105363 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441792,30.588575638318535,31.68183515511672,0.9654925444992217 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441790,32.19814823959854,31.68183515511672,1.016296817465084 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441811,32.71334888009885,31.68183515511672,1.0325585219395201 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441808,30.771569990536765,31.68183515511672,0.9712685467832521 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441813,32.62419336877616,31.68183515511672,1.0297444327023855 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441804,1246.3584432701225,628.1906149122311,1.9840449915735527 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441792,251.42262961841305,628.1906149122311,0.400233024260544 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441790,223.5119662786187,628.1906149122311,0.3558027786038273 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441811,910.108968139922,628.1906149122311,1.4487783588856697 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441808,509.55106725407944,628.1906149122311,0.8111408466764063 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441804,12919.478347311577,10551.186365326936,1.2244574117055942 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441792,12893.286985291106,10551.186365326936,1.2219750972896022 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441790,9134.576403375464,10551.186365326936,0.8657392720683332 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441811,9421.307929203069,10551.186365326936,0.8929145598416451 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441808,8405.633923882227,10551.186365326936,0.7966529670544563 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441813,10532.834602898174,10551.186365326936,0.9982606920403692 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441804,82.16699617495628,102.14043933131707,0.8044511724531346 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441792,122.30545802067948,102.14043933131707,1.1974244366029436 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441790,123.97735474505518,102.14043933131707,1.2137930437415179 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441811,70.39980249713737,102.14043933131707,0.6892451506770858 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441808,111.852585218757,102.14043933131707,1.095086196525318 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441804,2544.644714889646,2995.2816068385046,0.8495510769605058 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441792,2796.654562807272,2995.2816068385046,0.933686687896808 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441790,2730.4044145231237,2995.2816068385046,0.9115685177278017 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441811,3481.4499311506165,2995.2816068385046,1.1623113910899545 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441808,2535.034044073225,2995.2816068385046,0.8463424735375492 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441813,3883.5019735871433,2995.2816068385046,1.2965398527873806 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441804,38.0123194121712,35.73806763844074,1.0636366743926642 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441792,37.77150847760366,35.73806763844074,1.056898455163695 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441790,34.05625702170565,35.73806763844074,0.952940639271551 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441811,21.257123821203713,35.73806763844074,0.5948033910579718 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441808,47.59312945951949,35.73806763844074,1.3317208401141183 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441804,256.0962758256378,271.6614200921023,0.9427038838964055 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441792,278.59931385065767,271.6614200921023,1.025538752452237 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441790,265.82642908508626,271.6614200921023,0.9785210906832565 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441811,349.00566757110533,271.6614200921023,1.2847082498971727 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441808,207.894176826176,271.6614200921023,0.765269417923579 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441813,272.54665739395074,271.6614200921023,1.0032586051473498 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441804,167.18234472778195,166.02715311669658,1.0069578474930148 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441792,181.1876465734067,166.02715311669658,1.0913133374397752 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441790,155.9449164401673,166.02715311669658,0.9392735676829759 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441811,146.74116537936618,166.02715311669658,0.8838383518882919 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441808,179.07969246276082,166.02715311669658,1.0786168954959428 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441804,1499.5377827100697,1793.9624976146763,0.8358802286580208 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441792,1799.8240324624533,1793.9624976146763,1.0032673675484134 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441790,2203.7293490957068,1793.9624976146763,1.2284143910621725 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441811,1908.162904760793,1793.9624976146763,1.0636581909030776 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441808,1721.7071008655012,1793.9624976146763,0.9597230171504428 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441813,1630.813815793534,1793.9624976146763,0.9090568046778731 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441804,79.32116777394621,59.13775760336051,1.3412948171954153 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441792,23.826525251261693,59.13775760336051,0.40289869310005333 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441790,45.11703826452219,59.13775760336051,0.7629142546649149 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441811,70.34849374217848,59.13775760336051,1.1895698550832592 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441808,77.07556298489398,59.13775760336051,1.3033223799563571 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441804,326.6404584320485,238.79765196261823,1.3678545653505056 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441792,150.82421318169625,238.79765196261823,0.6315983927903384 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441790,191.82932569511644,238.79765196261823,0.8033132826831384 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441811,313.0435570873299,238.79765196261823,1.3109155576468323 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441808,249.505239330723,238.79765196261823,1.0448395839745566 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441813,200.9431180487954,238.79765196261823,0.8414786175546289 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441804,637.2488661748853,386.8144501381946,1.6474277678799736 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441792,203.0417735910961,386.8144501381946,0.5249074162523057 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441790,192.45891792990471,386.8144501381946,0.49754841852765896 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441811,556.97630356212,386.8144501381946,1.4399056275253752 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441808,344.34638943296693,386.8144501381946,0.8902107698146866 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441804,5655.819641564055,5555.372966797932,1.01808099570748 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441792,6845.084449129284,5555.372966797932,1.2321556968432903 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441790,4959.253382083525,5555.372966797932,0.8926949480661053 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441811,5292.3689798530195,5555.372966797932,0.9526577263998701 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441808,4322.296954823524,5555.372966797932,0.778039022880377 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441813,6257.414393334188,5555.372966797932,1.1263716101028778 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441804,73.73217263184539,84.54153084580483,0.872141442131269 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441792,74.97943293122945,84.54153084580483,0.8868946679944124 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441790,73.81482466957348,84.54153084580483,0.8731190922506978 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441811,160.08849948419945,84.54153084580483,1.8936077674792122 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441808,40.09272451217641,84.54153084580483,0.47423703014440877 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441804,30.2088289142141,122.00200397429413,0.2476092845210896 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441792,118.90507210713746,122.00200397429413,0.9746157295267938 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441790,306.00489789587004,122.00200397429413,2.508195668329722 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441811,133.9792089806338,122.00200397429413,1.0981721989489885 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441808,45.71567222866066,122.00200397429413,0.37471246979101236 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441813,97.19834371924873,122.00200397429413,0.7966946488823943 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441804,149.33120016689,143.84455848940917,1.0381428518054425 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441792,141.4769465092102,143.84455848940917,0.9835404828304763 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441790,78.24520606191304,143.84455848940917,0.5439566632454435 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441811,119.40628811052687,143.84455848940917,0.8301063965469253 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441808,230.76315159850577,143.84455848940917,1.6042536055717127 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441804,2796.63,5334.764851653101,0.5242274172840813 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441792,13444.359790249508,5334.764851653101,2.520141030411764 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441790,2450.309944103973,5334.764851653101,0.459309831312375 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441811,7536.76160924988,5334.764851653101,1.4127636023009411 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441808,1725.8051924020206,5334.764851653101,0.32350164260140535 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441813,4054.722573913221,5334.764851653101,0.7600564760894327 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441804,196.36957560953303,159.70733471984832,1.2295589050684241 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441792,186.55746465609224,159.70733471984832,1.1681208316658922 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441790,109.68802719083187,159.70733471984832,0.6868064474511572 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441811,157.59932803845666,159.70733471984832,0.986800814846172 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441808,148.3222781043278,159.70733471984832,0.9287130009683545 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441804,75673.06367743466,82077.5827732141,0.9219699352809212 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441792,178664.84099054665,82077.5827732141,2.1767800044039998 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441790,57145.97169242251,82077.5827732141,0.6962433561222274 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441811,56305.373762892676,82077.5827732141,0.6860018516684174 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441808,45524.55626786828,82077.5827732141,0.5546527410980865 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441813,79151.69024811985,82077.5827732141,0.9643521114263478 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441804,289406.8614299397,170961.68742491837,1.6928170620510465 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441792,316548.871193763,170961.68742491837,1.8515778357228865 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441790,127239.33080001466,170961.68742491837,0.7442564045578612 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441811,41901.45859782851,170961.68742491837,0.2450926826294369 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441808,79711.91510304598,170961.68742491837,0.46625601503876846 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441804,150021.75497342538,55195.40432138408,2.7180117043784966 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441792,39862.37221405305,55195.40432138408,0.7222045513417749 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441790,20966.72629553088,55195.40432138408,0.37986362367143395 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441811,32493.6037683589,55195.40432138408,0.5887012545312593 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441808,32677.5857895368,55195.40432138408,0.5920345396741062 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441813,55150.38288739944,55195.40432138408,0.9991843264029285 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441804,863.4183604603871,546.121028905539,1.5810018562931591 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441792,300.1322965289528,546.121028905539,0.5495710303088619 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441790,256.2758929674239,546.121028905539,0.46926574770617596 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441811,804.0433837480501,546.121028905539,1.4722805773646985 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441808,506.7352108228812,546.121028905539,0.927880788327105 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441804,708.4296469912756,1228.731327313693,0.5765537438848214 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441792,1644.951674065617,1228.731327313693,1.3387399161229845 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441790,1342.0014562953554,1228.731327313693,1.0921846187720292 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441811,1362.574981721036,1228.731327313693,1.1089283323637218 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441808,1142.6614856241663,1228.731327313693,0.9299522688351273 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441813,1171.7687191847083,1228.731327313693,0.9536411200213158 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441804,188.6653876546159,76.68368758811918,2.460306664801633 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441792,36.98071470295894,76.68368758811918,0.4822500829849042 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441790,38.9841919966654,76.68368758811918,0.5083765951118049 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441811,43.68360562003678,76.68368758811918,0.5696596889636903 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441808,75.10453796631893,76.68368758811918,0.9794069681379679 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441804,58.79571185945509,81.06808963980528,0.7252633202619071 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441792,66.63624311891991,81.06808963980528,0.8219787022858476 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441790,172.8900983374811,81.06808963980528,2.1326529230632105 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441811,100.35622334939865,81.06808963980528,1.2379251046286244 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441808,42.49638190468315,81.06808963980528,0.5242060358582445 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441813,45.23387926889375,81.06808963980528,0.5579739139021656 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441804,45.37606733862865,34.254424530644805,1.3246775551004855 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441792,41.48591949789376,34.254424530644805,1.2111112671234483 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441790,46.376794605126975,34.254424530644805,1.3538920954178406 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441811,27.068013704963885,34.254424530644805,0.7902048881524257 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441808,10.965327506610748,34.254424530644805,0.32011419420579995 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441804,66.80462263950137,60.87738129746832,1.0973636055905636 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441792,78.98207162181927,60.87738129746832,1.297396010447379 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441790,67.79672314456369,60.87738129746832,1.1136603069912785 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441811,67.99360590776291,60.87738129746832,1.1168943942500125 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441808,26.78208425181559,60.87738129746832,0.4399348934039869 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441813,56.905180219347095,60.87738129746832,0.93475078931678 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441804,83.85610989052016,81.37032235510941,1.0305490683023535 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441792,82.17814349896081,81.37032235510941,1.0099277122232104 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441790,57.16559307372353,81.37032235510941,0.7025361510090415 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441811,102.35264231533854,81.37032235510941,1.2578620724723184 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441808,81.29912299700399,81.37032235510941,0.999124995993076 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441804,402.9452249022638,592.3362991324378,0.680264278067097 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441792,1009.6382564131724,592.3362991324378,1.7045017465448826 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441790,665.0588625365343,592.3362991324378,1.122772424230305 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441811,415.8090978962258,592.3362991324378,0.701981456320064 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441808,570.8888844799102,592.3362991324378,0.9637918279127238 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441813,489.6774685665207,592.3362991324378,0.8266882669249279 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441804,2563.430945917313,1509.2244087879828,1.6985088042512742 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441792,785.2338131906139,1509.2244087879828,0.5202896326207803 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441790,757.6478862551378,1509.2244087879828,0.5020114184765831 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441811,1898.9629766450685,1509.2244087879828,1.2582376521262826 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441808,1540.8464219317814,1509.2244087879828,1.0209524925250801 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441804,977081.2766033668,911297.6405793307,1.0721867731186225 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441792,776595.5258217262,911297.6405793307,0.8521864769978208 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441790,977690.0030033332,911297.6405793307,1.0728547507066906 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441811,876816.6636368138,911297.6405793307,0.9621627716268455 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441808,871045.9255999066,911297.6405793307,0.9558303311815498 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441813,988556.4488108376,911297.6405793307,1.0847788963684706 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441804,272.31368588105477,749.6106308195243,0.3632735111871923 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441792,882.1274056827839,749.6106308195243,1.1767808104834152 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441790,289.8348006586263,749.6106308195243,0.3866471321808224 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441811,835.8428246871816,749.6106308195243,1.1150359804441174 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441808,1467.934437187975,749.6106308195243,1.9582625657044526 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441804,3357.143972535194,2138.7943755926544,1.5696431647876097 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441792,2125.028195798092,2138.7943755926544,0.9935635795793843 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441790,1026.9561604273515,2138.7943755926544,0.4801565649071733 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441811,1208.2480539628332,2138.7943755926544,0.5649201567719808 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441808,2445.0787314986,2138.7943755926544,1.143204208595824 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441813,2670.3111393338572,2138.7943755926544,1.2485123253580284 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441804,1169.7154658700078,613.8984432679271,1.9053892035355797 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441792,183.27574033864596,613.8984432679271,0.2985440708450501 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441790,119.41172913217648,613.8984432679271,0.1945138164816309 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441811,891.2039335583802,613.8984432679271,1.4517123203868871 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441808,705.8853474404251,613.8984432679271,1.1498405887508525 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441804,4444.594948928721,6365.76448478505,0.6982028567899179 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441792,5422.887301344456,6365.76448478505,0.8518831185642849 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441790,9085.242196117768,6365.76448478505,1.4272036324674908 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441811,7930.217611081234,6365.76448478505,1.2457604471600257 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441808,6471.481594577154,6365.76448478505,1.0166071349395318 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441813,4840.163256660964,6365.76448478505,0.7603428100787489 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441804,62.40515514372578,70.21289390855102,0.888799074782554 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441792,38.1225581270881,70.21289390855102,0.5429566566041406 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441790,54.46696642425,70.21289390855102,0.7757402293543213 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441811,109.70014611253148,70.21289390855102,1.562393173188542 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441808,86.36964373515974,70.21289390855102,1.2301108660704416 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441804,1692.6785620867386,2003.7789126851078,0.8447431756922285 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441792,2387.835916077289,2003.7789126851078,1.191666356483179 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441790,2111.0088873472823,2003.7789126851078,1.0535138752001756 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441811,1980.021889331393,2003.7789126851078,0.9881438899255208 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441808,1793.4889836964574,2003.7789126851078,0.8950533276613549 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441813,2057.639237571487,2003.7789126851078,1.026879375037541 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441804,1256.128406557134,700.7857837159185,1.7924570328703158 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441792,239.8150536649161,700.7857837159185,0.3422087879598472 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441790,169.87498589711248,700.7857837159185,0.24240643837885797 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441811,1088.339490554118,700.7857837159185,1.5530273527856042 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441808,749.7709819063119,700.7857837159185,1.069900388005375 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441804,3315.174404009777,4688.560133729121,0.7070772922716041 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441792,4889.684120274266,4688.560133729121,1.0428967488543606 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441790,6376.829471876925,4688.560133729121,1.3600826885001498 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441811,5971.6461326850185,4688.560133729121,1.2736631209495386 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441808,4460.733253106631,4688.560133729121,0.9514079218087614 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441813,3117.2934204221087,4688.560133729121,0.6648722276155856 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441804,730.6604414352491,384.65137963543384,1.8995393754410992 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441792,180.04633648538208,384.65137963543384,0.46807666894637684 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441790,131.34127558970738,384.65137963543384,0.3414553607325949 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441811,495.4796552395931,384.65137963543384,1.2881265516562048 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441808,385.7291894272375,384.65137963543384,1.0028020432237241 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441804,135.70643321476527,772.5530415852671,0.1756596970174342 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441792,1039.6332585647444,772.5530415852671,1.3457111714056975 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441790,55.70925123536669,772.5530415852671,0.07211058430506229 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441811,2631.854160242105,772.5530415852671,3.406697040298463 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441808,141.57557031955056,772.5530415852671,0.18325676387091772 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441813,630.8395759350706,772.5530415852671,0.8165647431024248 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441804,162.3737322195662,216.68366112664066,0.7493584489726106 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441792,253.25866765913122,216.68366112664066,1.168794482898802 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441790,227.8052170480967,216.68366112664066,1.0513262322762584 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441811,186.0435129798409,216.68366112664066,0.8585950228665735 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441808,253.9371757265683,216.68366112664066,1.1719258129857555 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441804,887.2673194712125,615.8359185894908,1.440752792567552 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441792,515.1184052594854,615.8359185894908,0.8364539802084155 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441790,481.04400422438994,615.8359185894908,0.7811236559994292 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441811,594.4745338953046,615.8359185894908,0.9653131880597152 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441808,778.2306350085867,615.8359185894908,1.2636980265637061 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441813,438.8806136779656,615.8359185894908,0.7126583566011816 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441804,57.40948728994969,101.73138829665541,0.5643242292392575 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441792,71.49115142455199,101.73138829665541,0.7027442819917005 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441790,90.6689475478319,101.73138829665541,0.8912583330076583 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441811,195.87680919539665,101.73138829665541,1.9254313980676938 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441808,93.21054602554682,101.73138829665541,0.9162417576936899 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441804,147.47357677624103,93.53234569214308,1.5767120527656042 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441792,60.36478026585334,93.53234569214308,0.6453893550851479 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441790,9.98724360961306,93.53234569214308,0.10677850037553382 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441811,127.521642588416,93.53234569214308,1.3633961774908003 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441808,131.51943634481117,93.53234569214308,1.4061385435333853 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441813,84.3273945679239,93.53234569214308,0.9015853707495287 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441804,51.16977497252381,42.30806113801961,1.2094568646290609 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441792,72.45263861523611,42.30806113801961,1.712501983460723 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441790,21.946744651007737,42.30806113801961,0.5187367149586907 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441811,22.405939390087305,42.30806113801961,0.5295903141718893 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441808,43.56520806124309,42.30806113801961,1.0297141227796365 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441804,115.17053345030098,205.3077634331321,0.5609653114155693 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441792,183.67112284297897,205.3077634331321,0.8946136267409095 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441790,195.16404033347547,205.3077634331321,0.9505925984968396 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441811,165.1318271801388,205.3077634331321,0.8043136042145896 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441808,369.48224364711103,205.3077634331321,1.7996506194830275 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441813,203.22681314478737,205.3077634331321,0.9898642396490648 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441804,860.8773813968163,761.179367641068,1.130978344913259 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441792,489.1697026420882,761.179367641068,0.6426470861369364 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441790,1028.030646276388,761.179367641068,1.3505760796726602 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441811,584.3098884701291,761.179367641068,0.7676375809829606 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441808,843.5092194199185,761.179367641068,1.108160908294184 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441804,316276.7989198534,258075.7105503754,1.2255194347633787 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441792,366948.8054690205,258075.7105503754,1.421864942990803 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441790,126160.70901064837,258075.7105503754,0.4888515418269953 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441811,244009.12105928708,258075.7105503754,0.9454943300898417 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441808,248377.33848677695,258075.7105503754,0.9624204383941612 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441813,246681.490356666,258075.7105503754,0.9558493119348197 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441804,196.67920548388503,131.47736122215045,1.4959168913617487 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441792,101.44335953522395,131.47736122215045,0.7715652230334954 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441790,113.16722107911814,131.47736122215045,0.8607354150339644 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441811,149.94914424371018,131.47736122215045,1.1404940200339808 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441808,96.14787576881496,131.47736122215045,0.7312884505368107 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441804,3247.7174599924315,3004.2024881525895,1.0810581086994537 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441792,2360.45629176313,3004.2024881525895,0.7857181069091898 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441790,2896.4031090548597,3004.2024881525895,0.9641171393996081 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441811,2707.3691865258415,3004.2024881525895,0.9011939765054641 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441808,3766.043944552592,3004.2024881525895,1.2535919131298274 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441813,3047.2249370266823,3004.2024881525895,1.014320755356457 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441804,142.872265687391,96.13121274223809,1.48622140106026 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441792,63.11310896103792,96.13121274223809,0.6565308723428526 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441790,106.03978171737263,96.13121274223809,1.1030733795245353 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441811,72.773924535996,96.13121274223809,0.7570270098550481 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441808,95.85698280939287,96.13121274223809,0.997147337217304 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441804,458.85542481704647,490.807523353751,0.9348989226604113 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441792,475.53058608145824,490.807523353751,0.9688738730655483 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441790,592.0533890287913,490.807523353751,1.2062842577946122 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441811,509.1827611385909,490.807523353751,1.037438785899775 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441808,543.4382840279534,490.807523353751,1.1072329949520123 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441813,365.7846950286656,490.807523353751,0.745271165627641 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441804,88.12363302740688,78.64120835950264,1.120578318488648 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441792,60.57925136989235,78.64120835950264,0.7703245236639631 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441790,85.64673964619313,78.64120835950264,1.089082192820146 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441811,97.04840864205056,78.64120835950264,1.234065583000718 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441808,61.80800911197028,78.64120835950264,0.7859493820265249 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441804,1679.699844637448,1710.8868039225827,0.9817714654098496 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441792,1654.3641403821653,1710.8868039225827,0.9669629437723017 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441790,1777.1862406359398,1710.8868039225827,1.0387515039343054 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441811,1754.0081248549109,1710.8868039225827,1.0252040759408882 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441808,1545.325985576319,1710.8868039225827,0.9032309922744864 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441813,1854.7364874487128,1710.8868039225827,1.0840790186681686 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441804,183.24441454230848,158.21676846284709,1.1581857999162615 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441792,110.40733463300415,158.21676846284709,0.6978232187755138 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441790,84.24773467417408,158.21676846284709,0.532482969363373 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441811,244.13694348616292,158.21676846284709,1.543053532555823 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441808,169.04741497858578,158.21676846284709,1.0684544793890287 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441804,868.3743299327565,1068.4447009417866,0.8127461619373685 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441792,1292.0059152209014,1068.4447009417866,1.209239854979912 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441790,1017.0065532704228,1068.4447009417866,0.9518569864907156 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441811,1406.012622138119,1068.4447009417866,1.3159432780178342 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441808,967.4848582560452,1068.4447009417866,0.9055076574419343 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441813,859.7839268324741,1068.4447009417866,0.8047060611322352 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441804,104.36009201878024,101.193417409009,1.0312932865679592 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441792,99.72085589166039,101.193417409009,0.9854480503272587 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441790,93.31653357627994,101.193417409009,0.9221601163948061 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441811,103.19354623941776,101.193417409009,1.019765404525519 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441808,105.37605931890668,101.193417409009,1.0413331421844572 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441804,8552.808966852097,8195.704907369402,1.0435720982537566 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441792,9298.878703355713,8195.704907369402,1.1346038941683174 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441790,8255.89822538413,8195.704907369402,1.0073444955247965 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441811,8007.07351339792,8195.704907369402,0.9769841159359132 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441808,6874.987288682486,8195.704907369402,0.8388524680165882 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441813,8184.582746544062,8195.704907369402,0.9986429281006275 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441804,3.527539325996642,54.484574340672744,0.064743817285608 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441792,112.80377104425587,54.484574340672744,2.070379963674376 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441790,38.441869431587214,54.484574340672744,0.7055551024630168 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441811,57.07316905800331,54.484574340672744,1.0475105981583888 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441808,60.5765228435207,54.484574340672744,1.1118105184186107 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441804,169.69401051965193,181.8259570369428,0.9332771474711614 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441792,157.72411929028576,181.8259570369428,0.8674455609120753 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441790,241.339727403574,181.8259570369428,1.327311739954375 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441811,83.64753100432178,181.8259570369428,0.46004174743502957 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441808,323.652757778818,181.8259570369428,1.7800140477910933 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441813,114.89759622500542,181.8259570369428,0.6319097564362656 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441804,612.0057583645283,598.5025834222519,1.0225615984229592 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441792,654.5556844161819,598.5025834222519,1.0936555706633997 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441790,511.49036965102187,598.5025834222519,0.8546168117208582 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441811,501.6708484270581,598.5025834222519,0.8382099966193837 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441808,712.7902562524694,598.5025834222519,1.1909560225733995 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441804,14972.234140973978,15066.853658787537,0.9937200214486471 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441792,16691.692743497224,15066.853658787537,1.1078419636578882 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441790,15923.941607140465,15066.853658787537,1.0568856622466127 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441811,16351.920207899242,15066.853658787537,1.0852909690512729 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441808,12150.413117506829,15066.853658787537,0.8064333398778494 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441813,14310.920135707487,15066.853658787537,0.9498280437177299 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441804,65.55813436159181,62.8704966822211,1.0427487903102686 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441792,59.90279374073866,62.8704966822211,0.9527965723496238 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441790,59.75889441403838,62.8704966822211,0.95050775113309 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441811,62.40339718877016,62.8704966822211,0.9925704500823033 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441808,66.7292637059665,62.8704966822211,1.0613764361247142 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441804,99.5854445559406,100.49015468400951,0.9909970272121307 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441792,98.68224490860406,100.49015468400951,0.9820090855557899 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441790,102.78018077768094,100.49015468400951,1.022788561733957 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441811,104.65968932565526,100.49015468400951,1.0414919715742983 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441808,95.26418288142956,100.49015468400951,0.947995186005903 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441813,101.96918565474664,100.49015468400951,1.0147181679179211 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441804,120.832627558624,109.95671552102958,1.0989108485649006 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441792,95.74094928432197,109.95671552102958,0.8707148884054399 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441790,97.59866927196576,109.95671552102958,0.8876099000365257 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441811,117.15273151678048,109.95671552102958,1.0654440791692676 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441808,118.45859997345566,109.95671552102958,1.0773202838238658 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441804,243.95605274215788,243.54938966397899,1.0016697355667363 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441792,240.62427444746083,243.54938966397899,0.9879896425913697 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441790,247.0038512641296,243.54938966397899,1.0141838236791176 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441811,245.3372489541229,243.54938966397899,1.0073408489859514 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441808,233.61998758202228,243.54938966397899,0.9592304374252133 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441813,250.7549229939804,243.54938966397899,1.0295855117516113 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441804,81.17936942014636,49.66723175069083,1.6344653518769388 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441792,24.576871493266538,49.66723175069083,0.4948307088390263 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441790,34.70825321906942,49.66723175069083,0.6988159395170369 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441811,76.77680404570756,49.66723175069083,1.5458241045342669 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441808,31.09486057526427,49.66723175069083,0.6260638952327309 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441804,318.75467809503067,318.9289567276793,0.99945355030024 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441792,443.2194012275004,318.9289567276793,1.389712009141734 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441790,315.7967083048582,318.9289567276793,0.9901788521965549 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441811,217.64150519917536,318.9289567276793,0.6824137495455164 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441808,302.4055463605655,318.9289567276793,0.9481909371395759 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441813,315.7559011789456,318.9289567276793,0.9900509016763784 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441804,51.68171957479672,52.85511393128503,0.9777997951529572 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441792,43.907397743917514,52.85511393128503,0.8307123848224013 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441790,46.78061026801564,52.85511393128503,0.8850725462219866 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441811,54.56059176139333,52.85511393128503,1.032267035358689 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441808,67.34525030830196,52.85511393128503,1.2741482384439662 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441804,132.65912059841028,145.91831693350866,0.9091327489670795 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441792,134.31083239422887,145.91831693350866,0.9204521763736554 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441790,145.13324549086403,145.91831693350866,0.9946197882545317 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441811,138.47962441668827,145.91831693350866,0.9490215301742411 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441808,170.04106028301254,145.91831693350866,1.165316759790315 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441813,154.88601841784805,145.91831693350866,1.0614569964401779 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441804,399.1525982208073,261.347965154705,1.5272841247664923 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441792,110.57566293627232,261.347965154705,0.4230974703431 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441790,97.29054561756855,261.347965154705,0.3722644083338372 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441811,418.28310758427864,261.347965154705,1.6004835061052642 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441808,281.43791141459815,261.347965154705,1.0768704904513067 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441804,8136.262874743144,7540.877985370558,1.078954319447635 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441792,6583.1400070239315,7540.877985370558,0.8729938370300308 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441790,8816.115949911491,7540.877985370558,1.1691100117274034 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441811,7944.33222973816,7540.877985370558,1.0535022904694002 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441808,6171.3505797917105,7540.877985370558,0.8183862133513159 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441813,7594.066271014911,7540.877985370558,1.0070533279742144 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441804,5953.346604618188,5107.556668860965,1.165595800613181 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441792,3819.411716433342,5107.556668860965,0.7477962485896623 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441790,4476.916475167717,5107.556668860965,0.8765280084824029 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441811,6483.625994140124,5107.556668860965,1.269418317699456 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441808,4804.482553945456,5107.556668860965,0.9406616246152981 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441804,110353.57746983696,180330.65339424144,0.6119512983107781 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441792,377661.4625872657,180330.65339424144,2.094272135539912 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441790,142368.53975446057,180330.65339424144,0.789486075022489 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441811,207603.6739176029,180330.65339424144,1.1512389602656006 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441808,130174.60403264772,180330.65339424144,0.7218662029026099 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441813,113822.0626036348,180330.65339424144,0.6311853279586105 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441804,174.2597031064356,98.01831453553807,1.777827989923812 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441792,56.218625116891104,98.01831453553807,0.5735522527936161 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441790,46.909776335869786,98.01831453553807,0.47858174830033334 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441811,95.5846037520756,98.01831453553807,0.975170856640469 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441808,117.11886436641824,98.01831453553807,1.1948671523417693 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441804,1050.4033606469563,1812.4793707702274,0.57953948474491 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441792,3340.647781580274,1812.4793707702274,1.8431369953527468 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441790,1766.6524339672865,1812.4793707702274,0.9747158850235815 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441811,923.5097735537756,1812.4793707702274,0.5095284329560799 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441808,1104.5640257319317,1812.4793707702274,0.6094215711059588 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441813,2689.0988491411404,1812.4793707702274,1.4836576308167229 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441804,684.0369846989539,434.5650550234931,1.5740726889831813 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441792,153.1137301711669,434.5650550234931,0.3523378799128002 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441790,119.63303927250396,434.5650550234931,0.27529374000409784 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441811,809.9670481064392,434.5650550234931,1.8638568351121823 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441808,406.07447286840136,434.5650550234931,0.9344388559877381 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441804,13024.368798395775,9833.502392298877,1.324489309993541 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441792,12849.110126542566,9833.502392298877,1.3066667006259507 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441790,7874.93911325411,9833.502392298877,0.800827497578216 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441811,9272.427805515652,9833.502392298877,0.9429425484024256 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441808,7883.868186120314,9833.502392298877,0.8017355232754688 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441813,8096.300323964841,9833.502392298877,0.8233384201243975 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441804,51.31604013982633,42.4088060383901,1.2100326543825133 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441792,44.281918567151905,42.4088060383901,1.0441680090466634 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441790,40.750703239256104,42.4088060383901,0.960901922170763 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441811,35.44448120155348,42.4088060383901,0.8357811622771875 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441808,40.25088704416267,42.4088060383901,0.9491162521228729 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441804,370.4855099445133,385.8715169071063,0.9601266061669512 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441792,404.3801262942872,385.8715169071063,1.0479657310172408 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441790,385.0585229318969,385.8715169071063,0.9978930966925835 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441811,441.2864270997008,385.8715169071063,1.1436097451212885 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441808,342.83495115325064,385.8715169071063,0.88846918243977 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441813,371.1835640189888,385.8715169071063,0.9619356385621657 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441804,981.8249089055272,1002.6445024002205,0.9792353187546997 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441792,1095.025004347932,1002.6445024002205,1.092136845837745 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441790,468.90415527755215,1002.6445024002205,0.4676674076953968 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441811,1367.9993965454391,1002.6445024002205,1.3643912605819901 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441808,1099.4690469246518,1002.6445024002205,1.0965691671301683 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441804,9236.179099863966,6245.085755978491,1.4789515245682685 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441792,6286.987338628085,6245.085755978491,1.0067095287858108 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441790,4592.574142335108,6245.085755978491,0.7353900845858818 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441811,4758.879392542876,6245.085755978491,0.7620198630558672 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441808,4973.675141946821,6245.085755978491,0.7964142265277088 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441813,7622.219420554086,6245.085755978491,1.220514772476463 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441804,318.4434239503949,289.8012081128336,1.0988340111626087 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441792,245.07689150957327,289.8012081128336,0.84567242871587 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441790,395.5998928474226,289.8012081128336,1.3650733046405952 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441811,206.2607929128464,289.8012081128336,0.7117319981376307 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441808,283.62503934393084,289.8012081128336,0.9786882573432956 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441804,10771.717821450116,19122.271903916942,0.5633074289276094 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441792,32245.711157481473,19122.271903916942,1.6862907984733952 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441790,19714.61374949541,19122.271903916942,1.0309765413102998 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441811,17138.39531676401,19122.271903916942,0.8962530918333735 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441808,15587.079719724028,19122.271903916942,0.8151269785328815 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441813,19276.113658586622,19122.271903916942,1.0080451609224408 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441804,92.5953252350946,111.01681566749893,0.8340657645272619 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441792,112.91476918331692,111.01681566749893,1.017096090393211 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441790,104.45020111300276,111.01681566749893,0.9408502710601652 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441811,117.21820078781884,111.01681566749893,1.055859872065628 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441808,127.9055820182615,111.01681566749893,1.1521280019537337 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441804,522.0190498909325,1048.3386659324408,0.49794886600564775 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441792,1774.6160822099623,1048.3386659324408,1.6927889239223441 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441790,1078.239065254478,1048.3386659324408,1.0285216984679681 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441811,901.0743663236073,1048.3386659324408,0.8595260249436188 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441808,957.838389079936,1048.3386659324408,0.9136726710618751 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441813,1056.245042835729,1048.3386659324408,1.007541815598546 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441804,7195.286312472285,5453.602601951663,1.3193638843243423 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441792,2478.3192354885923,5453.602601951663,0.45443707882229706 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441790,3108.617647397573,5453.602601951663,0.5700117654860114 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441811,7761.418574452769,5453.602601951663,1.4231727430369083 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441808,6724.371239947096,5453.602601951663,1.233014528330441 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441804,57431.494908858454,64173.361133824874,0.8949429154738028 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441792,54885.28202759948,64173.361133824874,0.8552658152522764 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441790,82519.30443515621,64173.361133824874,1.2858809789169894 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441811,102690.94964438165,64173.361133824874,1.600211486978741 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441808,50233.11615798094,64173.361133824874,0.7827720921961149 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441813,37280.0196289725,64173.361133824874,0.5809267111820753 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441804,58.08801997775296,44.60879663763593,1.3021651413197897 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441792,45.586439076541026,44.60879663763593,1.0219159114926732 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441790,37.54199461922188,44.60879663763593,0.8415827695192326 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441811,32.046873841276806,44.60879663763593,0.718398079679182 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441808,49.780655673386995,44.60879663763593,1.1159380979891222 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441804,138.25001298058004,136.29080299882398,1.014375217833099 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441792,133.16134084585005,136.29080299882398,0.9770383467987863 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441790,140.88025443778497,136.29080299882398,1.033673962864542 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441811,139.78381076995757,136.29080299882398,1.0256290791034794 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441808,128.1956179588441,136.29080299882398,0.9406035854081092 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441813,137.47378099992707,136.29080299882398,1.0086798079919839 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441804,53.284843159388565,82.77341642135346,0.6437434319268042 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441792,120.51251433078507,82.77341642135346,1.455932587309467 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441790,65.93783258956822,82.77341642135346,0.7966063917661119 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441811,59.539666487054234,82.77341642135346,0.7193090373843081 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441808,114.59222553997122,82.77341642135346,1.384408551613309 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441804,1579.8384113167526,2141.365658987758,0.7377714332374024 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441792,3254.1526843596303,2141.365658987758,1.5196623102183755 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441790,1959.7749272102892,2141.365658987758,0.9151986345651456 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441811,2280.397171290907,2141.365658987758,1.0649265629714406 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441808,1445.6812366241943,2141.365658987758,0.6751211454972059 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441813,2328.3495231247725,2141.365658987758,1.0873199135104294 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441804,381.6876677210229,285.0677067828484,1.3389368863579316 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441792,362.5471940717664,285.0677067828484,1.2717932808430608 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441790,384.7790174618413,285.0677067828484,1.349781151307147 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441811,0.19443278699097383,285.0677067828484,6.820582702448435e-4 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441808,296.13022187262055,285.0677067828484,1.0388066232216162 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441804,792759.3276474783,724296.655045942,1.0945229722166723 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441792,709327.3446320647,724296.655045942,0.9793326252308484 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441790,543102.8138389656,724296.655045942,0.7498347673640943 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441811,448005.5631688685,724296.655045942,0.6185387714381362 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441808,937704.072763968,724296.655045942,1.2946408991830696 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441813,914880.808224307,724296.655045942,1.263129964567179 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441804,153.9022899152112,126.94877083842833,1.2123180783773595 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441792,187.76322075201085,126.94877083842833,1.4790471740051976 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441790,179.67324933689983,126.94877083842833,1.4153209058288212 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441811,63.96836419967811,126.94877083842833,0.5038911663122178 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441808,49.436729988341675,126.94877083842833,0.38942267547640413 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441804,39731.239159025696,94593.87687362579,0.4200191436503367 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441792,123698.678340836,94593.87687362579,1.3076816642803766 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441790,83567.90551924804,94593.87687362579,0.883438847007951 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441811,54067.68938626444,94593.87687362579,0.571577053116208 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441808,119889.94411890605,94593.87687362579,1.2674175970086832 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441813,146607.8047174745,94593.87687362579,1.5498656949364444 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441804,19.120532323206888,34.2642969985689,0.5580307783348214 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441792,142.2049442114955,34.2642969985689,4.150236738183623 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441790,5.710293113270017,34.2642969985689,0.1666543199035578 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441811,1.010536237714047,34.2642969985689,0.029492396641210922 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441808,3.2751791071580567,34.2642969985689,0.09558576693678698 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441804,45.54475161032173,74.66086218948179,0.610021774122213 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441792,17.179057718995086,74.66086218948179,0.23009455309257423 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441790,86.35371239250625,74.66086218948179,1.1566128472150399 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441811,78.49778906779693,74.66086218948179,1.0513914086416174 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441808,98.7979825616286,74.66086218948179,1.3232901370853343 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441813,121.59187978564212,74.66086218948179,1.628589279843221 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441804,379.2185371986456,347.6986105145094,1.0906530130721384 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441792,396.5669930722006,347.6986105145094,1.140548110000721 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441790,418.8057819624752,347.6986105145094,1.204508069050792 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441811,120.26634398343955,347.6986105145094,0.3458925067473655 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441808,423.63539635578616,347.6986105145094,1.2183983011289827 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441804,2246.669005086905,2521.321340016667,0.8910680956962248 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441792,2374.8948320672857,2521.321340016667,0.9419246941572258 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441790,2637.075477259789,2521.321340016667,1.0459101088805907 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441811,2721.3434884976105,2521.321340016667,1.079332271260442 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441808,2548.6548590705406,2521.321340016667,1.0108409501875286 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441813,2599.290378117872,2521.321340016667,1.0309238798179885 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441804,80.7873704587917,79.44971561377609,1.01683649632578 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441792,63.37849397656673,79.44971561377609,0.7977183239354136 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441790,75.39601264964546,79.44971561377609,0.9489777536292685 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441811,134.20023665798388,79.44971561377609,1.6891216742721025 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441808,43.48646432589267,79.44971561377609,0.547345751837435 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441804,31.619594981548076,42.37178439720435,0.7462417604398626 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441792,33.83205007378549,42.37178439720435,0.7984570523779426 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441790,37.88471124264895,42.37178439720435,0.8941023320497341 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441811,13.947212476888916,42.37178439720435,0.3291627358938686 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441808,13.134707703467404,42.37178439720435,0.3099871268186199 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441813,123.81242990488728,42.37178439720435,2.922048992419972 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441804,2436.3167267305525,1321.2949146990686,1.8438856455339008 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441792,387.6931621692539,1321.2949146990686,0.2934190980804259 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441790,386.3456764605969,1321.2949146990686,0.29239927601521803 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441811,2169.171426815552,1321.2949146990686,1.6417011847121135 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441808,1226.9475813193878,1321.2949146990686,0.9285947956583418 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441804,19835.41703266022,23354.026662177774,0.8493360618100176 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441792,29428.894553476533,23354.026662177774,1.2601207911240895 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441790,23737.553194572967,23354.026662177774,1.016422287168847 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441811,22509.734540184625,23354.026662177774,0.9638481134664245 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441808,26420.88472910813,23354.026662177774,1.13132031196561 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441813,18191.675923064173,23354.026662177774,0.778952434465012 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441804,11957.53344672836,13473.54115415771,0.8874826083147758 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441792,10446.697204544413,13473.54115415771,0.7753490403909692 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441790,14210.175693865782,13473.54115415771,1.0546726752291664 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441811,8546.528473658966,13473.54115415771,0.6343193950182613 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441808,22206.77095199103,13473.54115415771,1.6481762810468272 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441804,72063.45449331448,49612.48263442616,1.4525266760851343 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441792,50792.342290911285,49612.48263442616,1.023781508076889 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441790,32393.680608445593,49612.48263442616,0.6529340780452615 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441811,26982.86981527294,49612.48263442616,0.5438725978318508 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441808,39455.74529265617,49612.48263442616,0.7952785911438703 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441813,75986.80330595649,49612.48263442616,1.5316065488169939 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441797,86.38725136535811,73.06854961986588,1.1822768046551062 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441802,296.9729206843674,73.06854961986588,4.064305672267325 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441791,67.15528091250818,73.06854961986588,0.9190723130796892 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441803,46.94507554736545,73.06854961986588,0.6424799149783865 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441807,39.11149419361536,73.06854961986588,0.5352712541454596 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441797,3090.667308582087,990.9231863649335,3.1189776877860518 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441802,2211.267518247845,990.9231863649335,2.231522633312859 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441791,18.77002471975493,990.9231863649335,0.018941957336380637 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441803,14787.087898919412,990.9231863649335,14.92253698610467 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441807,1478.7724658205198,990.9231863649335,1.4923179578078043 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441796,6.035028040657453,990.9231863649335,0.006090308637136779 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441797,55.80130208431012,50.719124328797626,1.1002023955020632 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441802,48.81024418021904,50.719124328797626,0.962363700599327 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441791,40.96533050560953,50.719124328797626,0.807690019252757 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441803,116.87279113985376,50.719124328797626,2.3043140568082516 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441807,41.767518926731334,50.719124328797626,0.8235063100846224 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441797,328.7348293844026,319.2477137201226,1.0297170982173334 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441802,320.4394503573762,319.2477137201226,1.0037329527700185 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441791,313.6366222786502,319.2477137201226,0.9824240199684201 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441803,362.1496987084632,319.2477137201226,1.1343846271862477 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441807,331.03560466345124,319.2477137201226,1.0369239635453202 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441796,331.80506230463914,319.2477137201226,1.0393341848503426 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441797,223.42483936129696,44.58166891160943,5.011585362680654 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441802,34.87459801264007,44.58166891160943,0.7822631782086211 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441791,29.349297802208817,44.58166891160943,0.6583265839688209 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441803,9.331526866134077,44.58166891160943,0.2093130897507534 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441807,92.62160305058951,44.58166891160943,2.077571461809275 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441797,4843.017502213456,1543.2839395802719,3.13812473389091 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441802,3707.247149888469,1543.2839395802719,2.402180865626536 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441791,4201.033246163962,1543.2839395802719,2.7221389003157257 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441803,3683.4720292059906,1543.2839395802719,2.386775326779975 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441807,4130.723383788819,1543.2839395802719,2.6765802959838063 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441796,3162.8887829948126,1543.2839395802719,2.0494535722668283 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441797,36.137670384411024,31.276034215973343,1.155442858735419 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441802,67.67868495919129,31.276034215973343,2.163915171976194 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441791,54.64329082370257,31.276034215973343,1.747129781428461 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441803,13.679061089484872,31.276034215973343,0.4373655878179939 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441807,47.02187570462818,31.276034215973343,1.5034475080799437 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441797,144.4727832830917,130.468422036268,1.1073390865640325 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441802,38.20903433551938,130.468422036268,0.29286040054119694 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441791,62.28256732951133,130.468422036268,0.4773765663556338 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441803,245.00845165519223,130.468422036268,1.877913811106599 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441807,25.258853556198865,130.468422036268,0.1936012803862787 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441796,156.2960363138835,130.468422036268,1.1979606549578399 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441797,84.30718270993552,95.42663227533711,0.8834764541064559 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441802,154.211606116562,95.42663227533711,1.616022722793056 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441791,123.27086284434844,95.42663227533711,1.2917867885002123 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441803,128.0434931797351,95.42663227533711,1.3418003981350577 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441807,97.97919284788438,95.42663227533711,1.026748932784113 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441797,571.3309408648989,569.3868516791151,1.003414355600328 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441802,558.6610557684186,569.3868516791151,0.9811625507700673 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441791,583.378121192396,569.3868516791151,1.0245725194953497 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441803,593.4745801028605,569.3868516791151,1.0423046797668596 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441807,555.245272587799,569.3868516791151,0.9751634955222223 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441796,556.9229890390836,569.3868516791151,0.9781100272981792 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441797,106095.48143909372,5328.634617598269,19.910444054224392 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441802,43261.972962814405,5328.634617598269,8.11877264392234 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441791,32600.413460220458,5328.634617598269,6.117967509454452 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441803,331.6788539443591,5328.634617598269,0.062244623200277516 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441807,8630.263450591041,5328.634617598269,1.6196012806148994 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441797,875521.2236130465,656386.6079991342,1.333849918544044 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441802,805464.9421411564,656386.6079991342,1.2271197070830837 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441791,826724.5300707578,656386.6079991342,1.2595085274376108 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441803,813239.0475020146,656386.6079991342,1.2389634974135353 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441807,1130040.996837764,656386.6079991342,1.721608855309331 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441796,672659.9290045891,656386.6079991342,1.0247922806576766 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441797,104008.92765735544,5223.837669019135,19.91044405422439 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441802,42411.1503635236,5223.837669019135,8.118772643922341 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441791,31959.269133723355,5223.837669019135,6.117967509454453 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441803,325.1558073675121,5223.837669019135,0.06224462320027752 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441807,8460.534178467744,5223.837669019135,1.6196012806148996 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441797,875521.2236130465,656386.6079991342,1.333849918544044 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441802,805464.9421411564,656386.6079991342,1.2271197070830837 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441791,826724.5300707578,656386.6079991342,1.2595085274376108 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441803,813188.1434403278,656386.6079991342,1.238885945463105 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441807,1130040.996837764,656386.6079991342,1.721608855309331 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441796,672659.9290045891,656386.6079991342,1.0247922806576766 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441797,52.25325720482072,50.79723336807032,1.0286634475976326 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441802,52.00252878455197,50.79723336807032,1.0237275799598815 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441791,48.01366029786801,50.79723336807032,0.9452022701702493 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441803,19.447463013971134,50.79723336807032,0.3828449252945978 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441807,50.727494125034866,50.79723336807032,0.9986271054856446 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441797,46.227442221866696,124.85055234194422,0.37026221634372647 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441802,62.02169359924022,124.85055234194422,0.4967674746794348 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441791,69.13783870400184,124.85055234194422,0.553764780428405 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441803,43.42756648076844,124.85055234194422,0.34783639852731923 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441807,216.69934374655904,124.85055234194422,1.7356698843674856 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441796,102.22538004048288,124.85055234194422,0.8187819606957374 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441797,296.28968064351665,149.81706398084205,1.9776764593478142 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441802,353.7678403871529,149.81706398084205,2.3613320871939605 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441791,186.1023718810926,149.81706398084205,1.2421974302265766 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441803,184.3730215008512,149.81706398084205,1.2306543500574008 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441807,191.32117480537693,149.81706398084205,1.2770319329568642 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441797,3490.691405045201,2791.14294318225,1.250631542741906 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441802,3206.309372065524,2791.14294318225,1.1487442375165253 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441791,3726.054311687696,2791.14294318225,1.3349564631897823 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441803,3755.5556788790536,2791.14294318225,1.345526099998753 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441807,2950.7551289022585,2791.14294318225,1.0571852423788912 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441796,3191.9894973870923,2791.14294318225,1.1436137676803566 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441797,750.5290655705924,222.01180748199775,3.3805817541098593 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441802,480.4646199778105,222.01180748199775,2.1641399411460127 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441791,729.7453506926178,222.01180748199775,3.2869663959282462 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441803,622.1419046927903,222.01180748199775,2.802291967030798 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441807,965.7808170913072,222.01180748199775,4.350132671072548 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441797,19324.054520308073,4330.453784028004,4.462362487640651 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441802,18162.31084467225,4330.453784028004,4.194089522825583 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441791,23480.886659920063,4330.453784028004,5.422269311942441 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441803,15918.2891492685,4330.453784028004,3.6758940155370934 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441807,15014.809022983376,4330.453784028004,3.4672599620765934 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441796,16906.899361258587,4330.453784028004,3.90418653666649 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441797,513.0124702330126,100.4664893584531,5.106304335992491 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441802,441.32167844827376,100.4664893584531,4.392725188930289 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441791,181.13410077076168,100.4664893584531,1.8029305286511568 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441803,316.17816315757574,100.4664893584531,3.147100741516783 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441807,72.20014428793294,100.4664893584531,0.718649021668618 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441797,303.45489412551854,219.8603821991507,1.380216349531529 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441802,426.9140965496897,219.8603821991507,1.941750907005104 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441791,358.1341977863145,219.8603821991507,1.6289164705531831 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441803,500.2668629575786,219.8603821991507,2.275384305046983 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441807,90.92497268645944,219.8603821991507,0.4135577850678851 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441796,225.9680499164938,219.8603821991507,1.027779755753407 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441797,34.70379930609792,115.26780159034894,0.3010710608451786 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441802,22.700221905328704,115.26780159034894,0.1969346304183295 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441791,19.578072200916093,115.26780159034894,0.1698485781007149 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441803,5.297717733607774,115.26780159034894,0.04596008304587409 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441807,61.18885667718039,115.26780159034894,0.5308408404858792 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441797,805.0279608116714,1760.6737631139824,0.4572272147611684 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441802,1265.0079569410032,1760.6737631139824,0.7184794727125772 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441791,866.9209152489798,1760.6737631139824,0.49238020887851275 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441803,1284.9377771258366,1760.6737631139824,0.7297989008782955 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441807,868.7874973804097,1760.6737631139824,0.4934403610603279 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441796,650.7443714444639,1760.6737631139824,0.36959963002659685 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441797,4045.8855453635897,518.6000624505415,7.80155236820752 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441802,2994.955765080098,518.6000624505415,5.775077910573381 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441791,2357.8794872372346,518.6000624505415,4.546623994018712 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441803,2553.7035841507163,518.6000624505415,4.924225369514415 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441807,5171.772092782581,518.6000624505415,9.972563574991488 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441797,7610.048712816869,841.89306662726494,9.039210577304944 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441802,37561.78093493465,841.89306662726494,44.61585731476815 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441791,8849.728046529835,841.89306662726494,10.511700829159953 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441803,8769.930704031827,841.89306662726494,10.416917601145393 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441807,2180.206559047714,841.89306662726494,2.589647837084477 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441796,4227.135150728352,841.89306662726494,5.020988197067371 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441797,1048.6521174549018,246.94010350613598,4.246584910939121 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441802,1279.7308817768717,246.94010350613598,5.182353386942161 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441791,449.49550491473684,246.94010350613598,1.8202612638961972 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441803,708.2202037778204,246.94010350613598,2.8679837487806936 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441807,528.9401913017925,246.94010350613598,2.1419776852432126 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441797,3568.9042117958784,6405.278640912654,0.557181726490413 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441802,6466.8305695367535,6405.278640912654,1.0096095629987034 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441791,3141.0478828281416,6405.278640912654,0.49038426880685876 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441803,4597.775576221991,6405.278640912654,0.7178103926431028 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441807,2422.2793668262193,6405.278640912654,0.3781692417491898 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441796,2824.848866970863,6405.278640912654,0.4410188885347797 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441797,93.6334766233467,184.84349394551683,0.506555435762026 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441802,882.046729905152,184.84349394551683,4.771857050944611 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441791,107.61843904104836,184.84349394551683,0.5822138325992108 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441803,53.74622810610623,184.84349394551683,0.2907661338729514 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441807,94.70280231790892,184.84349394551683,0.5123404686660102 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441797,18198.39204385411,66689.05961878091,0.2728842204086065 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441802,23675.98111027716,66689.05961878091,0.35502046730929687 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441791,20300.718849326084,66689.05961878091,0.304408533654132 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441803,28278.981482842923,66689.05961878091,0.4240422888626101 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441807,23308.877678069304,66689.05961878091,0.34951576482426633 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441796,22450.73539789719,66689.05961878091,0.33664795284614624 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441797,763.9732028573285,426.591426110135,1.790878006676323 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441802,1359.370318935914,426.591426110135,3.186586123709292 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441791,629.1754007398664,426.591426110135,1.4748899350298461 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441803,537.61744046958745,426.591426110135,1.2602631172685321 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441807,974.0633066642026,426.591426110135,2.283363534860929 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441797,267654.29739250743,6086.038398766024,43.978410889878006 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441802,21636.27487441227,6086.038398766024,3.555067098952109 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441791,145659.4152280414,6086.038398766024,23.93337105095732 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441803,646047.2395764196,6086.038398766024,106.1523436505772 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441807,371572.2209456142,6086.038398766024,61.053216657481556 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441796,251830.9754605316,6086.038398766024,41.378472983606486 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441797,512.6370147245732,118.38689307733607,4.330183869169485 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441802,359.33202336355805,118.38689307733607,3.035234847567331 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441791,307.69914385609457,118.38689307733607,2.5990980577139613 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441803,412.6003291839858,118.38689307733607,3.4851858889011913 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441807,757.7112022175687,118.38689307733607,6.400296371681914 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441797,1419.12130574649,43.003791743375764,32.9999111291178 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441802,2679.4522570062686,43.003791743375764,62.30734891927308 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441791,763.441153787737,43.003791743375764,17.75287998657319 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441803,1847.256277057914,43.003791743375764,42.95566047015988 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441807,147.79924401139283,43.003791743375764,3.4368886560836716 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441796,446.7408827999092,43.003791743375764,10.388406805284198 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441797,65.11517912444901,56.77751951238643,1.146847901839806 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441802,77.92882202737611,56.77751951238643,1.372529527472143 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441791,22.87168295641822,56.77751951238643,0.402829907907981 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441803,224.50387445385152,56.77751951238643,3.9540979666234692 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441807,39.022871503332446,56.77751951238643,0.6872944052235203 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441797,195.18329666457865,232.93832449773902,0.8379183506425245 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441802,129.98558363218677,232.93832449773902,0.5580257517197367 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441791,195.4240842477699,232.93832449773902,0.8389520473676575 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441803,247.65265104693245,232.93832449773902,1.0631683368587819 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441807,438.16115536819177,232.93832449773902,1.8810178888036293 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441796,231.76732636022896,232.93832449773902,0.994972926245456 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441797,55.9266563872575,55.88566907011774,1.0007334137323889 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441802,40.75732520224075,55.88566907011774,0.7292983314041387 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441791,112.55351493674272,55.88566907011774,2.013996017396264 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441803,18.466325882937507,55.88566907011774,0.3304304339591689 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441807,98.38727196668584,55.88566907011774,1.7605098695918424 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441797,797.3586693977884,226.42114305345407,3.521573377136189 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441802,1222.5769264995756,226.42114305345407,5.399570508355514 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441791,1011.9126633478636,226.42114305345407,4.4691615354532885 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441803,627.8652186442188,226.42114305345407,2.7729973012988047 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441807,4914.651491899347,226.42114305345407,21.705797548858254 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441796,624.2972248097414,226.42114305345407,2.7572390828464095 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441797,209.5862717399116,212.71806341276286,0.9852772650210986 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441802,356.17235795970566,212.71806341276286,1.6743869902039343 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441791,502.8750091640712,212.71806341276286,2.364044694165353 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441803,231.23240528270276,212.71806341276286,1.0870369989877835 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441807,712.3651881371787,212.71806341276286,3.348870221495433 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441797,10105.18223677906,10996.969545575432,0.9189060854355846 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441802,20978.108488164347,10996.969545575432,1.9076263147973134 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441791,12486.981537758924,10996.969545575432,1.135492963403085 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441803,10648.983777213873,10996.969545575432,0.9683562124165771 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441807,8896.928635964916,10996.969545575432,0.8090345798533692 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441796,11226.549747772227,10996.969545575432,1.0208766789109793 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441797,122.69567929827409,147.8550055811589,0.8298378456380725 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441802,149.78664777104146,147.8550055811589,1.0130644355413605 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441791,53.98484503158192,147.8550055811589,0.36512017174791667 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441803,1889.3475846226147,147.8550055811589,12.778380936082243 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441807,30.17340966455704,147.8550055811589,0.20407431960762798 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441797,212.9948749864744,92.19915296117537,2.310160865319072 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441802,302.02477590749595,92.19915296117537,3.2757868831471493 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441791,317.34785676904,92.19915296117537,3.4419823455718044 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441803,340.4617377854029,92.19915296117537,3.692677501373247 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441807,420.1889684863319,92.19915296117537,4.557405952127038 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441796,236.1769222541795,92.19915296117537,2.561595358187645 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441797,15030.920368405246,1229.7970051816276,12.222277583271024 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441802,27909.653975429163,1229.7970051816276,22.694521012683076 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441791,5707.382932625418,1229.7970051816276,4.640914645732529 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441803,12785.51602111496,1229.7970051816276,10.39644426457737 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441807,9265.300942251351,1229.7970051816276,7.534008379604867 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441797,237944.4253672356,50083.06853493704,4.750995342892177 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441802,160444.33918509673,50083.06853493704,3.2035644755507278 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441791,248349.8886475352,50083.06853493704,4.958759435322754 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441803,234646.0458369973,50083.06853493704,4.685137167130893 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441807,124138.15998379784,50083.06853493704,2.478645251083234 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441796,153009.19524653346,50083.06853493704,3.0551082376232004 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441797,1122.0798547800343,35.678906774941794,31.449390023578292 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441802,39.108025164805085,35.678906774941794,1.0961105229903414 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441791,70.61573970035849,35.678906774941794,1.9792013288353814 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441803,109.61886208488328,35.678906774941794,3.072371661394945 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441807,15.88460081784876,35.678906774941794,0.44520985236590604 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441797,110.20356463262004,67.70693010562654,1.6276556101524084 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441802,50.69269189097978,67.70693010562654,0.748707581511913 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441791,11.289846682616622,67.70693010562654,0.16674580674391587 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441803,156.43224642809844,67.70693010562654,2.310431830006995 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441807,352.89993711779977,67.70693010562654,5.212168629817604 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441796,5.871068303876143,67.70693010562654,0.08671295973273273 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441797,51.59976743263616,64.01321127549492,0.8060799701262482 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441802,37.33598718677046,64.01321127549492,0.5832544008155884 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441791,50.914279110119644,64.01321127549492,0.795371425610861 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441803,16.656676237582793,64.01321127549492,0.26020685270571925 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441807,47.681568434409435,64.01321127549492,0.7448707459652559 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441797,600.9005704735414,1060.427767412219,0.5666586531772266 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441802,527.9759843760048,1060.427767412219,0.497889625867148 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441791,674.4416294683828,1060.427767412219,0.6360090240886797 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441803,626.3369096993131,1060.427767412219,0.5906455196168375 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441807,1014.3074158838676,1060.427767412219,0.9565077858712624 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441796,437.9418290850911,1060.427767412219,0.4129860067261426 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441797,8.099708309379078,57.09593719876665,0.14186137765252488 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441802,34.74196186290444,57.09593719876665,0.6084839581835415 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441791,19.914403583884692,57.09593719876665,0.34878845257513125 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441803,4.7465304204435235,57.09593719876665,0.0831325424069938 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441807,14.95085319808198,57.09593719876665,0.2618549398013023 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441797,28.55879485069506,50.205845180981015,0.5688340620050693 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441802,315.56380165001576,50.205845180981015,6.285399648436905 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441791,60.895045689081634,50.205845180981015,1.2129074905435493 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441803,11.06940024751878,50.205845180981015,0.2204803087691489 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441807,13.418717880415375,50.205845180981015,0.2672740162434046 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441796,44.50881068351905,50.205845180981015,0.8865264696386366 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441797,34606.661242310605,1506.8779059558976,22.96580307238472 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441802,7724.277530738085,1506.8779059558976,5.1260141914670525 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441791,34418.23759793035,1506.8779059558976,22.84076066275384 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441803,35525.27199659606,1506.8779059558976,23.57541500620807 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441807,52209.0508445382,1506.8779059558976,34.6471672576678 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441797,80939.52403482923,16162.128318216166,5.007974348502303 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441802,42878.23388627209,16162.128318216166,2.653006648755813 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441791,37011.718692284405,16162.128318216166,2.290027523823634 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441803,60406.409398404096,16162.128318216166,3.737528140419518 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441807,46570.467180848245,16162.128318216166,2.8814563443577637 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441796,47931.09503985503,16162.128318216166,2.9656425252998635 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441797,125.27215551361222,24.995311385825953,5.0118261613116 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441802,120.76211416388506,24.995311385825953,4.8313906676259855 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441791,40.008378502873306,24.995311385825953,1.6006353305748688 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441803,131.9408998414258,24.995311385825953,5.278625971278969 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441807,67.74793459987573,24.995311385825953,2.7104257096110205 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441797,321.24147552233586,522.7489803443298,0.6145233900040076 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441802,1304.1899945926016,522.7489803443298,2.494868557626921 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441791,1461.393903920137,522.7489803443298,2.79559398271333 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441803,939.5149238085552,522.7489803443298,1.7972582618711292 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441807,558.692140418487,522.7489803443298,1.0687579726133216 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441796,237.18283595272595,522.7489803443298,0.45372223547235974 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441797,3.807844814306266,2.8430683750443606,1.3393433825687897 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441802,5.089497208102285,2.8430683750443606,1.7901423872800364 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441791,3.2229044362381325,2.8430683750443606,1.1336007478848782 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441803,2.9456349720316117,2.8430683750443606,1.0360760219091287 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441807,2.949545733183361,2.8430683750443606,1.0374515643287472 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441797,1018.426519492788,1771.7543971110147,0.5748124690156902 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441802,1615.1013176564068,1771.7543971110147,0.9115830728513822 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441791,1712.106373771659,1771.7543971110147,0.96633392109165 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441803,1637.3957079900108,1771.7543971110147,0.9241663012999509 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441807,1063.3951480895594,1771.7543971110147,0.6001933167619107 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441796,959.7137502890292,1771.7543971110147,0.5416742590586586 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441797,0.47520812004297247,73.62821549612136,0.0064541577823247105 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441802,3.518270332889889,73.62821549612136,0.04778426733804553 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441791,437.5138387621405,73.62821549612136,5.942203485635044 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441803,4.751134396262259,73.62821549612136,0.06452871856594898 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441807,30.728523157820135,73.62821549612136,0.41734711279861014 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441797,968.3227317360156,1923.334023596175,0.5034605117240548 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441802,100.36122145159098,1923.334023596175,0.052180858977339505 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441791,315.8709025471065,1923.334023596175,0.164230912920941 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441803,473.3196549385896,1923.334023596175,0.24609331979350887 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441807,400.3464992546123,1923.334023596175,0.20815235125205137 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441796,208.8435871894199,1923.334023596175,0.10858414847720121 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441797,22.25905318797211,51.40813337414527,0.4329869949949762 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441802,14.653103976519226,51.40813337414527,0.285034740901305 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441791,58.43266263078503,51.40813337414527,1.1366423714612561 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441803,102.55914925906572,51.40813337414527,1.9949985056381343 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441807,20.74949331021947,51.40813337414527,0.4036227722801355 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441797,61.071491890191915,89.1451395839603,0.6850793231713149 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441802,9.864809821055005,89.1451395839603,0.11066009730978041 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441791,8.730259380590363,89.1451395839603,0.09793309451681177 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441803,51.461460845470455,89.1451395839603,0.5772772479311907 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441807,19.08575891306551,89.1451395839603,0.21409758290960793 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441796,32.62968692299035,89.1451395839603,0.3660287826714149 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441797,21500.588636417237,4771.656231796832,4.505896399900732 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441802,14266.083629425695,4771.656231796832,2.9897551157103384 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441791,17942.4241386481,4771.656231796832,3.7602088807415277 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441803,10526.681468522913,4771.656231796832,2.206085467426673 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441807,10119.164951392831,4771.656231796832,2.1206818890182966 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441797,635346.8376465363,209884.98459768714,3.0271190617298576 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441802,483856.05832026375,209884.98459768714,2.305339084869417 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441791,513819.3108517335,209884.98459768714,2.448099428535278 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441803,693473.0720623676,209884.98459768714,3.3040623339093758 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441807,570170.2734008934,209884.98459768714,2.7165843926082194 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441796,436482.98429858807,209884.98459768714,2.0796293986215817 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441797,118.72463565945984,22.903585106474594,5.183670377695485 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441802,42.431640949689395,22.903585106474594,1.852620048452346 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441791,24.016906013215593,22.903585106474594,1.048609023502887 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441803,38.00044609231445,22.903585106474594,1.659148378546734 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441807,24.135591004790353,22.903585106474594,1.0537909629688273 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441797,69.31491846207679,83.56495705722055,0.829473512618619 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441802,20.137923879629433,83.56495705722055,0.24098527168320236 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441791,44.82210826828292,83.56495705722055,0.5363744546364246 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441803,22.382452365780612,83.56495705722055,0.26784495743179015 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441807,44.255001679895635,83.56495705722055,0.529588038316017 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441796,56.82756521560385,83.56495705722055,0.6800406200973877 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441797,2564.89128482401,1829.6496491832456,1.4018483188674815 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441802,2992.3612531120652,1829.6496491832456,1.635483194527353 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441791,1140.6737163676917,1829.6496491832456,0.6234383270463215 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441803,1162.327334305821,1829.6496491832456,0.6352731709180953 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441807,1328.7219731737207,1829.6496491832456,0.7262166140751927 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441797,182920.6602965181,96234.19538703516,1.9007865090038618 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441802,164486.92172359678,96234.19538703516,1.7092356938410767 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441791,235389.97710253455,96234.19538703516,2.446011796075626 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441803,170477.0528744064,96234.19538703516,1.771481043601819 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441807,184384.83423999156,96234.19538703516,1.9160012041294856 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441796,159695.29913103284,96234.19538703516,1.6594444260563461 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441797,119.88654878538082,77.99112650544876,1.537181909752324 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441802,262.40721277435614,77.99112650544876,3.364577799193904 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441791,52.83980571495984,77.99112650544876,0.6775104820580871 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441803,104.15783391364396,77.99112650544876,1.3355087761986242 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441807,94.97108180329454,77.99112650544876,1.2177165026159673 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441797,156.7563889080992,110.33780757772625,1.420695157438885 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441802,61.0778794630657,110.33780757772625,0.5535534990582449 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441791,173.64434572970077,110.33780757772625,1.5737520034316337 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441803,87.89599976098596,110.33780757772625,0.7966081771116269 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441807,388.0157908873808,110.33780757772625,3.516616827953984 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441796,186.87065068448433,110.33780757772625,1.6936230181376892 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441797,59.39739747948158,67.31067174214355,0.8824365578614864 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441802,79.98285701996537,67.31067174214355,1.1882641333066313 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441791,84.67088623704265,67.31067174214355,1.2579117700890479 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441803,30.425578228979106,67.31067174214355,0.45201715332057063 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441807,99.32128582324032,67.31067174214355,1.4755652150334246 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441797,6037.415396619602,2375.529574917848,2.5415029391197503 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441802,4692.1648025762815,2375.529574917848,1.9752079082149707 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441791,4691.196204727151,2375.529574917848,1.9748001684590202 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441803,4053.633396581192,2375.529574917848,1.7064125150794542 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441807,6206.98488464021,2375.529574917848,2.612884701658519 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441796,4355.748455464534,2375.529574917848,1.8335904976536306 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441797,315.5522259834861,194.62377093849457,1.6213447332864988 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441802,683.1026000206766,194.62377093849457,3.50986211358813 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441791,171.57958234434537,194.62377093849457,0.8815962280299683 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441803,336.02246250870974,194.62377093849457,1.7265232344866048 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441807,204.66509940206976,194.62377093849457,1.0515935356465191 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441797,5245.784501018256,3728.1507253933823,1.4070741467848615 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441802,4418.567409604636,3728.1507253933823,1.185190121072265 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441791,3637.270747010924,3728.1507253933823,0.9756233089602704 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441803,5893.730641873132,3728.1507253933823,1.5808724153048412 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441807,4124.731531936969,3728.1507253933823,1.1063746709172388 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441796,4334.1026169175075,3728.1507253933823,1.1625341720754025 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441797,113.08636202774666,68.78582331086372,1.6440358868233 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441802,198.74096851411625,68.78582331086372,2.8892722213405273 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441791,109.17244841932589,68.78582331086372,1.5871358830139013 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441803,199.69458882125068,68.78582331086372,2.9031358383074237 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441807,50.03499426855038,68.78582331086372,0.7274027097477233 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441797,522.92585861332,696.3940975413478,0.7509050700738767 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441802,628.0675331377134,696.3940975413478,0.9018852045919623 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441791,372.1178383261103,696.3940975413478,0.5343495007207698 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441803,587.0968275841295,696.3940975413478,0.8430525612679696 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441807,123.04742679320007,696.3940975413478,0.1766922310623034 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441796,456.61407037193226,696.3940975413478,0.6556834298050913 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441797,72.73298180997115,81.2393188807366,0.8952928558737281 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441802,224.7647859517203,81.2393188807366,2.7666995372239187 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441791,63.33976967541679,81.2393188807366,0.7796688912225218 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441803,18.330499320424337,81.2393188807366,0.22563580754947526 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441807,23.761834565781133,81.2393188807366,0.29249179945322656 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441797,211.8083086466914,543.8205698619286,0.3894819732553841 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441802,305.60725765452435,543.8205698619286,0.5619634022525397 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441791,168.11028331129722,543.8205698619286,0.309128217334587 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441803,317.8252393414477,543.8205698619286,0.5844303377897986 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441807,220.6258069395996,543.8205698619286,0.4056959577597711 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441796,103.6120619184362,543.8205698619286,0.1905261912853764 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441797,1287683.7280268571,306516.0644612488,4.201031780471826 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441802,1112218.1573581763,306516.0644612488,3.628580313769454 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441791,976200.5963659228,306516.0644612488,3.184826864072368 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441803,586841.169347521,306516.0644612488,1.9145527343860056 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441807,241203.24059826063,306516.0644612488,0.7869187574955134 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441797,1623432.650724286,335923.8645439917,4.8327398618376085 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441802,1695467.0989181604,335923.8645439917,5.047176690526929 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441791,1399784.0745015258,335923.8645439917,4.1669682396685275 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441803,1439556.3626432992,335923.8645439917,4.285364972796622 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441807,2259933.7059972216,335923.8645439917,6.727517585167774 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441796,1089554.460376358,335923.8645439917,3.243456554822031 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441797,103.16162383226158,33.931355493730415,3.040303646322736 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441802,47.62772890829937,33.931355493730415,1.4036494627248142 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441791,110.0452313094096,33.931355493730415,3.2431722726120666 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441803,17.93993223001948,33.931355493730415,0.5287125129243448 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441807,109.95754050257489,33.931355493730415,3.2405879135271216 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441797,14.081772065286012,76.3332642617619,0.18447753022845748 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441802,148.9039061341052,76.3332642617619,1.9507079590292926 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441791,82.325493428622,76.3332642617619,1.07850088981275 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441803,12.372363788478884,76.3332642617619,0.1620835150721656 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441807,9.506071357000078,76.3332642617619,0.12453379858618223 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441796,15.636826939557617,76.3332642617619,0.20484944657856943 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441797,209.29658101919043,130.67426801703346,1.6016663739176906 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441802,435.4066318528226,130.67426801703346,3.331999776697178 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441791,193.9558997070492,130.67426801703346,1.4842700299784115 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441803,658.427190903345,130.67426801703346,5.038690485088607 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441807,189.8600164606083,130.67426801703346,1.4529258081312533 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441797,7535.909713492771,5444.214081294075,1.3842052500076383 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441802,8488.998142475666,5444.214081294075,1.5592697156497295 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441791,8108.490201407502,5444.214081294075,1.489377544734636 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441803,8058.349557785197,5444.214081294075,1.48016764907778 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441807,9149.768092503746,5444.214081294075,1.6806407602415352 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441796,6884.93649438376,5444.214081294075,1.2646336811110905 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441797,211.0421915209963,100.67607722942154,2.09624964866352 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441802,188.18690448713505,100.67607722942154,1.8692315956877528 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441791,114.68449520984532,100.67607722942154,1.1391434625377912 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441803,45.00388686568356,100.67607722942154,0.44701669059997545 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441807,259.1476617864572,100.67607722942154,2.5740738904229374 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441797,737.7805216804719,599.1099853739104,1.231460899821284 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441802,1370.2895226692735,599.1099853739104,2.287208619656143 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441791,1105.0315466152597,599.1099853739104,1.844455231247062 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441803,735.6428006806929,599.1099853739104,1.2278927386289031 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441807,512.6376041994014,599.1099853739104,0.8556652646666526 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441796,710.0474397472425,599.1099853739104,1.1851704312758116 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441797,46.356454079850366,114.30018844822946,0.4055676084982731 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441802,94.05057743845413,114.30018844822946,0.8228383409975996 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441791,69.43840545717566,114.30018844822946,0.6075091073767278 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441803,35.503235993148714,114.30018844822946,0.31061397601482843 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441807,81.88587970231058,114.30018844822946,0.7164107147504796 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441797,4025.844616463388,1759.6959467320276,2.2878069497971385 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441802,3001.2124131353603,1759.6959467320276,1.7055289686317583 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441791,4129.582118727159,1759.6959467320276,2.346758896840276 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441803,4503.228637027297,1759.6959467320276,2.5590947375825626 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441807,4841.497295268084,1759.6959467320276,2.7513260482638158 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441796,2467.0063820397368,1759.6959467320276,1.4019503691085224 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441797,86.16584667308494,38.77498679262034,2.222201831658239 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441802,481.19253390412536,38.77498679262034,12.409869704861022 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441791,50.549344523418384,38.77498679262034,1.3036585877841986 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441803,64.92103162435141,38.77498679262034,1.6743018372015845 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441807,5.2780190314129865,38.77498679262034,0.1361191703208394 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441797,919.12384920998,2284.874121495706,0.4022645451506583 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441802,1069.1866852678827,2284.874121495706,0.46794117680670316 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441791,974.3625866745008,2284.874121495706,0.42644037914730787 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441803,2062.130305722515,2284.874121495706,0.9025137473974365 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441807,1467.0382374251192,2284.874121495706,0.6420652339765565 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441796,833.2925190100658,2284.874121495706,0.36469953034637315 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441797,526.2984940035761,306.4947439651267,1.7171534075751034 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441802,626.7096710350685,306.4947439651267,2.044764823459342 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441791,521.0287724249928,306.4947439651267,1.6999598938775797 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441803,545.0326596957673,306.4947439651267,1.7782773454600633 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441807,463.7092487652764,306.4947439651267,1.5129435590518243 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441797,19227.09756823012,53872.22448470133,0.3569018683030296 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441802,24356.98005233404,53872.22448470133,0.45212501034277786 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441791,25304.907213275128,53872.22448470133,0.46972085254176266 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441803,30732.91566998147,53872.22448470133,0.570477940421952 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441807,23474.26621626761,53872.22448470133,0.4357396866530701 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441796,19862.107325822537,53872.22448470133,0.3686891995978928 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441797,485.4960710869964,320.29657233769314,1.5157704234659468 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441802,974.5270359069948,320.29657233769314,3.0425771615174746 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441791,69.34381809221475,320.29657233769314,0.21649878294390423 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441803,90.76325146987456,320.29657233769314,0.2833725344215723 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441807,206.24974909817468,320.29657233769314,0.6439336755709102 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441797,2018.2827103551165,6299.521117687065,0.32038668855135927 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441802,6070.238819064762,6299.521117687065,0.9636032177146686 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441791,6520.846247808823,6299.521117687065,1.0351336436511573 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441803,11335.512035114803,6299.521117687065,1.7994244043865917 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441807,3521.828919679488,6299.521117687065,0.5590629595305753 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441796,2775.927432007811,6299.521117687065,0.44065689758764104 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441797,3542.275400103297,1965.7827420843205,1.8019668828445512 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441802,3314.210864196953,1965.7827420843205,1.685949720304744 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441791,1259.7144625645662,1965.7827420843205,0.6408207965183835 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441803,1210.296186920869,1965.7827420843205,0.6156815608410476 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441807,2333.4333292269257,1965.7827420843205,1.1870250355096643 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441797,2211.016206791114,6243.797224888628,0.35411403143870557 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441802,5373.233041552259,6243.797224888628,0.8605713555420761 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441791,6332.05787137304,6243.797224888628,1.0141357323605247 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441803,10194.890314797703,6243.797224888628,1.6328029158537498 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441807,4670.19627615003,6243.797224888628,0.747973726234092 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441796,3205.5021152209483,6243.797224888628,0.51338984911992 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441797,875.4717437038321,477.14850073021523,1.8347993179566398 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441802,983.5985510448854,477.14850073021523,2.061409706914331 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441791,377.46823300881897,477.14850073021523,0.7910917302079997 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441803,377.8242496119153,477.14850073021523,0.7918378639641606 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441807,540.3042756693734,477.14850073021523,1.132360837019306 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441797,116.6159617284424,205.1372392304115,0.5684777769552538 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441802,358.85331200581464,205.1372392304115,1.749332853225875 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441791,277.8931290021022,205.1372392304115,1.354669342556428 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441803,338.9706041988615,205.1372392304115,1.6524089213179256 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441807,261.47752727240754,205.1372392304115,1.2746468084164586 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441796,147.65737245275406,205.1372392304115,0.7197979899052084 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441797,169.3651668805152,44.32085041603382,3.8213428959667364 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441802,112.34735762076664,44.32085041603382,2.5348646645129147 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441791,107.48187386214862,44.32085041603382,2.4250860002285792 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441803,58.7011142556483,44.32085041603382,1.3244582110818923 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441807,6.14824830788437,44.32085041603382,0.13872135236963182 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441797,16.261662196498488,73.02499011367847,0.22268626358160207 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441802,41.63509759942282,73.02499011367847,0.5701486235685783 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441791,50.0262298453784,73.02499011367847,0.6850563042528626 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441803,67.03786207067374,73.02499011367847,0.9180126141245 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441807,168.72224184090325,73.02499011367847,2.310472642012717 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441796,18.132570207968907,73.02499011367847,0.24830636991174965 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441797,155.60529972724856,446.9213615105917,0.34817154230736147 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441802,799.160124790341,446.9213615105917,1.788144836239611 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441791,90481.67492031475,446.9213615105917,202.45547139319365 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441803,10278.7820695529,446.9213615105917,22.99908430156633 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441807,3346.109820895748,446.9213615105917,7.487021451796163 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441797,2131.4493932232135,2631.000022355788,0.8101289909206163 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441802,2818.0111352779227,2631.000022355788,1.0710798598757463 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441791,1562.8691858712573,2631.000022355788,0.5940209701981948 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441803,3825.683195287372,2631.000022355788,1.4540794993463622 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441807,1905.2567632654257,2631.000022355788,0.7241568784022531 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441796,1523.2285189522215,2631.000022355788,0.5789542022079985 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441797,28.560935720157865,48.89133349009634,0.5841717474517912 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441802,24.887416333027463,48.89133349009634,0.5090353352311157 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441791,129.31787762804285,48.89133349009634,2.6450061472395325 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441803,205.5050318828836,48.89133349009634,4.20330183721644 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441807,42.17657277799863,48.89133349009634,0.8626594892639227 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441797,115.1626145799954,307.70649021557807,0.37426124648626324 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441802,211.0981378655132,307.70649021557807,0.686037326406793 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441791,96.16710900369624,307.70649021557807,0.3125286988139961 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441803,173.96051981664232,307.70649021557807,0.5653456308145018 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441807,428.0258296152044,307.70649021557807,1.3910198296933256 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441796,123.51919245214972,307.70649021557807,0.40141887278884697 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441797,268.8358524788721,154.19153082843468,1.7435189276251462 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441802,332.94416554203775,154.19153082843468,2.1592895780540435 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441791,383.0218269671235,154.19153082843468,2.4840652719979994 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441803,646.3883535172758,154.19153082843468,4.192113211694468 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441807,144.0218790965019,154.19153082843468,0.9340453287071369 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441797,7664.563488345172,6593.957266089812,1.1623617168041225 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441802,8027.7096788097715,6593.957266089812,1.2174342894354497 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441791,7836.267681794439,6593.957266089812,1.1884013446816455 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441803,7559.20629051588,6593.957266089812,1.14638387624833 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441807,7659.2527157412605,6593.957266089812,1.1615563168918084 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441796,7042.548136668167,6593.957266089812,1.068030600211088 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441797,232.11869726398737,127.96554716912783,1.8139155608595474 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441802,240.01905134536193,127.96554716912783,1.8756536947256335 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441791,194.6679509276906,127.96554716912783,1.5212528312046711 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441803,164.6223833874541,127.96554716912783,1.286458636947632 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441807,116.72495108240189,127.96554716912783,0.9121591996018301 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441797,791.0450766227807,1681.9358703135756,0.4703182152095373 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441802,1441.1655092009007,1681.9358703135756,0.8568492619948783 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441791,1255.7189688482058,1681.9358703135756,0.7465914670183549 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441803,1245.7013469245016,1681.9358703135756,0.740635459954996 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441807,760.8382549168432,1681.9358703135756,0.45235865905814504 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441796,1082.5830541725825,1681.9358703135756,0.6436529913419045 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441797,46.905131339619096,45.403354316773296,1.0330763452490337 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441802,38.51477921214966,45.403354316773296,0.8482804804120211 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441791,40.90888609456776,45.403354316773296,0.9010102163190804 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441803,47.28837207287629,45.403354316773296,1.0415171474546014 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441807,49.4406743852793,45.403354316773296,1.0889211849930327 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441797,164.2615760494951,171.72890790902974,0.9565167451976674 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441802,161.94540180365345,171.72890790902974,0.9430293581639795 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441791,141.6455237043175,171.72890790902974,0.8248205001067824 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441803,172.48517835832726,171.72890790902974,1.004403862218108 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441807,136.3665544622656,171.72890790902974,0.794080368428729 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441796,156.7252394328688,171.72890790902974,0.9126316666259308 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441797,9732.76081256171,385.5886159476326,25.241307471285747 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441802,1699.291699483999,385.5886159476326,4.4070069218920676 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441791,181.11429061626384,385.5886159476326,0.46970860426247973 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441803,419.2313404929717,385.5886159476326,1.0872503055170804 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441807,593.141979846147,385.5886159476326,1.5382766900117781 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441797,263.0664163881822,430.1288265554666,0.6115991306484985 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441802,248.1457969641907,430.1288265554666,0.5769104083336564 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441791,309.84524290639115,430.1288265554666,0.7203545165472315 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441803,273.0304729453075,430.1288265554666,0.6347644149585945 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441807,479.6177430278622,430.1288265554666,1.115056033023199 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441796,219.8143699014508,430.1288265554666,0.5110431022764873 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441797,232283.64270452037,54695.927744901994,4.246817857955992 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441802,277231.6026738611,54695.927744901994,5.068596769522769 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441791,187764.7792253701,54695.927744901994,3.432884073218247 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441803,211460.8398732934,54695.927744901994,3.8661167035968758 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441807,51560.29732337546,54695.927744901994,0.9426715927344556 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441797,382459.5012458952,97212.60478924697,3.934258341035631 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441802,700625.4962960399,97212.60478924697,7.207146622755022 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441791,547922.2342558529,97212.60478924697,5.636329110239627 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441803,492393.6026632952,97212.60478924697,5.065120965854015 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441807,656656.6047206533,97212.60478924697,6.754850424430644 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441796,344494.04515684274,97212.60478924697,3.543717873867201 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441797,341603.7409762625,62941.57202670208,5.4273150475387215 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441802,253126.6608994771,62941.57202670208,4.021613263680349 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441791,261380.4207431377,62941.57202670208,4.152746941754978 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441803,209084.54045982883,62941.57202670208,3.3218830373529222 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441807,67790.28970546885,62941.57202670208,1.0770352173077242 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441797,88313.51688143938,14728.399701289269,5.996137983253452 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441802,209649.8044640108,14728.399701289269,14.234391292738943 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441791,158981.06718308022,14728.399701289269,10.79418473204279 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441803,126563.27839374448,14728.399701289269,8.593145281266748 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441807,162970.51487664937,14728.399701289269,11.065052428091256 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441796,84879.24679722366,14728.399701289269,5.762964647801733 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441797,36463.060260507635,3575.9352491809864,10.196789852069873 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441802,23476.484992954087,3575.9352491809864,6.565131457100914 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441791,30663.599717931676,3575.9352491809864,8.5749874036322975 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441803,11940.342360299464,3575.9352491809864,3.3390823737745863 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441807,17945.916633212004,3575.9352491809864,5.018523933654068 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441797,175061.69490772896,12966.336321671553,13.501245885095237 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441802,309172.4032072249,12966.336321671553,23.84423753458278 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441791,237387.0570841371,12966.336321671553,18.307951544290532 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441803,152763.44771102868,12966.336321671553,11.781542906279883 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441807,75234.71531441968,12966.336321671553,5.80231095723428 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441796,131623.8859938314,12966.336321671553,10.151200981408998 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441797,500.2374559390145,103.34580193186551,4.840423573942697 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441802,399.6143920042281,103.34580193186551,3.866769472336075 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441791,465.1775380799713,103.34580193186551,4.501174981318124 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441803,505.1729434385804,103.34580193186551,4.888180593650374 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441807,985.5236485716644,103.34580193186551,9.536174959689285 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441797,1986.2784452309515,211.8154700640626,9.377400265571778 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441802,3262.639424490355,211.8154700640626,15.403215938399518 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441791,2122.122188352742,211.8154700640626,10.018730868481494 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441803,1510.0243594690858,211.8154700640626,7.128961633502907 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441807,1157.9525332471126,211.8154700640626,5.466798685180526 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441796,704.4827762327127,211.8154700640626,3.32592693073667 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441797,313.0985963880113,76.10596635595309,4.113982272081358 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441802,240.13176052106627,76.10596635595309,3.155229110395271 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441791,70.1528416350712,76.10596635595309,0.9217784753820917 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441803,125.6273974383888,76.10596635595309,1.6506905234054898 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441807,154.98636413880791,76.10596635595309,2.0364548478883444 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441797,5542.420671881831,1382.686999693948,4.008442021302451 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441802,3595.812869603968,1382.686999693948,2.600597872403433 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441791,2394.867037151749,1382.686999693948,1.7320384423096788 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441803,4826.964175389428,1382.686999693948,3.4910027912736985 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441807,2619.417038565842,1382.686999693948,1.8944396231002671 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441796,1932.100681079722,1382.686999693948,1.397352171176401 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441797,30.762937040772012,30.899530320120164,0.9955794383301934 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441802,30.27050005080588,30.899530320120164,0.9796427239250076 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441791,34.26419722808618,30.899530320120164,1.1088905518338938 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441803,23.314373268505907,30.899530320120164,0.7545219304943546 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441807,32.94382291173078,30.899530320120164,1.066159341919818 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441797,31.23393217207173,31.68183515511672,0.9858624672197168 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441802,32.80073219222194,31.68183515511672,1.0353166737856887 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441791,29.78740698588401,31.68183515511672,0.9402045948425197 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441803,30.677588165333063,31.68183515511672,0.9683021206042268 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441807,30.193915338567123,31.68183515511672,0.9530355546241364 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441796,32.01962923675006,31.68183515511672,1.0106620743394277 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441797,581.6774221295932,628.1906149122311,0.9259568804778521 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441802,1038.4352661086384,628.1906149122311,1.653057593440369 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441791,209.08087753550782,628.1906149122311,0.33283031069275043 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441803,248.95775043134623,628.1906149122311,0.39630924837380743 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441807,371.0037782730722,628.1906149122311,0.5905910872688025 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441797,38346.53001528359,10551.186365326936,3.6343334946008605 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441802,42247.0581174799,10551.186365326936,4.004010227353315 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441791,47261.52454178647,10551.186365326936,4.479261658868637 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441803,37764.2067247963,10551.186365326936,3.5791431804196123 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441807,29502.43708225277,10551.186365326936,2.7961251048700073 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441796,29810.507873762577,10551.186365326936,2.825322844426782 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441797,49.049340851615376,102.14043933131707,0.4802147041145187 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441802,110.73696479795368,102.14043933131707,1.0841637800161767 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441791,155.17319214776987,102.14043933131707,1.5192140660804123 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441803,24.746575779999542,102.14043933131707,0.24227990345457665 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441807,46.8693909583013,102.14043933131707,0.4588720321269538 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441797,9883.916110381546,2995.2816068385046,3.2998286664651673 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441802,7127.0054341878795,2995.2816068385046,2.379410809960662 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441791,9829.24361138269,2995.2816068385046,3.281575792052947 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441803,8909.389736572877,2995.2816068385046,2.9744748260837706 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441807,9319.1155257419,2995.2816068385046,3.111265232779949 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441796,6088.888552488429,2995.2816068385046,2.0328267427633295 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441797,54.072823027468104,35.73806763844074,1.513031526341006 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441802,54.66700850922644,35.73806763844074,1.5296576485972417 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441791,55.36152960201561,35.73806763844074,1.5490912984469085 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441803,15.37952332563312,35.73806763844074,0.4303400922855305 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441807,36.61211990576992,35.73806763844074,1.0244571776004205 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441797,250.99698905508063,271.6614200921023,0.9239331406350754 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441802,275.79339647883415,271.6614200921023,1.0152100227751553 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441791,228.04017653437745,271.6614200921023,0.8394279042532584 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441803,265.67290583553824,271.6614200921023,0.977955963513208 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441807,247.09730380709703,271.6614200921023,0.9095781937800473 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441796,234.546649786238,271.6614200921023,0.8633785750907098 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441797,152.07438190185903,166.02715311669658,0.9159609078821555 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441802,165.8351299987608,166.02715311669658,0.9988434234139953 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441791,194.66442858573396,166.02715311669658,1.1724854936765006 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441803,153.87388444677728,166.02715311669658,0.926799511755905 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441807,157.00385405983735,166.02715311669658,0.9456516666854068 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441797,1776.6522950761337,1793.9624976146763,0.9903508559618392 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441802,2144.5438097959486,1793.9624976146763,1.1954228768145483 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441791,1302.6234693711474,1793.9624976146763,0.7261152176275519 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441803,2499.046676941582,1793.9624976146763,1.3930317273992148 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441807,1728.9038467880653,1793.9624976146763,0.9637346650706937 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441796,1431.4274187691378,1793.9624976146763,0.797913791772359 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441797,81.7682450686091,59.13775760336051,1.382674088135574 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441802,98.7805093241184,59.13775760336051,1.670345872541254 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441791,173.30178392584904,59.13775760336051,2.9304760773682283 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441803,51.529845248948995,59.13775760336051,0.8713527082741602 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441807,120.97530877249584,59.13775760336051,2.0456526198352405 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441797,417.2983078048359,238.79765196261823,1.7474975334772571 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441802,646.2071057320969,238.79765196261823,2.70608651475876 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441791,975.6664452739388,238.79765196261823,4.085745555934826 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441803,365.6324437070507,238.79765196261823,1.531139191286049 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441807,374.9498826352133,238.79765196261823,1.570157325893257 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441796,438.6460429062893,238.79765196261823,1.8368942881186943 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441797,615.2751473733824,386.8144501381946,1.5906208962813235 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441802,736.2927222085942,386.8144501381946,1.903477809439497 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441791,611.6356996018511,386.8144501381946,1.5812121273735666 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441803,314.4241982834877,386.8144501381946,0.8128553578366979 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441807,780.8208079172191,386.8144501381946,2.0185926550527276 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441797,14459.94531499146,5555.372966797932,2.602875702749809 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441802,21800.223653982383,5555.372966797932,3.9241692293700017 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441791,29530.481198070695,5555.372966797932,5.315661320052072 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441803,16102.359051138325,5555.372966797932,2.8985198918911794 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441807,12845.714310689067,5555.372966797932,2.3123045720714632 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441796,13285.248755178196,5555.372966797932,2.3914233723961282 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441797,70.82609301866422,84.54153084580483,0.8377668621572968 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441802,23.613302476942295,84.54153084580483,0.2793100886712184 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441791,33.57431391790261,84.54153084580483,0.39713397169420495 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441803,65.61467933644101,84.54153084580483,0.7761236244481488 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441807,158.4464922273099,84.54153084580483,1.8741852748834207 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441797,31.17878153260044,122.00200397429413,0.2555595852275494 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441802,38.9604428689011,122.00200397429413,0.31934264683971975 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441791,78.19099923835479,122.00200397429413,0.6408993023985874 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441803,199.3146142202652,122.00200397429413,1.6336995108888612 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441807,130.87770925671697,122.00200397429413,1.0727504876419323 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441796,74.873822545558,122.00200397429413,0.6137097761224803 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441797,76.40518806674471,143.84455848940917,0.531164952425852 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441802,102.13245582310356,143.84455848940917,0.7100195995987103 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441791,119.8010366190544,143.84455848940917,0.8328506679512314 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441803,25.491047744813596,143.84455848940917,0.17721245775654715 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441807,114.28893622269044,143.84455848940917,0.7945308284366223 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441797,2545.4674279891005,5334.764851653101,0.4771470718527225 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441802,2097.5279153447,5334.764851653101,0.3931809505520627 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441791,3568.4895741111177,5334.764851653101,0.6689122526188457 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441803,2840.46206706609,5334.764851653101,0.5324437245225359 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441807,3100.8070451344174,5334.764851653101,0.5812453090924073 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441796,2697.498081211992,5334.764851653101,0.5056451701664244 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441797,283.5599970037744,159.70733471984832,1.775497647000265 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441802,701.2455403854477,159.70733471984832,4.390816123852685 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441791,225.74667550059903,159.70733471984832,1.413502240811883 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441803,277.29308934714106,159.70733471984832,1.736257698079782 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441807,318.0295114240771,159.70733471984832,1.9913268979283305 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441797,66875.20042705238,82077.5827732141,0.8147803354764122 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441802,110269.36678542108,82077.5827732141,1.3434772694281552 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441791,65371.08724497482,82077.5827732141,0.7964548301282159 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441803,148795.53393928436,82077.5827732141,1.8128644742184532 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441807,41713.77674564881,82077.5827732141,0.508223748022731 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441796,49436.40072359317,82077.5827732141,0.6023130683586196 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441797,58064.73483284235,170961.68742491837,0.3396359483076743 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441802,38289.98705235856,170961.68742491837,0.22396823305323577 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441791,139566.236401301,170961.68742491837,0.8163597265767197 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441803,88177.5833249477,170961.68742491837,0.5157739412444255 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441807,88408.0432144728,170961.68742491837,0.5171219619208494 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441797,367751.32037397806,55195.40432138408,6.662716305739643 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441802,449695.68215154216,55195.40432138408,8.147339215654931 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441791,403366.7872125971,55195.40432138408,7.307977759596241 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441803,340003.3450891551,55195.40432138408,6.159993739867022 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441807,555227.9579029658,55195.40432138408,10.059314986988086 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441796,316104.86099759146,55195.40432138408,5.727014139746496 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441797,2243.3807567796234,546.121028905539,4.10784540063491 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441802,3093.400647529573,546.121028905539,5.664313373409083 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441791,1249.25291387187,546.121028905539,2.287501941420296 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441803,1791.888668975069,546.121028905539,3.2811200707032415 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441807,1984.7533962973616,546.121028905539,3.6342738903040095 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441797,2468.8763722560057,1228.731327313693,2.009289026311043 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441802,6081.130825312661,1228.731327313693,4.9491135206973995 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441791,2151.9254281823355,1228.731327313693,1.7513392719358514 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441803,2250.8995677116977,1228.731327313693,1.8318891344885901 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441807,1308.325890478342,1228.731327313693,1.0647778414982403 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441796,1603.2999262377691,1228.731327313693,1.3048417425337193 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441797,68.98111700193802,76.68368758811918,0.8995539882282011 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441802,114.5059960343702,76.68368758811918,1.4932249561262743 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441791,26.093124266761745,76.68368758811918,0.340269555200739 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441803,467.0258364297834,76.68368758811918,6.090289227328982 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441807,48.36653278322346,76.68368758811918,0.6307277897616002 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441797,291.7914937575178,81.06808963980528,3.599338470339939 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441802,316.28700808830945,81.06808963980528,3.9014982281389448 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441791,226.46861394787825,81.06808963980528,2.7935605113442787 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441803,250.61997298572237,81.06808963980528,3.091475006988019 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441807,176.23442190434417,81.06808963980528,2.1739061903071075 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441796,218.12157776420864,81.06808963980528,2.6905972341688025 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441797,43.61954902302856,34.254424530644805,1.2733989731459507 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441802,98.5066924745295,34.254424530644805,2.875736312148614 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441791,78.14654627356676,34.254424530644805,2.281356272783244 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441803,90.2296543441676,34.254424530644805,2.6341021803897493 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441807,185.58174623957177,34.254424530644805,5.41774526305488 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441797,86.28196297721618,60.87738129746832,1.4173073995350118 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441802,92.85591804275802,60.87738129746832,1.5252942236301412 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441791,205.15235807487807,60.87738129746832,3.3699274459988913 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441803,88.35290281511053,60.87738129746832,1.451325614408201 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441807,114.50067612123364,60.87738129746832,1.8808410230680426 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441796,74.09121102597818,60.87738129746832,1.2170564739626766 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441797,133.20635618546635,81.37032235510941,1.637038570452487 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441802,133.67825498831394,81.37032235510941,1.642837967446248 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441791,72.94813581753098,81.37032235510941,0.8964955982253205 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441803,64.86499902166317,81.37032235510941,0.7971579458489163 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441807,62.48559546615739,81.37032235510941,0.7679162827137773 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441797,519.0750816184806,592.3362991324378,0.8763182036602198 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441802,491.6388610042051,592.3362991324378,0.8299995487770736 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441791,628.6073456480502,592.3362991324378,1.0612338743526888 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441803,671.6610718739311,592.3362991324378,1.1339184730999532 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441807,351.71828033919314,592.3362991324378,0.5937814056885176 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441796,470.92576201676025,592.3362991324378,0.79503107053628 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441797,6832.888808743169,1509.2244087879828,4.52741737342459 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441802,7912.772417478464,1509.2244087879828,5.242939599574193 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441791,5726.719454220669,1509.2244087879828,3.7944784227414146 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441803,6026.791630413911,1509.2244087879828,3.993303842238984 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441807,6428.407589784535,1509.2244087879828,4.259411358809797 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441797,897000.5043065822,911297.6405793307,0.9843112330855377 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441802,1135520.1812036645,911297.6405793307,1.246047537752639 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441791,664184.0561372131,911297.6405793307,0.7288332884467665 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441803,1438492.5647219568,911297.6405793307,1.578510138364319 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441807,1400958.9888469167,911297.6405793307,1.5373231823098963 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441796,828351.5169065611,911297.6405793307,0.9089802058304035 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441797,2540.4762706185575,749.6106308195243,3.389061155444313 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441802,3150.0240485432437,749.6106308195243,4.2022136813873985 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441791,3057.6066540696697,749.6106308195243,4.078926483108824 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441803,5904.4257496969785,749.6106308195243,7.876656902853508 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441807,5942.678641551894,749.6106308195243,7.927687251520114 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441797,25442.131797497408,2138.7943755926544,11.895548299470097 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441802,46327.26540176178,2138.7943755926544,21.660457840377767 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441791,36339.16571063104,2138.7943755926544,16.99049058914864 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441803,24223.976148960912,2138.7943755926544,11.325995815866362 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441807,15722.22013418082,2138.7943755926544,7.350973199480307 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441796,18575.646752947607,2138.7943755926544,8.685101739993282 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441797,1670.775738588262,613.8984432679271,2.721583279628999 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441802,2348.0303591889706,613.8984432679271,3.824786306167919 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441791,1664.5065057701177,613.8984432679271,2.7113711136153964 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441803,1234.925146884664,613.8984432679271,2.011611465099772 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441807,2004.5119155235625,613.8984432679271,3.26521745983435 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441797,4611.026923360722,6365.76448478505,0.7243477094356281 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441802,12395.344750051963,6365.76448478505,1.947188712318582 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441791,6587.102334666821,6365.76448478505,1.0347700343628476 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441803,5214.852200421305,6365.76448478505,0.8192028173341057 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441807,4687.568115750517,6365.76448478505,0.7363715900822869 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441796,5679.410617231343,6365.76448478505,0.8921804491519949 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441797,117.28587907638844,70.21289390855102,1.6704322033663468 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441802,88.31914805776539,70.21289390855102,1.2578764830972058 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441791,81.50809109012117,70.21289390855102,1.1608706970016305 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441803,89.01356844493502,70.21289390855102,1.267766694830596 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441807,63.017991819297016,70.21289390855102,0.8975273388015451 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441797,1759.7775689233404,2003.7789126851078,0.8782294083358726 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441802,1047.2223168209275,2003.7789126851078,0.5226236837763836 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441791,939.6734701255124,2003.7789126851078,0.4689506732388601 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441803,2784.6904375819104,2003.7789126851078,1.389719404647474 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441807,2328.246954751788,2003.7789126851078,1.1619280650238433 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441796,2131.1836113459053,2003.7789126851078,1.0635822135138016 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441797,1357.1326874721487,700.7857837159185,1.9365870698403 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441802,1988.3948542483456,700.7857837159185,2.837378982925248 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441791,1094.1113991825857,700.7857837159185,1.561263690854368 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441803,1179.3304453673147,700.7857837159185,1.6828686779487905 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441807,1442.3541152146731,700.7857837159185,2.058195455345265 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441797,4313.45320087043,4688.560133729121,0.9199952816728952 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441802,9203.68796690427,4688.560133729121,1.963009475061157 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441791,4694.898846916231,4688.560133729121,1.0013519530530302 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441803,5101.184610711674,4688.560133729121,1.088006651341457 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441807,3167.259646566765,4688.560133729121,0.6755292789745312 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441796,4842.8319214160865,4688.560133729121,1.032903873105337 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441797,1190.4777391712726,384.65137963543384,3.0949524743667562 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441802,1204.13926900059,384.65137963543384,3.130469128024065 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441791,555.0406534812383,384.65137963543384,1.4429706556812474 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441803,576.8350178004533,384.65137963543384,1.4996307002646603 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441807,1051.2899535585973,384.65137963543384,2.7330980966583103 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441797,166.58444371492988,772.5530415852671,0.21562848729855638 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441802,494.70010030805906,772.5530415852671,0.640344511870592 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441791,348.4319367305937,772.5530415852671,0.451013610684409 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441803,827.505006286845,772.5530415852671,1.0711303454178593 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441807,134.48782888861632,772.5530415852671,0.17408232399506102 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441796,197.1521165296716,772.5530415852671,0.2551955735299656 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441797,153.1290236084039,216.68366112664066,0.706693909509438 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441802,177.94562946993406,216.68366112664066,0.8212231072001955 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441791,85.12765338823498,216.68366112664066,0.39286604696272953 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441803,366.1154365737413,216.68366112664066,1.6896310255703375 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441807,97.12718261088848,216.68366112664066,0.44824414589396544 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441797,1230.431380549324,615.8359185894908,1.9979857351735855 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441802,1835.49732936913,615.8359185894908,2.9804973597076785 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441791,1429.377431515306,615.8359185894908,2.321036153248659 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441803,1430.6515541511765,615.8359185894908,2.323105085244033 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441807,1612.7819799863,615.8359185894908,2.6188501373551127 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441796,1018.7780125200068,615.8359185894908,1.6543010593688878 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441797,69.35452324088615,101.73138829665541,0.6817416374840359 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441802,78.84174380636698,101.73138829665541,0.7749991927413717 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441791,25.19187958876064,101.73138829665541,0.24763133591865927 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441803,203.98613950801345,101.73138829665541,2.005144556891099 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441807,17.472516096818165,101.73138829665541,0.17175147601315693 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441797,272.94926389797166,93.53234569214308,2.918233920876636 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441802,123.55157576521924,93.53234569214308,1.3209502536361368 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441791,196.9866410367004,93.53234569214308,2.106080410781868 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441803,154.59289281829192,93.53234569214308,1.6528281384829853 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441807,344.8302111040432,93.53234569214308,3.6867482425709084 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441796,246.01538256477303,93.53234569214308,2.630270637865964 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441797,82.32776579446617,42.30806113801961,1.9459120456002972 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441802,97.23133307183004,42.30806113801961,2.298175110285409 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441791,138.29784930763918,42.30806113801961,3.2688297593330162 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441803,154.4671776508644,42.30806113801961,3.651010552030577 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441807,270.2305440493244,42.30806113801961,6.3872117223184475 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441797,977.9969920213482,205.3077634331321,4.763565564532964 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441802,2715.193038177723,205.3077634331321,13.22498960962112 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441791,1114.605472016212,205.3077634331321,5.428949462883971 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441803,998.6216128812732,205.3077634331321,4.86402265643754 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441807,213.8497191063509,205.3077634331321,1.0416056145680088 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441796,497.562869786913,205.3077634331321,2.4234975895052657 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441797,867.3061488860181,761.179367641068,1.139424143318338 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441802,770.3789612103681,761.179367641068,1.012085973372886 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441791,2305.1264345840746,761.179367641068,3.028361687899889 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441803,1161.1858632912658,761.179367641068,1.5255088519935025 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441807,1335.096506923628,761.179367641068,1.7539840984670372 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441797,860656.2334132496,258075.7105503754,3.33489824198412 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441802,663925.0572069297,258075.7105503754,2.5725980015361967 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441791,687446.1850604982,258075.7105503754,2.6637384184448902 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441803,885334.0620349904,258075.7105503754,3.4305206799466568 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441807,986456.2040167176,258075.7105503754,3.822351983117625 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441796,612223.2761091976,258075.7105503754,2.3722622900216486 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441797,1103.3315569213205,131.47736122215045,8.391798760374257 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441802,365.77084753700774,131.47736122215045,2.78200630235485 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441791,331.08178067199424,131.47736122215045,2.518165694796556 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441803,507.4044448292359,131.47736122215045,3.8592533354232827 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441807,188.522392122656,131.47736122215045,1.4338772117894847 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441797,2743.8157912993006,3004.2024881525895,0.9133258500782976 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441802,1848.1270663120597,3004.2024881525895,0.6151805923869502 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441791,2511.2964167417326,3004.2024881525895,0.8359278133365885 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441803,2353.455757431689,3004.2024881525895,0.7833878597440774 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441807,2569.629460640722,3004.2024881525895,0.8553449611916456 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441796,2219.312779350305,3004.2024881525895,0.7387360832375363 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441797,317.0982401480314,96.13121274223809,3.298598146247092 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441802,181.301927009404,96.13121274223809,1.8859839779150487 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441791,386.59034129892973,96.13121274223809,4.021486157004132 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441803,154.5582030534051,96.13121274223809,1.607783763925152 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441807,81.44175750067542,96.13121274223809,0.8471936967969985 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441797,321.2196377423184,490.807523353751,0.6544717072537586 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441802,235.1695127174712,490.807523353751,0.4791481416391657 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441791,179.0085169726634,490.807523353751,0.3647224389501513 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441803,350.2073050540205,490.807523353751,0.7135328787566435 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441807,339.6656792469278,490.807523353751,0.6920547527999337 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441796,249.6346822103961,490.807523353751,0.5086203253458916 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441797,122.14925637582076,78.64120835950264,1.553247450337032 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441802,159.42531388145284,78.64120835950264,2.02724903656937 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441791,167.89747517516034,78.64120835950264,2.1349808666167625 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441803,259.1257234660429,78.64120835950264,3.2950374094135007 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441807,265.2054972585544,78.64120835950264,3.372347688837466 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441797,1735.6841351814376,1710.8868039225827,1.01449384681792 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441802,2398.390880181941,1710.8868039225827,1.4018407732662996 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441791,1667.7832916448365,1710.8868039225827,0.9748063330788911 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441803,2123.6463668050337,1710.8868039225827,1.2412547469161077 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441807,1550.7120559048758,1710.8868039225827,0.9063791083954408 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441796,2100.9850842777255,1710.8868039225827,1.2280094039306149 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441797,249.4233303330013,158.21676846284709,1.5764658370681588 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441802,232.02640500708668,158.21676846284709,1.46650956950604 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441791,208.87695288452198,158.21676846284709,1.32019478664533 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441803,276.9780762049154,158.21676846284709,1.7506240261123533 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441807,276.4020941215922,158.21676846284709,1.7469835644285563 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441797,1009.9279759172484,1068.4447009417866,0.9452318636865734 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441802,2135.5480879772635,1068.4447009417866,1.9987446108299969 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441791,1299.382244605937,1068.4447009417866,1.216143655783579 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441803,1079.7041268782027,1068.4447009417866,1.0105381457051466 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441807,954.0879894309272,1068.4447009417866,0.8929689937064043 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441796,1014.2545876620594,1068.4447009417866,0.9492813121428175 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441797,153.38966074076808,101.193417409009,1.5158067062879148 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441802,175.3377442564173,101.193417409009,1.7326991097427589 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441791,142.04234953383852,101.193417409009,1.4036718313378438 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441803,136.86086665002838,101.193417409009,1.3524680770178634 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441807,134.01265529020583,101.193417409009,1.3243218652113138 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441797,8517.32467287618,8195.704907369402,1.0392424775100901 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441802,9492.367531283637,8195.704907369402,1.1582124586682354 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441791,10405.88117221585,8195.704907369402,1.2696749443551958 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441803,10170.314879675472,8195.704907369402,1.2409322925390522 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441807,11412.591881647108,8195.704907369402,1.3925088824739347 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441796,8525.14817331282,8195.704907369402,1.0401970629331945 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441797,52.23531944354825,54.484574340672744,0.9587175833831297 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441802,26.278206972746023,54.484574340672744,0.48230544683046805 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441791,53.59769381093034,54.484574340672744,0.9837223555387061 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441803,15.611173241423408,54.484574340672744,0.28652464354061524 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441807,47.66679421609808,54.484574340672744,0.8748676995814357 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441797,135.1100244556339,181.8259570369428,0.7430733579374625 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441802,351.43754856403837,181.8259570369428,1.9328238623962497 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441791,86.22918847883402,181.8259570369428,0.47424025636402534 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441803,235.16347283962008,181.8259570369428,1.2933437924478535 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441807,18.95148342874477,181.8259570369428,0.10422870165283535 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441796,196.67693263130917,181.8259570369428,1.0816768729634625 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441797,479.5841412327396,598.5025834222519,0.8013067186618748 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441802,629.5947094367032,598.5025834222519,1.0519498609958637 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441791,646.9785395732122,598.5025834222519,1.0809954000094262 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441803,703.8370094091265,598.5025834222519,1.175996610381479 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441807,575.9519611752231,598.5025834222519,0.9623215958098564 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441797,16750.982854241865,15066.853658787537,1.111777099160453 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441802,14492.737460120536,15066.853658787537,0.961895415481642 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441791,19344.897798325543,15066.853658787537,1.283937458770159 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441803,15582.29,15066.853658787537,1.0342099520500647 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441807,20409.319376274583,15066.853658787537,1.3545840318407238 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441796,16511.3980065357,15066.853658787537,1.0958756473290394 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441797,62.79472359760744,62.8704966822211,0.9987947751550833 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441802,63.22320500326724,62.8704966822211,1.0056100768986906 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441791,896.6811584656532,62.8704966822211,14.262352069491795 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441803,63.10952133451059,62.8704966822211,1.003801857228799 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441807,61.94540089846534,62.8704966822211,0.9852856930901682 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441797,99.19987358614227,100.49015468400951,0.9871601242736214 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441802,107.43513352746594,100.49015468400951,1.0691110374473485 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441791,97.17386944890396,100.49015468400951,0.9669989040664373 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441803,100.683067065473,100.49015468400951,1.0019197142453418 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441807,97.26512303623714,100.49015468400951,0.9679069889193279 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441796,101.10892608648004,100.49015468400951,1.0061575325902945 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441797,140.38361867424112,109.95671552102958,1.2767170973508417 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441802,132.46026671097448,109.95671552102958,1.2046582701503212 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441791,119.40262977683885,109.95671552102958,1.0859057512863115 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441803,131.4999790899998,109.95671552102958,1.1959249461652937 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441807,156.74816554085027,109.95671552102958,1.4255442680158237 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441797,264.5780964941253,243.54938966397899,1.0863426792370914 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441802,286.54456121552744,243.54938966397899,1.1765357392636795 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441791,260.86860601695753,243.54938966397899,1.0711117214330677 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441803,269.40518853868804,243.54938966397899,1.1061624457789931 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441807,251.98437486084035,243.54938966397899,1.0346335714842028 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441796,257.5921480760448,243.54938966397899,1.0576587706971483 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441797,228.59871696807704,49.66723175069083,4.602606364605722 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441802,219.29802572613977,49.66723175069083,4.415346255392812 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441791,252.1320768292534,49.66723175069083,5.076427011170125 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441803,255.10855066481363,49.66723175069083,5.136355332734349 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441807,346.96798225251916,49.66723175069083,6.98585304681679 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441797,500.7357805215887,318.9289567276793,1.5700543019339164 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441802,615.9871640860807,318.9289567276793,1.9314243849361334 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441791,488.6444029498371,318.9289567276793,1.532141853670161 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441803,505.8420472589054,318.9289567276793,1.5860649733690495 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441807,348.8639161245557,318.9289567276793,1.0938609015124228 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441796,614.9362184304721,318.9289567276793,1.928129150579267 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441797,50.93400203615255,52.85511393128503,0.9636532446485679 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441802,73.34065398326939,52.85511393128503,1.3875791485118516 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441791,44.08640351361986,52.85511393128503,0.8340991104651662 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441803,56.11486330924136,52.85511393128503,1.0616733015123987 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441807,46.6347072033895,52.85511393128503,0.8823121120128045 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441797,127.23353646333516,145.91831693350866,0.8719504112791563 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441802,137.15930494194512,145.91831693350866,0.9399731837946377 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441791,114.35906820717705,145.91831693350866,0.7837197591806628 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441803,129.56904749363926,145.91831693350866,0.8879560168767615 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441807,133.92517930096938,145.91831693350866,0.9178092381780674 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441796,112.97215099486291,145.91831693350866,0.7742150085677146 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441797,1638.8202683049988,261.347965154705,6.27064483679794 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441802,1906.921575694311,261.347965154705,7.296485260811227 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441791,1160.3063389551216,261.347965154705,4.43969915077884 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441803,1095.2463223027582,261.347965154705,4.19075894336666 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441807,1493.2920003836284,261.347965154705,5.713807641470153 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441797,8832.427934135794,7540.877985370558,1.171273152976466 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441802,13950.387853385631,7540.877985370558,1.8499686482727395 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441791,10498.081498026442,7540.877985370558,1.392156393246637 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441803,8938.409889502871,7540.877985370558,1.185327478689292 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441807,6261.274505480102,7540.877985370558,0.830311074867819 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441796,8190.973216931258,7540.877985370558,1.0862094881818665 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441797,8424.797552289228,5107.556668860965,1.649477058894393 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441802,13415.832604855565,5107.556668860965,2.6266634860161866 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441791,4544.337988929236,5107.556668860965,0.8897283541922342 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441803,5609.355869403705,5107.556668860965,1.0982464283954083 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441807,6843.191615358009,5107.556668860965,1.3398170708665103 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441797,74385.27568434596,180330.65339424144,0.41249379561512384 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441802,132678.95580757724,180330.65339424144,0.7357537573909446 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441791,81447.23147477373,180330.65339424144,0.45165494574409726 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441803,116772.75090829778,180330.65339424144,0.6475479831651667 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441807,45737.32350296683,180330.65339424144,0.25363033207102753 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441796,51330.06893554121,180330.65339424144,0.2846441687499611 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441797,323.6342309432382,98.01831453553807,3.301773066357916 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441802,425.22286546477153,98.01831453553807,4.338198095730369 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441791,247.2152713236366,98.01831453553807,2.5221334655168435 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441803,176.76509425072734,98.01831453553807,1.8033884288699782 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441807,425.6857910657972,98.01831453553807,4.342920943733002 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441797,1598.1201775726902,1812.4793707702274,0.8817315128356779 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441802,1726.533750999667,1812.4793707702274,0.9525811873190937 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441791,2020.43,1812.4793707702274,1.114732687490618 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441803,3329.666046973834,1812.4793707702274,1.8370780383331293 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441807,1522.5200223948325,1812.4793707702274,0.8400206076540477 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441796,1374.6560343275078,1812.4793707702274,0.7584395477799766 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441797,17958.653828440234,434.5650550234931,41.325582029299085 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441802,24704.93788755669,434.5650550234931,56.84980327334676 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441791,1530.9283083146927,434.5650550234931,3.522897873672629 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441803,3694.874482392026,434.5650550234931,8.502465717571969 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441807,1147.707285511193,434.5650550234931,2.6410482670981144 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441797,2471619.5674535297,9833.502392298877,251.3468211884692 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441802,1984081.632323034,9833.502392298877,201.7675445807458 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441791,2599070.1682663155,9833.502392298877,264.307676408538 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441803,2094589.255751987,9833.502392298877,213.00541477392306 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441807,1409941.3916490015,9833.502392298877,143.38140526138474 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441796,1991542.9070842275,9833.502392298877,202.52630524032898 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441797,52.23546882999613,42.4088060383901,1.2317127905631335 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441802,66.22560144332991,42.4088060383901,1.5616002342386137 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441791,46.77520974077643,42.4088060383901,1.1029598357103876 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441803,35.16263447072856,42.4088060383901,0.8291352140142305 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441807,50.891795204533715,42.4088060383901,1.2000289552708578 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441797,1189.012011028525,385.8715169071063,3.0813676545987834 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441802,1185.8495378410223,385.8715169071063,3.0731719908896533 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441791,1739.0914906611442,385.8715169071063,4.506918532366846 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441803,1412.9716694512615,385.8715169071063,3.6617672140631634 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441807,1151.014938313174,385.8715169071063,2.982896865617232 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441796,1065.0823134947568,385.8715169071063,2.76019935866674 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441797,1845.846536984228,1002.6445024002205,1.840978066069753 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441802,1510.014092501029,1002.6445024002205,1.5060313888783328 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441791,1065.4916271390468,1002.6445024002205,1.0626813637220143 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441803,1328.0290443085646,1002.6445024002205,1.3245263312464282 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441807,1937.0218968368267,1002.6445024002205,1.9319129484077453 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441797,21779.945721650103,6245.085755978491,3.4875334899604726 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441802,26620.32315075659,6245.085755978491,4.262603299766165 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441791,25638.14267156286,6245.085755978491,4.105330762995396 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441803,30410.53111523152,6245.085755978491,4.86951377507013 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441807,20319.65472684693,6245.085755978491,3.253703074836834 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441796,17637.628221189225,6245.085755978491,2.82424115702567 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441797,365.5741872417371,289.8012081128336,1.2614653666295326 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441802,360.2144696095059,289.8012081128336,1.242970903935145 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441791,216.0549608471757,289.8012081128336,0.7455281579193938 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441803,293.99089686598387,289.8012081128336,1.014457112792708 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441807,186.6559751701082,289.8012081128336,0.6440828055396995 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441797,34984.77573371662,19122.271903916942,1.8295302937592082 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441802,29217.617591475177,19122.271903916942,1.5279365202149613 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441791,47019.29228072035,19122.271903916942,2.45887583426157 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441803,33337.43584224783,19122.271903916942,1.743382586010562 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441807,36031.28548593817,19122.271903916942,1.8842575645291206 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441796,39002.21661047941,19122.271903916942,2.0396225305472373 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441797,100.70022129866292,111.01681566749893,0.9070717863162754 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441802,165.14288659076118,111.01681566749893,1.4875484006438504 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441791,84.10303854687021,111.01681566749893,0.7575702657403103 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441803,76.20194991151779,111.01681566749893,0.6864000687945018 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441807,50.693426834860304,111.01681566749893,0.4566283632804757 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441797,1906.3078456566464,1048.3386659324408,1.8184084090431676 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441802,1433.9765467583295,1048.3386659324408,1.3678562027309034 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441791,2145.685072364337,1048.3386659324408,2.0467480043349022 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441803,1645.555485531802,1048.3386659324408,1.569679283047496 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441807,2016.054696982856,1048.3386659324408,1.9230948571277622 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441796,1668.2551634816166,1048.3386659324408,1.5913322838262323 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441797,32979.30822480784,5453.602601951663,6.047251813508678 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441802,68684.59519130191,5453.602601951663,12.594352798409252 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441791,51707.612591117126,5453.602601951663,9.481367889294443 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441803,38456.33850042446,5453.602601951663,7.051547629572829 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441807,29890.286937088746,5453.602601951663,5.48083333508606 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441797,290056.6701963597,64173.361133824874,4.519892133925878 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441802,552376.7031386528,64173.361133824874,8.607570078599215 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441791,204613.8646090761,64173.361133824874,3.1884548509525863 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441803,257798.18712012225,64173.361133824874,4.017214971528746 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441807,155724.74082809617,64173.361133824874,2.426625909516462 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441796,105813.31839072658,64173.361133824874,1.6488667029621091 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441797,29.62412224736773,44.60879663763593,0.6640870070539898 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441802,9.66977309884625,44.60879663763593,0.21676830194267047 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441791,28.813842043228114,44.60879663763593,0.6459228720578892 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441803,133.00644854514252,44.60879663763593,2.9816192897014058 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441807,33.75781264589066,44.60879663763593,0.7567523715134153 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441797,140.74205333858637,136.29080299882398,1.0326599465394655 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441802,152.41593766955378,136.29080299882398,1.1183141805310879 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441791,139.004077738099,136.29080299882398,1.0199079811665535 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441803,145.95013092295426,136.29080299882398,1.0708729254769571 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441807,134.71758539346646,136.29080299882398,0.9884569055964026 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441796,135.2675118875777,136.29080299882398,0.9924918549987919 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441797,43.34658896436272,82.77341642135346,0.5236776593068156 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441802,104.16721834512616,82.77341642135346,1.2584622315801095 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441791,96.47435765382325,82.77341642135346,1.1655234473194378 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441803,31.61985790222966,82.77341642135346,0.3820049874620438 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441807,246.31906374342387,82.77341642135346,2.97582333063976 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441797,4224.113437395399,2141.365658987758,1.9726259360076663 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441802,4027.888065576123,2141.365658987758,1.8809903150684413 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441791,3844.8254103132,2141.365658987758,1.7955015735755668 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441803,5257.875313557441,2141.365658987758,2.4553841570630603 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441807,3816.053594829397,2141.365658987758,1.7820653744084411 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441796,2733.8384022083865,2141.365658987758,1.2766798564896644 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441797,340.66772276678614,285.0677067828484,1.195041439843943 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441802,170.75822286453686,285.0677067828484,0.5990093539238126 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441791,273.71248134533914,285.0677067828484,0.9601665668635025 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441803,328.76214221199484,285.0677067828484,1.1532773947714494 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441807,238.69164991639775,285.0677067828484,0.837315641993157 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441797,126280.59404456764,724296.655045942,0.17434927134456762 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441802,158303.9618224902,724296.655045942,0.2185623262507667 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441791,215441.1372960035,724296.655045942,0.297448753622006 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441803,488325.0061822702,724296.655045942,0.6742058005932607 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441807,274764.88690834696,724296.655045942,0.3793540740443136 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441796,112366.81115092212,724296.655045942,0.15513921038858686 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441797,66.99192048467529,126.94877083842833,0.5277083034536664 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441802,86.08382322832622,126.94877083842833,0.6780989107636796 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441791,45.2628785731587,126.94877083842833,0.356544441306692 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441803,25.736732959875273,126.94877083842833,0.2027332189976949 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441807,46.01834570697704,126.94877083842833,0.3624954019093735 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441797,5708.909233655078,94593.87687362579,0.06035178409361514 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441802,11263.739417863237,94593.87687362579,0.11907472016303138 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441791,13106.1796594158,94593.87687362579,0.13855209335510385 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441803,26477.9534098339,94593.87687362579,0.2799119169754248 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441807,13460.453524191376,94593.87687362579,0.1422973026274638 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441796,9023.7266914618,94593.87687362579,0.09539440595628819 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441797,5.98739560454023,34.2642969985689,0.17474152774213642 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441802,3.430203593481006,34.2642969985689,0.1001101406990569 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441791,394.04654803485073,34.2642969985689,11.50020816277972 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441803,3.706447880463413,34.2642969985689,0.108172301933357 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441807,3.776353606363725,34.2642969985689,0.1102124933869634 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441797,135.60163363930866,74.66086218948179,1.8162344990761732 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441802,42.879688733845846,74.66086218948179,0.5743261928186885 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441791,24.935923736323968,74.66086218948179,0.3339892281586448 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441803,19.640312466551674,74.66086218948179,0.26306034903141795 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441807,114.43388673655276,74.66086218948179,1.532715848447223 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441796,51.52511980334605,74.66086218948179,0.6901222178841232 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441797,422.8337519723459,347.6986105145094,1.2160927285462968 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441802,1043.116831570759,347.6986105145094,3.000060397213551 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441791,367.35694654928454,347.6986105145094,1.0565384371415392 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441803,1547.5518747851715,347.6986105145094,4.450842850637715 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441807,331.5232430072976,347.6986105145094,0.9534787686287379 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441797,6933.9411207429175,2521.321340016667,2.750121934357277 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441802,5383.907095717351,2521.321340016667,2.1353514168415204 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441791,5897.775871073933,2521.321340016667,2.3391607319021643 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441803,5451.032387163277,2521.321340016667,2.161974477686864 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441807,6385.427084546094,2521.321340016667,2.5325717048442082 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441796,4679.248199991572,2521.321340016667,1.8558714138201202 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441797,233.92261657701377,79.44971561377609,2.944285133935118 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441802,474.8876749182016,79.44971561377609,5.9772105066649095 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441791,86.85977104187731,79.44971561377609,1.0932672366522147 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441803,297.18386042097313,79.44971561377609,3.7405276799939013 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441807,126.55699212897008,79.44971561377609,1.5929193849376835 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441797,125.35227461805542,42.37178439720435,2.958390268461907 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441802,61.61875259159144,42.37178439720435,1.4542402088607103 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441791,137.42472649565312,42.37178439720435,3.2433075087751146 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441803,98.71056373725791,42.37178439720435,2.329629614177182 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441807,303.05999157631544,42.37178439720435,7.152400964173485 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441796,225.07538960409508,42.37178439720435,5.311916710756825 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441797,2134.4150441959964,1321.2949146990686,1.6153963967099048 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441802,1316.960429929088,1321.2949146990686,0.9967195175567841 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441791,3531.4183326392863,1321.2949146990686,2.6726950155889946 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441803,2149.923635237173,1321.2949146990686,1.6271338149566925 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441807,4189.87777274591,1321.2949146990686,3.1710390512629614 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441797,94652.55978966528,23354.026662177774,4.05294389523656 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441802,94483.20093289229,23354.026662177774,4.0456920898317446 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441791,114855.72767238604,23354.026662177774,4.9180267426172275 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441803,109835.43982749344,23354.026662177774,4.703062192070446 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441807,71971.87344185029,23354.026662177774,3.0817757675343374 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441796,92361.7624488999,23354.026662177774,3.9548538581777537 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441797,45857.61315120557,13473.54115415771,3.403530862935367 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441802,39255.93088261692,13473.54115415771,2.913557054783864 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441791,38428.984963263916,13473.54115415771,2.8521815106792006 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441803,31670.567683168072,13473.54115415771,2.350574902381551 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441807,9335.62160281896,13473.54115415771,0.6928855225219053 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441797,112416.81527799384,49612.48263442616,2.2658978004859542 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441802,110689.20515270822,49612.48263442616,2.2310757147214573 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441791,120248.40105780357,49612.48263442616,2.4237529483026328 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441803,120564.1447790542,49612.48263442616,2.430117147481642 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441807,135778.6181917452,49612.48263442616,2.7367833855895016 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441796,96343.62820284566,49612.48263442616,1.9419231428663217 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441099,405.2143143173143,73.06854961986588,5.545673431666756 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441079,162.0649679530624,73.06854961986588,2.2179852863673126 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441080,143.68709256446576,73.06854961986588,1.9664697508297073 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441096,200.09326880658105,73.06854961986588,2.738432196171302 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441089,146.4009626007255,73.06854961986588,2.0036111755654997 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441091,138.5352305461552,73.06854961986588,1.8959625073561093 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441099,17.493768369369146,990.9231863649335,0.01765401053288767 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441079,423.892377817063,990.9231863649335,0.42777521370960586 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441080,23.86968468122738,990.9231863649335,0.024088329963082265 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441096,3.564385848436262,990.9231863649335,0.003597035469027347 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441089,42.1697157974402,990.9231863649335,0.04255598857478958 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441091,339.52134763714685,990.9231863649335,0.3426313485333153 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441099,55.54302866085092,50.719124328797626,1.0951101659559677 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441079,54.611178218995114,50.719124328797626,1.0767374031335086 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441080,55.59697133914909,50.719124328797626,1.0961737229280573 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441096,78.25751797528352,50.719124328797626,1.5429587756279532 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441089,52.84058701468865,50.719124328797626,1.0418276678465146 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441091,47.33356194266294,50.719124328797626,0.9332488005079297 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441099,313.8239856739958,319.2477137201226,0.983010910296192 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441079,328.52016332369254,319.2477137201226,1.0290446860073645 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441080,319.9817176432805,319.2477137201226,1.0022991673600563 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441096,322.4725142705353,319.2477137201226,1.0101012486912901 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441089,363.4790560524887,319.2477137201226,1.1385486580841822 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441091,334.4809918859546,319.2477137201226,1.0477161699556812 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441099,53.73441195227974,44.58166891160943,1.2053028355402564 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441079,37.50891195527855,44.58166891160943,0.841352799726861 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441080,66.06988837835137,44.58166891160943,1.4819967486938612 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441096,50.687370572810984,44.58166891160943,1.1369554305673735 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441089,36.73845417473456,44.58166891160943,0.8240708585309952 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441091,246.3947178084123,44.58166891160943,5.526816824577178 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441099,1941.6593522075368,1543.2839395802719,1.258134878754464 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441079,2775.4637916574197,1543.2839395802719,1.7984142259733906 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441080,2221.384410186265,1543.2839395802719,1.439388017470341 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441096,1754.271859855638,1543.2839395802719,1.1367136110628797 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441089,2878.1998361727015,1543.2839395802719,1.8649839879468244 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441091,1406.6261692409316,1543.2839395802719,0.9114500145860993 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441099,34.497585647182724,31.276034215973343,1.1030038338289088 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441079,31.50679447557741,31.276034215973343,1.0073781815818008 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441080,36.45448770788538,31.276034215973343,1.1655725740723 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441096,24.900893311038484,31.276034215973343,0.7961653046894629 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441089,47.000763683496984,31.276034215973343,1.502772485761404 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441091,43.68999415315836,31.276034215973343,1.3969160492491386 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441099,60.867293288515306,130.468422036268,0.4665289296715433 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441079,244.68208822116804,130.468422036268,1.8754123365817252 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441080,243.3395413523741,130.468422036268,1.865122131121735 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441096,168.8147113347329,130.468422036268,1.2939124172729342 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441089,39.365370295582565,130.468422036268,0.30172335712498816 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441091,307.71608484990844,130.468422036268,2.3585483755170165 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441099,112.92341214948496,95.42663227533711,1.1833532155223072 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441079,117.60631696578088,95.42663227533711,1.2324265685751972 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441080,93.59183064134062,95.42663227533711,0.9807726460606669 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441096,87.91525773895992,95.42663227533711,0.9212863918879123 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441089,130.71127307691094,95.42663227533711,1.3697567435866969 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441091,105.21699783572868,95.42663227533711,1.1025957358753178 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441099,650.1894030543315,569.3868516791151,1.1419115161105855 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441079,519.8217759017327,569.3868516791151,0.9129500872188819 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441080,639.6494046231675,569.3868516791151,1.1234003783839561 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441096,647.3048486022362,569.3868516791151,1.1368454446978216 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441089,562.4489892782861,569.3868516791151,0.9878152044073913 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441091,770.1155205728371,569.3868516791151,1.3525347807062553 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441099,1819.0848086026851,5328.634617598269,0.3413791597935807 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441079,2139.058002694864,5328.634617598269,0.40142703641763 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441080,2538.5454439371506,5328.634617598269,0.47639698086136145 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441096,7917.4704683647715,5328.634617598269,1.485834746900576 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441089,10224.187545074072,5328.634617598269,1.9187255795899052 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441091,520.1805359419822,5328.634617598269,0.09761985447905204 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441099,833706.4508590208,656386.6079991342,1.270145430602875 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441079,824032.6283538535,656386.6079991342,1.2554074356662384 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441080,709413.5336469379,656386.6079991342,1.0807861175130398 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441096,716721.7571738436,656386.6079991342,1.0919201404163763 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441089,811378.82995326,656386.6079991342,1.2361294701404546 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441091,819266.3033460755,656386.6079991342,1.248145975804485 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441099,1783.3093143478095,5223.837669019135,0.3413791597935807 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441079,2096.989674201132,5223.837669019135,0.40142703641763 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441080,2488.6204940305684,5223.837669019135,0.4763969808613615 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441096,7761.759520796743,5223.837669019135,1.4858347469005764 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441089,10023.11095917232,5223.837669019135,1.9187255795899052 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441091,509.9502730718385,5223.837669019135,0.09761985447905207 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441099,833706.4508590208,656386.6079991342,1.270145430602875 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441079,824032.6283538535,656386.6079991342,1.2554074356662384 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441080,709413.5336469379,656386.6079991342,1.0807861175130398 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441096,716721.7571738436,656386.6079991342,1.0919201404163763 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441089,811378.82995326,656386.6079991342,1.2361294701404546 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441091,819266.3033460755,656386.6079991342,1.248145975804485 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441099,47.97355700477776,50.79723336807032,0.944412792270938 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441079,45.26109158889608,50.79723336807032,0.8910148956526813 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441080,51.59285742534955,50.79723336807032,1.0156627439040673 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441096,60.75554074961963,50.79723336807032,1.1960403494692844 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441089,38.70492586574369,50.79723336807032,0.7619494862110441 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441091,24.978850229851112,50.79723336807032,0.4917364307787695 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441099,182.34873815567508,124.85055234194422,1.4605360948364345 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441079,72.61353211801044,124.85055234194422,0.5816036113251181 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441080,104.84420234768504,124.85055234194422,0.8397576172553468 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441096,70.5998612232694,124.85055234194422,0.5654749610551062 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441089,52.52108558326989,124.85055234194422,0.42067163178760836 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441091,192.48130184972584,124.85055234194422,1.5416936348231172 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441099,231.95271279157032,149.81706398084205,1.5482396105508476 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441079,182.92669011709916,149.81706398084205,1.2210003670909677 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441080,161.2046851030755,149.81706398084205,1.0760101741393733 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441096,182.2760695067607,149.81706398084205,1.2166576000319254 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441089,187.09673484719897,149.81706398084205,1.2488346111970536 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441091,171.88690159967052,149.81706398084205,1.1473119084862768 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441099,3525.699803983189,2791.14294318225,1.2631742177860132 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441079,3166.898428798904,2791.14294318225,1.1346242357577883 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441080,3229.8144927040007,2791.14294318225,1.1571655620839005 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441096,3371.41,2791.14294318225,1.2078958579441916 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441089,3237.746181756152,2791.14294318225,1.1600072972488893 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441091,3455.817215086712,2791.14294318225,1.23813695157678 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441099,316.0457778685168,222.01180748199775,1.4235539156814618 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441079,483.1591519706168,222.01180748199775,2.176276827122335 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441080,257.39102118734,222.01180748199775,1.1593573517850444 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441096,321.71352678032144,222.01180748199775,1.4490829583755729 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441089,435.3449758785002,222.01180748199775,1.9609091102679346 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441091,453.155001898502,222.01180748199775,2.041130185993585 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441099,6267.6927581557175,4330.453784028004,1.4473524186478621 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441079,6751.659794411639,4330.453784028004,1.5591113844266762 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441080,7057.850405148468,4330.453784028004,1.6298177413138344 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441096,6845.615336031081,4330.453784028004,1.5808078500409675 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441089,7447.5965151792125,4330.453784028004,1.7198189581535668 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441091,5631.230066362312,4330.453784028004,1.3003787471723995 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441099,76.91996799794822,100.4664893584531,0.765628106338089 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441079,91.28920285354118,100.4664893584531,0.9086532577826185 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441080,89.09736229967152,100.4664893584531,0.886836624516481 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441096,44.34126195182026,100.4664893584531,0.44135375123555515 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441089,112.74437255513878,100.4664893584531,1.1222087411940869 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441091,41.24706954646457,100.4664893584531,0.41055549775706485 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441099,285.76234901419184,219.8603821991507,1.2997446204534784 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441079,72.46544182181758,219.8603821991507,0.3295975432089352 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441080,231.90230060301127,219.8603821991507,1.0547707517080223 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441096,505.7492118766514,219.8603821991507,2.3003198976455024 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441089,615.9739402580274,219.8603821991507,2.8016595536528945 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441091,166.37697345227193,219.8603821991507,0.756739216897962 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441099,194.78116850364717,115.26780159034894,1.689814204975309 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441079,117.63047703708015,115.26780159034894,1.0204972716936855 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441080,173.65946357389922,115.26780159034894,1.5065739189775547 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441096,170.39060064672202,115.26780159034894,1.4782150634942652 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441089,117.52269288556008,115.26780159034894,1.0195621957224865 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441091,150.93375763404936,115.26780159034894,1.3094182031028396 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441099,1901.6449362625644,1760.6737631139824,1.0800666063764452 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441079,1797.338819420036,1760.6737631139824,1.0208244463421814 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441080,1269.89031994999,1760.6737631139824,0.7212524810411343 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441096,1262.032947763867,1760.6737631139824,0.7167897734397974 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441089,1656.5870850888864,1760.6737631139824,0.9408824733998392 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441091,3282.6114102276656,1760.6737631139824,1.8644063874854004 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441099,1731.7198428082386,518.6000624505415,3.3392202743388437 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441079,1727.8393551584015,518.6000624505415,3.3317376534700753 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441080,592.721516220204,518.6000624505415,1.1429260409638524 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441096,478.4499146511378,518.6000624505415,0.9225797474653549 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441089,886.9925119312488,518.6000624505415,1.7103594391021515 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441091,1702.7201002065754,518.6000624505415,3.2833009933718675 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441099,546.2057544039865,841.89306662726494,0.6487828158416353 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441079,805.440021684037,841.89306662726494,0.9567010985263679 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441080,1507.197413037668,841.89306662726494,1.7902480407347934 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441096,981.129632727822,841.89306662726494,1.1653850965400596 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441089,1722.4054903566605,841.89306662726494,2.0458720455518713 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441091,452.07376113829497,841.89306662726494,0.5369728995980003 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441099,630.2404710443806,246.94010350613598,2.552199752474471 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441079,529.4079804858984,246.94010350613598,2.1438720279500636 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441080,361.9740220224232,246.94010350613598,1.4658373301177012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441096,421.6847170445678,246.94010350613598,1.707639670743435 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441089,520.4748629069896,246.94010350613598,2.1076967876708483 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441091,385.2069944191269,246.94010350613598,1.5599207619573838 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441099,5434.025229896751,6405.278640912654,0.8483667197844941 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441079,2471.519904735165,6405.278640912654,0.38585673524782227 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441080,3589.6797436833963,6405.278640912654,0.5604252281477519 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441096,3872.780771273523,6405.278640912654,0.604623309677237 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441089,3809.312276619721,6405.278640912654,0.5947145300265896 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441091,9102.115559346592,6405.278640912654,1.421033505273032 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441099,405.4531928528713,184.84349394551683,2.1934945298771504 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441079,210.69799583049544,184.84349394551683,1.1398723933047885 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441080,266.9832655336906,184.84349394551683,1.44437469685779 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441096,274.52095665097585,184.84349394551683,1.4851534711407897 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441089,363.88108078662,184.84349394551683,1.968590146288162 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441091,139.70821272957377,184.84349394551683,0.7558189349675093 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441099,62488.335545504495,66689.05961878091,0.9370102967819715 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441079,30828.68155422159,66689.05961878091,0.46227494780177775 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441080,37309.17046548214,66689.05961878091,0.55944964104689765 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441096,41418.02461944584,66689.05961878091,0.6210617581985176 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441089,41107.3943181436,66689.05961878091,0.6164038682375867 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441091,68527.65206583778,66689.05961878091,1.0275696262260547 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441099,3178.269467291179,426.591426110135,7.450382902141665 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441079,2011.1671061071795,426.591426110135,4.714504284453077 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441080,1494.5518944778803,426.591426110135,3.5034738229643305 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441096,1876.9251855373548,426.591426110135,4.399819289975089 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441089,2573.1577328928697,426.591426110135,6.031902132577194 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441091,556.6911949471281,426.591426110135,1.3049751140647743 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441099,379461.2194788013,6086.038398766024,62.34946193499847 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441079,276433.44779778225,6086.038398766024,45.42091746477159 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441080,275504.4232900411,6086.038398766024,45.26826898527309 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441096,269231.7056690999,6086.038398766024,44.23759562931578 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441089,204192.5351946903,6086.038398766024,33.5509771407442 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441091,402117.9151846655,6086.038398766024,66.07219488891114 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441099,280.2958869104941,118.38689307733607,2.3676260067691044 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441079,280.9599201435672,118.38689307733607,2.3732350164813476 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441080,129.70109006382907,118.38689307733607,1.095569675767249 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441096,80.35015164842892,118.38689307733607,0.6787081708102627 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441089,140.40072938465156,118.38689307733607,1.185948256053438 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441091,332.3828204405753,118.38689307733607,2.8075981369275964 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441099,42.41645043768952,43.003791743375764,0.9863421042220837 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441079,23.124140127802725,43.003791743375764,0.5377232841651628 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441080,96.3502104204802,43.003791743375764,2.24050500001135 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441096,153.2607537167943,43.003791743375764,3.563889310769959 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441089,79.78902863206629,43.003791743375764,1.855395196502803 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441091,19.556097894473897,43.003791743375764,0.45475287414594756 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441099,87.23155657778024,56.77751951238643,1.5363749125875434 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441079,80.19583588069605,56.77751951238643,1.4124575460398678 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441080,38.66684725783167,56.77751951238643,0.681023890967907 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441096,8.187979550406377,56.77751951238643,0.14421164610088522 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441089,55.67334682580662,56.77751951238643,0.9805526430872182 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441091,17.941651236034748,56.77751951238643,0.3159992086678011 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441099,139.09280683774426,232.93832449773902,0.5971228956748779 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441079,169.17876736936827,232.93832449773902,0.7262813782753486 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441080,99.36409625767264,232.93832449773902,0.42656826210079957 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441096,70.69795464709446,232.93832449773902,0.3035050363633086 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441089,149.66302835419825,232.93832449773902,0.6425006648300629 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441091,168.776825548518,232.93832449773902,0.7245558493323678 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441099,57.707789424721426,55.88566907011774,1.0326044294525227 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441079,52.26133591891968,55.88566907011774,0.9351473604681955 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441080,49.62041044691211,55.88566907011774,0.8878914983491593 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441096,32.128510168056344,55.88566907011774,0.5748971194698566 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441089,9.905617509376574,55.88566907011774,0.17724790047602992 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441091,32.345969888185124,55.88566907011774,0.5787882730293843 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441099,74.4494290472428,226.42114305345407,0.32880952742856967 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441079,197.13716236043945,226.42114305345407,0.8706658737867904 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441080,130.99919199018953,226.42114305345407,0.5785643081894649 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441096,147.62811399681206,226.42114305345407,0.6520067516926176 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441089,248.12,226.42114305345407,1.0958340579590804 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441091,130.27186434780612,226.42114305345407,0.5753520302521007 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441099,326.60996928631073,212.71806341276286,1.5354124800043403 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441079,346.8987912179663,212.71806341276286,1.630791413067898 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441080,257.0150872328388,212.71806341276286,1.208242887836568 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441096,352.1218392400694,212.71806341276286,1.6553452658921792 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441089,602.7619259478074,212.71806341276286,2.8336189051241725 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441091,303.8578805266771,212.71806341276286,1.4284535861774208 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441099,11480.383390211042,10996.969545575432,1.0439588236224686 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441079,9448.27028306456,10996.969545575432,0.8591703599712175 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441080,8778.385801380398,10996.969545575432,0.7982549887948296 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441096,12712.687829946795,10996.969545575432,1.1560173716277748 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441089,9593.145903861794,10996.969545575432,0.8723445003738818 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441091,14548.15891408745,10996.969545575432,1.3229243614610917 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441099,214.64203409502375,147.8550055811589,1.4517062391723008 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441079,176.8103249597791,147.8550055811589,1.195835908732399 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441080,159.08260552797148,147.8550055811589,1.0759365562409022 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441096,130.64854231156022,147.8550055811589,0.8836261024645938 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441089,181.25583424384513,147.8550055811589,1.2259025897121367 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441091,121.137432870509,147.8550055811589,0.8192988285676646 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441099,196.88995896398225,92.19915296117537,2.1354855510103405 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441079,183.9068175639408,92.19915296117537,1.9946692746882728 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441080,250.76402387871303,92.19915296117537,2.719808326051635 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441096,262.0528654919926,92.19915296117537,2.8422480801135106 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441089,155.61049142606385,92.19915296117537,1.6877648701565695 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441091,139.26868868020549,92.19915296117537,1.5105202619253006 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441099,3319.8981064836917,1229.7970051816276,2.699549675674628 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441079,3450.658645420761,1229.7970051816276,2.805876604741883 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441080,1278.2952559952923,1229.7970051816276,1.0394359805799838 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441096,1444.6221366921352,1229.7970051816276,1.1746834075911416 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441089,1874.9730559790496,1229.7970051816276,1.5246199560407423 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441091,4160.843593303177,1229.7970051816276,3.383358046711673 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441099,85470.32079939006,50083.06853493704,1.7065711686528855 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441079,78816.75842630565,50083.06853493704,1.5737206351748299 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441080,77270.81045726273,50083.06853493704,1.5428529584476243 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441096,82566.04011994104,50083.06853493704,1.6485818967411006 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441089,94773.72072189696,50083.06853493704,1.8923305519066693 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441091,72607.19829428353,50083.06853493704,1.4497354179413762 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441099,10.187190546914948,35.678906774941794,0.2855241785062112 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441079,28.77327657394944,35.678906774941794,0.8064506223648547 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441080,59.66498260111094,35.678906774941794,1.6722760867498099 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441096,8.766349538258886,35.678906774941794,0.24570118119246068 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441089,21.51977255393621,35.678906774941794,0.6031511192223551 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441091,77.61066369057217,35.678906774941794,2.1752534117743796 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441099,175.63014132856642,67.70693010562654,2.593975846410016 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441079,62.22921363355031,67.70693010562654,0.9190966646467253 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441080,73.6174064691689,67.70693010562654,1.0872949985226281 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441096,106.09462822907687,67.70693010562654,1.566968522477144 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441089,67.42824943487693,67.70693010562654,0.9958840155606693 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441091,16.146624185277137,67.70693010562654,0.23847816109942532 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441099,90.21727633338028,64.01321127549492,1.4093540151440054 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441079,79.79645465638966,64.01321127549492,1.246562280916795 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441080,55.31683579590988,64.01321127549492,0.8641471767107842 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441096,21.7190385766572,64.01321127549492,0.33928993943429187 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441089,143.71459637761825,64.01321127549492,2.2450771257063 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441091,78.00088140972959,64.01321127549492,1.2185122392006809 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441099,536.7004414708266,1060.427767412219,0.5061169256068675 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441079,705.3920104925237,1060.427767412219,0.6651957183410092 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441080,571.8793129252382,1060.427767412219,0.5392911525891155 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441096,418.9810331709747,1060.427767412219,0.39510567909158173 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441089,621.3366618225605,1060.427767412219,0.5859302075225921 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441091,678.7475791239423,1060.427767412219,0.6400696020817167 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441099,25.24284121568514,57.09593719876665,0.4421127396124154 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441079,295.082725200298,57.09593719876665,5.168191287814997 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441080,0.4788148100136213,57.09593719876665,0.008386145030717954 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441096,69.25250415741105,57.09593719876665,1.2129147458657883 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441089,22.046128540379037,57.09593719876665,0.38612429573807333 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441091,32.90724387489506,57.09593719876665,0.5763500082385179 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441099,317.03969018483315,50.205845180981015,6.314796395558623 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441079,41.01416310674544,50.205845180981015,0.8169200808969238 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441080,2.726591262548468,50.205845180981015,0.0543082434469474 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441096,176.81091488834437,50.205845180981015,3.5217197171162034 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441089,235.29506242464024,50.205845180981015,4.686606939420169 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441091,27.640449860092115,50.205845180981015,0.5505424669269958 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441099,2188.243019472895,1506.8779059558976,1.4521700867893268 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441079,2580.2495235281635,1506.8779059558976,1.7123149216866151 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441080,829.8698138389057,1506.8779059558976,0.5507213361871361 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441096,1048.1116828821257,1506.8779059558976,0.6955518285452924 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441089,3921.7832714048745,1506.8779059558976,2.602588607812301 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441091,2222.6409086405015,1506.8779059558976,1.4749973437499935 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441099,33539.53512765797,16162.128318216166,2.0751929738025843 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441079,27546.463794887874,16162.128318216166,1.7043834359266001 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441080,26434.041167423387,16162.128318216166,1.635554467020897 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441096,31449.008282612675,16162.128318216166,1.9458457242395995 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441089,23428.371255501617,16162.128318216166,1.449584534550177 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441091,25217.54287020676,16162.128318216166,1.5602860201143391 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441099,217.03079607156147,24.995311385825953,8.68286026613106 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441079,128.35524352116354,24.995311385825953,5.135172814608332 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441080,46.53190962584124,24.995311385825953,1.8616255227861656 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441096,169.95521078786476,24.995311385825953,6.799483637728993 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441089,89.3490002646021,24.995311385825953,3.574630413096957 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441091,16.485250376264194,24.995311385825953,0.6595337070140465 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441099,2256.2159890542544,522.7489803443298,4.316060047727126 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441079,556.8974949033809,522.7489803443298,1.065324880282995 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441080,3373.3897911681015,522.7489803443298,6.453173354725784 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441096,4214.36963582228,522.7489803443298,8.061937553749631 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441089,2585.138392561005,522.7489803443298,4.94527677673938 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441091,1390.1897343080911,522.7489803443298,2.6593829669306794 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441099,4.5503288892818965,2.8430683750443606,1.6004992807149414 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441079,4.468756437217828,2.8430683750443606,1.5718075852284423 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441080,3.1002122752878916,2.8430683750443606,1.0904459078440274 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441096,2.2086519736674117,2.8430683750443606,0.7768550320682843 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441089,3.756534890201619,2.8430683750443606,1.3212960065172563 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441091,2.5249186835909887,2.8430683750443606,0.8880963629837402 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441099,2755.8150352946004,1771.7543971110147,1.5554159424061114 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441079,1338.9005433497384,1771.7543971110147,0.7556919545581043 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441080,3630.6252857520935,1771.7543971110147,2.0491696206156536 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441096,4071.387715264654,1771.7543971110147,2.2979413636017347 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441089,2875.3110375355895,1771.7543971110147,1.6228609576045139 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441091,2217.571583117211,1771.7543971110147,1.251624709797891 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441099,487.7917909367267,73.62821549612136,6.625066051783137 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441079,108.05674749130571,73.62821549612136,1.4675997070307647 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441080,0.5470894805125003,73.62821549612136,0.007430432434442477 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441096,26.53408070195826,73.62821549612136,0.3603792448746234 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441089,55.32455628719598,73.62821549612136,0.7514042804705814 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441091,4.591488182402659,73.62821549612136,0.06236044363515143 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441099,881.2265527033918,1923.334023596175,0.4581765527423618 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441079,687.0382349922344,1923.334023596175,0.35721212569600214 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441080,869.0077002317381,1923.334023596175,0.451823598797936 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441096,853.340906772405,1923.334023596175,0.44367795520866493 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441089,931.7604259226408,1923.334023596175,0.48445065417210864 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441091,1317.302252835235,1923.334023596175,0.6849056048892613 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441099,67.88428114426594,51.40813337414527,1.320496907565351 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441079,19.372659751947467,51.40813337414527,0.3768403651413372 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441080,65.33159494005915,51.40813337414527,1.2708416091395454 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441096,58.53933381848278,51.40813337414527,1.138717358057665 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441089,11.322284628260846,51.40813337414527,0.22024306048729578 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441091,33.47398052269377,51.40813337414527,0.6511417226350581 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441099,4.651881347907398,89.1451395839603,0.052183230287345936 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441079,27.73159040136493,89.1451395839603,0.3110835939097527 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441080,29.394130265052933,89.1451395839603,0.3297334033266998 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441096,1.4490565923575685,89.1451395839603,0.01625502634378391 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441089,24.429328227260104,89.1451395839603,0.2740399346646558 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441091,38.72088661574392,89.1451395839603,0.43435779893838306 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441099,5208.978126613742,4771.656231796832,1.0916499164174345 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441079,5896.007027654586,4771.656231796832,1.235631139637728 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441080,4334.67550209179,4771.656231796832,0.9084215818413032 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441096,5351.605707265429,4771.656231796832,1.1215404981616226 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441089,9929.279119242658,4771.656231796832,2.0808873558570777 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441091,3191.012394150975,4771.656231796832,0.6687431447569634 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441099,392637.3433457541,209884.98459768714,1.8707262174965555 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441079,321105.25540181104,209884.98459768714,1.5299105651474485 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441080,237474.90983320543,209884.98459768714,1.131452591944123 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441096,370564.1537841184,209884.98459768714,1.7655581912847418 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441089,357534.5202525932,209884.98459768714,1.7034783166500664 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441091,316773.17173728213,209884.98459768714,1.5092702907951274 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441099,81.06520454648792,22.903585106474594,3.5394111519934786 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441079,71.86578042961932,22.903585106474594,3.1377524564616586 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441080,38.95618966152977,22.903585106474594,1.700877372709536 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441096,18.05977947924894,22.903585106474594,0.7885132129006144 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441089,11.551276272233904,22.903585106474594,0.5043435871953725 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441091,46.03958491882552,22.903585106474594,2.010147525149267 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441099,61.28961654418591,83.56495705722055,0.7334368221145408 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441079,11.253296625678155,83.56495705722055,0.1346652594815855 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441080,13.384462474769707,83.56495705722055,0.16016836418170818 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441096,198.53246649469065,83.56495705722055,2.3757861367504427 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441089,5.61915598683323,83.56495705722055,0.0672429710337259 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441091,38.6228224739765,83.56495705722055,0.4621892218233269 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441099,2415.1557837981945,1829.6496491832456,1.3200099728799546 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441079,1828.153239365564,1829.6496491832456,0.9991821331377023 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441080,2476.1576467039563,1829.6496491832456,1.3533507072292836 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441096,2111.293765337982,1829.6496491832456,1.1539333589250065 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441089,1478.5773497358016,1829.6496491832456,0.8081204783636242 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441091,832.1670883873832,1829.6496491832456,0.4548231891055547 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441099,130839.0907806742,96234.19538703516,1.3595904268172545 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441079,82878.86420226836,96234.19538703516,0.8612205242527954 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441080,105048.43469047436,96234.19538703516,1.0915915519217472 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441096,115060.90138256818,96234.19538703516,1.195634264097244 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441089,115879.19202093214,96234.19538703516,1.2041373812592149 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441091,158792.93510842454,96234.19538703516,1.6500676757340813 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441099,173.40389519205834,77.99112650544876,2.2233797992383617 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441079,103.85596169523014,77.99112650544876,1.3316381792225345 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441080,86.97109263678439,77.99112650544876,1.1151408696566045 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441096,154.31263729908122,77.99112650544876,1.9785922349550924 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441089,128.20352336466104,77.99112650544876,1.6438219206348332 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441091,133.13358222693455,77.99112650544876,1.7070349947776857 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441099,85.03197104217436,110.33780757772625,0.7706512654991312 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441079,146.2705868065637,110.33780757772625,1.3256615299658279 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441080,75.96103290662643,110.33780757772625,0.6884406585033559 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441096,39.703601084274105,110.33780757772625,0.3598367772198604 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441089,40.944841626917494,110.33780757772625,0.3710862353148929 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441091,90.9812192950038,110.33780757772625,0.824569758021638 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441099,81.4009037886649,67.31067174214355,1.2093313241694985 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441079,67.18734360024848,67.31067174214355,0.9981677772825158 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441080,67.0574462498666,67.31067174214355,0.9962379592162292 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441096,81.80497510284876,67.31067174214355,1.2153344036771847 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441089,60.9949339689902,67.31067174214355,0.9061703351090012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441091,44.806559486826266,67.31067174214355,0.6656679888513526 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441099,3857.02050910029,2375.529574917848,1.6236465964578344 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441079,3336.701445864016,2375.529574917848,1.4046137253329745 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441080,2918.9664777001954,2375.529574917848,1.2287645283478068 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441096,3082.9587567550307,2375.529574917848,1.2977985158789898 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441089,3941.7444112929375,2375.529574917848,1.6593118658306971 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441091,3339.5377591658375,2375.529574917848,1.4058076962823447 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441099,125.13752057486786,194.62377093849457,0.6429714107965471 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441079,166.70676157230986,194.62377093849457,0.856559097423885 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441080,186.15977465791505,194.62377093849457,0.9565109840397947 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441096,180.27774720535652,194.62377093849457,0.9262884299078158 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441089,283.6118909417959,194.62377093849457,1.4572315065841752 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441091,286.9574228792066,194.62377093849457,1.4744212461585255 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441099,3816.80829290202,3728.1507253933823,1.0237805748852289 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441079,3820.374140091147,3728.1507253933823,1.0247370402890654 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441080,4055.0833534158032,3728.1507253933823,1.0876929749099467 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441096,4641.250881922882,3728.1507253933823,1.2449203972119858 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441089,4717.381749771251,3728.1507253933823,1.2653409417274801 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441091,4207.590973334569,3728.1507253933823,1.1286000173425386 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441099,121.73020836997584,68.78582331086372,1.7696990820309093 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441079,108.20284378013338,68.78582331086372,1.5730398877561202 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441080,77.51389920878596,68.78582331086372,1.1268877143256315 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441096,86.62226212560405,68.78582331086372,1.2593039954487733 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441089,113.90967008062984,68.78582331086372,1.6560050399606028 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441091,288.9418223053141,68.78582331086372,4.200601350651856 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441099,412.3746357807081,696.3940975413478,0.5921569944900684 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441079,548.1925409535573,696.3940975413478,0.7871872304618562 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441080,552.920946954806,696.3940975413478,0.7939770726186788 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441096,603.8144105361074,696.3940975413478,0.8670584840794927 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441089,825.2709315962425,696.3940975413478,1.1850630763671035 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441091,467.4845749856082,696.3940975413478,0.6712931322021317 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441099,93.77140075036648,81.2393188807366,1.1542612868040856 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441079,111.45135469688908,81.2393188807366,1.371889329359165 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441080,61.60018384054486,81.2393188807366,0.7582557890591995 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441096,95.91330498000626,81.2393188807366,1.180626651003953 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441089,66.49033637913159,81.2393188807366,0.8184501949941597 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441091,226.9146434301011,81.2393188807366,2.7931628004319338 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441099,205.048177395644,543.8205698619286,0.3770511612823031 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441079,141.73179729252786,543.8205698619286,0.26062235440728615 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441080,135.89285786560046,543.8205698619286,0.249885468473733 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441096,136.93282458234447,543.8205698619286,0.2517978027515777 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441089,393.8783880846506,543.8205698619286,0.7242800473410799 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441091,175.13149336914285,543.8205698619286,0.32203911193283336 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441099,155869.52202514265,306516.0644612488,0.5085199116695837 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441079,208333.1742298165,306516.0644612488,0.6796810946793131 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441080,220988.187454276,306516.0644612488,0.7209677177693711 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441096,283260.27319360216,306516.0644612488,0.9241286380584246 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441089,453271.14568349806,306516.0644612488,1.4787843060695525 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441091,68563.8575916152,306516.0644612488,0.22368764818942585 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441099,338516.0796120542,335923.8645439917,1.0077166743469725 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441079,660229.2884779134,335923.8645439917,1.9654134706212618 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441080,491060.6652569214,335923.8645439917,1.4618213145515102 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441096,425427.0069146092,335923.8645439917,1.2664387732384415 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441089,646182.658590784,335923.8645439917,1.9235985495343144 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441091,272302.07500139443,335923.8645439917,0.8106065205311856 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441099,68.10624379598913,33.931355493730415,2.007177220154771 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441079,34.72496830805585,33.931355493730415,1.0233887742702195 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441080,50.14364249717864,33.931355493730415,1.4777966210764497 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441096,110.74215642489632,33.931355493730415,3.2637115380008455 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441089,587.0396787961238,33.931355493730415,17.300802465866493 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441091,14.121219340444222,33.931355493730415,0.4161702099715243 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441099,57.13114437001603,76.3332642617619,0.7484436165876781 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441079,85.16384644940634,76.3332642617619,1.1156845874868213 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441080,214.8010944075108,76.3332642617619,2.813990682632348 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441096,127.4212038665348,76.3332642617619,1.6692749235717501 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441089,68.48492001441514,76.3332642617619,0.8971831700995619 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441091,134.1221998621828,76.3332642617619,1.757060976748632 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441099,189.5815359670513,130.67426801703346,1.4507947038382436 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441079,161.96817298804476,130.67426801703346,1.2394802392689288 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441080,162.28680460662272,130.67426801703346,1.2419186047054693 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441096,129.94941378263812,130.67426801703346,0.9944529688561113 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441089,293.2783104478479,130.67426801703346,2.2443463039687273 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441091,28.516058453254978,130.67426801703346,0.21822244643863545 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441099,7344.95006576198,5444.214081294075,1.3491295448866891 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441079,6092.460320744539,5444.214081294075,1.119070673888044 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441080,7098.857434552099,5444.214081294075,1.3039269449273236 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441096,7225.030959755134,5444.214081294075,1.3271026546475857 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441089,7742.290807492781,5444.214081294075,1.4221135855209535 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441091,6645.044922390712,5444.214081294075,1.2205700994056432 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441099,74.48644483428542,100.67607722942154,0.7398624070795393 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441079,82.1665425710316,100.67607722942154,0.816147637375558 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441080,60.291023535768474,100.67607722942154,0.5988614693277804 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441096,105.97526119060724,100.67607722942154,1.052635979738363 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441089,161.35867882525037,100.67607722942154,1.6027509540081184 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441091,163.6766203704163,100.67607722942154,1.6257747110808514 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441099,506.9285547333607,599.1099853739104,0.8461360469847313 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441079,526.6781367950628,599.1099853739104,0.8791009157798594 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441080,1204.6083296369432,599.1099853739104,2.010663081980073 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441096,509.6930612265754,599.1099853739104,0.850750402546656 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441089,572.0410937161932,599.1099853739104,0.9548181597393621 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441091,567.2769735293674,599.1099853739104,0.9468661637734586 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441099,157.63264320674745,114.30018844822946,1.3791109651419757 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441079,132.63895082970052,114.30018844822946,1.1604438507971255 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441080,98.23709927162922,114.30018844822946,0.8594657682137088 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441096,205.59952309165757,114.30018844822946,1.7987680150219592 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441089,299.05269878572034,114.30018844822946,2.6163797526998107 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441091,132.7468460045451,114.30018844822946,1.1613878140250902 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441099,2812.77651017051,1759.6959467320276,1.5984446150451064 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441079,2119.6827692149386,1759.6959467320276,1.204573308901149 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441080,2115.194803783786,1759.6959467320276,1.2020228879380916 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441096,2223.2270955240665,1759.6959467320276,1.2634154779141666 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441089,2086.8794796185716,1759.6959467320276,1.1859318557243734 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441091,2684.626780068133,1759.6959467320276,1.5256196873407681 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441099,218.39962330561903,38.77498679262034,5.632487368046889 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441079,142.2897450726894,38.77498679262034,3.6696271705699206 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441080,44.4356861860012,38.77498679262034,1.145988428665518 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441096,166.112799011385,38.77498679262034,4.284019486577868 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441089,81.1629529225321,38.77498679262034,2.093178093305735 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441091,40.24053909675661,38.77498679262034,1.0377963327743853 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441099,2031.6202069515564,2284.874121495706,0.8891606709701949 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441079,1366.8088815253964,2284.874121495706,0.5981987666920867 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441080,2412.151888599616,2284.874121495706,1.055704498513289 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441096,2358.3524811632747,2284.874121495706,1.0321586029516012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441089,2518.950863229076,2284.874121495706,1.1024462308585037 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441091,2536.9537815354547,2284.874121495706,1.1103254037796773 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441099,372.46525073017045,306.4947439651267,1.2152418860812502 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441079,290.26332428705797,306.4947439651267,0.9470417682597664 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441080,340.2828593001459,306.4947439651267,1.1102404396822663 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441096,378.60679314740827,306.4947439651267,1.2352798884880276 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441089,270.7436988824262,306.4947439651267,0.8833551119990224 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441091,302.4067590861517,306.4947439651267,0.9866621370856521 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441099,54958.250910384006,53872.22448470133,1.0201593016822814 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441079,37907.66765258976,53872.22448470133,0.7036588523155342 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441080,54727.57843775634,53872.22448470133,1.0158774574697191 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441096,46886.339002159155,53872.22448470133,0.8703249114109622 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441089,55217.71913378836,53872.22448470133,1.0249756653258142 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441091,50943.76751832652,53872.22448470133,0.9456406897174547 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441099,88.88810063404419,320.29657233769314,0.2775181138695678 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441079,113.32376436475688,320.29657233769314,0.35380885763984404 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441080,523.1499571206676,320.29657233769314,1.6333298645765817 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441096,89.55850896879892,320.29657233769314,0.279611200067343 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441089,99.95338257189448,320.29657233769314,0.31206510217197153 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441091,415.8429360807859,320.29657233769314,1.2983059201843623 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441099,11471.011626771988,6299.521117687065,1.8209339110817504 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441079,6164.014948208847,6299.521117687065,0.9784894491268933 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441080,25432.84778524021,6299.521117687065,4.037266850940909 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441096,12253.413313128023,6299.521117687065,1.9451340957845684 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441089,11687.64585878104,6299.521117687065,1.8553229111282479 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441091,10671.798624802685,6299.521117687065,1.6940650607297187 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441099,4776.330156693779,1965.7827420843205,2.429734504449578 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441079,2033.0027473727175,1965.7827420843205,1.0341950327720975 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441080,1909.026059823905,1965.7827420843205,0.971127693287084 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441096,1750.9407458602277,1965.7827420843205,0.8907091859010342 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441089,1483.7157378263353,1965.7827420843205,0.7547709653067514 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441091,2058.523449755097,1965.7827420843205,1.0471774961115201 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441099,4987.3767202648005,6243.797224888628,0.798773012740458 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441079,5803.087419294185,6243.797224888628,0.9294163808142721 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441080,18571.9406329334,6243.797224888628,2.9744624887725553 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441096,10280.502388258634,6243.797224888628,1.6465144555430384 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441089,5271.581591648518,6243.797224888628,0.8442909661824497 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441091,10316.704666678595,6243.797224888628,1.6523125743986051 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441099,1065.7889415326154,477.14850073021523,2.233662978929119 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441079,477.31892442809055,477.14850073021523,1.0003571711901316 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441080,451.2689974082868,477.14850073021523,0.9457621615025026 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441096,493.21344877204217,477.14850073021523,1.0336686545535438 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441089,374.3437851477071,477.14850073021523,0.7845435636386187 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441091,663.0234149540943,477.14850073021523,1.3895535958709313 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441099,517.4080892565157,205.1372392304115,2.5222533519394768 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441079,166.29324776341105,205.1372392304115,0.8106438810782151 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441080,454.0217442044413,205.1372392304115,2.2132585283283506 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441096,381.4731461256846,205.1372392304115,1.8595996882711845 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441089,533.6765852087188,205.1372392304115,2.601558776996554 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441091,58.7380402953506,205.1372392304115,0.28633533587422244 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441099,126.92870238420534,44.32085041603382,2.863859812994173 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441079,14.602626135794464,44.32085041603382,0.32947531463682644 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441080,62.73272052358622,44.32085041603382,1.4154223110505024 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441096,161.8029065219412,44.32085041603382,3.6507175517418826 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441089,49.30262426911097,44.32085041603382,1.1124024879106316 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441091,41.913616826566944,44.32085041603382,0.9456862048703827 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441099,77.96735743491023,73.02499011367847,1.0676804928496113 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441079,29.676511324716667,73.02499011367847,0.40638843330918706 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441080,50.17498808200066,73.02499011367847,0.6870933909596281 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441096,32.24598450986902,73.02499011367847,0.441574650810243 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441089,133.11894217084344,73.02499011367847,1.8229231111653192 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441091,83.51059820628137,73.02499011367847,1.1435893120461897 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441099,90.18184926625996,446.9213615105917,0.2017846024666304 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441079,83.3321336442595,446.9213615105917,0.18645815756623796 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441080,126.6861603658507,446.9213615105917,0.28346409743685597 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441096,101.4806858045116,446.9213615105917,0.2270660893484873 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441089,7706.353049676649,446.9213615105917,17.24319693207149 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441091,233.92272941144856,446.9213615105917,0.5234091488059355 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441099,2655.4962043875826,2631.000022355788,1.0093105974244199 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441079,2484.6385271489175,2631.000022355788,0.9443703937806055 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441080,1744.0876880717876,2631.000022355788,0.6628991536496217 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441096,2038.6237362201991,2631.000022355788,0.7748474796267096 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441089,2358.351426073724,2631.000022355788,0.8963707358550549 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441091,2818.743540322059,2631.000022355788,1.0713582350326876 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441099,54.20607538471354,48.89133349009634,1.1087051940543569 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441079,45.30717086948725,48.89133349009634,0.9266912484329126 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441080,21.471558430687267,48.89133349009634,0.4391690080418168 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441096,24.596073915661595,48.89133349009634,0.5030763564803135 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441089,105.62380226298784,48.89133349009634,2.160378838600986 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441091,66.15826420407133,48.89133349009634,1.3531695595390676 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441099,114.41801657308476,307.70649021557807,0.37184141450160474 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441079,338.14498548648413,307.70649021557807,1.0989205500656842 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441080,101.47586831295637,307.70649021557807,0.32978137133819546 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441096,176.94753604318225,307.70649021557807,0.5750529861076815 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441089,349.40169047810946,307.70649021557807,1.1355031550791141 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441091,111.54703109420036,307.70649021557807,0.362511141757364 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441099,107.8305338834295,154.19153082843468,0.6993285124291945 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441079,126.103396886002,154.19153082843468,0.817836078340219 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441080,146.0734520360638,154.19153082843468,0.9473506829541521 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441096,115.65108591241528,154.19153082843468,0.7500482373516192 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441089,80.79324834251568,154.19153082843468,0.5239798055602187 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441091,127.51651590985723,154.19153082843468,0.8270007776999236 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441099,7708.703798666533,6593.957266089812,1.1690557714575183 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441079,6995.350282256925,6593.957266089812,1.0608728567640744 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441080,7435.538059749191,6593.957266089812,1.127629094290208 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441096,7410.537468076053,6593.957266089812,1.1238376545425308 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441089,7858.631312060263,6593.957266089812,1.1917928786821508 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441091,7730.357192179076,6593.957266089812,1.172339595212928 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441099,196.05276479889227,127.96554716912783,1.5320746023910312 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441079,175.30817214871044,127.96554716912783,1.369963838133802 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441080,178.87004858731055,127.96554716912783,1.3977984898615243 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441096,260.85510223424586,127.96554716912783,2.038479168845989 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441089,267.74935658354383,127.96554716912783,2.092355032324977 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441091,131.86426487508308,127.96554716912783,1.0304669326408806 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441099,1243.4286839622944,1681.9358703135756,0.7392842413964766 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441079,990.93633281602,1681.9358703135756,0.5891641591728896 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441080,2075.0361542745104,1681.9358703135756,1.2337189490391487 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441096,1544.8048628900144,1681.9358703135756,0.918468349570311 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441089,1780.5596550418609,1681.9358703135756,1.0586370660552582 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441091,1428.1479457913942,1681.9358703135756,0.8491096307525293 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441099,45.24646860087115,45.403354316773296,0.9965446227869514 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441079,43.51650673753922,45.403354316773296,0.9584425510487664 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441080,46.12497251926659,45.403354316773296,1.0158934997942808 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441096,39.46502579877634,45.403354316773296,0.8692094756575469 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441089,41.27246907540426,45.403354316773296,0.9090180603717428 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441091,35.16468895561254,45.403354316773296,0.7744953976367711 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441099,146.26160301872127,171.72890790902974,0.8517005366167045 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441079,148.6863595898066,171.72890790902974,0.8658202128005758 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441080,169.73832228982417,171.72890790902974,0.9884085583292707 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441096,176.23632230802895,171.72890790902974,1.0262472664263778 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441089,175.9821881355484,171.72890790902974,1.0247674097407744 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441091,162.07135553461293,171.72890790902974,0.9437628032926598 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441099,24.915774746663743,385.5886159476326,0.06461750610927681 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441079,240.27001093925716,385.5886159476326,0.6231252713433029 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441080,33.31932841300122,385.5886159476326,0.08641159784013533 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441096,231.1652727208532,385.5886159476326,0.5995127012573632 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441089,83.30145520722202,385.5886159476326,0.21603712288677973 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441091,183.5847404675874,385.5886159476326,0.47611556170143865 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441099,376.88924906793847,430.1288265554666,0.8762241119390246 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441079,471.0999555843833,430.1288265554666,1.095253157889973 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441080,439.5270782822381,430.1288265554666,1.0218498532219615 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441096,325.1775867003697,430.1288265554666,0.7560004506195005 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441089,390.9963287638656,430.1288265554666,0.9090214480508557 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441091,419.7491476264668,430.1288265554666,0.9758684415268752 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441099,18941.79473368785,54695.927744901994,0.34631087751232714 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441079,34493.24743048063,54695.927744901994,0.6306364815924641 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441080,41454.073413473794,54695.927744901994,0.7579005443844505 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441096,48553.89018257642,54695.927744901994,0.8877057613690802 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441089,64973.5709573127,54695.927744901994,1.1879050897599712 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441091,20325.537632698233,54695.927744901994,0.37160970607345994 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441099,138480.4072375889,97212.60478924697,1.4245108187133642 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441079,171740.18461551433,97212.60478924697,1.7666452307068632 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441080,312218.57581976097,97212.60478924697,3.2117087747688515 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441096,152725.4408244914,97212.60478924697,1.57104565972277 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441089,224175.4281278905,97212.60478924697,2.306032521337062 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441091,126234.39570635304,97212.60478924697,1.298539381595876 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441099,27601.954176093288,62941.57202670208,0.43853296457837987 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441079,45136.9621655377,62941.57202670208,0.7171247986368846 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441080,51769.016501656064,62941.57202670208,0.8224932240283701 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441096,75407.67557520342,62941.57202670208,1.1980583443834667 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441089,93405.55638856118,62941.57202670208,1.484004186437148 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441091,24764.25664011533,62941.57202670208,0.3934483337913683 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441099,23530.07202847525,14728.399701289269,1.5975986872773094 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441079,25197.38379385723,14728.399701289269,1.710802551865261 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441080,62099.898554883854,14728.399701289269,4.216337131959276 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441096,25676.641084476447,14728.399701289269,1.7433422235430514 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441089,35792.32579048997,14728.399701289269,2.430157146492762 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441091,20952.56197145767,14728.399701289269,1.42259596401526 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441099,5853.991279002978,3575.9352491809864,1.6370518119263335 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441079,7009.592429631104,3575.9352491809864,1.9602123475911777 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441080,3611.3891564431183,3575.9352491809864,1.0099145831206682 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441096,7833.123478290037,3575.9352491809864,2.190510435020907 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441089,5739.135260041511,3575.9352491809864,1.604932656808026 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441091,2203.2083836190222,3575.9352491809864,0.6161208830958652 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441099,11779.206272719051,12966.336321671553,0.9084452215720822 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441079,14497.6929560108,12966.336321671553,1.1181024922035827 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441080,13398.650506038392,12966.336321671553,1.0333412749478263 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441096,9474.561190998838,12966.336321671553,0.7307045688120348 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441089,16845.760266665082,12966.336321671553,1.2991919882958438 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441091,13016.00902292196,12966.336321671553,1.0038308971800605 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441099,132.27206566978424,103.34580193186551,1.2798978110111277 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441079,211.8497790726548,103.34580193186551,2.0499118020519544 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441080,105.64225411096552,103.34580193186551,1.0222210494879516 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441096,97.54619973403432,103.34580193186551,0.9438815889042615 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441089,175.54445205389015,103.34580193186551,1.6986123168275788 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441091,265.6591875412515,103.34580193186551,2.5705851865796836 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441099,279.9580288589238,211.8154700640626,1.3217071858549887 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441079,263.74977571295847,211.8154700640626,1.245186556171693 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441080,373.53917860253506,211.8154700640626,1.76351226135447 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441096,51.52701274300369,211.8154700640626,0.24326368950964528 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441089,426.1769050172596,211.8154700640626,2.012019730609688 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441091,359.92324722479464,211.8154700640626,1.6992302173015859 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441099,51.79995432343589,76.10596635595309,0.680629348836644 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441079,35.9940986169511,76.10596635595309,0.4729471333246609 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441080,60.75166760085406,76.10596635595309,0.7982510506037613 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441096,48.37224090725434,76.10596635595309,0.6355906537079351 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441089,32.73278943281227,76.10596635595309,0.43009491896757024 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441091,7.914530237490863,76.10596635595309,0.10399355814594134 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441099,3055.35,1382.686999693948,2.2097191921789157 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441079,1898.3738174316984,1382.686999693948,1.372959909113122 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441080,2958.089389548887,1382.686999693948,2.139377451443203 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441096,4093.081178932611,1382.686999693948,2.9602369732546823 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441089,2736.129455520718,1382.686999693948,1.9788494837416917 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441091,2170.4210206242674,1382.686999693948,1.5697124664545778 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441099,31.365105088880476,30.899530320120164,1.0150673736440956 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441079,30.66819698513407,30.899530320120164,0.992513370507918 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441080,31.33217459782916,30.899530320120164,1.0140016457605272 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441096,29.63599891672905,30.899530320120164,0.9591083945192407 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441089,32.53438722145809,30.899530320120164,1.052908794548032 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441091,23.60956926193851,30.899530320120164,0.7640753441020813 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441099,30.470651732295348,31.68183515511672,0.9617704145958931 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441079,31.26862013554697,31.68183515511672,0.9869573521373805 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441080,31.70973707623555,31.68183515511672,1.0008806914429742 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441096,29.822706876511496,31.68183515511672,0.941318794523651 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441089,31.56715367938945,31.68183515511672,0.9963802136092881 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441091,33.400402698130726,31.68183515511672,1.0542445705748977 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441099,1225.3351375240063,628.1906149122311,1.950578548033874 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441079,1372.4518551212311,628.1906149122311,2.1847697538636197 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441080,901.857699342274,628.1906149122311,1.4356433826511064 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441096,1272.4021023508617,628.1906149122311,2.0255032026045754 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441089,2040.284830081261,628.1906149122311,3.2478753767537953 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441091,1339.940971659033,628.1906149122311,2.1330165396473575 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441099,15909.10378664142,10551.186365326936,1.5078023679803012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441079,15779.937242607995,10551.186365326936,1.4955604702864183 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441080,17427.474048831988,10551.186365326936,1.651707537467232 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441096,22367.901193525584,10551.186365326936,2.1199418168776227 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441089,13408.990827747426,10551.186365326936,1.270851481859115 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441091,17488.324780604187,10551.186365326936,1.6574747308107376 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441099,142.81300149233675,102.14043933131707,1.398202342062466 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441079,245.70039288322073,102.14043933131707,2.4055153325337915 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441080,148.38737775832368,102.14043933131707,1.4527779470087607 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441096,104.1082476424956,102.14043933131707,1.019265712229761 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441089,244.3940593268395,102.14043933131707,2.392725750220132 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441091,5.565083768545704,102.14043933131707,0.05448462729334869 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441099,5290.846200803002,2995.2816068385046,1.766393580063895 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441079,3419.2404444499407,2995.2816068385046,1.141542229833582 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441080,3721.7791860798616,2995.2816068385046,1.242547337646883 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441096,4775.8321178313845,2995.2816068385046,1.5944517894169679 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441089,3371.7289577714887,2995.2816068385046,1.1256801197167972 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441091,4476.620491056846,2995.2816068385046,1.4945574669294226 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441099,38.193542397956854,35.73806763844074,1.0687075413354175 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441079,37.76032691138961,35.73806763844074,1.0565855796515893 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441080,38.78545352355425,35.73806763844074,1.0852700239963637 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441096,33.95983649807513,35.73806763844074,0.9502426611769881 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441089,42.09856610596,35.73806763844074,1.1779754443320196 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441091,14.786212999319137,35.73806763844074,0.41373845807529686 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441099,232.77756667435904,271.6614200921023,0.8568664869507039 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441079,271.27323631091,271.6614200921023,0.9985710750497415 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441080,278.02720950401164,271.6614200921023,1.0234328062105806 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441096,269.84991866611455,271.6614200921023,0.9933317678109259 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441089,250.71276959530033,271.6614200921023,0.9228869138293555 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441091,221.7654519827708,271.6614200921023,0.8163303125912575 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441099,181.08021044683684,166.02715311669658,1.0906662377060685 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441079,166.9795717769556,166.02715311669658,1.005736523468481 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441080,171.71856679241282,166.02715311669658,1.0342800172675122 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441096,192.4010180201143,166.02715311669658,1.1588527202226984 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441089,250.147585090491,166.02715311669658,1.5066667132132787 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441091,166.5479814199656,166.02715311669658,1.0031370067696272 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441099,1859.3788409028284,1793.9624976146763,1.0364647217403553 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441079,1774.6505102461206,1793.9624976146763,0.9892350105455193 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441080,1710.6303326790703,1793.9624976146763,0.9535485468361754 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441096,1667.263655668098,1793.9624976146763,0.9293748659099383 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441089,1833.437327724807,1793.9624976146763,1.0220042671809573 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441091,1966.7076316583912,1793.9624976146763,1.0962925001349826 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441099,103.29611436678827,59.13775760336051,1.7467032662888533 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441079,116.1484586434475,59.13775760336051,1.9640321742068783 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441080,81.68721752006647,59.13775760336051,1.3813039389816935 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441096,142.806529537376,59.13775760336051,2.414811371360841 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441089,436.2598916493012,59.13775760336051,7.377011055700067 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441091,201.899903217144,59.13775760336051,3.414060853833778 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441099,357.3318858808304,238.79765196261823,1.496379394621383 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441079,374.7160698947373,238.79765196261823,1.5691782009372353 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441080,278.8902998366032,238.79765196261823,1.1678938111177959 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441096,307.4952826705182,238.79765196261823,1.2876813492230401 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441089,177.93712773021699,238.79765196261823,0.7451376773087851 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441091,243.5412554694864,238.79765196261823,1.0198645316144512 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441099,797.8908699421187,386.8144501381946,2.0627225008193504 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441079,626.4511684245381,386.8144501381946,1.619513356341083 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441080,448.14406573565566,386.8144501381946,1.1585504770453903 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441096,778.6278011013186,386.8144501381946,2.0129232525391525 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441089,1068.9354381171263,386.8144501381946,2.7634320220850976 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441091,553.5522290875635,386.8144501381946,1.431053645720318 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441099,5837.314040845077,5555.372966797932,1.050751061311668 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441079,5162.948024516905,5555.372966797932,0.9293611887759144 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441080,5940.254450458154,5555.372966797932,1.06928094404471 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441096,5712.520774529731,5555.372966797932,1.0282875350891836 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441089,4426.058426453983,5555.372966797932,0.7967167016340082 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441091,5635.1649846818445,5555.372966797932,1.014363035274282 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441099,38.320706720308,84.54153084580483,0.4532767071630283 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441079,98.5099574400617,84.54153084580483,1.1652256169779307 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441080,31.02224965481445,84.54153084580483,0.3669468643925538 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441096,8.37971224707656,84.54153084580483,0.0991194761112181 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441089,34.243733644983124,84.54153084580483,0.40505220691402216 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441091,151.89926686517714,84.54153084580483,1.7967413807803645 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441099,39.85938411631546,122.00200397429413,0.3267108966891548 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441079,69.65906032189656,122.00200397429413,0.570966525570955 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441080,280.887111844584,122.00200397429413,2.3023155578966312 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441096,98.94899533063754,122.00200397429413,0.8110440165514505 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441089,148.6665182161363,122.00200397429413,1.2185580021083948 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441091,146.39705199259862,122.00200397429413,1.1999561255030249 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441099,185.9840814478423,143.84455848940917,1.2929518043710755 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441079,87.48617444302971,143.84455848940917,0.6081994019222566 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441080,97.84127214320488,143.84455848940917,0.6801875105369983 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441096,167.59325771181005,143.84455848940917,1.1650997401069532 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441089,104.41301074277884,143.84455848940917,0.725873900544291 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441091,104.15555692517952,143.84455848940917,0.7240840947963157 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441099,2490.342508602609,5334.764851653101,0.46681392298498753 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441079,5409.805157333695,5334.764851653101,1.014066281788848 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441080,606.4624363268865,5334.764851653101,0.11368119367791067 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441096,1832.565179250228,5334.764851653101,0.3435137686869863 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441089,1681.309267348841,5334.764851653101,0.3151608953912652 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441091,4864.498871331107,5334.764851653101,0.911848789328311 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441099,175.70349390957472,159.70733471984832,1.1001592019413897 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441079,262.3490891585946,159.70733471984832,1.6426865404697661 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441080,135.99660645275154,159.70733471984832,0.8515363849212741 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441096,231.28155665006344,159.70733471984832,1.4481586400259419 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441089,161.73554822076483,159.70733471984832,1.0126995638896255 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441091,100.95215000068762,159.70733471984832,0.6321071613759851 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441099,69641.930730605993,82077.5827732141,0.8484890560560409 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441079,57454.91805459599,82077.5827732141,0.7000074333737119 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441080,111651.60525163678,82077.5827732141,1.3603179026377725 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441096,50048.979202322065,82077.5827732141,0.6097764762470012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441089,68603.01513383466,82077.5827732141,0.8358313295286658 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441091,68325.86791755715,82077.5827732141,0.8324546801816292 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441099,702078.8264544925,170961.68742491837,4.106644225553904 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441079,189705.92750394024,170961.68742491837,1.1096400039175667 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441080,168423.6146084221,170961.68742491837,0.9851541426928713 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441096,55234.06684592651,170961.68742491837,0.3230786246783144 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441089,65810.84695742946,170961.68742491837,0.3849450011209778 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441091,129580.5106969151,170961.68742491837,0.7579505832487952 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441099,100031.37219442002,55195.40432138408,1.812313423993986 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441079,160257.28801814115,55195.40432138408,2.9034534666150362 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441080,190154.36145323789,55195.40432138408,3.445112211626056 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441096,129695.81733118604,55195.40432138408,2.349757537348787 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441089,178872.19828411218,55195.40432138408,3.240708180025282 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441091,64989.28835209987,55195.40432138408,1.1774402081319912 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441099,983.4549288711175,546.121028905539,1.8008003296302713 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441079,1100.4501356909634,546.121028905539,2.0150297780994353 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441080,816.7585723505603,546.121028905539,1.495563307619551 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441096,842.2860580960345,546.121028905539,1.5423065831836378 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441089,946.9344785902464,546.121028905539,1.7339278813122483 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441091,1109.2949199353286,546.121028905539,2.0312254266392666 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441099,1122.8116897673117,1228.731327313693,0.9137975607914648 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441079,656.1382544459933,1228.731327313693,0.5339965213391864 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441080,996.124515796165,1228.731327313693,0.8106935126118552 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441096,1324.3279543999934,1228.731327313693,1.077801082271824 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441089,1402.2981313505622,1228.731327313693,1.1412569210034944 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441091,1541.61024595472,1228.731327313693,1.2546357463881521 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441099,137.76019291621952,76.68368758811918,1.7964732428642762 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441079,154.7182712752535,76.68368758811918,2.0176164728314974 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441080,135.98540909868146,76.68368758811918,1.7733290270165627 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441096,251.19292643184784,76.68368758811918,3.2757022299324823 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441089,222.43324967153737,76.68368758811918,2.9006592753632727 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441091,243.11116022921877,76.68368758811918,3.170311286215253 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441099,109.05289049619564,81.06808963980528,1.3452011880473564 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441079,119.36314939840685,81.06808963980528,1.4723814256478827 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441080,150.5498662232931,81.06808963980528,1.8570792390964588 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441096,249.1822294852675,81.06808963980528,3.0737399955076334 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441089,82.28991003433228,81.06808963980528,1.0150715330773883 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441091,181.49892108343283,81.06808963980528,2.2388454185839723 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441099,164.57978171643063,34.254424530644805,4.804628423087176 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441079,74.35237685643072,34.254424530644805,2.1705919125838284 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441080,31.47706821139872,34.254424530644805,0.9189197787643054 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441096,82.24638651690923,34.254424530644805,2.401044175864922 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441089,32.20768884904231,34.254424530644805,0.9402490128020853 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441091,51.25508424943089,34.254424530644805,1.4963055124040077 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441099,59.09875963557898,60.87738129746832,0.9707835385822795 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441079,78.63832058888838,60.87738129746832,1.2917493971140752 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441080,39.82615623084492,60.87738129746832,0.6542028481192432 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441096,157.04745367521167,60.87738129746832,2.5797340543907845 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441089,12.6397884084849,60.87738129746832,0.20762700594367625 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441091,36.82185248070922,60.87738129746832,0.604852766264447 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441099,167.86857143640202,81.37032235510941,2.06301961916538 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441079,137.54210131641585,81.37032235510941,1.6903226795165731 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441080,117.10473457895516,81.37032235510941,1.4391578058139758 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441096,64.93230741414807,81.37032235510941,0.797985131861418 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441089,168.5196968623045,81.37032235510941,2.0710216204731897 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441091,287.61612109544456,81.37032235510941,3.534656282179329 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441099,477.5910087668822,592.3362991324378,0.8062835410667611 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441079,325.69741926513063,592.3362991324378,0.5498522034563162 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441080,1078.945163686421,592.3362991324378,1.821507757108069 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441096,932.4542625247482,592.3362991324378,1.5741974008522899 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441089,632.2778893187751,592.3362991324378,1.0674305968498596 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441091,592.2380064117538,592.3362991324378,0.999834059265272 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441099,321.83066149594384,1509.2244087879828,0.21324241751059228 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441079,742.4992279837122,1509.2244087879828,0.49197403889060687 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441080,998.1581734447982,1509.2244087879828,0.6613716075837867 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441096,1738.3499152942488,1509.2244087879828,1.1518167246514854 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441089,820.6869737812694,1509.2244087879828,0.5437806127455498 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441091,1044.748610768594,1509.2244087879828,0.6922420580300601 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441099,772818.6044101922,911297.6405793307,0.8480419239524153 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441079,1071906.6426601703,911297.6405793307,1.1762420914189322 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441080,892791.0621634065,911297.6405793307,0.9796920593318346 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441096,889314.8052763619,911297.6405793307,0.9758774363895051 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441089,747390.4221155606,911297.6405793307,0.8201386559504632 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441091,1186591.6073618962,911297.6405793307,1.3020900686273646 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441099,1203.363640934948,749.6106308195243,1.605318269858781 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441079,642.3298610285474,749.6106308195243,0.8568846740157747 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441080,747.5027249689434,749.6106308195243,0.9971879989905207 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441096,1135.071981992002,749.6106308195243,1.514215427749558 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441089,1431.3904362487633,749.6106308195243,1.9095119217878112 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441091,716.3197220191929,749.6106308195243,0.95558906526721 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441099,3393.4544367349745,2138.7943755926544,1.586620235895588 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441079,3880.387192790816,2138.7943755926544,1.8142871690110791 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441080,4250.4048789243625,2138.7943755926544,1.9872900954990524 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441096,3357.3769789225366,2138.7943755926544,1.569752107652806 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441089,4425.826376743837,2138.7943755926544,2.0693089654854977 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441091,3025.722006094062,2138.7943755926544,1.4146857877609869 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441099,577.3857571115047,613.8984432679271,0.9405232468711655 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441079,963.2745909509846,613.8984432679271,1.5691106591234298 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441080,720.1310343206651,613.8984432679271,1.1730458713777425 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441096,1157.500811085881,613.8984432679271,1.8854923379903514 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441089,1565.8153339631258,613.8984432679271,2.5506097158805603 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441091,860.8427722380267,613.8984432679271,1.4022559947465518 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441099,6409.390047157787,6365.76448478505,1.0068531536906538 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441079,5396.398507900515,6365.76448478505,0.8477219854423711 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441080,5099.848059140984,6365.76448478505,0.8011367796170029 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441096,6735.3599483409425,6365.76448478505,1.0580598708040914 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441089,5664.905840729304,6365.76448478505,0.8899018891240977 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441091,8368.52064582778,6365.76448478505,1.3146136125251824 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441099,40.34804804802789,70.21289390855102,0.5746529704441369 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441079,49.39896359333688,70.21289390855102,0.7035597145116493 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441080,129.70096301370307,70.21289390855102,1.8472527735807678 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441096,39.06242564907457,70.21289390855102,0.5563426241902454 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441089,92.14625500468703,70.21289390855102,1.312383664526108 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441091,173.5126852670908,70.21289390855102,2.4712367715975767 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441099,756.5035379216408,2003.7789126851078,0.3775384265861494 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441079,1825.635882258184,2003.7789126851078,0.9110964641362513 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441080,1625.551583808636,2003.7789126851078,0.8112429837034072 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441096,574.3403891780026,2003.7789126851078,0.28662862232060016 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441089,1863.557256130025,2003.7789126851078,0.9300213932448352 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441091,1036.386283745882,2003.7789126851078,0.5172158850384855 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441099,741.8548709717157,700.7857837159185,1.0586043384585062 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441079,1147.6273910079349,700.7857837159185,1.6376293835794409 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441080,855.8306807220639,700.7857837159185,1.2212443525666565 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441096,1460.1219972867343,700.7857837159185,2.0835496826782554 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441089,2160.465403809287,700.7857837159185,3.08291842387757 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441091,1008.9497066770124,700.7857837159185,1.4397405457157735 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441099,6316.768165032841,4688.560133729121,1.3472725068812756 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441079,4198.500431070943,4688.560133729121,0.8954775690872069 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441080,4662.0953111961035,4688.560133729121,0.9943554477753987 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441096,6462.332899411841,4688.560133729121,1.3783192952826482 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441089,4244.293733635142,4688.560133729121,0.9052445980381136 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441091,7694.603582280165,4688.560133729121,1.641144266642932 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441099,484.0465903841001,384.65137963543384,1.2584033647373667 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441079,804.5969557243728,384.65137963543384,2.091756323575276 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441080,607.1875058489438,384.65137963543384,1.5785397843221725 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441096,591.7072692913338,384.65137963543384,1.5382949356691351 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441089,696.2804574094766,384.65137963543384,1.810159781746785 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441091,379.91736073081165,384.65137963543384,0.9876927026516608 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441099,659.1214174923699,772.5530415852671,0.8531730276278024 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441079,304.70179833430234,772.5530415852671,0.39440890389747074 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441080,1657.1246671909958,772.5530415852671,2.1449979198717553 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441096,801.0135519998936,772.5530415852671,1.0368395551925158 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441089,642.8219523773988,772.5530415852671,0.8320748450596194 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441091,681.639011442779,772.5530415852671,0.8823200152627269 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441099,287.41407634616235,216.68366112664066,1.326422466981409 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441079,234.09418753049596,216.68366112664066,1.0803499733820712 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441080,227.56513110012423,216.68366112664066,1.0502182301928336 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441096,212.38088671509615,216.68366112664066,0.9801425987120009 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441089,303.6129311725018,216.68366112664066,1.4011805486111635 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441091,186.32782206924813,216.68366112664066,0.8599071157485608 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441099,722.8494522718199,615.8359185894908,1.173769555253342 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441079,605.7906989585683,615.8359185894908,0.9836884804414624 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441080,876.4363870649923,615.8359185894908,1.4231654254145816 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441096,772.0496863404023,615.8359185894908,1.2536613455556525 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441089,788.6572054715579,615.8359185894908,1.2806287870929915 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441091,476.00361916487697,615.8359185894908,0.7729390326162114 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441099,216.66106632567053,101.73138829665541,2.1297366521124497 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441079,63.555075843387336,101.73138829665541,0.6247341838888167 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441080,58.09934214641826,101.73138829665541,0.5711053699276841 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441096,35.3305211157763,101.73138829665541,0.3472922340620201 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441089,47.74020160985236,101.73138829665541,0.4692770088877466 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441091,274.1664128606811,101.73138829665541,2.6950031593119896 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441099,139.11146816607516,93.53234569214308,1.4873086645763534 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441079,175.84055939114808,93.53234569214308,1.8799973216743464 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441080,101.78385441644394,93.53234569214308,1.0882209107794674 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441096,204.81906675571057,93.53234569214308,2.189820700422312 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441089,61.41985297547177,93.53234569214308,0.6566696528453597 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441091,99.8546980561852,93.53234569214308,1.0675953577049357 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441099,97.22841748877296,42.30806113801961,2.2981061971048318 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441079,99.43207972385736,42.30806113801961,2.3501923049483344 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441080,57.75083404213737,42.30806113801961,1.3650078138475674 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441096,44.025053304627306,42.30806113801961,1.0405830974150867 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441089,68.64164213736954,42.30806113801961,1.6224246701696663 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441091,42.22809251856965,42.30806113801961,0.9981098491091549 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441099,154.0163170937301,205.3077634331321,0.7501728844457096 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441079,156.53821401784356,205.3077634331321,0.7624563796333372 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441080,310.6198679298397,205.3077634331321,1.5129475024991315 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441096,154.64562901544892,205.3077634331321,0.753238096940335 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441089,327.59872748853917,205.3077634331321,1.5956470520669654 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441091,319.7748564237248,205.3077634331321,1.5575390383514367 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441099,556.766664294639,761.179367641068,0.7314526483029697 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441079,743.5553889419773,761.179367641068,0.9768464839585599 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441080,877.2441490913361,761.179367641068,1.1524801989969309 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441096,350.3733913674191,761.179367641068,0.4603033217429991 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441089,1784.7054575661157,761.179367641068,2.344658215181272 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441091,263.9850794500227,761.179367641068,0.34681060821199783 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441099,589114.11774750706,258075.7105503754,2.282718185648526 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441079,404618.9741791703,258075.7105503754,1.5678305149921896 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441080,408217.8651083087,258075.7105503754,1.5817756124268274 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441096,547084.4483281181,258075.7105503754,2.119860281160901 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441089,507280.024196552,258075.7105503754,1.9656248281355904 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441091,438122.27442933945,258075.7105503754,1.6976501720948265 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441099,79.61552900314784,131.47736122215045,0.6055455347071168 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441079,108.56549941795171,131.47736122215045,0.8257353084118736 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441080,144.8909564552563,131.47736122215045,1.1020220904071962 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441096,146.56896896427003,131.47736122215045,1.1147848390158979 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441089,142.43973330491053,131.47736122215045,1.0833784005159453 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441091,143.47320557575915,131.47736122215045,1.0912388584780002 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441099,3048.0538129863353,3004.2024881525895,1.0145966608464903 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441079,2597.9390179242773,3004.2024881525895,0.8647682798245265 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441080,2385.601719737556,3004.2024881525895,0.794088191174012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441096,2044.124090331444,3004.2024881525895,0.680421542287072 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441089,2523.4757812042967,3004.2024881525895,0.8399819223757078 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441091,2724.3438730506346,3004.2024881525895,0.9068442902215783 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441099,80.33152343959546,96.13121274223809,0.835644544035794 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441079,95.45935554488575,96.13121274223809,0.9930110400338563 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441080,117.33191260444364,96.13121274223809,1.220539190731445 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441096,112.87160014859154,96.13121274223809,1.1741410196419801 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441089,213.32645859531183,96.13121274223809,2.2191175218741472 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441091,65.5459834059929,96.13121274223809,0.681838723721763 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441099,546.9585256453634,490.807523353751,1.1144053414420492 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441079,196.46716040392144,490.807523353751,0.4002937018190676 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441080,248.75047884252808,490.807523353751,0.5068187976068175 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441096,473.4147739229372,490.807523353751,0.964562993427715 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441089,655.7956274598547,490.807523353751,1.3361564284482006 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441091,459.06049001688336,490.807523353751,0.9353167345114516 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441099,57.65323478342387,78.64120835950264,0.7331173564865159 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441079,64.7387871632906,78.64120835950264,0.8232170958938204 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441080,70.67267974439424,78.64120835950264,0.8986723528117619 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441096,60.10480997651197,78.64120835950264,0.7642915365916956 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441089,81.65688294336229,78.64120835950264,1.0383472564418608 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441091,148.6244608491658,78.64120835950264,1.8899056099156024 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441099,1736.2506317321167,1710.8868039225827,1.014824959635776 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441079,1758.6657568632756,1710.8868039225827,1.0279264255420928 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441080,1626.0970306257718,1710.8868039225827,0.9504410384705687 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441096,1658.939823543884,1710.8868039225827,0.9696373949114583 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441089,1680.0275885731337,1710.8868039225827,0.9819630291853924 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441091,1711.7151447980264,1710.8868039225827,1.000484158784523 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441099,233.3892474609553,158.21676846284709,1.475123336979041 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441079,310.77997834003844,158.21676846284709,1.9642670075960798 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441080,193.9126258537079,158.21676846284709,1.225613616923563 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441096,186.2436384105446,158.21676846284709,1.1771422221550358 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441089,225.3080787568608,158.21676846284709,1.4240467742189304 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441091,259.339668629136,158.21676846284709,1.6391414838562757 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441099,849.2021178252443,1068.4447009417866,0.7948021241311883 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441079,873.6126026753769,1068.4447009417866,0.8176488702740781 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441080,879.1791480662348,1068.4447009417866,0.8228588220721929 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441096,1196.8931995024036,1068.4447009417866,1.1202200717055317 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441089,916.0187921248048,1068.4447009417866,0.8573385139327987 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441091,873.1579343734018,1068.4447009417866,0.8172233280802945 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441099,157.60558256243888,101.193417409009,1.557468722747253 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441079,162.8581397655064,101.193417409009,1.609374838160249 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441080,135.59080771768626,101.193417409009,1.33991727119609 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441096,144.79539666451623,101.193417409009,1.4308776239789829 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441089,190.8258574920506,101.193417409009,1.8857536624221354 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441091,101.64475563685966,101.193417409009,1.0044601540239164 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441099,9951.725670022128,8195.704907369402,1.2142611016989826 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441079,8210.12810114569,8195.704907369402,1.0017598478641319 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441080,11238.69533845703,8195.704907369402,1.371290873143985 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441096,9440.22295324019,8195.704907369402,1.1518500311976514 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441089,8141.454558095422,8195.704907369402,0.9933806365788989 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441091,9168.46253774567,8195.704907369402,1.1186911487627607 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441099,33.31269557578638,54.484574340672744,0.6114151753759494 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441079,65.45494676673663,54.484574340672744,1.201348226701195 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441080,30.979924523363053,54.484574340672744,0.5685999183852765 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441096,79.45676327463097,54.484574340672744,1.4583350285131342 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441089,18.50259805075013,54.484574340672744,0.33959333030776634 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441091,16.60825009988205,54.484574340672744,0.30482481144179535 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441099,222.2234070273527,181.8259570369428,1.2221764738584715 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441079,182.31000553953385,181.8259570369428,1.0026621529207334 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441080,69.33349517922669,181.8259570369428,0.3813179169195283 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441096,152.44924184152586,181.8259570369428,0.8384349755439577 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441089,111.65307998593433,181.8259570369428,0.6140656802001543 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441091,142.45621123046027,181.8259570369428,0.7834756574470634 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441099,718.4799520177205,598.5025834222519,1.2004625742957287 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441079,613.8841120369915,598.5025834222519,1.025700020418939 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441080,606.7192331300519,598.5025834222519,1.0137286787649553 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441096,912.8507527084976,598.5025834222519,1.525224415053976 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441089,728.8687645506235,598.5025834222519,1.2178205821317174 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441091,587.0646168982211,598.5025834222519,0.9808890273144215 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441099,19347.52536542675,15066.853658787537,1.2841118526523 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441079,15127.88368158586,15066.853658787537,1.00405061495787 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441080,13506.58542833838,15066.853658787537,0.8964436593210586 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441096,26129.1297949299,15066.853658787537,1.7342127551421753 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441089,13761.329311854235,15066.853658787537,0.913351229360891 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441091,23480.20360647527,15066.853658787537,1.5584012520610606 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441099,61.37451709688121,62.8704966822211,0.9762053798795114 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441079,61.12963785917773,62.8704966822211,0.9723104013024974 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441080,63.446043618475315,62.8704966822211,1.0091544836867332 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441096,64.35259023254359,62.8704966822211,1.023573752849667 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441089,62.6564727473179,62.8704966822211,0.9965957969763626 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441091,64.82848336293902,62.8704966822211,1.0311431718221435 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441099,98.11109490432378,100.49015468400951,0.9763254441475718 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441079,96.8877884994723,100.49015468400951,0.9641520485676948 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441080,98.84719385725415,100.49015468400951,0.9836505294282646 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441096,96.25959449068516,100.49015468400951,0.9579007495149419 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441089,100.20421100411232,100.49015468400951,0.99715451050109 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441091,103.29767062150913,100.49015468400951,1.0279382188864952 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441099,102.92703692206632,109.95671552102958,0.9360686742446503 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441079,112.06376689029642,109.95671552102958,1.0191625528216497 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441080,110.2480871670826,109.95671552102958,1.002649875859536 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441096,108.81078598228363,109.95671552102958,0.9895783578718593 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441089,108.72042014568105,109.95671552102958,0.9887565268797786 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441091,108.5288451776079,109.95671552102958,0.9870142506835011 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441099,247.65018764901583,243.54938966397899,1.0168376442687648 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441079,235.39051617057933,243.54938966397899,0.9665001275320119 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441080,246.4404962589509,243.54938966397899,1.0118707199347152 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441096,240.0484647086409,243.54938966397899,0.9856254004160377 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441089,249.3429900468992,243.54938966397899,1.0237881950388525 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441091,259.77668547190143,243.54938966397899,1.0666283575184112 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441099,66.11513356557279,49.66723175069083,1.331162040547049 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441079,70.16743011366134,49.66723175069083,1.4127509756507692 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441080,43.74820864903211,49.66723175069083,0.8808263941229945 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441096,44.38859739938789,49.66723175069083,0.893719980654458 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441089,95.51306438013864,49.66723175069083,1.9230599534835184 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441091,85.75425056799502,49.66723175069083,1.7265760048485537 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441099,330.5312261370463,318.9289567276793,1.0363788522949131 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441079,251.5620953157714,318.9289567276793,0.7887715743872395 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441080,391.2225573532213,318.9289567276793,1.2266761894789961 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441096,318.5897831831809,318.9289567276793,0.998936523205737 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441089,271.9582662599919,318.9289567276793,0.8527236568619456 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441091,321.6995113064812,318.9289567276793,1.0086870587331698 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441099,45.524119872420975,52.85511393128503,0.8613001938015911 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441079,45.56397309472931,52.85511393128503,0.8620542026257921 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441080,48.69623058023232,52.85511393128503,0.9213154027733338 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441096,61.388071773090786,52.85511393128503,1.1614405344561196 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441089,60.47777199265117,52.85511393128503,1.144217985629093 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441091,40.967195594068016,52.85511393128503,0.7750848034747961 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441099,150.52594001604703,145.91831693350866,1.0315767285380488 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441079,130.81295553516173,145.91831693350866,0.8964807043023251 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441080,148.62031578115278,145.91831693350866,1.0185172012974584 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441096,135.20997244294858,145.91831693350866,0.9266141172979702 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441089,135.65493663246858,145.91831693350866,0.9296635232866833 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441091,156.71779937417736,145.91831693350866,1.0740104646738062 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441099,573.0228266678373,261.347965154705,2.1925666279002263 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441079,548.2038607090976,261.347965154705,2.0976014119129958 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441080,373.8022430746084,261.347965154705,1.4302856456270325 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441096,414.6315476257146,261.347965154705,1.5865114824225754 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441089,536.2426466586944,261.347965154705,2.0518340226650147 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441091,566.9980871157842,261.347965154705,2.1695140682658445 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441099,6137.317529366839,7540.877985370558,0.8138730717130482 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441079,6132.269992521882,7540.877985370558,0.8132037150605803 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441080,5150.544635540776,7540.877985370558,0.6830165725440628 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441096,5950.54377309192,7540.877985370558,0.7891049006012409 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441089,6604.434844758047,7540.877985370558,0.8758177572387157 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441091,5869.891629957144,7540.877985370558,0.7784095752967812 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441099,6342.021783947773,5107.556668860965,1.2416938656036693 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441079,5302.146382877491,5107.556668860965,1.0380983955014877 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441080,3421.1426292886863,5107.556668860965,0.6698198083921866 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441096,4420.4724404015615,5107.556668860965,0.865476925072937 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441089,5139.1389387458985,5107.556668860965,1.0061834399366492 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441091,8553.885695327022,5107.556668860965,1.674751011080729 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441099,81718.92405293966,180330.65339424144,0.4531615813218654 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441079,54116.8415812831,180330.65339424144,0.3000978511566311 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441080,137771.64919133397,180330.65339424144,0.7639946209818007 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441096,183802.04063418417,180330.65339424144,1.0192501228970403 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441089,116052.37141883098,180330.65339424144,0.6435532131362915 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441091,99392.81461299032,180330.65339424144,0.5511698246647858 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441099,484.0811507587535,98.01831453553807,4.938680623642456 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441079,257.3757148817936,98.01831453553807,2.625792088972087 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441080,160.56240522863598,98.01831453553807,1.6380857596813867 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441096,202.26937410573444,98.01831453553807,2.0635875556949976 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441089,280.4312102128272,98.01831453553807,2.8610082874986844 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441091,465.5098121651649,98.01831453553807,4.749212576965777 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441099,1512.853895561823,1812.4793707702274,0.8346875114605712 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441079,799.1068749248188,1812.4793707702274,0.4408915697535537 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441080,2298.624826586574,1812.4793707702274,1.2682212353179805 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441096,3164.455271408552,1812.4793707702274,1.7459262281500019 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441089,1488.4737895702142,1812.4793707702274,0.8212362654023894 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441091,1197.1983460516778,1812.4793707702274,0.6605307433336022 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441099,311.2413949576673,434.5650550234931,0.7162135826610385 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441079,421.6902426955313,434.5650550234931,0.970373107135212 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441080,317.7105193114613,434.5650550234931,0.7311000174514389 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441096,470.29964173199386,434.5650550234931,1.0822306954860164 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441089,1048.9230454290264,434.5650550234931,2.4137307712704152 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441091,851.2909986466036,434.5650550234931,1.958949503200578 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441099,21991.81915527112,9833.502392298877,2.2364177358103916 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441079,28683.671848900965,9833.502392298877,2.9169334286596227 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441080,53118.30988158499,9833.502392298877,5.401769152279322 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441096,65571.37716806862,9833.502392298877,6.668161002271271 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441089,43659.1165099936,9833.502392298877,4.439833821994624 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441091,13795.280088590638,9833.502392298877,1.4028857204930802 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441099,42.25891386286413,42.4088060383901,0.9964655412512609 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441079,40.56032273494699,42.4088060383901,0.956412748291716 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441080,39.87198579138734,42.4088060383901,0.9401817574230614 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441096,41.413827861356786,42.4088060383901,0.9765384062891886 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441089,36.33275068803488,42.4088060383901,0.8567265641750221 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441091,46.13600726588852,42.4088060383901,1.0878874360227075 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441099,421.1762113285891,385.8715169071063,1.0914933932010897 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441079,399.1617263306315,385.8715169071063,1.034442058667742 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441080,508.9614218910772,385.8715169071063,1.3189919431487949 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441096,459.2099886593337,385.8715169071063,1.1900593035217024 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441089,435.6506119531405,385.8715169071063,1.129004326219854 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441091,432.051703966905,385.8715169071063,1.1196776259360859 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441099,1117.786757799982,1002.6445024002205,1.114838564540197 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441079,967.7086797645442,1002.6445024002205,0.9651563215556024 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441080,857.9971726996882,1002.6445024002205,0.8557341816024897 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441096,710.932877568996,1002.6445024002205,0.7090577725874934 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441089,992.020630045534,1002.6445024002205,0.9894041484003012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441091,735.2501832443085,1002.6445024002205,0.7333109407015154 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441099,13019.467218340227,6245.085755978491,2.0847539532786312 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441079,15339.019221372366,6245.085755978491,2.456174313809566 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441080,14589.73340087346,6245.085755978491,2.336194244715782 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441096,10792.404790226006,6245.085755978491,1.728143569508924 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441089,15342.021568843187,6245.085755978491,2.4566550674113796 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441091,10086.640500300442,6245.085755978491,1.6151324248260943 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441099,322.0580470345069,289.8012081128336,1.1113067786422552 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441079,281.1681429106388,289.8012081128336,0.9702103891891523 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441080,331.2363555598407,289.8012081128336,1.1429778285495429 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441096,258.05347607305913,289.8012081128336,0.890449966559789 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441089,329.57116260467336,289.8012081128336,1.1372318450665513 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441091,239.51554064612105,289.8012081128336,0.8264822020785576 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441099,24157.510218374584,19122.271903916942,1.2633179958823952 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441079,26952.65829765484,19122.271903916942,1.409490380279236 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441080,25274.454859300207,19122.271903916942,1.3217286620698596 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441096,22007.870591293653,19122.271903916942,1.15090250268775 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441089,22698.348350573713,19122.271903916942,1.1870110656633985 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441091,27497.52089517347,19122.271903916942,1.4379839923487843 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441099,109.82635175158948,111.01681566749893,0.9892767243525076 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441079,78.5111253176873,111.01681566749893,0.7072002997530766 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441080,103.88698147581064,111.01681566749893,0.9357769888388574 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441096,63.44217669333892,111.01681566749893,0.5714645687852505 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441089,171.62696470286903,111.01681566749893,1.5459546706590883 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441091,71.84980202868898,111.01681566749893,0.6471974682095263 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441099,1340.1843257634018,1048.3386659324408,1.278388720472673 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441079,1294.6933040116444,1048.3386659324408,1.2349952797554065 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441080,1286.9091707251605,1048.3386659324408,1.227570071147308 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441096,1148.3367928831349,1048.3386659324408,1.0953872352516456 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441089,1445.2159153096509,1048.3386659324408,1.3785773264636854 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441091,1740.1714143933732,1048.3386659324408,1.6599324921833198 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441099,9325.623998211056,5453.602601951663,1.7099933161381664 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441079,11680.877174478224,5453.602601951663,2.1418643834257427 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441080,4640.8096474352915,5453.602601951663,0.8509621962140219 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441096,6740.952244959432,5453.602601951663,1.236054904797623 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441089,9194.479292018998,5453.602601951663,1.6859459632663 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441091,8629.309637679838,5453.602601951663,1.5823136131319315 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441099,109856.17824560216,64173.361133824874,1.7118657384410947 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441079,77153.08433192573,64173.361133824874,1.2022602988026978 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441080,76668.53404809837,64173.361133824874,1.1947096535619586 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441096,114792.1506857821,64173.361133824874,1.788781959642079 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441089,199914.7427325567,64173.361133824874,3.115229422309072 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441091,79900.19498561011,64173.361133824874,1.2450679467916455 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441099,137.0597777748018,44.60879663763593,3.072483189541276 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441079,60.17844731475481,44.60879663763593,1.34902646676604 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441080,27.251672978580057,44.60879663763593,0.6109035668446643 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441096,30.892699042066347,44.60879663763593,0.69252482403891 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441089,9.726940981438872,44.60879663763593,0.21804984026922536 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441091,47.89376043625375,44.60879663763593,1.073639372639932 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441099,133.50358875659515,136.29080299882398,0.9795495060495544 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441079,132.29413152862008,136.29080299882398,0.9706754132908119 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441080,131.73613955617148,136.29080299882398,0.9665812854394012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441096,131.4929235756401,136.29080299882398,0.96479674844072 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441089,134.33751322709247,136.29080299882398,0.9856682202411827 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441091,138.4227704830655,136.29080299882398,1.0156427832057011 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441099,79.82407236597317,82.77341642135346,0.9643684629329926 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441079,54.80833990400701,82.77341642135346,0.662149060333673 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441080,65.3580913021163,82.77341642135346,0.7896024367221306 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441096,112.62645051826516,82.77341642135346,1.3606596826322415 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441089,194.71021862376804,82.77341642135346,2.352327921715911 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441091,29.620311224354367,82.77341642135346,0.35784811724544296 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441099,2721.896949186694,2141.365658987758,1.2711032969835514 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441079,2240.197021339585,2141.365658987758,1.0461534264066537 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441080,3161.69036796266,2141.365658987758,1.4764831754410492 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441096,3580.240264018892,2141.365658987758,1.6719425050046346 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441089,2127.9247327540797,2141.365658987758,0.9937231989421033 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441091,3071.832491636648,2141.365658987758,1.4345202925728853 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441099,472.0725429447641,285.0677067828484,1.6560014751315464 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441079,383.3343002830073,285.0677067828484,1.344713172211449 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441080,440.307107019575,285.0677067828484,1.5445702776673365 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441096,478.644215206212,285.0677067828484,1.6790544976419282 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441089,305.28065919538216,285.0677067828484,1.0709057951202134 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441091,240.499804691575,285.0677067828484,0.8436585378461574 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441099,932500.330693286,724296.655045942,1.2874563539633324 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441079,887429.6939882278,724296.655045942,1.2252295903975121 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441080,782123.7978131202,724296.655045942,1.0798390305468277 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441096,694753.7540472695,724296.655045942,0.9592116009471303 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441089,799970.1560491864,724296.655045942,1.1044786006894431 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441091,617985.9292448624,724296.655045942,0.85322212237148 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441099,20.82781610681413,126.94877083842833,0.16406473232673 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441079,17.533457392246195,126.94877083842833,0.13811443211657065 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441080,84.70672431753769,126.94877083842833,0.6672512365271074 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441096,171.1378012673923,126.94877083842833,1.3480855319600118 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441089,126.8510861480958,126.94877083842833,0.999230518817257 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441091,120.03589668312613,126.94877083842833,0.9455459544062822 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441099,106920.61291600384,94593.87687362579,1.1303121983132813 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441079,49693.50488116005,94593.87687362579,0.5253353232107072 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441080,72635.04241807788,94593.87687362579,0.767861988732271 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441096,90811.12627404532,94593.87687362579,0.9600106188201368 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441089,76224.81357880897,94593.87687362579,0.8058112860797823 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441091,205634.47667092143,94593.87687362579,2.1738666758065337 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441099,241.3988736103385,34.2642969985689,7.045201412432915 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441079,6.453248101995178,34.2642969985689,0.1883373851874068 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441080,12.34984819987024,34.2642969985689,0.3604290553629642 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441096,17.914640643106097,34.2642969985689,0.5228369531076131 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441089,600.3593619518417,34.2642969985689,17.521426515095776 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441091,22.769721651956996,34.2642969985689,0.6645319952984299 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441099,42.21920451182049,74.66086218948179,0.565479734277276 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441079,216.20250259935875,74.66086218948179,2.895794346047846 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441080,75.87686956347628,74.66086218948179,1.016287079178223 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441096,66.04507836717747,74.66086218948179,0.8846010671503053 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441089,194.83986828726347,74.66086218948179,2.6096653932656095 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441091,27.43264625307284,74.66086218948179,0.3674300757932788 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441099,388.7518039655293,347.6986105145094,1.1180712036504004 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441079,382.4524379191656,347.6986105145094,1.099953886365059 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441080,377.5267580323225,347.6986105145094,1.0857873647342873 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441096,293.7852654023794,347.6986105145094,0.8449423049682271 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441089,1089.522548842611,347.6986105145094,3.1335257487235353 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441091,52.120467591721145,347.6986105145094,0.14990128236231812 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441099,4267.915351387143,2521.321340016667,1.6927296349139418 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441079,4248.0105953094335,2521.321340016667,1.684835061635322 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441080,3723.066332687166,2521.321340016667,1.476633015235795 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441096,3958.0436526172207,2521.321340016667,1.5698291168991003 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441089,4366.170678819622,2521.321340016667,1.731699410750539 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441091,3798.158345092396,2521.321340016667,1.5064158165048842 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441099,284.1499133832279,79.44971561377609,3.5764748959524035 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441079,120.20436355599222,79.44971561377609,1.5129615333091202 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441080,100.72193778045197,79.44971561377609,1.2677444721147297 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441096,92.1010842546637,79.44971561377609,1.1592374314137122 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441089,94.88335764442068,79.44971561377609,1.1942567309576184 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441091,236.8054664407111,79.44971561377609,2.980570347059247 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441099,46.902101768767075,42.37178439720435,1.1069182578929018 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441079,102.65344028582837,42.37178439720435,2.422683909734076 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441080,57.75989867795918,42.37178439720435,1.3631688988243347 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441096,76.7884623433272,42.37178439720435,1.8122546273598434 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441089,39.29540406673164,42.37178439720435,0.9273955446002957 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441091,64.62177382823096,42.37178439720435,1.5251133448251624 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441099,1281.8078428471215,1321.2949146990686,0.970114868820985 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441079,1721.7537099527117,1321.2949146990686,1.30308055438543 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441080,1284.172271104357,1321.2949146990686,0.9719043468784057 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441096,1446.0995481067052,1321.2949146990686,1.0944563034483952 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441089,1871.2235041426773,1321.2949146990686,1.4162042730398743 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441091,2334.4106099861842,1321.2949146990686,1.7667597021803854 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441099,19013.36200484751,23354.026662177774,0.8141363491564373 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441079,27756.94386361172,23354.026662177774,1.188529253011625 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441080,33302.20845144119,23354.026662177774,1.4259728711098314 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441096,24369.01278121291,23354.026662177774,1.0434608615343803 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441089,28632.500184879613,23354.026662177774,1.226019846558213 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441091,17889.57275135895,23354.026662177774,0.7660166278876185 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441099,6072.510344375129,13473.54115415771,0.45069891240145527 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441079,8007.96394075336,13473.54115415771,0.5943473841902531 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441080,9701.873152551818,13473.54115415771,0.7200685433434091 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441096,13396.88386897556,13473.54115415771,0.9943105317076576 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441089,17702.919675357512,13473.54115415771,1.3139025199692722 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441091,4887.343247772307,13473.54115415771,0.36273635801113463 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441099,66950.41912195092,49612.48263442616,1.349467222095714 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441079,77487.16922324296,49612.48263442616,1.561848250856822 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441080,80162.278829558,49612.48263442616,1.6157683424198026 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441096,62440.64824441893,49612.48263442616,1.258567298567141 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441089,70781.12552970195,49612.48263442616,1.4266797743474915 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441091,74467.20579691629,49612.48263442616,1.500977210627299 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441095,118.74130957350948,73.06854961986588,1.6250672853266284 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441083,137.07168933722474,73.06854961986588,1.8759328062529066 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441084,97.26664800399882,73.06854961986588,1.3311698194369794 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441094,165.39680411435782,73.06854961986588,2.263584058734207 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441078,152.75183481512968,73.06854961986588,2.0905278072414277 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441088,236.61681674616895,73.06854961986588,3.23828539059762 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441095,550.4169920378397,990.9231863649335,0.555458787937912 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441083,75.80759285930314,990.9231863649335,0.07650198713927862 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441084,60.88023525791238,990.9231863649335,0.06143789558627972 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441094,74.08480481276212,990.9231863649335,0.07476341842855865 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441078,319.19595366342196,990.9231863649335,0.3221197748277026 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441088,118.94336265726562,990.9231863649335,0.12003287872755619 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441095,54.66672442787479,50.719124328797626,1.0778325760020224 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441083,56.19486051140433,50.719124328797626,1.1079619621803616 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441084,56.24990213553984,50.719124328797626,1.1090471864397295 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441094,52.82892958631748,50.719124328797626,1.0415978249908768 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441078,55.938834138389005,50.719124328797626,1.1029140364441918 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441088,54.22543312300458,50.719124328797626,1.0691318874410478 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441095,304.1700857531193,319.2477137201226,0.95277138310152 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441083,397.4206126860121,319.2477137201226,1.244865963345385 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441084,321.3256019426714,319.2477137201226,1.0065087019679348 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441094,347.30912992842315,319.2477137201226,1.0878985659170652 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441078,298.24544633787644,319.2477137201226,0.9342132567293547 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441088,321.06835254714713,319.2477137201226,1.005702903259068 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441095,46.19425790951066,44.58166891160943,1.0361715709005523 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441083,17.02043125719476,44.58166891160943,0.3817809353647257 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441084,34.522995883863764,44.58166891160943,0.7743764808874999 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441094,126.25272914288898,44.58166891160943,2.8319426397698573 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441078,63.028732545061374,44.58166891160943,1.4137813609002912 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441088,125.53351434167314,44.58166891160943,2.8158101167222838 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441095,2104.523392639562,1543.2839395802719,1.3636657122291644 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441083,3223.350519595532,1543.2839395802719,2.088630897352686 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441084,4937.875052594706,1543.2839395802719,3.199589476669902 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441094,2819.473544807173,1543.2839395802719,1.8269311774047148 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441078,3628.720772499552,1543.2839395802719,2.3512982150818327 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441088,2947.724057264753,1543.2839395802719,1.910033521159073 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441095,32.087304269244264,31.276034215973343,1.025939032029086 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441083,31.77770113759473,31.276034215973343,1.0160399786672818 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441084,33.58946935320923,31.276034215973343,1.0739683017757529 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441094,31.571462972893084,31.276034215973343,1.0094458509310895 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441078,43.00225145741766,31.276034215973343,1.3749266022818034 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441088,32.82505762614341,31.276034215973343,1.0495274880272047 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441095,202.94656302024768,130.468422036268,1.555522477031507 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441083,28.91785747413932,130.468422036268,0.22164641085411954 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441084,69.74617064819692,130.468422036268,0.5345827715215922 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441094,94.51641733777195,130.468422036268,0.7244390317796439 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441078,39.72290178051888,130.468422036268,0.30446372509569086 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441088,25.382019143892116,130.468422036268,0.1945453064254609 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441095,87.56479132907451,95.42663227533711,0.9176137650590181 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441083,85.05947124165988,95.42663227533711,0.8913598773582979 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441084,105.10870514236072,95.42663227533711,1.10146090914209 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441094,101.66496735711722,95.42663227533711,1.0653731032211267 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441078,88.73170324766114,95.42663227533711,0.9298421324525118 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441088,117.4840318847198,95.42663227533711,1.2311451120452397 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441095,538.8294701466687,569.3868516791151,0.9463328290031056 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441083,576.6663234593476,569.3868516791151,1.0127847556696565 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441084,570.1120160932887,569.3868516791151,1.0012735882678623 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441094,543.6346666860053,569.3868516791151,0.954772076458796 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441078,573.5466101118668,569.3868516791151,1.0073056805236802 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441088,584.7100038390456,569.3868516791151,1.026911671941041 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441095,5502.942944212807,5328.634617598269,1.0327116304876431 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441083,8963.626881020666,5328.634617598269,1.6821620404254263 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441084,2355.6136390238435,5328.634617598269,0.44206702243089235 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441094,3396.143478211324,5328.634617598269,0.6373384031615287 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441078,895.6234599610432,5328.634617598269,0.16807747654589988 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441088,5098.381503459982,5328.634617598269,0.9567894722265519 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441095,827914.5609605005,656386.6079991342,1.261321530438038 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441083,974159.832512834,656386.6079991342,1.4841250882347663 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441084,1127380.6865777457,656386.6079991342,1.7175558928820083 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441094,951100.4611469556,656386.6079991342,1.448994311517413 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441078,896351.4305320926,656386.6079991342,1.3655845801980087 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441088,516532.9582324,656386.6079991342,0.7869340293321178 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441095,5394.7179165755215,5223.837669019135,1.0327116304876434 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441083,8787.341432168434,5223.837669019135,1.6821620404254267 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441084,2309.2863640056225,5223.837669019135,0.44206702243089235 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441094,3329.3523583476976,5223.837669019135,0.6373384031615287 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441078,878.009453294152,5223.837669019135,0.16807747654589988 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441088,4998.112886338001,5223.837669019135,0.9567894722265522 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441095,827914.5609605005,656386.6079991342,1.261321530438038 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441083,974159.832512834,656386.6079991342,1.4841250882347663 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441084,1127380.6865777457,656386.6079991342,1.7175558928820083 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441094,951100.4611469556,656386.6079991342,1.448994311517413 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441078,896351.4305320926,656386.6079991342,1.3655845801980087 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441088,516532.9582324,656386.6079991342,0.7869340293321178 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441095,53.081218855271906,50.79723336807032,1.0449627929665404 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441083,54.49796556930732,50.79723336807032,1.0728530267469876 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441084,43.773867554080766,50.79723336807032,0.8617372374771055 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441094,44.36662960261433,50.79723336807032,0.8734064172577933 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441078,51.31027017913623,50.79723336807032,1.0100996998664968 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441088,73.67397464041048,50.79723336807032,1.45035407945504 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441095,90.62160980424832,124.85055234194422,0.72584067995191 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441083,87.96123831662543,124.85055234194422,0.7045322320698646 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441084,194.47169403585272,124.85055234194422,1.5576358325049948 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441094,79.63543967202766,124.85055234194422,0.6378461142400065 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441078,48.754552371419805,124.85055234194422,0.3905032973974313 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441088,248.2144517705026,124.85055234194422,1.9880925403572571 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441095,159.744591232462,149.81706398084205,1.0662643292281409 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441083,171.09449261920523,149.81706398084205,1.1420227314098481 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441084,166.2479058592225,149.81706398084205,1.1096726997699111 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441094,201.3116062498791,149.81706398084205,1.343716135537284 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441078,195.01046132670064,149.81706398084205,1.3016572087652025 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441088,189.3947761708928,149.81706398084205,1.2641735937043312 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441095,2963.5338091453477,2791.14294318225,1.061763538977531 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441083,3094.2350147170373,2791.14294318225,1.1085906661552865 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441084,3440.434679836603,2791.14294318225,1.2326257557823534 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441094,3182.311248127692,2791.14294318225,1.1401462816158967 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441078,2847.4533303228477,2791.14294318225,1.0201746697632035 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441088,2953.014793458277,2791.14294318225,1.057994826338587 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441095,309.2759637907012,222.01180748199775,1.3930608795020032 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441083,473.1043242214572,222.01180748199775,2.130987219046085 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441084,246.49360295540137,222.01180748199775,1.1102724929411187 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441094,475.91796246247145,222.01180748199775,2.1436605911199664 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441078,326.1774606640322,222.01180748199775,1.4691896992482298 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441088,616.8498999352747,222.01180748199775,2.7784553755560646 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441095,9753.669724761136,4330.453784028004,2.2523435674883676 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441083,10514.03700012534,4330.453784028004,2.427929617654441 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441084,9606.941846786378,4330.453784028004,2.218460772452907 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441094,10608.052948932069,4330.453784028004,2.449640032658404 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441078,13390.878477143591,4330.453784028004,3.0922575658313494 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441088,9714.344865729325,4330.453784028004,2.243262565590402 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441095,161.5862004145185,100.4664893584531,1.6083591797260592 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441083,189.77167150851085,100.4664893584531,1.8889051734596491 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441084,66.66039148013493,100.4664893584531,0.6635087172430021 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441094,129.9863116672565,100.4664893584531,1.2938275488404896 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441078,107.81339922791828,100.4664893584531,1.0731279645221028 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441088,190.49241218509215,100.4664893584531,1.8960791145536768 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441095,392.91831718273806,219.8603821991507,1.7871265084349328 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441083,228.20261897982573,219.8603821991507,1.037943337936703 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441084,151.31047296261715,219.8603821991507,0.6882116343523833 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441094,429.3680157277019,219.8603821991507,1.952912168317701 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441078,109.48682613537964,219.8603821991507,0.497983424936494 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441088,565.5890656953301,219.8603821991507,2.5724919607526946 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441095,147.11427388351785,115.26780159034894,1.2762824644331148 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441083,81.37286424026766,115.26780159034894,0.7059461802651469 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441084,117.65963418712091,115.26780159034894,1.0207502230785344 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441094,143.43418769870044,115.26780159034894,1.2443560623152354 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441078,132.25419758429365,115.26780159034894,1.1473646218595612 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441088,64.87468372713145,115.26780159034894,0.5628170471897266 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441095,1640.9262170791706,1760.6737631139824,0.9319876580525499 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441083,1086.6309155360905,1760.6737631139824,0.6171676651864462 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441084,1978.3049501802857,1760.6737631139824,1.1236067644248835 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441094,1303.519058146316,1760.6737631139824,0.7403524068200298 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441078,1553.373662633341,1760.6737631139824,0.8822609248666238 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441088,1622.5028976095143,1760.6737631139824,0.9215238686466851 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441095,675.0642777312344,518.6000624505415,1.3017049680660515 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441083,628.0144127576671,518.6000624505415,1.2109802104344334 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441084,724.6329765946904,518.6000624505415,1.3972867129451958 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441094,1343.2703033163043,518.6000624505415,2.590185386729318 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441078,2059.111903574139,518.6000624505415,3.970519968401498 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441088,1035.513620331334,518.6000624505415,1.9967479668980763 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441095,1819.8002829239545,841.89306662726494,2.161557512540536 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441083,2245.1312628029655,841.89306662726494,2.6667653551267008 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441084,1419.1577221979896,841.89306662726494,1.6856745570827936 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441094,2085.8243720905452,841.89306662726494,2.4775407409478185 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441078,2083.958277831915,841.89306662726494,2.475324195483077 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441088,1723.353272143417,841.89306662726494,2.0469978201001204 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441095,511.935132503033,246.94010350613598,2.0731145943263622 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441083,518.0558882474511,246.94010350613598,2.0979009925561907 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441084,422.2329180443433,246.94010350613598,1.7098596463245253 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441094,560.0290236049243,246.94010350613598,2.267873932396763 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441078,435.6696470318944,246.94010350613598,1.7642725537331316 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441088,501.75590423387536,246.94010350613598,2.031893147811075 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441095,2500.2871673841487,6405.278640912654,0.3903479157665335 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441083,1961.5673540651471,6405.278640912654,0.3062423141962883 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441084,3798.966046630687,6405.278640912654,0.5930992638423912 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441094,2079.824108366949,6405.278640912654,0.3247047045045656 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441078,2862.213095247046,6405.278640912654,0.4468522379284385 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441088,2073.4148335540035,6405.278640912654,0.32370408061726 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441095,171.59574402814292,184.84349394551683,0.9283299096192223 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441083,173.1909029977972,184.84349394551683,0.936959691147397 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441084,798.0272171203958,184.84349394551683,4.317312987795051 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441094,102.43584397049406,184.84349394551683,0.5541760858550279 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441078,483.8263799212252,184.84349394551683,2.617492071773078 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441088,129.04787656291572,184.84349394551683,0.6981467067537306 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441095,51955.173637487846,66689.05961878091,0.7790659207744516 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441083,21110.94396505279,66689.05961878091,0.3165578295110274 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441084,38749.387684295485,66689.05961878091,0.581045645354743 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441094,36332.72255737112,66689.05961878091,0.5448078405223026 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441078,33272.658076539636,66689.05961878091,0.4989222860052059 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441088,43841.645481200816,66689.05961878091,0.6574038640193116 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441095,933.4598096956504,426.591426110135,2.1881823041015713 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441083,884.1345192241606,426.591426110135,2.072555764390585 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441084,1074.9428313051951,426.591426110135,2.5198416224794737 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441094,1044.8186845956127,426.591426110135,2.4492257008603526 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441078,410.9361279283556,426.591426110135,0.9633014232739464 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441088,1487.1415373594518,426.591426110135,3.4861027351625906 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441095,100258.68673841497,6086.038398766024,16.47355474437081 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441083,314659.4448245514,6086.038398766024,51.701850071854665 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441084,766602.4655180854,6086.038398766024,125.96083285861587 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441094,380330.89632168354,6086.038398766024,62.49235897013032 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441078,482222.7556874647,6086.038398766024,79.23426112218382 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441088,108320.22677563391,6086.038398766024,17.798150402336667 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441095,132.64428778656867,118.38689307733607,1.1204305167457935 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441083,128.57390784558464,118.38689307733607,1.0860485016833235 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441084,117.50854947702231,118.38689307733607,0.992580736114597 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441094,188.1085144075832,118.38689307733607,1.5889302398087393 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441078,282.41785108216413,118.38689307733607,2.3855499856531845 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441088,199.3002555963592,118.38689307733607,1.6834655460226209 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441095,174.6151493858673,43.003791743375764,4.060459375951767 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441083,72.60935083114853,43.003791743375764,1.688440667382154 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441084,35.38918592082457,43.003791743375764,0.8229317575531201 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441094,88.63861878525475,43.003791743375764,2.0611814724200106 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441078,208.3534954598913,43.003791743375764,4.84500289423864 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441088,118.03457695146771,43.003791743375764,2.744748129556496 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441095,93.22096063675905,56.77751951238643,1.64186391792657 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441083,73.24153762418209,56.77751951238643,1.2899742407416004 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441084,79.33194132340428,56.77751951238643,1.3972421128065915 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441094,80.15118460476982,56.77751951238643,1.411671120773148 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441078,39.77857196134883,56.77751951238643,0.7006042585687606 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441088,37.23456333722795,56.77751951238643,0.6557976406331903 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441095,203.2174386382098,232.93832449773902,0.872408776341921 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441083,89.92234307474456,232.93832449773902,0.38603498702343153 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441084,168.5619461949539,232.93832449773902,0.7236333761668746 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441094,211.5705937561756,232.93832449773902,0.9082687196809007 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441078,130.04826038077496,232.93832449773902,0.5582948218640478 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441088,162.4059488269467,232.93832449773902,0.6972057911772397 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441095,94.1162892875144,55.88566907011774,1.684086293561773 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441083,64.34198266855095,55.88566907011774,1.1513145273043681 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441084,40.31335397844536,55.88566907011774,0.7213540546122056 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441094,63.88801733144904,55.88566907011774,1.1431914190969252 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441078,64.82118436554654,55.88566907011774,1.1598892067341582 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441088,25.730316660086633,55.88566907011774,0.46040992419369137 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441095,466.5360376920567,226.42114305345407,2.060479120458798 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441083,687.9229685389384,226.42114305345407,3.0382452771936226 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441084,203.91196259002356,226.42114305345407,0.9005871087837566 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441094,203.74325146256123,226.42114305345407,0.8998419878768168 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441078,273.47235648412766,226.42114305345407,1.2078039744705538 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441088,213.009912141691,226.42114305345407,0.9407686458477205 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441095,297.60236431478467,212.71806341276286,1.3990460402853067 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441083,390.1416973039861,212.71806341276286,1.8340788320686547 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441084,237.98112262273824,212.71806341276286,1.1187631120961945 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441094,287.00847743110853,212.71806341276286,1.3492435612963949 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441078,163.90395862971243,212.71806341276286,0.7705220515836944 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441088,380.63972143327067,212.71806341276286,1.7894094903199118 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441095,9385.324882255927,10996.969545575432,0.853446473899899 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441083,8142.6466580841,10996.969545575432,0.7404445946983864 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441084,11973.252731024217,10996.969545575432,1.0887774746854315 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441094,6174.316483544112,10996.969545575432,0.5614561773546344 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441078,11732.232220727508,10996.969545575432,1.0668604811630042 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441088,9124.691803255784,10996.969545575432,0.8297460282525791 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441095,167.7785124804303,147.8550055811589,1.134750303657019 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441083,172.58646779814728,147.8550055811589,1.1672683459026556 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441084,182.85750241715135,147.8550055811589,1.2367352846690014 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441094,185.25281475935077,147.8550055811589,1.2529356989382674 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441078,159.52753517754653,147.8550055811589,1.0789457857751084 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441088,236.0829252223399,147.8550055811589,1.5967191932014226 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441095,235.2267883089149,92.19915296117537,2.551290123109567 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441083,284.62297292367873,92.19915296117537,3.087045420509797 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441084,441.0407695622087,92.19915296117537,4.783566392935615 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441094,200.80410906370184,92.19915296117537,2.177938762064978 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441078,73.5532486339421,92.19915296117537,0.7977649064185549 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441088,290.03169614650034,92.19915296117537,3.145708901128748 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441095,2889.07941429962,1229.7970051816276,2.3492327612823667 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441083,3836.567576477112,1229.7970051816276,3.1196754914120914 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441084,2211.6128801111245,1229.7970051816276,1.7983560463984813 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441094,5687.565307134761,1229.7970051816276,4.624800095601769 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441078,4186.466159056042,1229.7970051816276,3.404192839482274 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441088,5085.598847725692,1229.7970051816276,4.135315687302885 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441095,113167.26109055211,50083.06853493704,2.2595912031949217 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441083,93730.81865853368,50083.06853493704,1.8715071061021105 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441084,133753.74077404378,50083.06853493704,2.6706378959336248 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441094,125400.33017974664,50083.06853493704,2.5038467859106843 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441078,92486.37241448618,50083.06853493704,1.8466594623683923 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441088,114060.2770777899,50083.06853493704,2.277421899543226 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441095,60.83746454103083,35.678906774941794,1.7051381345506509 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441083,76.41780093177512,35.678906774941794,2.1418201351798505 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441084,6.808176778061174,35.678906774941794,0.19081797603851278 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441094,141.95074648454715,35.678906774941794,3.9785621061753713 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441078,13.888048328597574,35.678906774941794,0.3892509492009297 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441088,46.84213768540475,35.678906774941794,1.3128804080483536 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441095,142.76226086020296,67.70693010562654,2.1085324742605516 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441083,166.4986193763349,67.70693010562654,2.459107496331437 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441084,138.799260827158,67.70693010562654,2.05000079918885 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441094,380.1991809090215,67.70693010562654,5.615365817293589 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441078,39.17084207694582,67.70693010562654,0.5785351959664564 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441088,87.61971053312915,67.70693010562654,1.294102544546586 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441095,58.74638510744472,64.01321127549492,0.9177228252870605 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441083,58.24247618011278,64.01321127549492,0.909850873274479 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441084,85.37225411033799,64.01321127549492,1.333666166862333 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441094,69.01202394966873,64.01321127549492,1.0780903281458623 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441078,18.509249735408112,64.01321127549492,0.28914733953510763 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441088,64.99804027578844,64.01321127549492,1.0153847773087823 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441095,571.1479732135243,1060.427767412219,0.5386014877819608 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441083,567.9842609499588,1060.427767412219,0.5356180575467397 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441084,713.092488813897,1060.427767412219,0.6724573900531381 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441094,475.2610612656076,1060.427767412219,0.4481786274093857 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441078,912.0413528881433,1060.427767412219,0.8600692861087692 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441088,689.5194496809163,1060.427767412219,0.6502276447961779 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441095,68.27882943768564,57.09593719876665,1.1958614358143955 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441083,18.9955573626083,57.09593719876665,0.33269542973748806 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441084,33.63694405603536,57.09593719876665,0.5891302552567955 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441094,11.778481538306584,57.09593719876665,0.20629281374789335 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441078,53.876166306859666,57.09593719876665,0.9436077057339811 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441088,9.698320286521607,57.09593719876665,0.16986007695712374 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441095,9.11591872913221,50.205845180981015,0.18157086483199975 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441083,143.94693102607116,50.205845180981015,2.867134902463531 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441084,22.96866568187965,50.205845180981015,0.45748987192791335 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441094,120.88259320289932,50.205845180981015,2.4077394328716943 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441078,160.511373084798,50.205845180981015,3.197065451367064 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441088,26.048476916274193,50.205845180981015,0.5188335506030258 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441095,2183.5157702405622,1506.8779059558976,1.4490329718222492 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441083,5003.8864945899595,1506.8779059558976,3.320698030551926 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441084,1453.386135346712,1506.8779059558976,0.9645015894136076 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441094,1905.568571147346,1506.8779059558976,1.2645806031236062 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441078,1782.210645107473,1506.8779059558976,1.1827173509302442 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441088,5423.121066534232,1506.8779059558976,3.598912058567904 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441095,45914.911995733826,16162.128318216166,2.840895152650385 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441083,37379.52254140335,16162.128318216166,2.3127846658211024 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441084,56711.27051919306,16162.128318216166,3.508898667465372 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441094,53177.34713169137,16162.128318216166,3.2902440869594964 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441078,39093.47866505785,16162.128318216166,2.4188323403543333 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441088,55745.838471388546,16162.128318216166,3.449164452466201 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441095,126.44242437539457,24.995311385825953,5.058645696532352 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441083,100.15538035548332,24.995311385825953,4.006966699053737 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441084,112.22171371496198,24.995311385825953,4.489710569423005 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441094,77.1126534052985,24.995311385825953,3.085084727091123 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441078,18.615760041081916,24.995311385825953,0.7447700792252712 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441088,259.7651341619039,24.995311385825953,10.392554433597033 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441095,2012.4032825096845,522.7489803443298,3.8496551082397783 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441083,3085.03391228176,522.7489803443298,5.901558928435743 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441084,2145.7701030888124,522.7489803443298,4.104781039793544 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441094,1811.8235382114003,522.7489803443298,3.4659532707609864 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441078,650.2850944942263,522.7489803443298,1.2439719998418548 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441088,2207.7851573786934,522.7489803443298,4.223413608429128 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441095,4.199678456059826,2.8430683750443606,1.4771640713685958 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441083,4.321690225176891,2.8430683750443606,1.5200795953806279 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441084,4.393156926106009,2.8430683750443606,1.545216768146655 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441094,3.8345050812374897,2.8430683750443606,1.3487206691529745 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441078,2.311927364583823,2.8430683750443606,0.8131803599509807 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441088,2.3041225827491507,2.8430683750443606,0.8104351632813612 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441095,2717.2212513472095,1771.7543971110147,1.5336331354830293 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441083,2793.759345018886,1771.7543971110147,1.576832178079722 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441084,2693.6835182414607,1771.7543971110147,1.5203481490627166 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441094,2309.1489240926894,1771.7543971110147,1.303312088773669 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441078,1427.8074737142497,1771.7543971110147,0.8058721209002796 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441088,2499.4884604255226,1771.7543971110147,1.41074206701625 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441095,1.246740356101673,73.62821549612136,0.016932915563699216 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441083,322.90172305454854,73.62821549612136,4.385570407740747 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441084,105.1009686182662,73.62821549612136,1.4274550579567256 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441094,0.7003939480988391,73.62821549612136,0.009512575354155298 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441078,63.49483908705565,73.62821549612136,0.862371017132698 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441088,9.45035648420738,73.62821549612136,0.1283523771495618 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441095,721.4069791767499,1923.334023596175,0.37508148367691807 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441083,687.0741755342777,1923.334023596175,0.3572308122796129 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441084,818.0163430074531,1923.334023596175,0.425311637485598 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441094,776.98,1923.334023596175,0.40397559158613183 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441078,450.52831698759263,1923.334023596175,0.23424340830055734 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441088,845.8972054676198,1923.334023596175,0.4398077479469708 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441095,32.013663944586874,51.40813337414527,0.6227353891959736 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441083,52.52717033698677,51.40813337414527,1.0217677026842662 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441084,12.036983969566718,51.40813337414527,0.2341455170519863 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441094,9.707979358862202,51.40813337414527,0.18884131209760366 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441078,67.93846289696597,51.40813337414527,1.3215508604934936 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441088,54.107900327569254,51.40813337414527,1.052516338879205 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441095,8.329526553436944,89.1451395839603,0.09343780931086969 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441083,35.63730509154544,89.1451395839603,0.39976722519998825 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441084,193.87547685967627,89.1451395839603,2.174829472077689 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441094,61.902468180220296,89.1451395839603,0.6944009339052993 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441078,127.66845372373018,89.1451395839603,1.432141497781684 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441088,6.649503693148433,89.1451395839603,0.07459188155609624 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441095,5530.930816340935,4771.656231796832,1.1591218117274529 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441083,8893.08671814453,4771.656231796832,1.8637316449755472 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441084,3835.893139825942,4771.656231796832,0.8038913436941966 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441094,2416.661409671771,4771.656231796832,0.5064617592457502 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441078,6742.768820764724,4771.656231796832,1.4130877190676503 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441088,4010.314379802637,4771.656231796832,0.8404449492985581 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441095,272051.3553969438,209884.98459768714,1.2961925595507404 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441083,528657.7822817625,209884.98459768714,2.518797537113515 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441084,639995.7401155793,209884.98459768714,3.049268823790989 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441094,446767.03693532664,209884.98459768714,2.128627913958214 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441078,507174.488502476,209884.98459768714,2.416440077762785 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441088,270180.77899200516,209884.98459768714,1.2872801716134887 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441095,71.81978972213118,22.903585106474594,3.135744442988033 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441083,57.33282487395732,22.903585106474594,2.5032249146772205 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441084,1.9538592523092144,22.903585106474594,0.08530800934552729 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441094,413.18531805025367,22.903585106474594,18.040202707542527 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441078,3.570843974232875,22.903585106474594,0.15590764317606487 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441088,12.457968422900034,22.903585106474594,0.5439309333008439 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441095,88.29463011631222,83.56495705722055,1.0565987613187313 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441083,26.81138149897708,83.56495705722055,0.3208447947938053 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441084,57.175241835728045,83.56495705722055,0.6842011753392954 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441094,108.55865683688845,83.56495705722055,1.2990930727404506 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441078,13.707795582587831,83.56495705722055,0.16403760697443437 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441088,22.066199843738843,83.56495705722055,0.2640604461584197 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441095,1810.395100174742,1829.6496491832456,0.9894763737871353 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441083,2415.9428045293535,1829.6496491832456,1.3204401212045316 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441084,2075.215096811932,1829.6496491832456,1.1342144643584124 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441094,1728.8624669690057,1829.6496491832456,0.9449144910014705 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441078,738.3750512098673,1829.6496491832456,0.40356089568266656 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441088,1921.689880308214,1829.6496491832456,1.050304839052687 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441095,100572.6291061177,96234.19538703516,1.0450820386831752 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441083,196161.84935951463,96234.19538703516,2.0383798978168826 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441084,154828.95188692535,96234.19538703516,1.6088766707534004 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441094,193247.14883184189,96234.19538703516,2.0080923215977395 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441078,96460.52836399087,96234.19538703516,1.0023518976393522 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441088,151424.1671168694,96234.19538703516,1.5734964739703068 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441095,71.34991730194886,77.99112650544876,0.9148466049783764 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441083,90.64318172833757,77.99112650544876,1.1622242912724807 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441084,68.87566672024774,77.99112650544876,0.883121834577371 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441094,97.00180226380056,77.99112650544876,1.2437543424510433 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441078,99.51908905529385,77.99112650544876,1.2760309219067512 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441088,133.23125023674356,77.99112650544876,1.7082872912142835 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441095,227.5504712963809,110.33780757772625,2.0623073476975287 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441083,204.27054682403408,110.33780757772625,1.8513196093744926 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441084,79.54104564688984,110.33780757772625,0.7208865881339723 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441094,240.98414153638092,110.33780757772625,2.1840577298640116 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441078,57.15318598075319,110.33780757772625,0.5179837014659935 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441088,144.98022869435948,110.33780757772625,1.3139669155763292 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441095,57.74660493137316,67.31067174214355,0.8579115827664177 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441083,60.849043749807,67.31067174214355,0.9040029192237151 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441084,66.54107012811691,67.31067174214355,0.9885664249946151 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441094,51.138916781365054,67.31067174214355,0.7597445614162058 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441078,51.752538543761545,67.31067174214355,0.7688608240609641 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441088,54.11695309081136,67.31067174214355,0.8039877138371873 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441095,3715.478269933489,2375.529574917848,1.5640631500291804 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441083,4348.781790735811,2375.529574917848,1.8306578190617573 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441084,5424.065911127271,2375.529574917848,2.283308096180974 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441094,3883.989673515562,2375.529574917848,1.634999502647691 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441078,4364.452602421921,2375.529574917848,1.8372545846215598 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441088,3678.688059347972,2375.529574917848,1.5485759883562764 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441095,181.76711216330065,194.62377093849457,0.9339409635667941 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441083,194.37433180101516,194.62377093849457,0.9987183521505282 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441084,226.54356776720047,194.62377093849457,1.1640076989300205 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441094,263.8852863951224,194.62377093849457,1.3558738746178955 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441078,312.51542383848357,194.62377093849457,1.6057412839731966 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441088,206.13382791650045,194.62377093849457,1.0591400368130948 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441095,3983.243316785376,3728.1507253933823,1.0684233579008737 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441083,3078.694263525241,3728.1507253933823,0.825796618831817 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441084,8764.048260894491,3728.1507253933823,2.350776271248995 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441094,3471.9307361711217,3728.1507253933823,0.9312742407443236 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441078,4908.828945023691,3728.1507253933823,1.3166927269298445 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441088,4339.161581464354,3728.1507253933823,1.1638911355995403 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441095,78.54049312503459,68.78582331086372,1.1418122128172632 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441083,82.59900994705283,68.78582331086372,1.2008144406989678 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441084,101.4468814259139,68.78582331086372,1.474822522185205 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441094,96.52180181162048,68.78582331086372,1.4032223089837796 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441078,26.24310180329559,68.78582331086372,0.3815190476778211 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441088,192.55198619407057,68.78582331086372,2.7992975430979508 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441095,626.9168187026017,696.3940975413478,0.9002328148902483 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441083,340.21566311346146,696.3940975413478,0.4885389814684083 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441084,1001.7512589680396,696.3940975413478,1.4384832704710875 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441094,598.8331159012158,696.3940975413478,0.8599055018062679 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441078,411.87653501170576,696.3940975413478,0.5914417374671257 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441088,885.7629626365757,696.3940975413478,1.2719277285143622 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441095,61.63891440861557,81.2393188807366,0.7587325356469887 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441083,72.52701819002884,81.2393188807366,0.892757585726465 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441084,83.42286784634545,81.2393188807366,1.026877982185134 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441094,92.99083964845175,81.2393188807366,1.144653117845153 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441078,21.37049001655774,81.2393188807366,0.263055996911184 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441088,209.72823805043896,81.2393188807366,2.581610000427632 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441095,282.01471864397536,543.8205698619286,0.5185804551592752 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441083,156.08442661137573,543.8205698619286,0.28701456925581953 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441084,420.7493664683312,543.8205698619286,0.7736915258191794 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441094,215.0996552988352,543.8205698619286,0.39553423908449653 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441078,243.0404167066174,543.8205698619286,0.4469128793129751 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441088,951.3700793044712,543.8205698619286,1.7494190768584132 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441095,297545.29598994885,306516.0644612488,0.9707331213224745 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441083,541919.0829940803,306516.0644612488,1.7679956968865238 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441084,148843.624411102,306516.0644612488,0.48559811921348583 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441094,197225.31124164705,306516.0644612488,0.643442005521969 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441078,127832.6586902695,306516.0644612488,0.41705043719309104 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441088,307806.14788437675,306516.0644612488,1.0042088607179382 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441095,933172.7885423092,335923.8645439917,2.777929426982117 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441083,1581215.6235010915,335923.8645439917,4.707065470467698 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441084,1524275.3722538657,335923.8645439917,4.537562028595473 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441094,1160876.8203046042,335923.8645439917,3.455773592865948 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441078,902737.0124078676,335923.8645439917,2.68732622980898 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441088,1034986.9666315044,335923.8645439917,3.0810164917472402 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441095,7.63389825941864,33.931355493730415,0.22498064543366608 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441083,88.89154586289477,33.931355493730415,2.6197463841171773 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441084,39.11295231877163,33.931355493730415,1.152708217801633 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441094,59.11780985979436,33.931355493730415,1.7422766936239171 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441078,44.16563573105106,33.931355493730415,1.3016171941380785 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441088,231.02721766584375,33.931355493730415,6.808664561264912 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441095,27.553599628939985,76.3332642617619,0.3609645139038366 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441083,23.500799772946177,76.3332642617619,0.3078710179661291 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441084,19.221562856426186,76.3332642617619,0.251811094970492 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441094,8.803050647158411,76.3332642617619,0.11532391195758386 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441078,37.63828129850274,76.3332642617619,0.4930783671117956 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441088,88.47813656402957,76.3332642617619,1.1591032745648149 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441095,156.73676915428618,130.67426801703346,1.1994463143566678 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441083,164.41634786381476,130.67426801703346,1.2582151816024179 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441084,169.70052418590714,130.67426801703346,1.2986529541055978 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441094,169.7177404382565,130.67426801703346,1.2987847034745488 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441078,93.93678742913694,130.67426801703346,0.7188621666271147 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441088,119.48364461519022,130.67426801703346,0.9143624558097043 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441095,8286.259042554884,5444.214081294075,1.5220303461294569 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441083,8466.7584018364,5444.214081294075,1.5551846924843693 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441084,8446.401815514524,5444.214081294075,1.5514455694414642 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441094,7860.729302761373,5444.214081294075,1.4438685153418689 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441078,5825.915708579293,5444.214081294075,1.0701114286810869 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441088,9123.25566260131,5444.214081294075,1.6757709242089056 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441095,61.59443050906406,100.67607722942154,0.6118080104442501 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441083,73.16068557070662,100.67607722942154,0.7266938440995014 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441084,55.05623337855889,100.67607722942154,0.5468651033462126 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441094,85.94838875313336,100.67607722942154,0.8537121341872848 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441078,116.06595680432326,100.67607722942154,1.1528653082085343 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441088,112.0014021419009,100.67607722942154,1.1124927115174652 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441095,562.1626566252044,599.1099853739104,0.9383296395474917 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441083,581.6016383250931,599.1099853739104,0.9707760720464538 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441084,548.0105522769139,599.1099853739104,0.914707759268768 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441094,1109.0493080531246,599.1099853739104,1.8511614480285388 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441078,587.917124327247,599.1099853739104,0.9813175187863414 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441088,547.1402384475094,599.1099853739104,0.9132550813788121 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441095,70.24784697762563,114.30018844822946,0.6145908237889155 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441083,77.69906528470308,114.30018844822946,0.6797807277447814 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441084,132.75253695918116,114.30018844822946,1.1614376035723633 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441094,134.4405139652519,114.30018844822946,1.1762055320332625 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441078,124.6414047027961,114.30018844822946,1.0904741837696141 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441088,143.93292125237278,114.30018844822946,1.2592535778500926 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441095,2692.1020670913476,1759.6959467320276,1.5298677433967574 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441083,3225.2416158950823,1759.6959467320276,1.8328402823708003 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441084,4638.753172004643,1759.6959467320276,2.636110619348405 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441094,2362.4305707275284,1759.6959467320276,1.3425220278053454 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441078,3824.101134166508,1759.6959467320276,2.173160165123035 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441088,2482.284480933805,1759.6959467320276,1.4106326070385702 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441095,62.90699679116564,38.77498679262034,1.6223602377380593 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441083,89.74087165727144,38.77498679262034,2.3144010889605497 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441084,61.69882707196368,38.77498679262034,1.5912017559656837 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441094,123.37859911721698,38.77498679262034,3.1819120861879546 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441078,37.75902996281197,38.77498679262034,0.9737986543943395 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441088,76.60627421785625,38.77498679262034,1.9756621614745713 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441095,2617.6599550724295,2284.874121495706,1.1456473380506749 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441083,1379.5256125069484,2284.874121495706,0.6037643822601021 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441084,2786.8872451164634,2284.874121495706,1.219711501346137 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441094,1794.929467696429,2284.874121495706,0.7855703956773981 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441078,1853.2114931851272,2284.874121495706,0.8110781577638916 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441088,2657.6058581094226,2284.874121495706,1.1631300967992593 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441095,502.4001282276186,306.4947439651267,1.6391802408356544 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441083,433.6439744684003,306.4947439651267,1.4148496279523175 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441084,358.64834895455726,306.4947439651267,1.1701614987412792 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441094,416.8130961841663,306.4947439651267,1.3599355434023095 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441078,358.21033889365305,306.4947439651267,1.168732403888827 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441088,487.1454507024406,306.4947439651267,1.589408824439314 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441095,40365.2093136856,53872.22448470133,0.7492768249276311 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441083,28003.406676547107,53872.22448470133,0.5198115901915195 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441084,51715.12554190374,53872.22448470133,0.9599589776841281 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441094,33546.38201812988,53872.22448470133,0.6227027441136462 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441078,30989.334428683356,53872.22448470133,0.5752376985562148 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441088,38416.72140668505,53872.22448470133,0.7131081327000829 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441095,322.6108432893859,320.29657233769314,1.0072254003057293 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441083,34.97466113201737,320.29657233769314,0.10919461571740798 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441084,93.73938783239949,320.29657233769314,0.29266434900704696 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441094,135.35063131026274,320.29657233769314,0.422579081388235 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441078,986.5045516183576,320.29657233769314,3.0799722407839947 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441088,80.014211409526,320.29657233769314,0.24981288693019763 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441095,20925.991836038454,6299.521117687065,3.3218385088486935 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441083,8178.8780078823565,6299.521117687065,1.298333294719602 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441084,25129.154923817405,6299.521117687065,3.9890579703372495 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441094,15413.180931525378,6299.521117687065,2.4467226386859844 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441078,4300.163889454376,6299.521117687065,0.6826175845939898 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441088,20397.969729144224,6299.521117687065,3.238019104638473 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441095,3430.210206777156,1965.7827420843205,1.7449589587606729 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441083,3022.2733051168666,1965.7827420843205,1.5374401455535969 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441084,2784.8267694463525,1965.7827420843205,1.4166503295748742 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441094,3214.229342226961,1965.7827420843205,1.6350887986832725 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441078,1702.635698355482,1965.7827420843205,0.8661362529565075 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441088,1998.505661659265,1965.7827420843205,1.0166462543771486 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441095,15919.519613653263,6243.797224888628,2.5496535265744833 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441083,7745.402721926334,6243.797224888628,1.2404955579037868 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441084,20631.103691936827,6243.797224888628,3.304255879691037 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441094,12897.354864656008,6243.797224888628,2.0656267973029925 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441078,4804.5641163052715,6243.797224888628,0.7694939382646225 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441088,15866.154330018777,6243.797224888628,2.5411065988456705 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441095,787.8938426913818,477.14850073021523,1.6512549897686155 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441083,722.3941747423984,477.14850073021523,1.5139818602319106 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441084,636.0377167750966,477.14850073021523,1.3329974123395998 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441094,798.0980128096539,477.14850073021523,1.672640722098605 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441078,514.8723245149271,477.14850073021523,1.079060971012128 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441088,513.5531926733064,477.14850073021523,1.0762963561393957 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441095,336.78148313424714,205.1372392304115,1.6417374261139002 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441083,288.705035003578,205.1372392304115,1.4073750630879 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441084,612.6204958474106,205.1372392304115,2.9863933927633255 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441094,387.9578313310575,205.1372392304115,1.8912111364397408 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441078,246.65716800880176,205.1372392304115,1.2024007388134672 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441088,406.1091993433677,205.1372392304115,1.9796951585529685 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441095,117.9733367707114,44.32085041603382,2.6618021915940617 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441083,28.345203658533073,44.32085041603382,0.6395455726246334 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441084,61.958806420045704,44.32085041603382,1.3979606852857465 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441094,19.2065066312533,44.32085041603382,0.4333514914755566 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441078,66.1180434150545,44.32085041603382,1.4918044846706096 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441088,94.86693528248638,44.32085041603382,2.140458370992057 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441095,30.031891558828708,73.02499011367847,0.41125498972444735 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441083,30.256362795045337,73.02499011367847,0.4143288858779038 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441084,153.31939019924604,73.02499011367847,2.0995468806031026 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441094,70.6823722056746,73.02499011367847,0.9679203255713269 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441078,58.288489761254915,73.02499011367847,0.7981992146868743 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441088,57.00786326294476,73.02499011367847,0.7806623893300123 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441095,136.7725029584107,446.9213615105917,0.3060325926156683 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441083,104.43801511105156,446.9213615105917,0.23368320269599926 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441084,71.62631506172738,446.9213615105917,0.16026603610897192 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441094,89.65889038489122,446.9213615105917,0.2006144662269995 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441078,803.8076502500248,446.9213615105917,1.7985438143595542 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441088,101.98083131764405,446.9213615105917,0.22818517998994142 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441095,2362.1384493192736,2631.000022355788,0.8978101213409428 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441083,2217.9498577487752,2631.000022355788,0.8430064001910691 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441084,6882.4151344850015,2631.000022355788,2.615893225391352 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441094,2119.677108328514,2631.000022355788,0.8056545383190694 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441078,2491.14690508908,2631.000022355788,0.9468441215969721 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441088,2596.3719858879103,2631.000022355788,0.9868384507131733 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441095,31.91209102765038,48.89133349009634,0.6527146786477943 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441083,36.914106847878465,48.89133349009634,0.7550235228367408 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441084,49.34890279509705,48.89133349009634,1.0093589041725235 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441094,40.26878760379485,48.89133349009634,0.8236385618721543 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441078,74.14783417865137,48.89133349009634,1.516584410479847 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441088,57.925205085061485,48.89133349009634,1.1847744978523664 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441095,210.36,307.70649021557807,0.683638488913973 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441083,221.10642990707825,307.70649021557807,0.7185627763397902 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441084,335.6656963481783,307.70649021557807,1.0908632317537796 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441094,118.88467779817728,307.70649021557807,0.3863573943951819 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441078,349.72729716224785,307.70649021557807,1.1365613280279858 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441088,280.79102670521377,307.70649021557807,0.9125287754200199 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441095,152.0026834770604,154.19153082843468,0.9858043607219273 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441083,181.4461851044533,154.19153082843468,1.1767584388687615 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441084,133.50063640492945,154.19153082843468,0.8658104351624376 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441094,164.38705063050602,154.19153082843468,1.0661224371227993 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441078,127.9008653330892,154.19153082843468,0.8294934530185157 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441088,154.88226966208805,154.19153082843468,1.004479745612111 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441095,7575.389240107268,6593.957266089812,1.1488380852973652 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441083,8307.483609779343,6593.957266089812,1.2598631253650276 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441084,8064.061731233186,6593.957266089812,1.2229472236199583 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441094,8095.496797416308,6593.957266089812,1.2277144771696258 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441078,7243.244717541155,6593.957266089812,1.0984670396319338 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441088,8075.762757695344,6593.957266089812,1.2247217310955119 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441095,172.85204100766208,127.96554716912783,1.3507701473679417 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441083,170.22320027388582,127.96554716912783,1.3302267996315247 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441084,160.71907391966232,127.96554716912783,1.2559558215090914 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441094,150.4025038585708,127.96554716912783,1.1753359180325997 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441078,155.06743318514995,127.96554716912783,1.211790490609183 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441088,185.00463715042767,127.96554716912783,1.4457378665049052 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441095,1392.8840829736837,1681.9358703135756,0.8281433956896336 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441083,1034.6603268553745,1681.9358703135756,0.6151603905459696 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441084,1397.6750840737827,1681.9358703135756,0.8309918997168447 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441094,1485.0561857171028,1681.9358703135756,0.8829445949328811 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441078,989.4556466460092,1681.9358703135756,0.5882838127838594 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441088,1453.8403556567416,1681.9358703135756,0.8643851298478411 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441095,49.78803201201017,45.403354316773296,1.0965716687944584 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441083,43.82000891737544,45.403354316773296,0.9651271272084644 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441084,46.13665005754939,45.403354316773296,1.016150695291365 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441094,44.47284204490415,45.403354316773296,0.9795056491778761 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441078,41.85501323884964,45.403354316773296,0.9218484816525373 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441088,44.89107212574392,45.403354316773296,0.9887170849216282 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441095,151.70820973074615,171.72890790902974,0.8834168433139445 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441083,163.83957602067576,171.72890790902974,0.9540593835690541 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441084,162.25605576872226,171.72890790902974,0.9448383370298636 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441094,149.63013974048897,171.72890790902974,0.8713159686530634 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441078,157.61709178895202,171.72890790902974,0.9178250401059256 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441088,155.6223086183197,171.72890790902974,0.9062091555415805 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441095,836.2246831629915,385.5886159476326,2.168696503416897 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441083,1404.16147529955,385.5886159476326,3.6416051128704776 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441084,78.3903464463053,385.5886159476326,0.2033004689561468 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441094,208.98086498684435,385.5886159476326,0.5419788249537595 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441078,548.6108679966841,385.5886159476326,1.4227880318727868 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441088,40.86169274239754,385.5886159476326,0.10597224879675138 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441095,252.00871569488768,430.1288265554666,0.5858912496356258 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441083,279.0040605877196,430.1288265554666,0.6486523184740353 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441084,278.51868736805636,430.1288265554666,0.6475238816204764 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441094,223.28968476421292,430.1288265554666,0.5191228092112513 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441078,292.04423999082394,430.1288265554666,0.6789692342397884 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441088,322.25014556961895,430.1288265554666,0.749194487033674 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441095,72163.646612842,54695.927744901994,1.3193605006465605 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441083,118349.74065232268,54695.927744901994,2.1637760895892955 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441084,24584.468754489902,54695.927744901994,0.4494753040692564 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441094,43652.55596413199,54695.927744901994,0.7980951738806676 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441078,19908.35111672433,54695.927744901994,0.3639823280734079 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441088,67005.57868881203,54695.927744901994,1.2250560773248311 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441095,514507.94625921577,97212.60478924697,5.292605288940137 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441083,497691.4355256444,97212.60478924697,5.119618352009181 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441084,672981.9557143771,97212.60478924697,6.922784932811697 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441094,532483.706918822,97212.60478924697,5.477517119032305 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441078,207883.10308468775,97212.60478924697,2.138437742053821 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441088,534707.5480145694,97212.60478924697,5.500393176109148 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441095,86190.40616426645,62941.57202670208,1.3693716789866859 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441083,136773.57869678727,62941.57202670208,2.173024509759035 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441084,32738.871246584476,62941.57202670208,0.5201470219506985 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441094,49234.73041580696,62941.57202670208,0.7822291186963016 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441078,32815.58830027884,62941.57202670208,0.5213658833681066 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441088,88710.01471715068,62941.57202670208,1.4094025913352894 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441095,146871.901495131,14728.399701289269,9.972020346669053 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441083,117848.49384636678,14728.399701289269,8.001445930072821 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441084,152421.97061694154,14728.399701289269,10.348848056017864 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441094,152392.00327194433,14728.399701289269,10.346813391994278 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441078,33552.963606776604,14728.399701289269,2.2781133244122582 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441088,150437.095406873,14728.399701289269,10.214082891415847 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441095,3924.540144453317,3575.9352491809864,1.0974863555910788 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441083,6685.005340835439,3575.9352491809864,1.8694425024520613 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441084,2936.7851234371697,3575.9352491809864,0.8212635069692036 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441094,3346.2463984407245,3575.9352491809864,0.9357681739922812 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441078,9355.104081096277,3575.9352491809864,2.6161279299559244 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441088,6755.179444207732,3575.9352491809864,1.8890664884815527 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441095,48027.617487418785,12966.336321671553,3.7040237346880196 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441083,49641.76815958355,12966.336321671553,3.8285115338720437 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441084,39217.23860923957,12966.336321671553,3.024542757208374 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441094,73711.34727910355,12966.336321671553,5.684824568055093 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441078,35937.39826352253,12966.336321671553,2.771592327391495 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441088,45897.663456645016,12966.336321671553,3.5397557427176256 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441095,110.91304275882972,103.34580193186551,1.0732225275290155 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441083,125.36972551841455,103.34580193186551,1.2131090298285083 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441084,104.62552032612123,103.34580193186551,1.0123828773915695 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441094,265.8416158863772,103.34580193186551,2.572350409179107 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441078,226.02285566110368,103.34580193186551,2.1870540596328962 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441088,218.09069717160267,103.34580193186551,2.110300496921848 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441095,430.9458478733337,211.8154700640626,2.0345343413443606 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441083,558.4242133979911,211.8154700640626,2.6363712396884815 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441084,719.5447349299174,211.8154700640626,3.397035800606511 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441094,453.17966767930903,211.8154700640626,2.1395022164445634 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441078,538.7500698085931,211.8154700640626,2.5434878276154747 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441088,509.2286838854595,211.8154700640626,2.404114693470905 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441095,42.13934469046891,76.10596635595309,0.5536930507311366 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441083,62.36062081652765,76.10596635595309,0.8193920109346294 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441084,67.33279969484296,76.10596635595309,0.8847243247647971 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441094,32.56814902341296,76.10596635595309,0.42793161407463615 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441078,53.826352254862606,76.10596635595309,0.7072553550284465 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441088,36.6929788295012,76.10596635595309,0.48213012180786846 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441095,2682.0407701072827,1382.686999693948,1.9397309519080899 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441083,3151.89613699693,1382.686999693948,2.279544204649779 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441084,3676.793967605451,1382.686999693948,2.659165789813091 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441094,3233.707423947112,1382.686999693948,2.338712539181232 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441078,1779.7998503360068,1382.686999693948,1.2872037205310805 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441088,3412.075240078725,1382.686999693948,2.467713402117741 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441095,30.935627523247852,30.899530320120164,1.0011682120327954 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441083,31.15441907912359,30.899530320120164,1.0082489525362608 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441084,31.928797690770725,30.899530320120164,1.0333101299594951 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441094,29.56097754769352,30.899530320120164,0.9566804815944063 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441078,30.44147905989137,30.899530320120164,0.9851761092973464 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441088,30.154720136476023,30.899530320120164,0.9758957441770835 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441095,29.82536053780393,31.68183515511672,0.9414025542326275 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441083,35.6824762579947,31.68183515511672,1.1262755482215765 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441084,31.222347413456035,31.68183515511672,0.9854968078897262 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441094,33.078189094003335,31.68183515511672,1.0440742757498094 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441078,31.724822713348804,31.68183515511672,1.0013568519002014 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441088,30.162901467564293,31.68183515511672,0.9520566381298429 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441095,1214.2823000390265,628.1906149122311,1.9329838288155297 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441083,1000.0546367875338,628.1906149122311,1.5919604862725598 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441084,756.0603424908109,628.1906149122311,1.203552432244543 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441094,921.2258639553196,628.1906149122311,1.466475050863392 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441078,439.03895881142824,628.1906149122311,0.698894489012335 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441088,1483.1185840247188,628.1906149122311,2.3609371882003294 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441095,19514.983340753577,10551.186365326936,1.8495534686870154 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441083,22368.752090931048,10551.186365326936,2.1200224615914967 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441084,24500.28872663432,10551.186365326936,2.322041131521153 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441094,7222.8607141860175,10551.186365326936,0.6845543680207957 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441078,21773.34786844485,10551.186365326936,2.063592388055614 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441088,23323.787034894955,10551.186365326936,2.210536922325725 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441095,113.00729341929625,102.14043933131707,1.1063912996568375 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441083,89.88791498628507,102.14043933131707,0.8800423766997125 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441084,113.30308213720184,102.14043933131707,1.109287201807269 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441094,101.49193852265392,102.14043933131707,0.9936508907450498 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441078,134.3886269783691,102.14043933131707,1.3157239958842089 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441088,164.07415618914249,102.14043933131707,1.606358434164636 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441095,5776.418311352206,2995.2816068385046,1.92850592016594 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441083,6883.709912406734,2995.2816068385046,2.298184550224122 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441084,11921.474587242512,2995.2816068385046,3.980084730605858 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441094,6498.316885479525,2995.2816068385046,2.169517841208408 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441078,7230.701425250794,2995.2816068385046,2.4140305902264534 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441088,7905.225624568647,2995.2816068385046,2.639226177104779 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441095,37.565692526039776,35.73806763844074,1.0511394434105665 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441083,36.889883041087614,35.73806763844074,1.032229369934035 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441084,38.1008765766324,35.73806763844074,1.0661146249454787 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441094,34.353610293252814,35.73806763844074,0.9612609904040036 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441078,34.98643081012374,35.73806763844074,0.978968173771418 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441088,33.043909227059466,35.73806763844074,0.9246137637144273 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441095,246.25478359171825,271.6614200921023,0.9064768324785671 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441083,294.2658963993166,271.6614200921023,1.0832082682169248 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441084,262.9378062981958,271.6614200921023,0.9678879180159301 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441094,265.4646682341488,271.6614200921023,0.9771894299313735 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441078,230.94473057001815,271.6614200921023,0.8501197206865818 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441088,269.31452175733347,271.6614200921023,0.9913609435820032 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441095,199.59464781557935,166.02715311669658,1.2021807521766572 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441083,161.21945769227662,166.02715311669658,0.9710427160005524 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441084,174.9134624915866,166.02715311669658,1.0535232292313297 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441094,170.7062310495654,166.02715311669658,1.0281826065497852 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441078,189.645773167147,166.02715311669658,1.1422575741803478 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441088,197.4222422018348,166.02715311669658,1.189096111664767 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441095,1665.6148242929423,1793.9624976146763,0.9284557656626656 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441083,1781.385465334158,1793.9624976146763,0.9929892445927709 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441084,3394.5547829714537,1793.9624976146763,1.8922105604130457 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441094,1275.758851060311,1793.9624976146763,0.7111402009554885 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441078,1933.2813996938096,1793.9624976146763,1.0776598743086196 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441088,1706.3183380591868,1793.9624976146763,0.9511449321421018 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441095,77.77296517099295,59.13775760336051,1.315115221186092 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441083,68.27979783762811,59.13775760336051,1.154588888804064 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441084,63.13941693304408,59.13775760336051,1.0676667410442389 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441094,103.26016988131374,59.13775760336051,1.7460954568802582 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441078,177.6390389971951,59.13775760336051,3.003817631852526 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441088,144.91961690936947,59.13775760336051,2.450542982731127 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441095,201.45490493104168,238.79765196261823,0.8436217997762296 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441083,279.62364025982276,238.79765196261823,1.170964781109303 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441084,349.00077099339626,238.79765196261823,1.4614916358056544 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441094,256.33413376040494,238.79765196261823,1.0734365755008843 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441078,248.80827326463856,238.79765196261823,1.041920936909327 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441088,431.3504952552477,238.79765196261823,1.8063431181591854 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441095,558.8436964378799,386.8144501381946,1.4447332467497673 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441083,571.1927964706505,386.8144501381946,1.4766583726812281 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441084,435.62058654691873,386.8144501381946,1.126174542836462 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441094,567.149864004875,386.8144501381946,1.4662065075445168 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441078,372.4646241863398,386.8144501381946,0.9629025597499572 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441088,914.3470882554436,386.8144501381946,2.3637873092093145 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441095,7142.452077379549,5555.372966797932,1.2856836291760976 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441083,7897.392862814048,5555.372966797932,1.421577436836979 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441084,8435.4899722215,5555.372966797932,1.5184380999505855 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441094,7774.448879939248,5555.372966797932,1.3994467925742835 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441078,7222.677436002193,5555.372966797932,1.3001246683470256 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441088,16508.688523974146,5555.372966797932,2.971661600875307 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441095,81.53490191942679,84.54153084580483,0.9644360718773614 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441083,67.75664289399766,84.54153084580483,0.8014598531173857 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441084,41.583665890849005,84.54153084580483,0.4918726391019982 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441094,43.33593584101431,84.54153084580483,0.5125993746204414 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441078,4.284953828374899,84.54153084580483,0.050684601822389756 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441088,51.54333696709156,84.54153084580483,0.6096806676129556 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441095,96.23013977809728,122.00200397429413,0.7887586813604555 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441083,27.183839113041017,122.00200397429413,0.222814693427238 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441084,245.88037334111328,122.00200397429413,2.015379791572279 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441094,19.751736409711036,122.00200397429413,0.16189681944792264 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441078,91.31728054646985,122.00200397429413,0.7484900048503337 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441088,127.62180031803013,122.00200397429413,1.04606314782272 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441095,79.8276800627467,143.84455848940917,0.554957941413016 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441083,195.45569725720145,143.84455848940917,1.358797992150619 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441084,96.76426979158292,143.84455848940917,0.6727002453742967 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441094,129.7797113399995,143.84455848940917,0.9022219033023399 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441078,274.4119080541654,143.84455848940917,1.907697523882139 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441088,152.71494364811602,143.84455848940917,1.061666463103364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441095,5773.981459786875,5334.764851653101,1.0823310155831278 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441083,6111.007220631423,5334.764851653101,1.1455063888594423 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441084,2978.2174813836937,5334.764851653101,0.5582659337760358 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441094,2672.9675985916488,5334.764851653101,0.5010469388849197 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441078,1901.385331827444,5334.764851653101,0.35641408472545055 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441088,7419.247788507841,5334.764851653101,1.3907356734212595 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441095,148.88867064909343,159.70733471984832,0.9322594413729807 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441083,168.14760359853614,159.70733471984832,1.0528483484712419 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441084,139.53421004484127,159.70733471984832,0.8736869242079967 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441094,132.1683595146419,159.70733471984832,0.8275659959292785 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441078,156.87253875485192,159.70733471984832,0.982250057769926 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441088,189.8761642093044,159.70733471984832,1.1889007135606948 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441095,100498.88655027687,82077.5827732141,1.2244376985121757 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441083,44891.99798786734,82077.5827732141,0.5469459074094196 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441084,106200.74194099716,82077.5827732141,1.2939067934595123 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441094,66554.84388864927,82077.5827732141,0.810877241262633 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441078,53473.70423950583,82077.5827732141,0.6515019379561564 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441088,91301.21257424388,82077.5827732141,1.1123769668816306 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441095,284554.49503529945,170961.68742491837,1.6644342912225167 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441083,547433.9100231295,170961.68742491837,3.2020853225582915 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441084,323000.602284977,170961.68742491837,1.8893157124857571 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441094,28603.03907891511,170961.68742491837,0.16730671947465872 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441078,165982.54912813124,170961.68742491837,0.970875706880386 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441088,124985.52381550944,170961.68742491837,0.7310732930756759 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441095,324497.78521956195,55195.40432138408,5.879072528033705 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441083,452127.8765047776,55195.40432138408,8.1914043762084 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441084,419835.42543664086,55195.40432138408,7.606347495745876 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441094,384738.0622468782,55195.40432138408,6.9704727590485485 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441078,166379.8820267031,55195.40432138408,3.014379259873333 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441088,389653.5096956068,55195.40432138408,7.059528134385733 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441095,959.0174325269048,546.121028905539,1.7560529292359173 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441083,923.1951871176994,546.121028905539,1.6904589610252527 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441084,717.4979044180972,546.121028905539,1.3138075013445432 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441094,1371.4500517978154,546.121028905539,2.511256624829642 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441078,1038.8130040380613,546.121028905539,1.9021662764385912 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441088,1501.1378814717384,546.121028905539,2.7487274835032696 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441095,1400.5536198033594,1228.731327313693,1.1398371545269477 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441083,1435.2584046350803,1228.731327313693,1.1680815591907352 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441084,1236.1505724657206,1228.731327313693,1.0060381346085217 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441094,1388.7094274808987,1228.731327313693,1.1301977874340983 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441078,771.3876841068649,1228.731327313693,0.6277919891513687 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441088,1512.5724534135975,1228.731327313693,1.2310034096065985 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441095,182.48632471754055,76.68368758811918,2.379728081123392 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441083,132.06022408212837,76.68368758811918,1.722142325646176 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441084,98.7040368530406,76.68368758811918,1.2871581943632702 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441094,151.4669107767082,76.68368758811918,1.9752168360794295 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441078,118.16421284978424,76.68368758811918,1.5409302364860678 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441088,237.62289802842724,76.68368758811918,3.098741146940393 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441095,134.5275798924132,81.06808963980528,1.6594393736195647 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441083,232.1727722972903,81.06808963980528,2.863923071690233 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441084,135.40975903628987,81.06808963980528,1.6703213266518404 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441094,226.20574419992587,81.06808963980528,2.7903179315681874 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441078,103.96752249411468,81.06808963980528,1.2824715983323915 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441088,97.75899830065124,81.06808963980528,1.205887529051265 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441095,70.5364235640291,34.254424530644805,2.0591916089825295 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441083,33.47730372258743,34.254424530644805,0.9773132721186968 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441084,66.70674896846384,34.254424530644805,1.9473907351380675 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441094,65.25159785705671,34.254424530644805,1.9049100590985293 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441078,139.11830571083323,34.254424530644805,4.061323686415306 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441088,24.683005594983705,34.254424530644805,0.7205786094261112 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441095,121.85771907059927,60.87738129746832,2.001691210651121 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441083,171.55123980377303,60.87738129746832,2.8179799483409655 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441084,83.06613587277329,60.87738129746832,1.3644827373057147 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441094,332.5049129400203,60.87738129746832,5.4618793688789635 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441078,44.55748817229122,60.87738129746832,0.7319218931998347 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441088,163.6513670808665,60.87738129746832,2.6882129880260175 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441095,94.45775519683492,81.37032235510941,1.1608379131719604 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441083,80.00773830530403,81.37032235510941,0.9832545329750704 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441084,148.7710281960856,81.37032235510941,1.828320496837063 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441094,117.1352654210448,81.37032235510941,1.4395330143814975 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441078,94.73123138472266,81.37032235510941,1.164198796845178 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441088,96.57780824672832,81.37032235510941,1.1868922901061114 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441095,570.4234894517868,592.3362991324378,0.9630061339939061 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441083,445.6191382031351,592.3362991324378,0.7523076651824457 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441084,638.5650460226958,592.3362991324378,1.0780447643643765 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441094,506.10924737594735,592.3362991324378,0.8544288913531343 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441078,496.42986410231725,592.3362991324378,0.838087864663048 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441088,581.0647914556752,592.3362991324378,0.980971100887669 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441095,2257.5864706348675,1509.2244087879828,1.4958587056300487 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441083,2838.7707682100895,1509.2244087879828,1.8809467642322517 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441084,721.8476531854321,1509.2244087879828,0.4782904709082517 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441094,3311.225087900324,1509.2244087879828,2.193991210730205 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441078,608.0967128548796,1509.2244087879828,0.4029200093200358 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441088,4612.003929461052,1509.2244087879828,3.0558768481387255 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441095,673069.1679520078,911297.6405793307,0.7385832443548563 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441083,1181769.348626938,911297.6405793307,1.2967984289695547 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441084,1785771.1946234885,911297.6405793307,1.9595915923673815 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441094,1150656.5772096892,911297.6405793307,1.2626572548549484 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441078,1176529.1035682638,911297.6405793307,1.2910481177371642 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441088,762232.6095688337,911297.6405793307,0.83642552732197 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441095,819.7661577445426,749.6106308195243,1.093589290280368 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441083,1139.2284841006367,749.6106308195243,1.5197603092356844 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441084,703.5231605280943,749.6106308195243,0.9385181207461745 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441094,296.3406630277075,749.6106308195243,0.39532612111400833 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441078,2599.4267664309064,749.6106308195243,3.4677026439566894 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441088,1115.458001212921,749.6106308195243,1.4880498692947137 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441095,10432.136331023636,2138.7943755926544,4.877577971062748 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441083,12664.998833071437,2138.7943755926544,5.921559817811844 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441084,11963.126037726985,2138.7943755926544,5.593396997040463 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441094,14056.425771562706,2138.7943755926544,6.572125834989493 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441078,7761.005035329847,2138.7943755926544,3.628682179033359 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441088,9834.825950956949,2138.7943755926544,4.59830363460337 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441095,1022.6178344187696,613.8984432679271,1.6657768815557379 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441083,1149.3974950070833,613.8984432679271,1.8722925715344183 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441084,573.2075527892833,613.8984432679271,0.9337172281101799 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441094,1477.8762785619338,613.8984432679271,2.4073628053116534 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441078,392.5796496788187,613.8984432679271,0.6394863091507842 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441088,1649.425136567916,613.8984432679271,2.686804559704753 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441095,5673.3353277727465,6365.76448478505,0.8912260799677253 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441083,4657.124944092416,6365.76448478505,0.7315892624088607 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441084,5781.121051532437,6365.76448478505,0.9081581741438941 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441094,3923.596866896847,6365.76448478505,0.6163590997239562 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441078,5394.1108226866345,6365.76448478505,0.8473626122328614 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441088,5083.942893185275,6365.76448478505,0.7986382319572953 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441095,41.22781382340273,70.21289390855102,0.587182945017193 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441083,56.92155443115216,70.21289390855102,0.8106994493816163 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441084,48.63315795396685,70.21289390855102,0.6926528055845304 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441094,111.402471405017,70.21289390855102,1.586638368019889 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441078,88.29383505377342,70.21289390855102,1.257515965212486 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441088,136.11226220151397,70.21289390855102,1.9385650501572227 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441095,667.7789588214605,2003.7789126851078,0.3332597995687169 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441083,1968.0440526953828,2003.7789126851078,0.982166266066829 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441084,3932.133464408851,2003.7789126851078,1.9623589406576327 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441094,750.649485885259,2003.7789126851078,0.37461692062592483 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441078,784.7241834478533,2003.7789126851078,0.39162213878990554 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441088,1718.592171121991,2003.7789126851078,0.8576755450625237 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441095,1284.7764494328503,700.7857837159185,1.833336918766131 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441083,1236.1865100880918,700.7857837159185,1.7640005531122644 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441084,800.8604296559723,700.7857837159185,1.1428034761341872 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441094,1347.241775921531,700.7857837159185,1.922473039875007 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441078,534.1138476801126,700.7857837159185,0.7621642163572048 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441088,1609.6858054832437,700.7857837159185,2.2969726882127666 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441095,4570.872643619284,4688.560133729121,0.9748990123293497 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441083,4056.8365517066577,4688.560133729121,0.8652627749236071 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441084,7138.714594962371,4688.560133729121,1.5225814304069683 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441094,3266.4487047995062,4688.560133729121,0.6966848268194193 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441078,4821.748664330342,4688.560133729121,1.028407128585826 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441088,3868.734623574948,4688.560133729121,0.8251434370530059 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441095,879.5741066357091,384.65137963543384,2.2866786737366045 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441083,633.7946066262242,384.65137963543384,1.6477117727406156 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441084,532.934498131144,384.65137963543384,1.3855000302774174 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441094,837.7458741136867,384.65137963543384,2.1779354461374565 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441078,358.9910968991125,384.65137963543384,0.9332895081238453 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441088,737.050175903488,384.65137963543384,1.9161511304133418 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441095,1537.303111155156,772.5530415852671,1.9898997588575063 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441083,522.3645035160396,772.5530415852671,0.6761535783279754 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441084,1822.181174122396,772.5530415852671,2.358648631274958 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441094,946.7143579254594,772.5530415852671,1.2254360632414518 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441078,262.4789560293796,772.5530415852671,0.3397552554977672 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441088,1287.4356739351938,772.5530415852671,1.6664689731767741 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441095,233.83069173160564,216.68366112664066,1.0791339343068576 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441083,244.05507001706647,216.68366112664066,1.126319671488422 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441084,244.5479354952673,216.68366112664066,1.1285942568246592 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441094,285.607543884136,216.68366112664066,1.3180852787844157 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441078,247.85752948605105,216.68366112664066,1.1438681079935733 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441088,186.5876917212258,216.68366112664066,0.861106420073707 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441095,1443.7842832554384,615.8359185894908,2.3444301309385764 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441083,1542.2127520907814,615.8359185894908,2.504259179333128 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441084,1358.608959961443,615.8359185894908,2.206121661551015 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441094,1235.484273244804,615.8359185894908,2.0061906685705413 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441078,923.0166031456066,615.8359185894908,1.4988028065327559 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441088,1597.8719558448452,615.8359185894908,2.594639103715495 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441095,45.67682420521354,101.73138829665541,0.4489944054633062 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441083,57.513596218008,101.73138829665541,0.5653475999982874 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441084,77.07957344410276,101.73138829665541,0.7576773966687024 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441094,75.33995239078283,101.73138829665541,0.7405772559702672 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441078,130.27072149930865,101.73138829665541,1.2805361617540367 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441088,162.0598952721871,101.73138829665541,1.5930176318798461 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441095,165.33656593173015,93.53234569214308,1.7676939962131066 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441083,186.70780852316625,93.53234569214308,1.9961843909881767 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441084,153.2518777904503,93.53234569214308,1.638490691710769 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441094,135.42191043016496,93.53234569214308,1.4478618004075214 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441078,207.19590890658333,93.53234569214308,2.2152326809867255 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441088,185.26900007763584,93.53234569214308,1.9808013870136354 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441095,47.24241754926575,42.30806113801961,1.11662922569647 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441083,42.98387556790359,42.30806113801961,1.0159736563601744 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441084,52.23057483787566,42.30806113801961,1.2345300974083 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441094,104.41240157821764,42.30806113801961,2.4679079771015253 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441078,46.903736925992135,42.30806113801961,1.108624117115182 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441088,34.366325581741705,42.30806113801961,0.8122878869260883 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441095,154.7517845124553,205.3077634331321,0.7537551523854445 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441083,383.4831746828817,205.3077634331321,1.867845464147685 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441084,450.85822841160814,205.3077634331321,2.196011591926239 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441094,143.5691858934204,205.3077634331321,0.6992876620575544 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441078,787.8595560740175,205.3077634331321,3.837456231072432 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441088,244.7389847907345,205.3077634331321,1.1920590858243165 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441095,600.9775297520714,761.179367641068,0.7895347079815499 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441083,583.6388554192963,761.179367641068,0.7667560107784077 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441084,569.8760276336193,761.179367641068,0.7486750848222449 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441094,178.44082116065613,761.179367641068,0.23442677080653532 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441078,544.6713767045233,761.179367641068,0.7155624546057868 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441088,172.7753596385442,761.179367641068,0.2269837662231748 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441095,620028.8342061945,258075.7105503754,2.4025075156585385 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441083,788542.835353489,258075.7105503754,3.0554709456067486 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441084,916350.9122625996,258075.7105503754,3.5507057611441946 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441094,689210.497815742,258075.7105503754,2.6705748338188178 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441078,568763.9495761035,258075.7105503754,2.203864704520819 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441088,603178.0060969918,258075.7105503754,2.337213389088989 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441095,158.05227994832558,131.47736122215045,1.2021254342127605 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441083,171.55105083037043,131.47736122215045,1.3047953597160318 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441084,114.17889619594584,131.47736122215045,0.8684300866293149 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441094,133.07445809860516,131.47736122215045,1.0121473146525672 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441078,62.765029093535574,131.47736122215045,0.4773827867406372 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441088,181.7600314882139,131.47736122215045,1.382443561375585 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441095,2019.9701416094413,3004.2024881525895,0.6723814887895941 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441083,1965.6817053677264,3004.2024881525895,0.6543106575271186 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441084,2790.6651406503183,3004.2024881525895,0.9289204544818868 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441094,2525.411348149546,3004.2024881525895,0.8406262088220717 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441078,2334.238623011561,3004.2024881525895,0.776991109027069 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441088,2429.382744985514,3004.2024881525895,0.8086614516052291 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441095,94.52996245703284,96.13121274223809,0.983343076202536 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441083,111.7027265804572,96.13121274223809,1.1619818724223512 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441084,83.03032381716626,96.13121274223809,0.8637186762617886 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441094,72.41306871347864,96.13121274223809,0.7532732257070738 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441078,54.84598751279833,96.13121274223809,0.5705325663565682 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441088,82.81862782557481,96.13121274223809,0.8615165195891261 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441095,292.6213554350598,490.807523353751,0.5962038915694291 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441083,362.15161629164027,490.807523353751,0.737868918180006 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441084,608.2146611841282,490.807523353751,1.2392121804248621 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441094,358.1088547070484,490.807523353751,0.729631958899172 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441078,314.81745358719303,490.807523353751,0.6414275222107535 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441088,749.7054182693562,490.807523353751,1.527493737558305 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441095,73.00541101473358,78.64120835950264,0.9283353160215263 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441083,85.87670521113384,78.64120835950264,1.0920064302490704 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441084,69.6777389561878,78.64120835950264,0.8860207060611405 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441094,78.67133764479918,78.64120835950264,1.0003831233767264 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441078,154.73716346747958,78.64120835950264,1.9676346116162118 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441088,95.5344114352189,78.64120835950264,1.2148136254276536 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441095,1967.7576689837656,1710.8868039225827,1.1501390182402775 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441083,2029.0757833284104,1710.8868039225827,1.185978978081022 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441084,2589.4590233866684,1710.8868039225827,1.5135186135340846 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441094,1812.5358722003184,1710.8868039225827,1.0594130880223536 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441078,1788.9199916791492,1710.8868039225827,1.0456097899508363 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441088,1911.624579103075,1710.8868039225827,1.1173296647798423 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441095,212.818874855102,158.21676846284709,1.3451094781086794 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441083,205.3251131919343,158.21676846284709,1.2977455878208592 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441084,168.0322886503036,158.21676846284709,1.0620384317213596 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441094,272.34791172949286,158.21676846284709,1.7213593374171738 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441078,269.01065638382914,158.21676846284709,1.7002664066356468 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441088,244.0506059153527,158.21676846284709,1.5425078408971635 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441095,1046.7641633149383,1068.4447009417866,0.9797083203204267 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441083,764.9164160572703,1068.4447009417866,0.7159157749418669 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441084,1214.416515891639,1068.4447009417866,1.136620842259019 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441094,693.25878012593,1068.4447009417866,0.6488485361150214 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441078,820.3742908196361,1068.4447009417866,0.7678210113228253 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441088,1105.7298643338245,1068.4447009417866,1.034896671169947 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441095,131.1356491638608,101.193417409009,1.2958911016299575 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441083,135.77658504103775,101.193417409009,1.3417531349124088 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441084,148.42067213067637,101.193417409009,1.4667028343432824 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441094,134.78128314364724,101.193417409009,1.331917496163619 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441078,131.89815134693072,101.193417409009,1.3034261983051494 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441088,130.8059476687832,101.193417409009,1.2926329697917474 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441095,9389.33518685496,8195.704907369402,1.145640953764974 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441083,8776.203945627636,8195.704907369402,1.0708296656381884 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441084,12913.066755961356,8195.704907369402,1.5755895193774245 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441094,10312.988497076843,8195.704907369402,1.258340632518824 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441078,9418.45646899419,8195.704907369402,1.149194190791974 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441088,8832.56550984493,8195.704907369402,1.0777066292251294 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441095,65.04133092401337,54.484574340672744,1.1937567965078146 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441083,44.54987005229478,54.484574340672744,0.8176602385427519 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441084,40.4432177473818,54.484574340672744,0.7422874866288701 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441094,13.20553133469959,54.484574340672744,0.2423719281007883 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441078,95.93046783069916,54.484574340672744,1.760690415435384 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441088,109.74648886411087,54.484574340672744,2.014267160791327 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441095,287.9109199269041,181.8259570369428,1.5834423457394882 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441083,125.45956900094404,181.8259570369428,0.6899981226302776 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441084,525.0509606440318,181.8259570369428,2.8876567966440216 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441094,80.62276372448511,181.8259570369428,0.44340623879188185 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441078,206.3474890016163,181.8259570369428,1.134862658579002 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441088,199.4063276104579,181.8259570369428,1.0966879034215296 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441095,671.7778999370298,598.5025834222519,1.1224310780678473 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441083,583.8282785716194,598.5025834222519,0.9754816349050252 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441084,581.4611740372434,598.5025834222519,0.9715265900982994 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441094,624.0565774630813,598.5025834222519,1.0426965475983598 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441078,650.2449980734647,598.5025834222519,1.0864531183062711 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441088,814.9484811377981,598.5025834222519,1.3616457200199596 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441095,12631.025776992356,15066.853658787537,0.838332014303828 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441083,16703.381559508845,15066.853658787537,1.108617760401942 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441084,24341.773202432236,15066.853658787537,1.6155843651030106 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441094,21765.360047203245,15066.853658787537,1.444585614230672 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441078,16605.441690786167,15066.853658787537,1.1021174073129243 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441088,13974.204896756506,15066.853658787537,0.9274799645117839 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441095,64.14183538397104,62.8704966822211,1.020221546971005 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441083,63.76139824903795,62.8704966822211,1.0141704235504916 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441084,63.18839391593034,62.8704966822211,1.0050563817765914 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441094,61.00610278914051,62.8704966822211,0.9703454880831598 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441078,66.01212772924234,62.8704966822211,1.0499698779683675 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441088,67.71536971951912,62.8704966822211,1.0770611541656243 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441095,96.8525419036598,100.49015468400951,0.9638013018112256 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441083,109.9089972999342,100.49015468400951,1.0937290090312048 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441084,101.01932824923908,100.49015468400951,1.0052659244768163 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441094,107.16964241549964,100.49015468400951,1.0664690760253452 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441078,99.99088579532832,100.49015468400951,0.9950316636465419 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441088,96.67702447029612,100.49015468400951,0.9620546885841329 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441095,125.42848186268832,109.95671552102958,1.1407077891363508 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441083,127.98919606711073,109.95671552102958,1.163996173045314 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441084,111.23874039397276,109.95671552102958,1.0116593594749381 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441094,124.14198340597264,109.95671552102958,1.1290077447086901 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441078,117.69447396121384,109.95671552102958,1.0703709491823117 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441088,147.7702937279281,109.95671552102958,1.3438951229828846 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441095,260.8013913279313,243.54938966397899,1.070835741726779 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441083,288.6274285178543,243.54938966397899,1.1850878744392204 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441084,265.2178428231425,243.54938966397899,1.0889694414305826 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441094,277.3942400856643,243.54938966397899,1.1389650389532098 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441078,244.40331649634444,243.54938966397899,1.003506175209651 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441088,257.32851937473,243.54938966397899,1.0565763261807464 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441095,60.42811960236427,49.66723175069083,1.2166597064577445 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441083,95.34409765601264,49.66723175069083,1.9196579776098852 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441084,53.72986109131773,49.66723175069083,1.0817969755395194 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441094,57.35488503062758,49.66723175069083,1.1547832043171968 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441078,29.597813678453303,49.66723175069083,0.5959223543406287 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441088,92.4448397697806,49.66723175069083,1.8612843219009234 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441095,402.6336602620557,318.9289567276793,1.2624556402567375 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441083,282.5566658823269,318.9289567276793,0.8859548809285159 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441084,506.468380179936,318.9289567276793,1.5880288368183173 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441094,469.18737660779914,318.9289567276793,1.4711344539606026 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441078,392.492381577113,318.9289567276793,1.230657716389944 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441088,311.3770387989876,318.9289567276793,0.9763210026264878 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441095,51.829486161749664,52.85511393128503,0.9805954865432936 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441083,52.529192854482424,52.85511393128503,0.9938336888796356 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441084,47.235867009955754,52.85511393128503,0.893685842232132 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441094,46.76602949285442,52.85511393128503,0.8847966831299087 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441078,46.10075275764875,52.85511393128503,0.872209883372546 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441088,56.167449714869505,52.85511393128503,1.0626682176466542 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441095,123.56640546958414,145.91831693350866,0.8468190153665922 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441083,139.9297082633323,145.91831693350866,0.9589591711580306 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441084,133.58924504064333,145.91831693350866,0.9155070305636586 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441094,137.54172445280693,145.91831693350866,0.9425939617675364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441078,137.24993218307634,145.91831693350866,0.9405942658015835 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441088,128.35493896920698,145.91831693350866,0.8796355499885263 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441095,485.0303317396291,261.347965154705,1.8558795032228979 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441083,619.1111480843158,261.347965154705,2.368915127071423 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441084,351.55174329213696,261.347965154705,1.3451481938420138 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441094,772.5807441789884,261.347965154705,2.9561383564691583 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441078,383.94212414073985,261.347965154705,1.4690840386435198 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441088,845.6945480710627,261.347965154705,3.235894901919185 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441095,7356.500277815359,7540.877985370558,0.9755495702340106 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441083,5788.547136755685,7540.877985370558,0.7676224370670859 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441084,6923.706306221109,7540.877985370558,0.9181565223112251 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441094,5747.466657615473,7540.877985370558,0.7621747320094111 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441078,7110.643784151948,7540.877985370558,0.9429464046423676 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441088,6313.808285205204,7540.877985370558,0.8372776084501179 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441095,3947.682024809796,5107.556668860965,0.7729100782919297 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441083,4587.1445106549545,5107.556668860965,0.8981093716729984 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441084,5574.679256896526,5107.556668860965,1.091457152278593 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441094,4720.5402223341025,5107.556668860965,0.924226695537933 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441078,3915.566890119431,5107.556668860965,0.7666223096439262 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441088,4886.266116122906,5107.556668860965,0.9566738918263615 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441095,103384.23837482248,180330.65339424144,0.5733037419256858 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441083,66985.2101381922,180330.65339424144,0.37145770215642804 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441084,112164.55243335804,180330.65339424144,0.6219938225818009 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441094,77840.81502426749,180330.65339424144,0.4316560360599969 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441078,63004.47691520407,180330.65339424144,0.34938306787733303 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441088,79993.763730111,180330.65339424144,0.44359493089190716 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441095,124.39126858556504,98.01831453553807,1.2690614929974648 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441083,154.00912274273873,98.01831453553807,1.571228024808571 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441084,441.3200248719224,98.01831453553807,4.502424133317605 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441094,276.59288724084627,98.01831453553807,2.8218490447574793 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441078,440.4548824451983,98.01831453553807,4.493597798863441 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441088,203.1241426775044,98.01831453553807,2.072308054265293 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441095,1684.2430078833038,1812.4793707702274,0.9292480979618385 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441083,1623.4243845261929,1812.4793707702274,0.8956926135034055 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441084,2182.5256046733193,1812.4793707702274,1.204165763136845 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441094,961.1372435659456,1812.4793707702274,0.5302886526965009 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441078,953.8622072515165,1812.4793707702274,0.5262747938731932 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441088,1378.7582681988551,1812.4793707702274,0.7607028749866217 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441095,1119.4028277945424,434.5650550234931,2.5759154236044735 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441083,1786.9291210375063,434.5650550234931,4.111994511249652 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441084,276.05512275789783,434.5650550234931,0.6352446418936607 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441094,1522.0416373931807,434.5650550234931,3.502448298128568 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441078,296.87823765814295,434.5650550234931,0.6831617826290551 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441088,2552.893153338611,434.5650550234931,5.874593743393836 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441095,923188.036203318,9833.502392298877,93.88191504649598 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441083,1022595.4279271632,9833.502392298877,103.99096752424757 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441084,220812.55247837532,9833.502392298877,22.455127752987078 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441094,1034486.3281278204,9833.502392298877,105.2001908229544 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441078,323615.7883100237,9833.502392298877,32.909514372362786 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441088,980129.070867726,9833.502392298877,99.67242918813095 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441095,47.668918608389525,42.4088060383901,1.1240334982606623 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441083,65.7490575382723,42.4088060383901,1.5503633249838182 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441084,44.68663331462342,42.4088060383901,1.0537111861666502 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441094,41.26394427123774,42.4088060383901,0.9730041499844164 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441078,37.72250816010859,42.4088060383901,0.8894970569546502 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441088,94.17093628086845,42.4088060383901,2.220551462722654 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441095,917.9784507440978,385.8715169071063,2.3789743749474246 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441083,957.6886685596124,385.8715169071063,2.48188484145142 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441084,590.0392075569836,385.8715169071063,1.5291079587484246 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441094,857.1325524300179,385.8715169071063,2.2212900275724725 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441078,563.238909941481,385.8715169071063,1.4596540176275141 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441088,901.8847256597955,385.8715169071063,2.3372669039910323 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441095,725.6882546062682,1002.6445024002205,0.7237742319127571 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441083,518.4851641765299,1002.6445024002205,0.5171176453222788 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441084,1129.1020276066538,1002.6445024002205,1.126123990012121 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441094,788.3183601152886,1002.6445024002205,0.7862391487991419 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441078,1212.2699418278576,1002.6445024002205,1.2090725465763956 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441088,748.436620688034,1002.6445024002205,0.7464625985544819 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441095,23924.32317072948,6245.085755978491,3.8309038667445767 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441083,22472.54152184164,6245.085755978491,3.598436018325036 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441084,42014.87861875434,6245.085755978491,6.727670405251525 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441094,22985.566748287096,6245.085755978491,3.680584646300934 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441078,18826.98467095419,6245.085755978491,3.0146879332971377 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441088,23998.455622984213,6245.085755978491,3.842774392651089 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441095,276.48388828084495,289.8012081128336,0.9540467069867992 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441083,291.61223620543376,289.8012081128336,1.0062492082224 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441084,248.3681396765425,289.8012081128336,0.8570293453705714 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441094,259.8341079993786,289.8012081128336,0.8965942885172951 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441078,198.44940704599665,289.8012081128336,0.6847777079270516 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441088,340.7480087965493,289.8012081128336,1.1757991314649028 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441095,24565.402831468,19122.271903916942,1.284648756952154 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441083,37284.77026551856,19122.271903916942,1.949808602914033 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441084,36796.02879233876,19122.271903916942,1.9242498473626235 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441094,7030.068851163164,19122.271903916942,0.36763774129386523 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441078,27450.663282315112,19122.271903916942,1.435533571546601 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441088,32575.188955522044,19122.271903916942,1.7035208535471902 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441095,62.86460885374628,111.01681566749893,0.5662620430586751 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441083,97.88611204557762,111.01681566749893,0.8817232908098496 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441084,90.48825103982745,111.01681566749893,0.815085989413031 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441094,69.65668861624394,111.01681566749893,0.6274426824209163 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441078,47.061248547005064,111.01681566749893,0.4239109927991082 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441088,122.59994414508,111.01681566749893,1.1043367025791222 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441095,1238.0978008542704,1048.3386659324408,1.1810093828343622 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441083,1770.4498377808093,1048.3386659324408,1.6888147841099512 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441084,1797.3352876390288,1048.3386659324408,1.7144605517725475 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441094,1264.8879086437416,1048.3386659324408,1.2065642046300868 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441078,1156.2145857029277,1048.3386659324408,1.1029017847725164 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441088,1622.4858321897934,1048.3386659324408,1.5476733663607454 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441095,8185.231927701232,5453.602601951663,1.500885290903303 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441083,15065.134077445377,5453.602601951663,2.762418749040142 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441084,4754.008901937408,5453.602601951663,0.8717189808139131 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441094,11028.836236295125,5453.602601951663,2.022302877798296 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441078,13532.319989894228,5453.602601951663,2.4813542492171066 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441088,13048.297730235628,5453.602601951663,2.392601493472604 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441095,126868.74676012696,64173.361133824874,1.976969018274722 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441083,126956.90579855198,64173.361133824874,1.9783427820431674 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441084,155764.01183106314,64173.361133824874,2.427237861302579 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441094,193627.2832179139,64173.361133824874,3.01725326205262 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441078,174254.4646675633,64173.361133824874,2.715370701936262 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441088,139318.1737732488,64173.361133824874,2.1709658230729034 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441095,69.87374440011922,44.60879663763593,1.5663669425497917 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441083,52.94968138891045,44.60879663763593,1.1869784746499394 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441084,66.02296211198266,44.60879663763593,1.4800435584106262 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441094,29.466753894567315,44.60879663763593,0.6605592644412773 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441078,26.037075174637224,44.60879663763593,0.5836758024687454 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441088,9.358007903257704,44.60879663763593,0.20977942936399363 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441095,132.95832726956914,136.29080299882398,0.9755487849808648 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441083,154.06408246463351,136.29080299882398,1.1304070346255344 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441084,142.5616447778935,136.29080299882398,1.0460107479088199 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441094,148.88265982175304,136.29080299882398,1.0923896297172577 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441078,134.9268092533994,136.29080299882398,0.9899920338319795 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441088,131.90495905087926,136.29080299882398,0.9678199566556038 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441095,68.01515637504961,82.77341642135346,0.8217029007093564 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441083,70.92078033131376,82.77341642135346,0.8568062476761318 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441084,61.59264377772858,82.77341642135346,0.7441114121011349 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441094,48.212139381925866,82.77341642135346,0.5824592177820069 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441078,130.06938842663587,82.77341642135346,1.571390840804793 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441088,120.45340516708,82.77341642135346,1.4552184792508582 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441095,3115.8102137507976,2141.365658987758,1.4550575240025416 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441083,2842.962258365669,2141.365658987758,1.3276397921266572 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441084,5562.3725931386025,2141.365658987758,2.597581860805587 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441094,1091.0550877266337,2141.365658987758,0.509513675605681 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441078,3309.2616528092017,2141.365658987758,1.545397741352366 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441088,4028.245306300044,2141.365658987758,1.8811571435231806 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441095,361.5328256812119,285.0677067828484,1.2682349388547582 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441083,317.8506782876179,285.0677067828484,1.115000649757014 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441084,492.51029261418745,285.0677067828484,1.7276958452167273 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441094,262.073514022733,285.0677067828484,0.919337784628017 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441078,410.6249432967708,285.0677067828484,1.4404470710867514 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441088,595.1495380242357,285.0677067828484,2.087748011659537 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441095,680539.3350687837,724296.655045942,0.9395864668539954 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441083,589759.10609158606,724296.655045942,0.8142507658746232 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441084,1139717.9540430903,724296.655045942,1.5735513150627463 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441094,715368.530522784,724296.655045942,0.9876733870563136 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441078,495299.13569214713,724296.655045942,0.6838346307987994 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441088,740203.7129742018,724296.655045942,1.0219620756459944 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441095,28.33352411977163,126.94877083842833,0.2231886447788659 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441083,42.98088334181568,126.94877083842833,0.3385687238872032 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441084,24.19832321828122,126.94877083842833,0.19061486817449524 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441094,22.386555952689125,126.94877083842833,0.1763432273100241 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441078,6.320683230525082,126.94877083842833,0.04978924324182401 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441088,89.00157026478696,126.94877083842833,0.7010825680073898 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441095,34759.60804286225,94593.87687362579,0.36746150164983626 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441083,31283.207665897655,94593.87687362579,0.33071070453842333 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441084,35697.706385994745,94593.87687362579,0.37737861652171917 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441094,31458.594398478155,94593.87687362579,0.332564806921972 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441078,17776.66156995396,94593.87687362579,0.18792613388394028 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441088,51759.61645152175,94593.87687362579,0.5471772398193473 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441095,9.010074611429614,34.2642969985689,0.2629581051029861 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441083,96.7104723052166,34.2642969985689,2.8224852332226704 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441084,67.53116206193117,34.2642969985689,1.9708900510858782 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441094,5.753464648325906,34.2642969985689,0.16791427673435727 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441078,12.311168777843957,34.2642969985689,0.35930020039104116 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441088,4.314281081103178,34.2642969985689,0.12591185166540467 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441095,11.250898521466612,74.66086218948179,0.15069339131006762 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441083,6.150237053045758,74.66086218948179,0.08237565000839492 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441084,162.39472581557808,74.66086218948179,2.1750984525659045 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441094,37.54907276294165,74.66086218948179,0.502928464282208 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441078,5.983192057076566,74.66086218948179,0.0801382663100223 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441088,32.759141045298215,74.66086218948179,0.43877260568139165 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441095,307.7404557124783,347.6986105145094,0.8850781867005371 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441083,326.6233586263149,347.6986105145094,0.939386436267294 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441084,302.56617865037305,347.6986105145094,0.870196686154853 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441094,311.6577622831776,347.6986105145094,0.8963445721626551 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441078,204.22277373302387,347.6986105145094,0.5873557372887508 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441088,203.1920177392821,347.6986105145094,0.5843912273293451 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441095,5079.488297009574,2521.321340016667,2.014613614056825 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441083,5224.067393187213,2521.321340016667,2.0719562041832718 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441084,5625.792519637279,2521.321340016667,2.2312873929826376 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441094,5892.66710210296,2521.321340016667,2.337134505062336 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441078,4878.654901405667,2521.321340016667,1.934959588044187 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441088,5565.569559464743,2521.321340016667,2.2074019170551074 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441095,72.34308039790163,79.44971561377609,0.9105517853528702 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441083,87.64245218152956,79.44971561377609,1.1031185134454138 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441084,114.06478429306443,79.44971561377609,1.435685243324978 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441094,118.98950290180248,79.44971561377609,1.4976705955781977 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441078,259.1425470201456,79.44971561377609,3.261717742073477 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441088,123.2130480775684,79.44971561377609,1.5508305741021937 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441095,108.20851993391214,42.37178439720435,2.55378718346003 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441083,131.95927582145566,42.37178439720435,3.114319533594205 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441084,28.829122549085625,42.37178439720435,0.6803849061166218 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441094,106.84250196996229,42.37178439720435,2.5215483249039576 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441078,74.80082743953675,42.37178439720435,1.7653452292292895 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441088,66.0316245726065,42.37178439720435,1.5583866837801432 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441095,1654.7323120149665,1321.2949146990686,1.2523565281350075 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441083,2939.756456218795,1321.2949146990686,2.2249056009485506 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441084,969.9422037831746,1321.2949146990686,0.7340845658246431 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441094,2040.2925524888403,1321.2949146990686,1.5441613600348465 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441078,894.4247201770459,1321.2949146990686,0.6769304189600666 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441088,2842.4139399589008,1321.2949146990686,2.151233542442169 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441095,56038.11423481564,23354.026662177774,2.3995054491211265 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441083,48712.83435675073,23354.026662177774,2.085843056591263 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441084,46354.84306960019,23354.026662177774,1.9848758306280694 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441094,61899.629356700294,23354.026662177774,2.650490652087323 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441078,89518.81823174826,23354.026662177774,3.8331213510484443 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441088,55597.232448354014,23354.026662177774,2.380627257670928 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441095,13660.39415240206,13473.54115415771,1.0138681432079708 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441083,24990.9704981396,13473.54115415771,1.8548182851267576 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441084,5418.883794465859,13473.54115415771,0.40218705182740183 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441094,8022.59917516593,13473.54115415771,0.5954336045272174 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441078,6738.678997753683,13473.54115415771,0.5001416421008399 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441088,15735.717717593763,13473.54115415771,1.1678976994654433 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441095,104421.45513283144,49612.48263442616,2.1047415809095846 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441083,127342.41116991018,49612.48263442616,2.5667413604000364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441084,136075.8049296675,49612.48263442616,2.742773546172921 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441094,116064.76149254812,49612.48263442616,2.3394265984990366 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441078,70311.3200546996,49612.48263442616,1.4172102729225344 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441088,117306.75877528168,49612.48263442616,2.364460566097178 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441098,223.37123551445336,73.06854961986588,3.057009297112464 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441081,119.73874453787488,73.06854961986588,1.6387179595162007 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441101,175.8276883401001,73.06854961986588,2.406338831889118 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441086,155.03869578965484,73.06854961986588,2.121825280455586 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441085,258.68596626863865,73.06854961986588,3.5403188870510593 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441100,361.4938660539963,73.06854961986588,4.947325052086614 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441098,606.5080820377455,990.9231863649335,0.612063669902243 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441081,11.392165440189796,990.9231863649335,0.011496517184122415 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441101,262.8206634784013,990.9231863649335,0.2652280894168225 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441086,38.705008975399785,990.9231863649335,0.03905954518773935 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441085,281.1234913124066,990.9231863649335,0.28369857036413665 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441100,3.614764528001093,990.9231863649335,0.0036478756151234726 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441098,55.39572655603541,50.719124328797626,1.0922058945048165 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441081,61.114822069356414,50.719124328797626,1.2049660335846188 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441101,53.11734043820186,50.719124328797626,1.0472842569965775 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441086,56.86451003575147,50.719124328797626,1.1211650593002171 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441085,67.98122615240271,50.719124328797626,1.340347000308992 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441100,49.40875789613689,50.719124328797626,0.9741642536222431 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441098,312.47679502618996,319.2477137201226,0.9787910190020388 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441081,363.4581028585646,319.2477137201226,1.138483025056838 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441101,295.54144732820976,319.2477137201226,0.9257433479611522 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441086,336.57091778341334,319.2477137201226,1.0542625783014303 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441085,314.74065334919516,319.2477137201226,0.9858822469911916 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441100,372.4147651020598,319.2477137201226,1.166538550150895 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441098,6.660086131662909,44.58166891160943,0.1493906866714128 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441081,41.27567655511688,44.58166891160943,0.9258441319671719 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441101,103.94475597848918,44.58166891160943,2.3315582057858117 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441086,37.0239035342333,44.58166891160943,0.8304737000231944 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441085,71.8594188184265,44.58166891160943,1.6118602235573494 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441100,30.83690244842587,44.58166891160943,0.6916946628796055 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441098,1561.7776290543366,1543.2839395802719,1.0119833356647867 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441081,1330.5000806806272,1543.2839395802719,0.8621226765584591 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441101,2463.7563931325685,1543.2839395802719,1.5964375251663918 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441086,2033.1735648107783,1543.2839395802719,1.3174332426239996 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441085,1919.934159317813,1543.2839395802719,1.2440576293692132 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441100,2030.3927158439144,1543.2839395802719,1.31563133897196 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441098,31.003088967123492,31.276034215973343,0.9912730224374019 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441081,35.30235364409112,31.276034215973343,1.1287349732486687 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441101,38.6434138328704,31.276034215973343,1.235559903983427 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441086,46.497539980936914,31.276034215973343,1.4866827315718187 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441085,53.66636569938666,31.276034215973343,1.7158941996545742 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441100,36.8855514279081,31.276034215973343,1.179355130935042 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441098,57.07100181735224,130.468422036268,0.43743153267759666 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441081,168.68043827104597,130.468422036268,1.2928832558744037 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441101,33.77737269407204,130.468422036268,0.25889308820399853 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441086,738.6562848361118,130.468422036268,5.661571384919317 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441085,211.57922862606895,130.468422036268,1.62168918213216 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441100,55.50441005296236,130.468422036268,0.42542409256343333 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441098,99.8563717565596,95.42663227533711,1.0464203689850569 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441081,111.66257480242702,95.42663227533711,1.1701405796260722 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441101,98.92886257560797,95.42663227533711,1.03670076389331 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441086,118.33616649760047,95.42663227533711,1.240074847828244 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441085,119.85551206946904,95.42663227533711,1.2559964572955546 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441100,167.42397306835446,95.42663227533711,1.7544784833785334 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441098,484.6510434997784,569.3868516791151,0.8511806025561499 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441081,600.7587010018016,569.3868516791151,1.0550976005683503 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441101,518.6462477766098,569.3868516791151,0.9108855363398859 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441086,585.4193220721947,569.3868516791151,1.0281574299543448 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441085,516.2527948010993,569.3868516791151,0.9066819742652572 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441100,589.9632760758757,569.3868516791151,1.0361378636266028 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441098,1687.8819926577205,5328.634617598269,0.3167569394012017 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441081,3766.304739284301,5328.634617598269,0.7068048401828414 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441101,4417.897588762082,5328.634617598269,0.8290862304898143 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441086,268.2429111805192,5328.634617598269,0.05033989575765322 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441085,9648.106726359065,5328.634617598269,1.810615179823997 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441100,3561.262077692412,5328.634617598269,0.6683254404291563 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441098,735040.472730199,656386.6079991342,1.1198285641000898 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441081,752381.3631381039,656386.6079991342,1.1462472786146427 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441101,735806.2406212811,656386.6079991342,1.120995205652111 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441086,872326.4470194181,656386.6079991342,1.3289827007265338 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441085,656855.2077195634,656386.6079991342,1.0007139081064704 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441100,730750.8269312939,656386.6079991342,1.1132933213839393 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441098,1654.686831967209,5223.837669019135,0.3167569394012017 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441081,3692.2337487921777,5223.837669019135,0.7068048401828416 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441101,4331.011881697774,5223.837669019135,0.8290862304898144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441086,682.0795524025182,5223.837669019135,0.1305705872997754 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441085,9458.35978046245,5223.837669019135,1.8106151798239967 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441100,3491.223610877631,5223.837669019135,0.6683254404291563 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441098,735040.472730199,656386.6079991342,1.1198285641000898 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441081,752381.3631381039,656386.6079991342,1.1462472786146427 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441101,735806.2406212811,656386.6079991342,1.120995205652111 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441086,872326.4470194181,656386.6079991342,1.3289827007265338 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441085,656855.2077195634,656386.6079991342,1.0007139081064704 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441100,730750.8269312939,656386.6079991342,1.1132933213839393 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441098,51.76182100547136,50.79723336807032,1.0189889797818665 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441081,51.27048360974452,50.79723336807032,1.0093164570252298 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441101,47.97440855607521,50.79723336807032,0.944429556004728 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441086,41.749638250324345,50.79723336807032,0.8218880337008071 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441085,69.16536119188358,50.79723336807032,1.3615970123947523 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441100,41.966832628283754,50.79723336807032,0.8261637464425946 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441098,92.14468295713372,124.85055234194422,0.7380398502744726 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441081,78.42261326474139,124.85055234194422,0.6281318888358244 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441101,68.64511688392253,124.85055234194422,0.5498182875147828 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441086,46.46243096432714,124.85055234194422,0.3721443765589 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441085,67.59607994384075,124.85055234194422,0.5414159463124095 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441100,81.04358765640842,124.85055234194422,0.649124782679727 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441098,140.65287441449178,149.81706398084205,0.9388308025611679 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441081,157.22688370769896,149.81706398084205,1.0494591172057974 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441101,166.26878383309682,149.81706398084205,1.109812056217832 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441086,186.1394988451244,149.81706398084205,1.2424452455491124 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441085,154.56722107978536,149.81706398084205,1.0317063822552999 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441100,179.57050970738766,149.81706398084205,1.1985985103162238 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441098,3302.5381865823547,2791.14294318225,1.1832207285009384 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441081,3273.719263524146,2791.14294318225,1.1728955951613496 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441101,3050.177066033391,2791.14294318225,1.0928057530997715 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441086,4538.054001795715,2791.14294318225,1.6258766011538517 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441085,2714.042779776679,2791.14294318225,0.9723768488482831 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441100,3127.0121214311134,2791.14294318225,1.1203339223701423 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441098,210.6367224305588,222.01180748199775,0.9487636032495194 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441081,194.0351026046214,222.01180748199775,0.8739855091732232 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441101,531.4589154059931,222.01180748199775,2.3938317580207418 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441086,304.003821322857,222.01180748199775,1.3693137530422013 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441085,289.60114696585475,222.01180748199775,1.304440291939597 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441100,303.9419950383714,222.01180748199775,1.3690352710768192 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441098,4334.93299323692,4330.453784028004,1.0010343510016058 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441081,3375.6346937281983,4330.453784028004,0.779510615302844 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441101,6170.234327451004,4330.453784028004,1.4248470564929376 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441086,4855.762811089728,4330.453784028004,1.1213057691550061 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441085,3679.167027397239,4330.453784028004,0.8496031157212893 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441100,4050.912659376109,4330.453784028004,0.9354476139006667 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441098,76.01429518895408,100.4664893584531,0.756613430750463 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441081,77.47891715715902,100.4664893584531,0.7711916446161763 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441101,90.26347867950156,100.4664893584531,0.8984436428096103 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441086,38.60082839740719,100.4664893584531,0.3842159574192325 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441085,104.43143904765752,100.4664893584531,1.0394653950239858 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441100,48.50338521869436,100.4664893584531,0.4827817268068336 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441098,175.62876036835462,219.8603821991507,0.7988194990458497 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441081,222.63319784910007,219.8603821991507,1.012611711224252 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441101,103.57347824275764,219.8603821991507,0.4710875020172586 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441086,481.4484786762349,219.8603821991507,2.189791875464568 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441085,80.38105790880073,219.8603821991507,0.36560046473489316 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441100,177.87679827159167,219.8603821991507,0.8090443421064825 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441098,148.08983011063785,115.26780159034894,1.2847458532863787 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441081,83.66525403895886,115.26780159034894,0.7258336923636091 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441101,149.29481327764924,115.26780159034894,1.2951996239871837 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441086,90.62818816943528,115.26780159034894,0.7862402762873837 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441085,179.02162772982163,115.26780159034894,1.5530931037103308 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441100,85.24206204494722,115.26780159034894,0.7395132107046649 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441098,2572.114559981089,1760.6737631139824,1.4608694772800879 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441081,3656.395509068517,1760.6737631139824,2.076702445205807 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441101,2142.750195120305,1760.6737631139824,1.2170058076690882 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441086,2046.3547948975977,1760.6737631139824,1.1622566529749105 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441085,3304.656489455666,1760.6737631139824,1.8769272074634358 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441100,2104.4065303324337,1760.6737631139824,1.1952279714843452 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441098,274.1354485518679,518.6000624505415,0.5286066632088229 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441081,543.697461926963,518.6000624505415,1.048394516880366 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441101,1188.709860124427,518.6000624505415,2.2921514018093534 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441086,634.713684843424,518.6000624505415,1.2238982036450412 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441085,286.9919725578228,518.6000624505415,0.5533974893903778 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441100,506.1239688508345,518.6000624505415,0.9759427456665669 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441098,4.775611032668599,841.89306662726494,0.005672467468820392 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441081,678.4512591445225,841.89306662726494,0.8058639345522681 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441101,705.4443304907362,841.89306662726494,0.8379262859555782 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441086,7.398881077895638,841.89306662726494,0.008788385807162583 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441085,3.873333521995395,841.89306662726494,0.004600742868108514 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441100,814.7017104788212,841.89306662726494,0.9677021260462734 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441098,257.31434396325966,246.94010350613598,1.0420111610460465 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441081,271.6176985495086,246.94010350613598,1.0999335251463496 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441101,414.8050950295998,246.94010350613598,1.6797801942254904 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441086,301.7334822363825,246.94010350613598,1.2218893486812077 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441085,410.93107508202314,246.94010350613598,1.66409209864048 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441100,490.37875313205967,246.94010350613598,1.9858206349211913 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441098,4278.19,6405.278640912654,0.6679162983907946 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441081,10318.971685375003,6405.278640912654,1.6110105842178801 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441101,8898.371711796462,6405.278640912654,1.3892247645495999 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441086,8371.98192360721,6405.278640912654,1.307044141707211 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441085,14388.080139317635,6405.278640912654,2.246284813812183 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441100,10362.86357832034,6405.278640912654,1.6178630406691865 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441098,314.7730336723463,184.84349394551683,1.702916488719514 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441081,112.88680307605097,184.84349394551683,0.6107155879087889 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441101,256.25624728963817,184.84349394551683,1.3863417197965888 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441086,277.89210759571137,184.84349394551683,1.5033913375259012 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441085,359.94931089216044,184.84349394551683,1.9473193414005503 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441100,311.6148230361595,184.84349394551683,1.685830625599454 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441098,52295.50758003567,66689.05961878091,0.7841692157450704 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441081,72647.87522384452,66689.05961878091,1.0893522211758027 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441101,45071.450568099666,66689.05961878091,0.6758447461359417 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441086,73908.1737762962,66689.05961878091,1.1082503516886035 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441085,50549.5660816161,66689.05961878091,0.757988887091465 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441100,30511.05921228973,66689.05961878091,0.4575122124483703 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441098,2671.391530748532,426.591426110135,6.2621782043478 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441081,716.6132802226188,426.591426110135,1.6798586102797284 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441101,3057.0662669288654,426.591426110135,7.1662627981173 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441086,891.2148591177839,426.591426110135,2.089153237898633 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441085,1311.0425204969613,426.591426110135,3.073297868294436 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441100,3802.450654595584,426.591426110135,8.913565584916112 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441098,5577.336538009499,6086.038398766024,0.9164149439379701 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441081,11239.546957397542,6086.038398766024,1.8467755575903726 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441101,9993.108261537453,6086.038398766024,1.6419725947775168 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441086,15609.431181083852,6086.038398766024,2.5647934104800827 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441085,9421.335701954024,6086.038398766024,1.5480243607835678 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441100,9986.23441819633,6086.038398766024,1.6408431501551306 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441098,49.06162387403993,118.38689307733607,0.41441769944913154 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441081,67.8770753116666,118.38689307733607,0.573349579056239 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441101,249.95677351679169,118.38689307733607,2.1113551257190926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441086,138.5897441586833,118.38689307733607,1.1706510793230271 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441085,44.12039815244571,118.38689307733607,0.37267975369219397 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441100,98.91094545661493,118.38689307733607,0.8354889877209759 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441098,46.418957135475274,43.003791743375764,1.0794154481186087 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441081,139.7233201818197,43.003791743375764,3.249093033833289 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441101,53.73127002931848,43.003791743375764,1.2494542423132993 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441086,196.9599891927496,43.003791743375764,4.58006099480958 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441085,38.937455220959365,43.003791743375764,0.905442372461429 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441100,56.969434781531064,43.003791743375764,1.3247537594241685 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441098,77.66216975762997,56.77751951238643,1.367833086485707 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441081,92.442187602681,56.77751951238643,1.6281476964225967 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441101,71.21355193371943,56.77751951238643,1.254256130688902 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441086,47.15760082418397,56.77751951238643,0.8305681760876539 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441085,23.05725814159834,56.77751951238643,0.40609837026374906 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441100,50.88827891825784,56.77751951238643,0.8962751341603817 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441098,336.2053060327939,232.93832449773902,1.4433232777719975 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441081,222.875839132148,232.93832449773902,0.956801932926719 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441101,302.71944070583965,232.93832449773902,1.2995690655823273 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441086,144.62119897805692,232.93832449773902,0.6208561828110027 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441085,156.41386606910598,232.93832449773902,0.6714818886345351 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441100,114.78868592057718,232.93832449773902,0.4927857456177906 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441098,39.5947918889368,55.88566907011774,0.7084963381087669 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441081,74.15120511790894,55.88566907011774,1.3268375659039546 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441101,90.1754816580173,55.88566907011774,1.6135707625666496 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441086,74.6822629702394,55.88566907011774,1.3363401425245218 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441085,132.47257332038015,55.88566907011774,2.3704211745979378 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441100,21.9206814506913,55.88566907011774,0.39224154985401016 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441098,143.47620456371442,226.42114305345407,0.6336696415751342 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441081,186.2624171392799,226.42114305345407,0.8226370321578431 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441101,150.11031929268637,226.42114305345407,0.6629695322103729 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441086,149.29697346116012,226.42114305345407,0.6593773507534749 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441085,94.514971579379,226.42114305345407,0.4174299727701033 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441100,94.33700501833488,226.42114305345407,0.41664397479021453 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441098,356.65428954693954,212.71806341276286,1.6766525786523339 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441081,174.52227173685282,212.71806341276286,0.8204393596711433 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441101,560.120831555536,212.71806341276286,2.633160637931651 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441086,238.77489258230608,212.71806341276286,1.1224946708873613 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441085,451.81694862654473,212.71806341276286,2.1240177791099435 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441100,366.8040069450517,212.71806341276286,1.7243669910312085 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441098,10956.305362712716,10996.969545575432,0.9963022373851097 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441081,14040.760351587553,10996.969545575432,1.276784508077207 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441101,15258.6710730357,10996.969545575432,1.3875341756470483 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441086,14293.247109056209,10996.969545575432,1.2997441749583654 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441085,13991.382377908109,10996.969545575432,1.272294364363086 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441100,14405.554696253172,10996.969545575432,1.3099567691400187 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441098,169.7732179083913,147.8550055811589,1.1482412600174114 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441081,139.85178342693024,147.8550055811589,0.9458711450263642 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441101,151.20965168440344,147.8550055811589,1.0226887557175273 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441086,111.91769805532732,147.8550055811589,0.7569422328004629 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441085,73.19204466719515,147.8550055811589,0.49502581518634753 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441100,244.9844494038567,147.8550055811589,1.6569236086456511 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441098,363.3994815442466,92.19915296117537,3.9414622572213047 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441081,137.213190649127,92.19915296117537,1.4882261522175462 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441101,173.44700427361525,92.19915296117537,1.881221233633816 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441086,131.05164052076805,92.19915296117537,1.4213974457656164 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441085,143.01295844086002,92.19915296117537,1.5511309361061278 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441100,148.35220226078562,92.19915296117537,1.609040837102441 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441098,756.3848408633511,1229.7970051816276,0.6150485305106441 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441081,1182.9353493004528,1229.7970051816276,0.9618948040337325 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441101,1997.0843546923368,1229.7970051816276,1.6239138217753175 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441086,2382.4358902252357,1229.7970051816276,1.9372594665518605 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441085,1093.801762947148,1229.7970051816276,0.8894165121060816 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441100,1733.093786239056,1229.7970051816276,1.40925191632183 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441098,79215.94399013369,50083.06853493704,1.5816911045471203 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441081,48309.284430506625,50083.06853493704,0.9645831584142442 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441101,58193.33629409848,50083.06853493704,1.1619363189279002 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441086,77734.34190339065,50083.06853493704,1.5521082109648412 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441085,41588.70170434677,50083.06853493704,0.8303944410941044 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441100,46017.09382066757,50083.06853493704,0.9188153834577225 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441098,32.10287512201419,35.678906774941794,0.899771826657 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441081,44.796313192860026,35.678906774941794,1.255540520774073 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441101,46.79734870362125,35.678906774941794,1.3116250730105954 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441086,35.069217730116605,35.678906774941794,0.9829117789771129 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441085,7.827203992465301,35.678906774941794,0.21937903091701638 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441100,10.751122437514454,35.678906774941794,0.30132992878204556 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441098,29.227282309942936,67.70693010562654,0.4316734234493687 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441081,15.298642251884036,67.70693010562654,0.22595386067596496 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441101,122.43031890251392,67.70693010562654,1.8082391080427938 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441086,40.8364182732046,67.70693010562654,0.6031349849933757 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441085,14.788021732205005,67.70693010562654,0.21841223208813154 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441100,21.70879861448508,67.70693010562654,0.32062890136383615 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441098,73.19783114007382,64.01321127549492,1.143480067341894 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441081,70.59424080690043,64.01321127549492,1.1028073642967637 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441101,71.50790068651186,64.01321127549492,1.1170803535970395 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441086,32.19305648547478,64.01321127549492,0.5029126932396015 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441085,84.05533932915847,64.01321127549492,1.313093620118632 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441100,105.56439264336994,64.01321127549492,1.6491032169757955 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441098,587.2784007671344,1060.427767412219,0.55381273370489 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441081,681.1834814780933,1060.427767412219,0.642366696168658 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441101,573.8380545769638,1060.427767412219,0.5411382766572693 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441086,899.3788202032132,1060.427767412219,0.8481283193837742 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441085,514.1010999716308,1060.427767412219,0.48480539247496407 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441100,813.164944892489,1060.427767412219,0.7668272841222086 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441098,59.657837406791586,57.09593719876665,1.0448700964327158 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441081,44.06252967960303,57.09593719876665,0.7717279344449546 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441101,153.8366682032514,57.09593719876665,2.694354025010636 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441086,0.986746896115142,57.09593719876665,0.01728226112971935 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441085,40.676504973259014,57.09593719876665,0.7124238075233431 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441100,10.347676205479525,57.09593719876665,0.18123314395307008 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441098,2.826244318150562,50.205845180981015,0.056293132960167754 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441081,51.69,50.205845180981015,1.0295613949664413 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441101,344.40244623710475,50.205845180981015,6.859807757355937 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441086,31.872016227577912,50.205845180981015,0.6348268037852228 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441085,47.940004782983216,50.205845180981015,0.9548689920500304 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441100,51.2144395933819,50.205845180981015,1.0200891830177368 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441098,753.2251202066275,1506.8779059558976,0.49985809548970345 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441081,598.0956123582433,1506.8779059558976,0.3969104663319339 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441101,2689.1795740462708,1506.8779059558976,1.7846034927032608 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441086,1448.69788307019,1506.8779059558976,0.9613903537534445 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441085,6791.9775168662445,1506.8779059558976,4.507317739560134 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441100,1227.2103645948353,1506.8779059558976,0.8144059712763169 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441098,22210.159522593854,16162.128318216166,1.3742100721698278 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441081,16766.719505188565,16162.128318216166,1.037407894249359 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441101,30575.214931455735,16162.128318216166,1.8917814739160763 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441086,56708.99331502042,16162.128318216166,3.5087577699221897 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441085,24790.12030414089,16162.128318216166,1.533840086902429 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441100,32513.31278528242,16162.128318216166,2.0116974785206354 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441098,9.702820530802915,24.995311385825953,0.3881856233367461 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441081,27.588111433466384,24.995311385825953,1.1037314561766463 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441101,10.766971061041616,24.995311385825953,0.4307596290697632 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441086,34.30899621718157,24.995311385825953,1.3726172755998196 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441085,51.81754232677396,24.995311385825953,2.073090489929165 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441100,59.13519036888974,24.995311385825953,2.365851317316392 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441098,277.90143299039005,522.7489803443298,0.5316154472598665 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441081,488.68879814108607,522.7489803443298,0.9348440963370056 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441101,57.09286718997402,522.7489803443298,0.10921660172797945 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441086,2390.7036701809348,522.7489803443298,4.5733301451993285 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441085,77.60373704584508,522.7489803443298,0.14845315813859308 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441100,1042.7168183110637,522.7489803443298,1.9946797746486966 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441098,2.452778487589363,2.8430683750443606,0.8627223000048644 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441081,3.2369776042691987,2.8430683750443606,1.1385507407005968 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441101,2.6259922517373213,2.8430683750443606,0.9236472378883072 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441086,3.5477341400910296,2.8430683750443606,1.2478539634262837 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441085,2.1658237050724805,2.8430683750443606,0.7617909312640738 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441100,4.174364255725882,2.8430683750443606,1.4682602403682075 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441098,1274.8353549786295,1771.7543971110147,0.7195327733106514 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441081,1598.3248676626297,1771.7543971110147,0.9021142378812913 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441101,981.4748935820382,1771.7543971110147,0.5539565163108445 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441086,4097.57293102805,1771.7543971110147,2.31272062183645 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441085,893.2540405092864,1771.7543971110147,0.5041635804408374 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441100,2225.1778334867963,1771.7543971110147,1.2559177711736595 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441098,386.7779515110968,73.62821549612136,5.253121359860633 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441081,97.64674354917992,73.62821549612136,1.3262136382257401 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441101,107.44402283711652,73.62821549612136,1.4592778340903365 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441086,30.304028749072845,73.62821549612136,0.4115817359537829 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441085,5.140398160005743,73.62821549612136,0.06981560160556292 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441100,24.232562454149623,73.62821549612136,0.3291205999067866 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441098,984.4987341393786,1923.334023596175,0.5118709085687577 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441081,1249.832390300376,1923.334023596175,0.6498259662476558 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441101,589.0825995782806,1923.334023596175,0.30628200424429497 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441086,538.5919726253378,1923.334023596175,0.28003038786694967 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441085,702.987401545404,1923.334023596175,0.3655045836661204 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441100,611.331414017621,1923.334023596175,0.31784984122236726 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441098,71.77444558801375,51.40813337414527,1.3961690665880375 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441081,36.95472117158985,51.40813337414527,0.7188496984054183 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441101,2.7311342091497655,51.40813337414527,0.0531265002226931 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441086,32.82742579007087,51.40813337414527,0.6385648269147385 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441085,68.37856848173742,51.40813337414527,1.3301118712885829 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441100,15.06988420007837,51.40813337414527,0.29314202269124745 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441098,184.1772797227245,89.1451395839603,2.066038379459368 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441081,5.187770989419618,89.1451395839603,0.05819465888584511 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441101,70.95725262206874,89.1451395839603,0.7959744407067587 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441086,60.077755124349736,89.1451395839603,0.6739319205144797 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441085,5.506954394542761,89.1451395839603,0.06177515028013502 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441100,3.937585952769539,89.1451395839603,0.044170506335468464 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441098,4051.220030910773,4771.656231796832,0.8490175809218409 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441081,4418.194781340641,4771.656231796832,0.9259247872676089 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441101,7031.459172361021,4771.656231796832,1.4735887982678981 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441086,4080.3101196401058,4771.656231796832,0.8551140152239362 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441085,14606.331124404143,4771.656231796832,3.0610610687065214 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441100,6295.7829394864375,4771.656231796832,1.3194125128992529 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441098,402727.5338184515,209884.98459768714,1.9188010737900563 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441081,531291.2931525495,209884.98459768714,2.5313449371852026 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441101,601537.0165933241,209884.98459768714,2.8660316875281264 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441086,968700.9368458492,209884.98459768714,4.6153894176978865 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441085,475353.3879225339,209884.98459768714,2.2648279905954363 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441100,515760.6703462761,209884.98459768714,2.4573490635116144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441098,70.72209012999208,22.903585106474594,3.0878174661834805 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441081,11.534970246387456,22.903585106474594,0.503631645122957 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441101,33.26244695509131,22.903585106474594,1.45228123896151 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441086,18.226492347828227,22.903585106474594,0.7957921112828662 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441085,29.99904684904713,22.903585106474594,1.3097969907150793 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441100,105.60668352006252,22.903585106474594,4.6109237060100545 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441098,13.873549475357333,83.56495705722055,0.16602114048664576 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441081,25.24556545094731,83.56495705722055,0.3021070833993318 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441101,35.18161891167086,83.56495705722055,0.4210092382095102 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441086,59.18587246206616,83.56495705722055,0.7082618665326307 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441085,48.7,83.56495705722055,0.5827801714378074 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441100,71.68419563068619,83.56495705722055,0.8578260332450229 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441098,2808.574243641269,1829.6496491832456,1.5350339038378273 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441081,1854.566463703433,1829.6496491832456,1.0136183528531324 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441101,1598.7299971158254,1829.6496491832456,0.8737902351029321 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441086,1198.8845795014413,1829.6496491832456,0.6552536328671571 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441085,2108.4774137131913,1829.6496491832456,1.1523940742723144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441100,2018.223624092314,1829.6496491832456,1.103065619690222 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441098,74139.7192925483,96234.19538703516,0.7704093019573013 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441081,125907.2051795409,96234.19538703516,1.30834164169157 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441101,53223.216813906074,96234.19538703516,0.5530593008010581 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441086,68529.78806557154,96234.19538703516,0.7121147300079572 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441085,84569.1119923479,96234.19538703516,0.8787844243122461 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441100,89183.77133703261,96234.19538703516,0.926736810947012 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441098,112.45397214023345,77.99112650544876,1.4418816239611179 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441081,56.00572077312996,77.99112650544876,0.7181037546523601 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441101,125.82716360206553,77.99112650544876,1.613352303524873 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441086,81.69622462165871,77.99112650544876,1.0475066623887155 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441085,194.16073846708824,77.99112650544876,2.4895234517932425 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441100,162.3950928153651,77.99112650544876,2.0822252490995825 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441098,131.03042584088786,110.33780757772625,1.1875387840073306 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441081,53.865236028752975,110.33780757772625,0.48818475925224636 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441101,71.41784947586304,110.33780757772625,0.6472654391429113 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441086,102.41928456405552,110.33780757772625,0.9282338195083981 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441085,62.461023883653105,110.33780757772625,0.5660890428664094 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441100,105.4017287276383,110.33780757772625,0.9552639393653822 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441098,70.14106658327519,67.31067174214355,1.0420497191288542 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441081,79.87271857585334,67.31067174214355,1.1866278631393397 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441101,72.29006162417416,67.31067174214355,1.0739762321954809 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441086,78.29434393692077,67.31067174214355,1.1631787636417283 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441085,51.76988001827533,67.31067174214355,0.7691184574208006 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441100,89.47274075357093,67.31067174214355,1.329250450750614 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441098,3063.024535199832,2375.529574917848,1.2894070305589689 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441081,4030.327986011842,2375.529574917848,1.6966018981898894 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441101,3037.700872161941,2375.529574917848,1.2787468125994568 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441086,4903.016619535376,2375.529574917848,2.063967829028159 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441085,3099.2440432829853,2375.529574917848,1.3046539500103531 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441100,3501.5230253749705,2375.529574917848,1.4739968141613484 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441098,202.7391855774772,194.62377093849457,1.0416979621751716 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441081,180.5075855845581,194.62377093849457,0.9274693667383646 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441101,292.1303351935597,194.62377093849457,1.5010002826729698 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441086,232.16959853673893,194.62377093849457,1.1929149117664033 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441085,348.6200688075485,194.62377093849457,1.7912512285959157 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441100,172.14844471407406,194.62377093849457,0.8845191103016742 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441098,3436.803482301809,3728.1507253933823,0.9218520750496665 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441081,2983.785496670661,3728.1507253933823,0.8003392878800043 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441101,3371.948850799191,3728.1507253933823,0.9044561497559608 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441086,7524.718108114009,3728.1507253933823,2.018351365694858 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441085,3228.447350388237,3728.1507253933823,0.8659648142438183 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441100,4305.85424559766,3728.1507253933823,1.1549571255983275 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441098,66.23371263657909,68.78582331086372,0.9628977229399308 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441081,135.13331566443404,68.78582331086372,1.9645518387375571 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441101,96.5744910449428,68.78582331086372,1.4039882987006462 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441086,45.75653326005827,68.78582331086372,0.6652029598202351 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441085,35.35624688783463,68.78582331086372,0.5140048513783018 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441100,103.6474713170824,68.78582331086372,1.5068144325127646 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441098,748.8190782295563,696.3940975413478,1.0752806218106923 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441081,520.2002912004131,696.3940975413478,0.7469912410760009 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441101,778.5379447291707,696.3940975413478,1.117955978486658 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441086,938.6698908003008,696.3940975413478,1.347900411727094 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441085,598.1065978970781,696.3940975413478,0.8588622448247647 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441100,764.1195630661805,696.3940975413478,1.0972516363420377 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441098,64.18143682358657,81.2393188807366,0.7900292334775496 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441081,285.61575642475196,81.2393188807366,3.5157330263200537 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441101,69.74870103941923,81.2393188807366,0.8585584172833086 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441086,36.466664887967845,81.2393188807366,0.44887950059629056 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441085,0.5143695940345118,81.2393188807366,0.006331535038958563 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441100,107.9173045246264,81.2393188807366,1.3283876085058568 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441098,313.54717454324236,543.8205698619286,0.5765636533808373 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441081,208.77454943583496,543.8205698619286,0.3839033699825681 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441101,328.9370783834316,543.8205698619286,0.6048632519857532 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441086,461.4774708713566,543.8205698619286,0.8485840669626047 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441085,217.77658363499893,543.8205698619286,0.400456686826485 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441100,258.70783516272394,543.8205698619286,0.4757227833960155 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441098,255819.88297488325,306516.0644612488,0.8346051402706339 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441081,215787.67736552592,306516.0644612488,0.704001200540035 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441101,258397.17228042617,306516.0644612488,0.8430134738112363 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441086,206369.35120479637,306516.0644612488,0.6732741775460404 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441085,692387.0075240906,306516.0644612488,2.258893049344973 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441100,386293.393540985,306516.0644612488,1.2602712820939994 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441098,373265.8722297904,335923.8645439917,1.1111621162625334 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441081,400611.4689073415,335923.8645439917,1.192566266320976 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441101,543434.7534084468,335923.8645439917,1.6177319052522392 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441086,408423.37389938417,335923.8645439917,1.2158212529907892 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441085,458345.63264417864,335923.8645439917,1.3644330785083443 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441100,682671.037918902,335923.8645439917,2.0322195294032204 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441098,49.40677076924173,33.931355493730415,1.4560800784504688 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441081,24.54305383604876,33.931355493730415,0.7233148655255945 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441101,83.77048673489665,33.931355493730415,2.468822288881891 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441086,108.65127309289824,33.931355493730415,3.202090559364008 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441085,641.0191141142608,33.931355493730415,18.891644757095058 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441100,229.28426713549436,33.931355493730415,6.757297602739738 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441098,39.963823121672355,76.3332642617619,0.5235440080831403 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441081,90.72715932296462,76.3332642617619,1.188566481473178 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441101,17.190449123765838,76.3332642617619,0.22520259404623885 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441086,102.54031688460525,76.3332642617619,1.343324144149976 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441085,50.21461821859534,76.3332642617619,0.6578340216972702 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441100,101.26398597930894,76.3332642617619,1.3266036368110061 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441098,145.05093232502668,130.67426801703346,1.1100190919463901 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441081,136.92655052514036,130.67426801703346,1.047846317434829 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441101,144.6311808422269,130.67426801703346,1.1068068950145118 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441086,225.3730644861455,130.67426801703346,1.7246935292323047 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441085,218.74075793996107,130.67426801703346,1.6739390337464763 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441100,307.0840443753638,130.67426801703346,2.349996284925317 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441098,7593.551416964346,5444.214081294075,1.3947929496481848 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441081,6598.054097738392,5444.214081294075,1.2119387664068588 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441101,6613.043822874075,5444.214081294075,1.2146920977255493 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441086,7464.497584791703,5444.214081294075,1.371088181568608 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441085,6604.687688752927,5444.214081294075,1.2131572326382527 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441100,7913.921570468055,5444.214081294075,1.4536389370983251 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441098,39.14816772255159,100.67607722942154,0.38885273244546864 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441081,41.51872860225276,100.67607722942154,0.41239914927991794 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441101,84.45199846238252,100.67607722942154,0.8388487194423812 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441086,126.9969897436468,100.67607722942154,1.2614415781640451 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441085,118.30861108671505,100.67607722942154,1.1751412484726866 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441100,166.06303609500745,100.67607722942154,1.6494786116525133 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441098,532.8425334935401,599.1099853739104,0.8893901729262415 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441081,516.5415476377816,599.1099853739104,0.8621815029762907 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441101,548.92296865269725,599.1099853739104,0.9162307123125466 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441086,753.8405089082321,599.1099853739104,1.2582673086941671 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441085,533.9612013933867,599.1099853739104,0.8912573891756057 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441100,599.8717985133416,599.1099853739104,1.0012715747659517 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441098,129.31500738552523,114.30018844822946,1.1313630287153595 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441081,88.31496227420918,114.30018844822946,0.7726580635884962 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441101,183.21281999803492,114.30018844822946,1.6029091682645684 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441086,172.69161943611573,114.30018844822946,1.5108603212350238 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441085,200.39661800373275,114.30018844822946,1.75324836051779 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441100,201.77476098600405,114.30018844822946,1.7653055845782344 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441098,2416.2310713895977,1759.6959467320276,1.3730957759360853 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441081,2104.1299342082857,1759.6959467320276,1.1957349439350102 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441101,2155.1392973844772,1759.6959467320276,1.2247225444752752 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441086,4522.866263881438,1759.6959467320276,2.5702544080305225 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441085,2171.1358133872486,1759.6959467320276,1.2338130444747093 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441100,2666.359943983345,1759.6959467320276,1.5152390098613937 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441098,262.11574001845327,38.77498679262034,6.759918228220755 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441081,108.43519677979928,38.77498679262034,2.796524402696552 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441101,12.66435788565384,38.77498679262034,0.32661153318726915 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441086,150.83814937473718,38.77498679262034,3.890088994264847 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441085,81.81088004224816,38.77498679262034,2.109888018267963 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441100,1280.4282358905432,38.77498679262034,33.02201604190448 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441098,1211.0126706652966,2284.874121495706,0.5300128612216735 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441081,1578.4044448758286,2284.874121495706,0.6908058654200986 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441101,1276.7043007742532,2284.874121495706,0.5587635173260693 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441086,2691.3018442624875,2284.874121495706,1.177877511475656 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441085,1237.9807908428422,2284.874121495706,0.541815752209774 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441100,1232.3015081204285,2284.874121495706,0.5393301523822018 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441098,313.71908445568204,306.4947439651267,1.023570846263443 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441081,386.08939100425823,306.4947439651267,1.2596933507224772 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441101,263.37179022348005,306.4947439651267,0.8593027952657053 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441086,266.67421683753935,306.4947439651267,0.8700776182572378 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441085,381.1609215354812,306.4947439651267,1.243613239836994 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441100,325.4395995027824,306.4947439651267,1.0618113553680102 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441098,51922.32619742227,53872.22448470133,0.9638051276714442 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441081,43716.52574224348,53872.22448470133,0.8114854391182256 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441101,41650.61162427122,53872.22448470133,0.7731370297526733 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441086,74075.60200863848,53872.22448470133,1.3750240075880757 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441085,36167.67133503125,53872.22448470133,0.6713602729603669 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441100,50650.99279958142,53872.22448470133,0.940206076212155 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441098,125.91311022094008,320.29657233769314,0.39311413575849363 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441081,26.55030855922664,320.29657233769314,0.0828928900657553 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441101,75.22008763267836,320.29657233769314,0.23484512208070954 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441086,60.13703673885057,320.29657233769314,0.18775423133609825 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441085,258.9277857378176,320.29657233769314,0.8084001144565057 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441100,1536.4811782951465,320.29657233769314,4.797057823882089 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441098,12589.777034511646,6299.521117687065,1.9985292213980408 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441081,6957.602468327843,6299.521117687065,1.10446529797211 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441101,2891.7022663388016,6299.521117687065,0.45903525241304693 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441086,10621.807231179992,6299.521117687065,1.6861293156645372 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441085,3931.280257820747,6299.521117687065,0.6240601760636938 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441100,5633.565076767589,6299.521117687065,0.8942846561701837 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441098,1937.8969542087111,1965.7827420843205,0.9858144100674919 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441081,1395.2073410976673,1965.7827420843205,0.7097464593764458 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441101,1682.5090776314248,1965.7827420843205,0.8558977762962043 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441086,1380.2370291855902,1965.7827420843205,0.7021310135839957 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441085,1921.364349045897,1965.7827420843205,0.9774042206763263 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441100,2652.333243325011,1965.7827420843205,1.3492504469302344 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441098,11323.798394920712,6243.797224888628,1.8136076472474965 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441081,7630.244486832409,6243.797224888628,1.2220519360265598 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441101,3590.4080729123634,6243.797224888628,0.5750359826870268 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441086,11392.765027125648,6243.797224888628,1.8246532705630687 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441085,4856.152184321279,6243.797224888628,0.7777562290082056 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441100,6054.504693181058,6243.797224888628,0.9696831071077991 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441098,471.9263413961715,477.14850073021523,0.9890554841395249 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441081,350.3428868281902,477.14850073021523,0.7342428746858366 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441101,408.38856799251306,477.14850073021523,0.8558940610051717 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441086,359.1104767884623,477.14850073021523,0.7526178458884168 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441085,512.78267872378035,477.14850073021523,1.074681525644598 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441100,620.9521112064451,477.14850073021523,1.3013812476747946 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441098,422.2350288975344,205.1372392304115,2.0583051155488996 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441081,360.37617671382,205.1372392304115,1.7567564917310947 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441101,406.550739600746,205.1372392304115,1.98184757251269 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441086,602.8656474632571,205.1372392304115,2.9388406011748773 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441085,355.64936325158044,205.1372392304115,1.7337142909099637 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441100,334.09998670366394,205.1372392304115,1.6286657067096464 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441098,56.382624907826326,44.32085041603382,1.2721467295543805 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441081,35.060247752353654,44.32085041603382,0.7910553931896129 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441101,62.6384088176478,44.32085041603382,1.4132943801770395 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441086,8.785006062805415,44.32085041603382,0.19821384247688736 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441085,41.093389504806765,44.32085041603382,0.9271796258210003 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441100,61.21659707611861,44.32085041603382,1.3812144058944424 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441098,48.274903892636225,73.02499011367847,0.6610737477332947 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441081,218.08941348392273,73.02499011367847,2.986503841279835 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441101,3.2726176009077768,73.02499011367847,0.04481503654862906 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441086,521.3766774861889,73.02499011367847,7.139702130387946 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441085,197.86310953707655,73.02499011367847,2.7095260023871526 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441100,23.14541799179734,73.02499011367847,0.3169520181483999 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441098,114.82669076531666,446.9213615105917,0.2569281772014725 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441081,594.6023268126751,446.9213615105917,1.3304406054857674 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441101,85.04142296491065,446.9213615105917,0.19028274387572597 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441086,5281.505149256607,446.9213615105917,11.817526759976632 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441085,1435.6786904978524,446.9213615105917,3.2123742880520783 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441100,1740.6845883505218,446.9213615105917,3.8948341660533248 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441098,3532.5320479387747,2631.000022355788,1.3426575514719143 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441081,3015.37781193514,2631.000022355788,1.1460956998530092 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441101,2703.348740843502,2631.000022355788,1.0274985624754702 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441086,7007.841728077675,2631.000022355788,2.663565818522068 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441085,2591.6283758248933,2631.000022355788,0.9850354822514819 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441100,2524.175384313933,2631.000022355788,0.9593977053842042 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441098,20.983895050172716,48.89133349009634,0.42919457401224925 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441081,39.9494072660114,48.89133349009634,0.8171061088792707 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441101,42.602529316160734,48.89133349009634,0.8713718009918977 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441086,24.581045257909583,48.89133349009634,0.5027689674876393 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441085,147.44779995402152,48.89133349009634,3.015826925315695 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441100,146.35540465460974,48.89133349009634,2.9934835932477926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441098,369.9578803635985,307.70649021557807,1.2023076929719856 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441081,144.3675695302653,307.70649021557807,0.4691729752892827 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441101,229.95939427886324,307.70649021557807,0.7473335844094627 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441086,189.4269094377952,307.70649021557807,0.6156090802799882 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441085,140.8696865116468,307.70649021557807,0.45780537944764826 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441100,135.2697459230578,307.70649021557807,0.43960641138342027 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441098,111.21435245502444,154.19153082843468,0.7212740664645846 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441081,140.83347246566328,154.19153082843468,0.9133671071880426 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441101,113.60864569715572,154.19153082843468,0.7368021128447412 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441086,80.3411341141981,154.19153082843468,0.5210476456297188 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441085,79.0181221626433,154.19153082843468,0.512467330326754 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441100,98.6181695054546,154.19153082843468,0.6395822713193291 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441098,6876.065209533997,6593.957266089812,1.0427827982590907 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441081,7329.706540300226,6593.957266089812,1.1115793209631628 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441101,6702.5038064099035,6593.957266089812,1.0164615171041984 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441086,8099.780621964589,6593.957266089812,1.2283641363007685 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441085,6559.54223586577,6593.957266089812,0.9947808229815159 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441100,7721.05,6593.957266089812,1.170928122283472 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441098,133.98669116501867,127.96554716912783,1.0470528523426144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441081,171.08873788347523,127.96554716912783,1.3369906327783125 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441101,190.9132193514497,127.96554716912783,1.4919110930626196 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441086,163.28577976082187,127.96554716912783,1.2760136097024026 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441085,161.9838935150464,127.96554716912783,1.265839885019658 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441100,215.1497346429373,127.96554716912783,1.6813098478653867 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441098,1568.7520959592598,1681.9358703135756,0.9327062485841305 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441081,1742.897534536385,1681.9358703135756,1.0362449397142852 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441101,1426.3281314161432,1681.9358703135756,0.848027654675218 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441086,2182.6273248472703,1681.9358703135756,1.2976876011570804 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441085,1277.6123838164067,1681.9358703135756,0.7596082623401165 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441100,1737.4843387193512,1681.9358703135756,1.033026507958011 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441098,44.43809902319962,45.403354316773296,0.9787404409189855 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441081,49.15705093352436,45.403354316773296,1.0826744339319516 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441101,43.514270335334096,45.403354316773296,0.958393294727537 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441086,38.26392032677759,45.403354316773296,0.8427553625182667 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441085,50.439228102970645,45.403354316773296,1.1109141353535845 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441100,43.5552185956089,45.403354316773296,0.959295172152476 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441098,156.71266879786222,171.72890790902974,0.9125584661662083 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441081,189.4346960442521,171.72890790902974,1.1031031312713038 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441101,168.44583104843463,171.72890790902974,0.9808822119666989 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441086,198.1446958784167,171.72890790902974,1.15382260500591 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441085,144.17726519537388,171.72890790902974,0.8395631635399973 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441100,168.8696097698823,171.72890790902974,0.9833499311562494 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441098,751.6490661471462,385.5886159476326,1.949354921435826 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441081,1430.115544804306,385.5886159476326,3.7089153716056082 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441101,12.18317948472548,385.5886159476326,0.03159631529780458 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441086,52.796917825224455,385.5886159476326,0.13692550983505924 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441085,312.5188353555208,385.5886159476326,0.8104980863801344 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441100,79.14115941018312,385.5886159476326,0.20524765549855187 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441098,446.900972352323,430.1288265554666,1.0389933079611755 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441081,377.1368885822297,430.1288265554666,0.8767998452984331 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441101,445.5886749884375,430.1288265554666,1.0359423676780177 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441086,744.032437748621,430.1288265554666,1.7297897555644888 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441085,325.2809304700076,430.1288265554666,0.7562407129856977 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441100,419.3750939144128,430.1288265554666,0.9749988097120315 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441098,39771.76533495034,54695.927744901994,0.7271430794709816 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441081,35382.43917195034,54695.927744901994,0.6468934823991208 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441101,50316.72750744652,54695.927744901994,0.919935534179441 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441086,37191.30697347574,54695.927744901994,0.6799648256618557 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441085,115348.3399315216,54695.927744901994,2.108901790083866 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441100,46811.838361763184,54695.927744901994,0.8558560077834376 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441098,244600.64244041548,97212.60478924697,2.516141224388544 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441081,197238.3363985073,97212.60478924697,2.0289378813180874 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441101,107409.39747876748,97212.60478924697,1.104891672346675 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441086,162638.26357450002,97212.60478924697,1.6730162094421115 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441085,171165.8985938264,97212.60478924697,1.7607377043841919 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441100,203314.14162812245,97212.60478924697,2.0914380606187786 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441098,48470.90074042652,62941.57202670208,0.7700935832975926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441081,47243.31681469637,62941.57202670208,0.7505900360202961 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441101,64030.10106662393,62941.57202670208,1.017294277929062 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441086,42501.891886924066,62941.57202670208,0.675259459183721 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441085,156885.24445141642,62941.57202670208,2.492553639824249 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441100,72923.07686075688,62941.57202670208,1.1585836596172125 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441098,41178.02691154645,14728.399701289269,2.7958249196578957 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441081,31077.027037633343,14728.399701289269,2.1100070386406595 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441101,17655.523605411574,14728.399701289269,1.1987401186475184 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441086,26018.319582454344,14728.399701289269,1.76654084015501 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441085,26510.183253275576,14728.399701289269,1.7999364351141947 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441100,31399.5895704674,14728.399701289269,2.1319077569383724 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441098,1570.0214527910664,3575.9352491809864,0.43905198035972715 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441081,3311.560126085152,3575.9352491809864,0.9260682577637878 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441101,6689.560555792269,3575.9352491809864,1.8707163552036943 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441086,1082.2595655864193,3575.9352491809864,0.3026507725033037 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441085,6180.626958357211,3575.9352491809864,1.7283945395187985 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441100,2601.957746853652,3575.9352491809864,0.7276299948243166 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441098,14244.267612976684,12966.336321671553,1.0985576233410848 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441081,9864.53551355212,12966.336321671553,0.7607804755970139 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441101,13044.720634288338,12966.336321671553,1.0060452166805034 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441086,10094.707988392993,12966.336321671553,0.7785320184484953 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441085,10270.38467156162,12966.336321671553,0.7920806939425133 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441100,6804.936810528293,12966.336321671553,0.5248156951747983 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441098,46.613250346240896,103.34580193186551,0.45104154668007107 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441081,80.28130812114567,103.34580193186551,0.7768221506866244 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441101,178.27302153151467,103.34580193186551,1.7250146420949704 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441086,87.19318153388978,103.34580193186551,0.8437031781065967 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441085,53.21974738317388,103.34580193186551,0.5149676753997317 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441100,88.46908009233938,103.34580193186551,0.8560490938051442 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441098,409.18917792506534,211.8154700640626,1.9318191338966317 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441081,281.9084730388388,211.8154700640626,1.3309154093115905 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441101,182.2975005499679,211.8154700640626,0.8606429950316324 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441086,182.18755485292013,211.8154700640626,0.8601239314475867 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441085,155.8214556351012,211.8154700640626,0.7356471913405273 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441100,162.24542423837121,211.8154700640626,0.7659753283804098 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441098,19.611606605617855,76.10596635595309,0.25768816223806895 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441081,73.43205125077522,76.10596635595309,0.9648658937898276 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441101,13.968743811499744,76.10596635595309,0.18354334726093513 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441086,34.81669911518842,76.10596635595309,0.4574766050843926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441085,13.983269146165648,76.10596635595309,0.1837342039750851 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441100,13.025973481333352,76.10596635595309,0.17115574645501427 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441098,1748.3885856677314,1382.686999693948,1.2644861679141626 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441081,2919.815525131163,1382.686999693948,2.111696664377008 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441101,1211.792693493578,1382.686999693948,0.8764041997659653 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441086,5542.2893296336515,1382.686999693948,4.008347030716578 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441085,1935.077524721749,1382.686999693948,1.3995051122561144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441100,4618.152908124808,1382.686999693948,3.339984327000266 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441098,31.18165375085471,30.899530320120164,1.0091303468956239 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441081,34.5607598582222,30.899530320120164,1.1184881938389217 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441101,30.167948333018444,30.899530320120164,0.9763238476597377 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441086,30.08682931778291,30.899530320120164,0.9736985969068901 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441085,30.62949907030873,30.899530320120164,0.9912609917686805 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441100,31.119112474915916,30.899530320120164,1.0071063266179412 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441098,31.16995054260333,31.68183515511672,0.9838429620630509 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441081,34.006033574400774,31.68183515511672,1.0733605994698414 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441101,30.130080593921008,31.68183515511672,0.9510206857147574 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441086,33.05728355061766,31.68183515511672,1.0434144167712078 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441085,30.076859079580515,31.68183515511672,0.9493408109827566 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441100,35.667301098386915,31.68183515511672,1.1257965620917174 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441098,1333.8059363119808,628.1906149122311,2.1232503393867734 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441081,497.8237701615772,628.1906149122311,0.7924724730743258 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441101,2541.8448954198307,628.1906149122311,4.046295559151213 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441086,1124.2798214499476,628.1906149122311,1.789711267187633 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441085,2613.0095635426287,628.1906149122311,4.15958070928473 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441100,1967.8123969330777,628.1906149122311,3.1325084301172095 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441098,11877.589511577851,10551.186365326936,1.125711280260361 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441081,8699.617207253443,10551.186365326936,0.8245155479237788 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441101,12511.52178373704,10551.186365326936,1.1857928910110158 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441086,20021.460176790544,10551.186365326936,1.897555353830599 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441085,9337.668884128703,10551.186365326936,0.88498757967293 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441100,12308.810302202008,10551.186365326936,1.166580693015805 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441098,129.9735163375764,102.14043933131707,1.272498113269085 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441081,207.9233637954832,102.14043933131707,2.0356615377483718 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441101,122.6392501734751,102.14043933131707,1.200692409160932 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441086,145.71617388250615,102.14043933131707,1.4266256816248921 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441085,101.17087210124568,102.14043933131707,0.9905075087162454 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441100,140.25738342916583,102.14043933131707,1.3731817128200055 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441098,3089.882056566043,2995.2816068385046,1.0315831571601004 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441081,3024.7574775834746,2995.2816068385046,1.0098407677854644 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441101,4197.17699030845,2995.2816068385046,1.4012628998642087 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441086,7021.227309761792,2995.2816068385046,2.344095891929387 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441085,2730.730260587363,2995.2816068385046,0.9116773041816347 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441100,3249.5631441472815,2995.2816068385046,1.0848940335787556 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441098,36.06876714852007,35.73806763844074,1.0092534244835225 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441081,40.07545385345981,35.73806763844074,1.1213659971462384 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441101,36.309310799210486,35.73806763844074,1.0159841647441314 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441086,44.42051008447939,35.73806763844074,1.2429466118279882 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441085,44.062446582339554,35.73806763844074,1.2329275054296698 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441100,51.32953965651826,35.73806763844074,1.436270706514276 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441098,222.84842493868877,271.6614200921023,0.8203167930990559 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441081,250.85547282964663,271.6614200921023,0.9234122119533876 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441101,237.2247999559022,271.6614200921023,0.8732369869651535 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441086,298.28663216307314,271.6614200921023,1.0980088083981303 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441085,243.6071691604284,271.6614200921023,0.8967308242658728 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441100,323.4555022617733,271.6614200921023,1.1906567452681027 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441098,158.23871008284632,166.02715311669658,0.953089341787509 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441081,186.3480687544807,166.02715311669658,1.1223951339062053 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441101,159.5332254622025,166.02715311669658,0.9608863518250557 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441086,195.46398439657665,166.02715311669658,1.1773013072096081 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441085,277.3598738987215,166.02715311669658,1.6705693538199247 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441100,216.73701848288388,166.02715311669658,1.3054311563756353 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441098,1524.745039086265,1793.9624976146763,0.8499313899335279 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441081,1805.220411281379,1793.9624976146763,1.0062754453795282 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441101,1904.9680312322548,1793.9624976146763,1.061877287716536 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441086,2842.986614308724,1793.9624976146763,1.5847525341744164 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441085,1543.356099989688,1793.9624976146763,0.8603056652754979 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441100,2159.855099234477,1793.9624976146763,1.203957776211212 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441098,102.56670642894947,59.13775760336051,1.7343692183404855 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441081,55.09831464231404,59.13775760336051,0.9316943501960424 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441101,124.19647656760556,59.13775760336051,2.100121506138205 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441086,100.51774182037973,59.13775760336051,1.6997219017764682 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441085,444.0513979394634,59.13775760336051,7.508762860400208 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441100,122.96575228882828,59.13775760336051,2.0793103640074566 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441098,92.24421429665465,238.79765196261823,0.3862861026418078 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441081,302.61771248645226,238.79765196261823,1.2672558126066689 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441101,396.9997290158978,238.79765196261823,1.6624942739304855 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441086,298.2846225294175,238.79765196261823,1.2491103663620255 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441085,166.86614296755977,238.79765196261823,0.6987763137372944 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441100,221.56673589357288,238.79765196261823,0.9278430255598045 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441098,690.987798565531,386.8144501381946,1.7863546677707267 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441081,330.7263000695193,386.8144501381946,0.8549998583335315 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441101,1267.7571301941696,386.8144501381946,3.2774296041454667 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441086,524.2994214281001,386.8144501381946,1.3554287365448399 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441085,2042.2240657548573,386.8144501381946,5.279596108742178 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441100,953.8118915650537,386.8144501381946,2.465812461825797 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441098,4896.234547399566,5555.372966797932,0.8813511849991436 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441081,5351.48400289377,5555.372966797932,0.9632987802758305 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441101,5233.835982808836,5555.372966797932,0.9421214406465985 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441086,8426.79,5555.372966797932,1.5168720534810696 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441085,4396.696563249319,5555.372966797932,0.7914313925503252 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441100,5021.58534913984,5555.372966797932,0.9039150708965338 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441098,43.7084117440164,84.54153084580483,0.51700520805255 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441081,25.227840702582412,84.54153084580483,0.2984076636676409 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441101,18.752297775244376,84.54153084580483,0.221811665670529 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441086,12.149435440581836,84.54153084580483,0.14370966930728016 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441085,54.84243699202744,84.54153084580483,0.6487040918629031 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441100,20.890733539328696,84.54153084580483,0.24710616581371436 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441098,161.4389899078241,122.00200397429413,1.3232486733729338 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441081,103.06677593908682,122.00200397429413,0.8447957622138981 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441101,24.837065431659187,122.00200397429413,0.20357915954308725 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441086,327.8031905179708,122.00200397429413,2.686867263156096 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441085,19.104018145192093,122.00200397429413,0.15658774055233812 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441100,29.970292903275347,122.00200397429413,0.24565410343251493 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441098,141.60912188853175,143.84455848940917,0.9844593592948321 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441081,282.23480085477155,143.84455848940917,1.9620818737856645 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441101,282.6471193883544,143.84455848940917,1.9649482911038643 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441086,117.89623263756148,143.84455848940917,0.8196085682743558 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441085,118.46724045260802,143.84455848940917,0.8235781853460269 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441100,96.81571231554857,143.84455848940917,0.6730578711649826 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441098,1192.609425532951,5334.764851653101,0.2235542631580834 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441081,3612.568644640177,5334.764851653101,0.6771748605790447 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441101,4165.150332236814,5334.764851653101,0.7807561247889203 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441086,2967.164765021595,5334.764851653101,0.556194105556902 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441085,5017.9010429173695,5334.764851653101,0.9406039783295146 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441100,4068.5622862712858,5334.764851653101,0.762650725834813 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441098,137.58969836899993,159.70733471984832,0.8615114553777622 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441081,146.4427559588083,159.70733471984832,0.916944461039888 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441101,156.89709581816635,159.70733471984832,0.9824038206722843 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441086,96.78793419379204,159.70733471984832,0.6060331190397312 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441085,206.9140847690633,159.70733471984832,1.295582855552771 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441100,210.47879979301183,159.70733471984832,1.3179031518009152 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441098,91135.30664536556,82077.5827732141,1.1103556362908318 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441081,54909.75301643186,82077.5827732141,0.6689981741805336 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441101,36669.14487427835,82077.5827732141,0.4467619980427258 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441086,122529.70568531736,82077.5827732141,1.4928522691009942 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441085,46606.12411246764,82077.5827732141,0.5678301253247614 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441100,50757.54245263678,82077.5827732141,0.6184093236868743 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441098,517592.0453082569,170961.68742491837,3.027532385205129 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441081,746854.7589172302,170961.68742491837,4.368550463946655 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441101,506573.91203051055,170961.68742491837,2.963084417688517 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441086,66711.48873960001,170961.68742491837,0.39021309244445684 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441085,154310.3831558979,170961.68742491837,0.9026021296360142 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441100,224918.376160679,170961.68742491837,1.315606903210153 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441098,126338.53030038248,55195.40432138408,2.2889320560957604 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441081,108560.35073359168,55195.40432138408,1.9668367696245443 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441101,96712.92472570312,55195.40432138408,1.7521916165805516 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441086,75022.93384346103,55195.40432138408,1.359224282634619 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441085,103026.0125281295,55195.40432138408,1.8665686717003476 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441100,153191.7448710797,55195.40432138408,2.7754438391119707 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441098,524.4456643688824,546.121028905539,0.9603103279503896 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441081,483.1132570786084,546.121028905539,0.8846267246782236 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441101,934.8889420873056,546.121028905539,1.7118713482996288 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441086,643.260819714889,546.121028905539,1.1778722767808891 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441085,689.4547745946585,546.121028905539,1.2624578401171795 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441100,857.7408115190784,546.121028905539,1.5706057194648686 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441098,855.3170637583073,1228.731327313693,0.6960977104964349 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441081,2163.782599460475,1228.731327313693,1.7609892019201892 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441101,931.1189593944116,1228.731327313693,0.7577888987579288 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441086,1374.4105829264756,1228.731327313693,1.1185607075968942 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441085,1463.7845869145283,1228.731327313693,1.1912975232060854 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441100,1921.4841479664856,1228.731327313693,1.5637951969266701 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441098,208.91251610516952,76.68368758811918,2.7243410257899088 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441081,96.75103472771988,76.68368758811918,1.261689907863922 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441101,305.0981626246876,76.68368758811918,3.978657941744018 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441086,136.65746608344386,76.68368758811918,1.7820930419707226 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441085,353.4431844680716,76.68368758811918,4.609105216307197 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441100,220.8956019847985,76.68368758811918,2.8806074529339987 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441098,308.81906471999775,81.06808963980528,3.8093788331773437 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441081,67.54234847577915,81.06808963980528,0.8331557925674266 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441101,8.167035279699393,81.06808963980528,0.1007429102620582 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441086,289.06813633899236,81.06808963980528,3.5657450129064947 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441085,113.8197834991631,81.06808963980528,1.4040022899870628 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441100,270.9848290348161,81.06808963980528,3.342681815234976 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441098,40.578971406409806,34.254424530644805,1.184634451240216 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441081,72.42919414597118,34.254424530644805,2.1144478454505737 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441101,44.698242964241054,34.254424530644805,1.3048896186900751 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441086,42.73323438260434,34.254424530644805,1.2475245159752777 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441085,323.5934588568014,34.254424530644805,9.44676383534942 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441100,125.32126645666143,34.254424530644805,3.6585424561590902 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441098,53.22620334478819,60.87738129746832,0.8743182149164107 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441081,76.62595456619734,60.87738129746832,1.2586933427996179 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441101,67.34378549955584,60.87738129746832,1.1062201439068213 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441086,29.348241231452707,60.87738129746832,0.482087773914697 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441085,38.361351666565966,60.87738129746832,0.6301412913791231 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441100,36.4356395208766,60.87738129746832,0.5985086536958486 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441098,115.91712171751752,81.37032235510941,1.4245626459686607 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441081,97.76795637785398,81.37032235510941,1.2015186071302928 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441101,121.22862655809212,81.37032235510941,1.489838347070035 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441086,211.72355585925965,81.37032235510941,2.601975139477435 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441085,151.24240196977718,81.37032235510941,1.8586924273169032 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441100,206.89868575045895,81.37032235510941,2.542679932463944 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441098,790.0039121739048,592.3362991324378,1.3337084243038622 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441081,603.5123564603377,592.3362991324378,1.0188677569554134 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441101,515.9099740467602,592.3362991324378,0.8709747736250252 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441086,996.2717625535016,592.3362991324378,1.681936028591673 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441085,591.9371849350065,592.3362991324378,0.9993262033780204 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441100,1050.593740692811,592.3362991324378,1.7736440299734415 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441098,843.567164424122,1509.2244087879828,0.5589408437288447 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441081,785.3393699985602,1509.2244087879828,0.5203595737159095 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441101,1303.753832671509,1509.2244087879828,0.8638568426802202 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441086,852.2491001151639,1509.2244087879828,0.5646934247502543 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441085,1883.8501949247816,1509.2244087879828,1.2482240440556156 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441100,547.5791269146226,1509.2244087879828,0.3628215417973319 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441098,926433.103825702,911297.6405793307,1.016608693551263 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441081,1275221.3395349982,911297.6405793307,1.3993466928371652 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441101,933808.0405055832,911297.6405793307,1.0247014794331544 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441086,1602289.163944416,911297.6405793307,1.7582500959025942 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441085,1043883.0349893846,911297.6405793307,1.1454907688839913 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441100,1179663.457963051,911297.6405793307,1.294487558656593 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441098,452.8827147818196,749.6106308195243,0.6041572733389573 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441081,545.5942958337793,749.6106308195243,0.7278369241339323 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441101,258.9404386370727,749.6106308195243,0.34543325293290167 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441086,1436.37757483092,749.6106308195243,1.916164893847058 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441085,1646.244721890449,749.6106308195243,2.1961331045834616 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441100,1529.5680108094189,749.6106308195243,2.0404833495186603 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441098,4066.595652426656,2138.7943755926544,1.9013495167340773 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441081,3680.0850309839248,2138.7943755926544,1.7206352667559184 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441101,3747.827262033691,2138.7943755926544,1.7523083587664559 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441086,5455.7759252559745,2138.7943755926544,2.550865098354391 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441085,3389.5349859132652,2138.7943755926544,1.5847876844046935 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441100,2747.5055918944126,2138.7943755926544,1.2846048331004638 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441098,798.505927903072,613.8984432679271,1.300713394307429 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441081,286.5358643868827,613.8984432679271,0.4667479898818187 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441101,1451.2692688569778,613.8984432679271,2.364021744592684 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441086,555.1743612240243,613.8984432679271,0.9043423506153551 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441085,1506.6038112007338,613.8984432679271,2.4541580577737325 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441100,916.1938403854748,613.8984432679271,1.4924192273698522 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441098,6796.970224038675,6365.76448478505,1.0677382489226956 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441081,8736.821482502592,6365.76448478505,1.3724701099741683 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441101,6698.008803528865,6365.76448478505,1.0521923673956082 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441086,8391.678597539025,6365.76448478505,1.3182515026429513 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441085,7434.305297589388,6365.76448478505,1.1678574215804371 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441100,9187.958808171386,6365.76448478505,1.4433394182476784 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441098,49.44482728983072,70.21289390855102,0.7042129235440754 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441081,78.15050677836986,70.21289390855102,1.1130506439480645 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441101,63.69903334983813,70.21289390855102,0.9072270035301937 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441086,51.53680718803905,70.21289390855102,0.7340077344648877 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441085,49.47271837919865,70.21289390855102,0.7046101595475402 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441100,69.24083945922764,70.21289390855102,0.9861556133750955 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441098,1863.444336620901,2003.7789126851078,0.9299650399673308 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441081,1969.4807335712867,2003.7789126851078,0.9828832517915558 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441101,1893.5566703306756,2003.7789126851078,0.9449928125020879 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441086,1129.4934011835633,2003.7789126851078,0.5636816487254162 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441085,2112.5700293390373,2003.7789126851078,1.0542929741226525 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441100,1266.4341906158716,2003.7789126851078,0.6320229156014133 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441098,1184.8344008574863,700.7857837159185,1.6907226550386036 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441081,440.1326623947019,700.7857837159185,0.6280559232536045 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441101,1920.1510836518712,700.7857837159185,2.7399971978173774 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441086,798.5429322741797,700.7857837159185,1.1394964778536227 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441085,2511.170893519703,700.7857837159185,3.583364491505825 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441100,1460.8608906570264,700.7857837159185,2.0846040610453134 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441098,4973.6568823223515,4688.560133729121,1.0608068875009766 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441081,6466.674690954765,4688.560133729121,1.3792453347103373 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441101,6370.682621440346,4688.560133729121,1.3587716569123585 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441086,8037.080705203491,4688.560133729121,1.7141895328131518 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441085,5637.643310930825,4688.560133729121,1.2024252969209195 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441100,6752.58059117857,4688.560133729121,1.440224802194826 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441098,492.5066413107023,384.65137963543384,1.2803974387859778 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441081,384.1572561257752,384.65137963543384,0.9987153990968991 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441101,809.4288366282858,384.65137963543384,2.1043180383115976 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441086,326.86608026352485,384.65137963543384,0.8497722810024055 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441085,417.3054304852197,384.65137963543384,1.0848925873624444 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441100,475.70790954755034,384.65137963543384,1.236724823393116 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441098,769.3621024012651,772.5530415852671,0.9958696179909483 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441081,460.60703080956745,772.5530415852671,0.5962141186635015 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441101,124.37928472262077,772.5530415852671,0.1609977283467765 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441086,408.33156966795656,772.5530415852671,0.5285482648933287 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441085,206.40428990002752,772.5530415852671,0.26717167468073005 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441100,286.47161118823954,772.5530415852671,0.37081157638109113 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441098,235.66751807650465,216.68366112664066,1.0876109294589078 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441081,215.41748535531647,216.68366112664066,0.99415657015974 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441101,200.3133747293853,216.68366112664066,0.9244507577906957 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441086,246.95098466529288,216.68366112664066,1.1396843831292036 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441085,158.67831823458707,216.68366112664066,0.7323040297987563 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441100,297.28086950267027,216.68366112664066,1.3719579407001279 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441098,886.9137298899726,615.8359185894908,1.4401786305699054 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441081,678.455627899785,615.8359185894908,1.1016824569988029 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441101,928.1644028252022,615.8359185894908,1.5071618507589941 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441086,1190.6169999917045,615.8359185894908,1.9333347796904912 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441085,1060.9828722826935,615.8359185894908,1.7228336968599791 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441100,1106.2840773568323,615.8359185894908,1.7963942082018582 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441098,54.63427363327329,101.73138829665541,0.5370444122315146 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441081,115.78033155652916,101.73138829665541,1.1380984128409426 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441101,77.55054413642534,101.73138829665541,0.762306948080595 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441086,108.8508941120173,101.73138829665541,1.0699833742030624 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441085,28.97915006870418,101.73138829665541,0.28485947703966324 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441100,23.779504134891177,101.73138829665541,0.23374795658492914 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441098,178.28951626648615,93.53234569214308,1.9061803159873372 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441081,148.07334134470744,93.53234569214308,1.5831244287626791 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441101,110.48863563197914,93.53234569214308,1.1812879791943507 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441086,83.07833028212401,93.53234569214308,0.8882310142800447 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441085,44.50463796898332,93.53234569214308,0.47582082582925966 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441100,149.457719642445,93.53234569214308,1.597925493437077 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441098,23.48043075992544,42.30806113801961,0.5549871615086858 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441081,60.131599999674336,42.30806113801961,1.4212799731831205 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441101,89.11895931771825,42.30806113801961,2.106429765878177 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441086,22.656969076600323,42.30806113801961,0.5355236913997914 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441085,31.04466568109951,42.30806113801961,0.7337766100843985 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441100,45.88881904625255,42.30806113801961,1.0846353581779984 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441098,282.229493403958,205.3077634331321,1.374665471410091 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441081,677.0324235608213,205.3077634331321,3.297646480773865 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441101,189.0959849980183,205.3077634331321,0.921036700395434 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441086,219.9391609536393,205.3077634331321,1.0712656807314185 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441085,157.6163523141877,205.3077634331321,0.7677077070956584 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441100,160.79031907209705,205.3077634331321,0.7831672625690348 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441098,744.261678614427,761.179367641068,0.9777743725778199 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441081,1144.3735534539476,761.179367641068,1.503421666565158 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441101,854.2631392021823,761.179367641068,1.1222888789663144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441086,274.31597532939895,761.179367641068,0.360382830895059 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441085,1079.5688839487325,761.179367641068,1.4182844804298482 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441100,106.03098814901674,761.179367641068,0.13929829506232144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441098,508988.4687953531,258075.7105503754,1.972244763793842 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441081,583342.8264595661,258075.7105503754,2.2603554019691434 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441101,394392.80750009377,258075.7105503754,1.5282058379651726 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441086,998473.6262202788,258075.7105503754,3.868917474220731 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441085,436671.3445144601,258075.7105503754,1.6920280625526884 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441100,565938.1185737166,258075.7105503754,2.1929150843633836 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441098,105.6213764029383,131.47736122215045,0.8033426851674894 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441081,96.58732338157732,131.47736122215045,0.7346308328958531 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441101,107.99528218083852,131.47736122215045,0.8213983090089899 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441086,131.05208273687833,131.47736122215045,0.9967653862131174 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441085,173.48412507218924,131.47736122215045,1.3194980752546603 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441100,106.20737412738112,131.47736122215045,0.807799708939458 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441098,3881.1017396430216,3004.2024881525895,1.2918908612014612 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441081,3209.5598117685213,3004.2024881525895,1.0683566851521433 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441101,6075.454044273501,3004.2024881525895,2.022318425017201 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441086,4553.558975270919,3004.2024881525895,1.515729713036452 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441085,4055.77795534453,3004.2024881525895,1.350034816673958 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441100,3078.2301567933214,3004.2024881525895,1.0246413711900806 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441098,93.0122990199426,96.13121274223809,0.9675556602967404 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441081,84.0190287107071,96.13121274223809,0.8740036281035167 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441101,103.8956769522433,96.13121274223809,1.0807694398990315 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441086,170.86968718637306,96.13121274223809,1.7774631393087212 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441085,249.91927467409596,96.13121274223809,2.5997724104887583 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441100,104.4043230477567,96.13121274223809,1.086060604766339 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441098,479.677680096443,490.807523353751,0.9773234053519466 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441081,391.5587490727873,490.807523353751,0.7977847332029794 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441101,304.2250875318109,490.807523353751,0.6198460150997722 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441086,587.879191329462,490.807523353751,1.1977795028739735 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441085,521.2625446261186,490.807523353751,1.0620508444211787 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441100,446.63341832176144,490.807523353751,0.9099970906514591 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441098,58.508407374263186,78.64120835950264,0.7439917136928542 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441081,73.55493455314968,78.64120835950264,0.9353230461172287 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441101,59.332237446702976,78.64120835950264,0.7544675200750974 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441086,67.35029183054789,78.64120835950264,0.8564249359274957 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441085,52.46441498370228,78.64120835950264,0.6671364298455966 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441100,53.49525925012285,78.64120835950264,0.6802446244922015 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441098,1895.3110422805169,1710.8868039225827,1.1077945296761313 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441081,1877.214152013036,1710.8868039225827,1.0972170383856557 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441101,1979.7462075420592,1710.8868039225827,1.1571462255732277 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441086,2781.566654999077,1710.8868039225827,1.625804026673025 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441085,1672.7315724527878,1710.8868039225827,0.9776985646377565 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441100,2043.9975728830564,1710.8868039225827,1.1947006477557396 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441098,160.78691999861172,158.21676846284709,1.0162444951994338 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441081,192.93705582872283,158.21676846284709,1.2194475825994946 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441101,255.2116104153358,158.21676846284709,1.6130503289559053 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441086,179.37613995885602,158.21676846284709,1.1337365925342966 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441085,130.89143640582338,158.21676846284709,0.8272918077994981 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441100,220.71392008487587,158.21676846284709,1.3950096581368652 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441098,825.9774215466266,1068.4447009417866,0.7730652047958722 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441081,923.8025312586668,1068.4447009417866,0.8646236257659156 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441101,982.9269940894684,1068.4447009417866,0.919960568125858 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441086,1286.7270017302462,1068.4447009417866,1.204299109346561 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441085,706.5143919078719,1068.4447009417866,0.6612549917511976 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441100,1177.107101710711,1068.4447009417866,1.1017014738087458 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441098,115.93218751262248,101.193417409009,1.1456494946113098 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441081,124.68175069586404,101.193417409009,1.2321132528998266 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441101,115.54112172897176,101.193417409009,1.1417849568413272 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441086,173.14068485638953,101.193417409009,1.7109876243884539 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441085,123.1599146734576,101.193417409009,1.2170743693304005 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441100,159.57944504422343,101.193417409009,1.576974561489772 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441098,7661.875381408298,8195.704907369402,0.9348647209734094 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441081,8921.313172010847,8195.704907369402,1.0885351867645934 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441101,7052.7401931338345,8195.704907369402,0.8605410117672931 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441086,11615.81627255144,8195.704907369402,1.4173053329563814 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441085,7164.622318070475,8195.704907369402,0.8741923237900135 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441100,11676.744538512015,8195.704907369402,1.4247395032503596 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441098,67.6238320465054,54.484574340672744,1.241155553931238 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441081,71.01624245123838,54.484574340672744,1.3034192394933468 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441101,26.94844378927551,54.484574340672744,0.49460685185455316 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441086,25.768992431992512,54.484574340672744,0.47295941546442355 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441085,64.75445324575507,54.484574340672744,1.1884914956088013 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441100,14.774327816287464,54.484574340672744,0.27116533431845913 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441098,127.45250710623412,181.8259570369428,0.7009588134896424 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441081,252.46991163604656,181.8259570369428,1.3885251355214951 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441101,232.43464497950237,181.8259570369428,1.278335881011076 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441086,304.97841886408946,181.8259570369428,1.6773095757836431 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441085,290.68953744773444,181.8259570369428,1.598724088600139 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441100,224.21540975088624,181.8259570369428,1.2331320203381682 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441098,654.6743449948975,598.5025834222519,1.0938538330970173 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441081,1116.290873751222,598.5025834222519,1.8651396078664266 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441101,647.2613129751059,598.5025834222519,1.0814678681486225 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441086,618.5435799813649,598.5025834222519,1.0334852298289476 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441085,696.3571303158951,598.5025834222519,1.1634989548985881 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441100,566.8687602749088,598.5025834222519,0.9471450516279143 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441098,15353.275273652203,15066.853658787537,1.0190100482390771 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441081,15602.867134023898,15066.853658787537,1.0355756740840008 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441101,17912.978990128544,15066.853658787537,1.1888997793299096 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441086,24679.73259604589,15066.853658787537,1.6380150199210155 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441085,14021.354932259026,15066.853658787537,0.9306093528081267 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441100,22560.51369497618,15066.853658787537,1.497360643827457 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441098,61.47446927495087,62.8704966822211,0.9777951904161589 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441081,67.82312959941147,62.8704966822211,1.078775151757166 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441101,60.75915546189519,62.8704966822211,0.9664176150699479 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441086,59.21397928372864,62.8704966822211,0.9418404881231601 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441085,60.06223474489287,62.8704966822211,0.9553325950083933 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441100,60.96760347236629,62.8704966822211,0.969733129046634 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441098,96.24334935296318,100.49015468400951,0.9577390905168732 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441081,105.78618918123858,100.49015468400951,1.0527020235353644 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441101,96.29943428969342,100.49015468400951,0.9582972042635045 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441086,105.68604833153888,100.49015468400951,1.0517054995473718 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441085,96.86944835819654,100.49015468400951,0.9639695417207959 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441100,111.96370843408651,100.49015468400951,1.1141758989838906 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441098,105.44416538596472,109.95671552102958,0.9589606681712695 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441081,112.2597365468918,109.95671552102958,1.0209447964587643 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441101,118.26138706513755,109.95671552102958,1.0755267334492151 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441086,100.59390079437698,109.95671552102958,0.914849996361869 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441085,114.99127003114111,109.95671552102958,1.045786694211948 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441100,111.62642303246102,109.95671552102958,1.01518513447332 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441098,236.91888325944544,243.54938966397899,0.9727755162364334 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441081,258.48095998688456,243.54938966397899,1.0613081820632209 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441101,233.6599451473821,243.54938966397899,0.9593945009254953 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441086,263.0546150066437,243.54938966397899,1.0800873505352477 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441085,230.6994237964624,243.54938966397899,0.9472387679343173 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441100,272.7788759948579,243.54938966397899,1.1200146153977488 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441098,64.43965734912149,49.66723175069083,1.297428003891624 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441081,50.86965955269521,49.66723175069083,1.024209680298674 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441101,113.62546836249628,49.66723175069083,2.2877350791936544 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441086,49.46250425724836,49.66723175069083,0.9958780168286786 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441085,126.03522192054255,49.66723175069083,2.537593046320515 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441100,86.27015719753979,49.66723175069083,1.736963268470058 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441098,325.29606216686454,318.9289567276793,1.0199640242909078 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441081,269.4189364070726,318.9289567276793,0.8447616019925047 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441101,325.4033413104386,318.9289567276793,1.02030039745901 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441086,240.41376089623455,318.9289567276793,0.7538160327709418 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441085,375.01572924370595,318.9289567276793,1.1758597685562835 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441100,253.00795105338764,318.9289567276793,0.7933050471469765 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441098,47.518423037602155,52.85511393128503,0.8990317020105015 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441081,51.53881580816643,52.85511393128503,0.975096106597559 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441101,47.032381615860885,52.85511393128503,0.8898359707824286 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441086,55.058206117788615,52.85511393128503,1.0416817224037724 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441085,56.8433386725808,52.85511393128503,1.0754557968880876 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441100,41.75189064537223,52.85511393128503,0.789930955397283 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441098,155.0725900913595,145.91831693350866,1.0627355999591348 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441081,169.57766459097544,145.91831693350866,1.1621410399644876 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441101,147.23978119293446,145.91831693350866,1.0090561917598595 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441086,204.83167131401035,145.91831693350866,1.4037420086701455 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441085,163.7686474620672,145.91831693350866,1.1223309787536304 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441100,136.31828142343952,145.91831693350866,0.934209524124078 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441098,268.03054590364763,261.347965154705,1.0255696681816018 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441081,198.9818773421636,261.347965154705,0.7613676166346895 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441101,573.0470432589563,261.347965154705,2.192659288239497 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441086,308.7709473529287,261.347965154705,1.181455333582382 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441085,426.5490147041391,261.347965154705,1.632111481915091 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441100,404.2584930139713,261.347965154705,1.5468208936490875 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441098,5964.637831010872,7540.877985370558,0.7909739214163628 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441081,5175.994877838707,7540.877985370558,0.6863915432500343 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441101,7184.824222918081,7540.877985370558,0.9527835136514305 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441086,7843.247540584141,7540.877985370558,1.0400973939374414 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441085,6135.347217894005,7540.877985370558,0.8136117876189869 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441100,6489.587196193958,7540.877985370558,0.8605877470480064 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441098,5354.797566056373,5107.556668860965,1.0484068828257456 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441081,5301.69135611848,5107.556668860965,1.038009306571396 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441101,6475.226672685407,5107.556668860965,1.2677738285632072 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441086,6116.754749764587,5107.556668860965,1.1975892087612772 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441085,7994.3853662011825,5107.556668860965,1.5652073749744628 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441100,7888.471385113734,5107.556668860965,1.5444706532982901 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441098,293832.35888772813,180330.65339424144,1.629408829597859 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441081,163410.07341870485,180330.65339424144,0.9061691417568117 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441101,180037.7175119067,180330.65339424144,0.9983755624636134 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441086,580863.9825766833,180330.65339424144,3.2211050736160214 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441085,131119.4711688796,180330.65339424144,0.7271058397499639 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441100,283250.89793262054,180330.65339424144,1.5707307249276883 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441098,144.22873487432554,98.01831453553807,1.4714467960172195 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441081,93.40549438528528,98.01831453553807,0.9529392014940193 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441101,286.8634534222705,98.01831453553807,2.926631158488893 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441086,177.26902819911606,98.01831453553807,1.8085296512096667 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441085,203.89896432815112,98.01831453553807,2.080212920354026 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441100,163.3996457472483,98.01831453553807,1.667031784024456 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441098,1174.6460061146388,1812.4793707702274,0.6480879314038558 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441081,1301.9931037733604,1812.4793707702274,0.7183491987663662 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441101,1101.236164389412,1812.4793707702274,0.6075854887779677 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441086,3028.803723368811,1812.4793707702274,1.6710831429114126 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441085,1264.6228850968196,1812.4793707702274,0.697730912412762 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441100,2518.63989515009,1812.4793707702274,1.3896102409594733 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441098,555.1820615741028,434.5650550234931,1.2775579977181761 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441081,246.72253048811675,434.5650550234931,0.5677459050976352 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441101,838.1840557150103,434.5650550234931,1.9287884426641189 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441086,593.1543139043467,434.5650550234931,1.3649379006608806 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441085,1651.1500612204525,434.5650550234931,3.7995463328987404 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441100,512.3866252412291,434.5650550234931,1.1790792179861975 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441098,8156.509789269178,9833.502392298877,0.8294613113286028 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441081,14015.344594753553,9833.502392298877,1.4252647770472597 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441101,7911.241806559845,9833.502392298877,0.8045192334275066 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441086,10913.063850468592,9833.502392298877,1.1097840235453826 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441085,6944.462482785098,9833.502392298877,0.7062043822985862 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441100,11718.518514687434,9833.502392298877,1.1916932591448608 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441098,41.469629859154274,42.4088060383901,0.9778542178625438 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441081,45.569341172002595,42.4088060383901,1.0745254448038801 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441101,40.93210881402118,42.4088060383901,0.9651794671363264 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441086,34.56339698999076,42.4088060383901,0.8150051892218477 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441085,35.142255354196266,42.4088060383901,0.828654674276473 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441100,33.99164153392373,42.4088060383901,0.8015231908003536 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441098,375.5479787215349,385.8715169071063,0.9732461772034429 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441081,444.1457337691584,385.8715169071063,1.151019741827902 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441101,328.03424484619643,385.8715169071063,0.8501126164364357 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441086,449.8219509422494,385.8715169071063,1.165729864043161 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441085,367.4107797526504,385.8715169071063,0.9521583316062686 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441100,390.8700364758788,385.8715169071063,1.0129538443491175 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441098,605.3727682428441,1002.6445024002205,0.6037760809475825 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441081,804.646527610923,1002.6445024002205,0.8025242503047569 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441101,1022.5288525735208,1002.6445024002205,1.0198319046538422 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441086,700.802032906501,1002.6445024002205,0.6989536483059131 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441085,495.5377119947616,1002.6445024002205,0.4942307176756057 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441100,743.4658233043833,1002.6445024002205,0.7415049117853916 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441098,8732.743136363048,6245.085755978491,1.3983383859866287 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441081,7040.489798129943,6245.085755978491,1.127364791010276 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441101,9245.352903661558,6245.085755978491,1.4804204881911955 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441086,9542.898406310816,6245.085755978491,1.528065230677624 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441085,6410.309448541049,6245.085755978491,1.026456593074705 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441100,8163.944240110177,6245.085755978491,1.3072589487333686 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441098,396.9452761537428,289.8012081128336,1.3697157397604527 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441081,306.30744836581005,289.8012081128336,1.0569571133276634 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441101,184.47195859586623,289.8012081128336,0.6365465478806507 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441086,275.29628799788605,289.8012081128336,0.9499487244742607 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441085,367.3950105655717,289.8012081128336,1.2677483746807814 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441100,343.97751958488226,289.8012081128336,1.1869430145748572 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441098,14711.603720929645,19122.271903916942,0.7693439249713926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441081,20643.53397282079,19122.271903916942,1.0795544628037759 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441101,9890.09213283343,19122.271903916942,0.5172027770825482 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441086,31014.088848979252,19122.271903916942,1.621883058917619 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441085,15272.022656228704,19122.271903916942,0.798651056368487 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441100,21284.569250736,19122.271903916942,1.1130774291717993 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441098,126.97639487633134,111.01681566749893,1.143758214581043 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441081,69.53547155674887,111.01681566749893,0.6263508022515363 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441101,49.5949712733384,111.01681566749893,0.4467338661728318 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441086,113.37614646463535,111.01681566749893,1.0212520128860725 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441085,140.64186449416138,111.01681566749893,1.2668519057094108 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441100,141.79202190019404,111.01681566749893,1.2772121146481847 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441098,726.0818428127067,1048.3386659324408,0.6926023683070928 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441081,1499.548541637194,1048.3386659324408,1.4304046873091592 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441101,682.8989870888303,1048.3386659324408,0.6514106645884595 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441086,1305.7784211853984,1048.3386659324408,1.2455692646078058 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441085,904.758520838244,1048.3386659324408,0.8630403039017072 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441100,982.7929301915062,1048.3386659324408,0.9374765637565842 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441098,1811.109980390607,5453.602601951663,0.3320942343218171 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441081,4529.064063831533,5453.602601951663,0.8304719640207615 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441101,8555.086411794586,5453.602601951663,1.5687036691549554 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441086,7280.401350073417,5453.602601951663,1.3349710056739381 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441085,3532.6447556065355,5453.602601951663,0.6477635085369658 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441100,6929.576276948231,5453.602601951663,1.270641955918894 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441098,55692.092494391945,64173.361133824874,0.8678381731985896 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441081,98469.3592138928,64173.361133824874,1.5344273305016431 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441101,138173.2023996392,64173.361133824874,2.1531239747828956 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441086,82691.01187128799,64173.361133824874,1.2885566598085312 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441085,113575.8067882571,64173.361133824874,1.769827928311408 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441100,51365.842907362065,64173.361133824874,0.8004231350800769 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441098,49.41979755484953,44.60879663763593,1.1078487042879477 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441081,34.27889461719595,44.60879663763593,0.7684335198648967 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441101,50.64971277309494,44.60879663763593,1.1354198407217817 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441086,12.09712965800938,44.60879663763593,0.2711826045494168 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441085,52.720381968562485,44.60879663763593,1.1818382458692664 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441100,12.734950587314284,44.60879663763593,0.2854807021754528 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441098,129.57203884777994,136.29080299882398,0.9507027326627313 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441081,141.71656884108253,136.29080299882398,1.0398102125959694 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441101,129.18485697128372,136.29080299882398,0.9478618815709702 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441086,145.10504803542554,136.29080299882398,1.064672339164937 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441085,129.53085977887915,136.29080299882398,0.9504005914470754 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441100,150.29050726346324,136.29080299882398,1.1027193615167126 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441098,45.09128299802191,82.77341642135346,0.5447556105270229 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441081,66.64046303599642,82.77341642135346,0.8050949920535702 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441101,68.24041348588337,82.77341642135346,0.8244242709339112 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441086,94.42978652274466,82.77341642135346,1.140822628874651 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441085,41.77140452492223,82.77341642135346,0.5046475828940928 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441100,147.93648013024395,82.77341642135346,1.787246274542802 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441098,1692.9961003886017,2141.365658987758,0.7906151353846291 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441081,1745.9305888036404,2141.365658987758,0.8153351023799256 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441101,1579.9913603653024,2141.365658987758,0.7378428591743542 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441086,3633.9603015021407,2141.365658987758,1.697029316898612 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441085,1687.839135839546,2141.365658987758,0.788206875717528 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441100,2591.435564209384,2141.365658987758,1.2101789123835947 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441098,380.2520817662334,285.0677067828484,1.3339009390351328 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441081,419.95048425835125,285.0677067828484,1.473160495791445 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441101,336.2779973517477,285.0677067828484,1.1796425528055654 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441086,311.3613177470016,285.0677067828484,1.0922363717058363 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441085,337.5090251899133,285.0677067828484,1.183960922823897 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441100,350.934341392206,285.0677067828484,1.2310561071708197 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441098,609534.830389213,724296.655045942,0.8415541147992052 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441081,1065253.4014527893,724296.655045942,1.4707418487045483 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441101,665936.1954393813,724296.655045942,0.9194246456890527 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441086,1451722.5522244652,724296.655045942,2.0043203873865503 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441085,748088.5830343362,724296.655045942,1.032848319569949 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441100,856015.8967445153,724296.655045942,1.181858138900584 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441098,85.23567636944456,126.94877083842833,0.6714178940568607 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441081,44.92647771820303,126.94877083842833,0.35389454676471316 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441101,48.68390853090506,126.94877083842833,0.3834925553778428 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441086,192.0751512993769,126.94877083842833,1.5130130841820986 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441085,473.1348730490718,126.94877083842833,3.7269748255479005 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441100,43.05382426528119,126.94877083842833,0.3391432936367469 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441098,112979.69882662132,94593.87687362579,1.1943658782223119 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441081,179451.19249986892,94593.87687362579,1.8970698572763818 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441101,46715.39151259252,94593.87687362579,0.4938521715840307 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441086,105826.82219688008,94593.87687362579,1.1187491801214693 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441085,82356.73371794216,94593.87687362579,0.8706349336751253 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441100,76959.2392642992,94593.87687362579,0.8135752736629469 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441098,6.059709781630549,34.2642969985689,0.17685200959715128 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441081,67.49774211682617,34.2642969985689,1.9699146934094494 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441101,699.5514705917802,34.2642969985689,20.416338050682842 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441086,89.77179601923845,34.2642969985689,2.619980676182789 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441085,231.32623519638497,34.2642969985689,6.751232491536209 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441100,207.0364739814838,34.2642969985689,6.042338297211554 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441098,56.436047563245566,74.66086218948179,0.7558986851774699 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441081,178.2539129310532,74.66086218948179,2.3875147929401437 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441101,85.8992911188349,74.66086218948179,1.1505263748606478 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441086,132.09070361555723,74.66086218948179,1.7692094591718517 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441085,151.4458208237112,74.66086218948179,2.028449931898146 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441100,117.95072731924294,74.66086218948179,1.5798200537772495 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441098,345.5218590047108,347.6986105145094,0.9937395449853033 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441081,329.8646140784053,347.6986105145094,0.9487084621657988 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441101,378.2585798806595,347.6986105145094,1.0878921239314956 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441086,672.7584624163052,347.6986105145094,1.9348897064063217 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441085,648.3915139726998,347.6986105145094,1.8648090454351773 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441100,807.9486129388996,347.6986105145094,2.323703887522967 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441098,2855.4675758965795,2521.321340016667,1.132528222633337 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441081,2888.6710377737813,2521.321340016667,1.1456972944807924 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441101,3010.9240581642493,2521.321340016667,1.1941849737187193 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441086,3013.1589101876684,2521.321340016667,1.1950713549934695 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441085,3284.6537780896033,2521.321340016667,1.3027509528269374 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441100,3182.1753734531735,2521.321340016667,1.2621062309464046 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441098,78.39108033811596,79.44971561377609,0.9866754050976543 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441081,74.16480966473803,79.44971561377609,0.9334811218868392 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441101,108.00707183087133,79.44971561377609,1.3594393761699453 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441086,62.775868354847965,79.44971561377609,0.7901333298663565 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441085,120.37676546617588,79.44971561377609,1.5151314833064462 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441100,134.1472168544199,79.44971561377609,1.6884543364074622 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441098,161.09248597369597,42.37178439720435,3.8018810929360978 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441081,59.70844290616907,42.37178439720435,1.4091557331276465 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441101,73.11322412086501,42.37178439720435,1.7255167598202201 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441086,104.3374280056857,42.37178439720435,2.4624270488020743 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441085,70.82548616347299,42.37178439720435,1.6715247462683205 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441100,159.38171066697296,42.37178439720435,3.7615057504514446 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441098,1176.5814339260048,1321.2949146990686,0.8904760177586675 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441081,951.133061782339,1321.2949146990686,0.7198491806796701 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441101,3068.4084019238576,1321.2949146990686,2.32227367848661 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441086,1657.185414754656,1321.2949146990686,1.2542131179942428 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441085,1684.837729076613,1321.2949146990686,1.2751413104926261 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441100,1684.745413924955,1321.2949146990686,1.2750714433110977 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441098,14657.18799750486,23354.026662177774,0.6276086008432291 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441081,11692.263626451804,23354.026662177774,0.5006530049649903 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441101,19961.444573354995,23354.026662177774,0.854732456295551 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441086,16262.326518028,23354.026662177774,0.696339297426816 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441085,15579.415509267896,23354.026662177774,0.6670976159541263 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441100,12429.9572420093,23354.026662177774,0.5322404321024357 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441098,11529.310950475498,13473.54115415771,0.8557001324716883 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441081,9241.8468910997,13473.54115415771,0.6859256067398302 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441101,11149.064045666884,13473.54115415771,0.8274783828619894 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441086,11134.289104871154,13473.54115415771,0.8263817935818081 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441085,28933.823562378813,13473.54115415771,2.1474550180484897 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441100,15174.734464790155,13473.54115415771,1.1262617816035307 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441098,77806.08480589677,49612.48263442616,1.5682763827647488 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441081,63922.77284030481,49612.48263442616,1.2884413245619102 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441101,52076.17570475553,49612.48263442616,1.0496587338409025 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441086,57079.156809553744,49612.48263442616,1.1504999100759865 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441085,49803.471485450995,49612.48263442616,1.0038496128571543 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441100,60061.25928372029,49612.48263442616,1.2106078167119119 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441092,164.9120873940779,73.06854961986588,2.2569503329684486 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441087,123.01219992032392,73.06854961986588,1.6835177454634924 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441090,119.88354332410783,73.06854961986588,1.6406996436605592 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441093,122.94140150450256,73.06854961986588,1.6825488140122773 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441082,333.903828771292,73.06854961986588,4.56973390752114 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441097,127.74204679455777,73.06854961986588,1.7482493830673664 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441092,720.8366168124898,990.9231863649335,0.7274394491229744 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441087,40.34530947765416,990.9231863649335,0.04071487077182584 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441090,122.52,990.9231863649335,0.12364227791404085 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441093,925.2653853674584,990.9231863649335,0.9337407763781048 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441082,31.50078704171311,990.9231863649335,0.03178933289195649 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441097,850.5575977553077,990.9231863649335,0.8583486686545929 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441092,45.24490866765,50.719124328797626,0.8920680170726165 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441087,48.33744692901955,50.719124328797626,0.9530418272930278 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441090,40.27154098724164,50.719124328797626,0.7940109676612853 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441093,118.28072193928766,50.719124328797626,2.332073424069932 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441082,45.17703548179146,50.719124328797626,0.8907298002410612 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441097,39.59689565837883,50.719124328797626,0.7807093711177551 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441092,357.926421011974,319.2477137201226,1.1211557847701932 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441087,322.71277973415175,319.2477137201226,1.0108538475456927 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441090,367.0539148681151,319.2477137201226,1.1497464166333957 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441093,374.7550946890004,319.2477137201226,1.1738693139633254 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441082,312.70011083990727,319.2477137201226,0.9794905253857027 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441097,333.2945987492076,319.2477137201226,1.0439999549735213 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441092,88.44837006287537,44.58166891160943,1.9839627412387584 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441087,22.04086397837445,44.58166891160943,0.49439297622693595 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441090,26.478517953703335,44.58166891160943,0.5939328562643404 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441093,122.7269353558076,44.58166891160943,2.7528564621287317 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441082,98.20690888972264,44.58166891160943,2.2028540269417496 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441097,150.35688743968225,44.58166891160943,3.3726168425365546 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441092,4897.714391232262,1543.2839395802719,3.173566617018186 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441087,4138.795840045502,1543.2839395802719,2.681810996601917 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441090,3844.119642505051,1543.2839395802719,2.490869984398684 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441093,4606.302777328705,1543.2839395802719,2.984740953490052 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441082,4185.386435194486,1543.2839395802719,2.712000253390046 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441097,3801.019250256857,1543.2839395802719,2.46294227055238 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441092,37.22050579680816,31.276034215973343,1.1900647486118572 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441087,40.18783508197921,31.276034215973343,1.2849402454437275 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441090,63.8623775893449,31.276034215973343,2.041894990533327 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441093,44.39102302202621,31.276034215973343,1.419330299854793 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441082,110.8727620501413,31.276034215973343,3.544975084901148 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441097,48.97345715363236,31.276034215973343,1.565846130473299 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441092,67.65040634073067,130.468422036268,0.5185193879475679 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441087,175.9473886292771,130.468422036268,1.3485821770755126 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441090,31.130440461606888,130.468422036268,0.23860517338788043 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441093,53.62752109414752,130.468422036268,0.41103832066919593 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441082,467.1194399126768,130.468422036268,3.580325665185293 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441097,29.07546239223647,130.468422036268,0.22285440368209547 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441092,95.6104454803649,95.42663227533711,1.0019262254220334 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441087,75.15289642162288,95.42663227533711,0.7875463550341182 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441090,167.2351583825122,95.42663227533711,1.75249984616437 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441093,124.74393550240124,95.42663227533711,1.3072234923105543 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441082,154.69601418801818,95.42663227533711,1.6210989584298592 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441097,108.69317385950971,95.42663227533711,1.1390234703651103 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441092,566.0479150883062,569.3868516791151,0.9941359085111249 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441087,499.903713725949,569.3868516791151,0.8779684888257233 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441090,531.5788195798523,569.3868516791151,0.9335986913154608 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441093,628.582581694098,569.3868516791151,1.103963991863204 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441082,638.7222303673407,569.3868516791151,1.1217720052434585 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441097,539.3911588656625,569.3868516791151,0.9473193089636762 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441092,47156.4681810144,5328.634617598269,8.849634393260171 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441087,1653.548714080663,5328.634617598269,0.3103137731792827 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441090,85019.76010003401,5328.634617598269,15.95526175115273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441093,39015.84789397234,5328.634617598269,7.321922160907635 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441082,60903.423086281706,5328.634617598269,11.429461289228383 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441097,67060.56939591738,5328.634617598269,12.584944213372061 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441092,1096895.1096273342,656386.6079991342,1.6711113484947593 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441087,886111.4797151003,656386.6079991342,1.3499840930884273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441090,1112231.1960039726,656386.6079991342,1.6944757593309088 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441093,1172159.4102215136,656386.6079991342,1.7857759374381685 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441082,1042141.9723791973,656386.6079991342,1.5876953607508273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441097,983123.1503331604,656386.6079991342,1.497780634693353 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441092,46229.053500559785,5223.837669019135,8.849634393260171 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441087,1621.0287775493969,5223.837669019135,0.3103137731792827 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441090,83347.69735473185,5223.837669019135,15.955261751152731 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441093,38248.532793775295,5223.837669019135,7.321922160907636 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441082,59705.65041926725,5223.837669019135,11.429461289228385 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441097,65741.70564431736,5223.837669019135,12.584944213372061 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441092,1096895.1096273342,656386.6079991342,1.6711113484947593 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441087,886111.4797151003,656386.6079991342,1.3499840930884273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441090,1112231.1960039726,656386.6079991342,1.6944757593309088 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441093,1172159.4102215136,656386.6079991342,1.7857759374381685 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441082,1042141.9723791973,656386.6079991342,1.5876953607508273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441097,983123.1503331604,656386.6079991342,1.497780634693353 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441092,44.60529015481893,50.79723336807032,0.8781047154992605 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441087,49.66878693613863,50.79723336807032,0.977785277718668 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441090,63.66252613558455,50.79723336807032,1.253267587907671 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441093,43.75067210687757,50.79723336807032,0.8612806093171599 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441082,49.54700816790476,50.79723336807032,0.9753879273088242 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441097,51.87230648417526,50.79723336807032,1.021164009234816 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441092,161.33843917260958,124.85055234194422,1.2922525062663024 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441087,175.06863214308004,124.85055234194422,1.4022255317188916 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441090,217.79821705344455,124.85055234194422,1.744471393742277 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441093,54.96875034438903,124.85055234194422,0.44027638895692717 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441082,204.10072571065425,124.85055234194422,1.6347602944651571 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441097,72.19431952906062,124.85055234194422,0.5782458961922153 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441092,276.33003533222677,149.81706398084205,1.8444496774250139 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441087,230.5523958661489,149.81706398084205,1.5388927652168578 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441090,231.1857552227772,149.81706398084205,1.5431203167373526 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441093,270.35268732629106,149.81706398084205,1.8045520326100009 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441082,269.75398185795655,149.81706398084205,1.8005557891085857 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441097,242.89535987336183,149.81706398084205,1.6212796688127744 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441092,3807.543070988804,2791.14294318225,1.3641519436649603 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441087,3152.4632265858536,2791.14294318225,1.1294524468143698 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441090,3618.6122648658634,2791.14294318225,1.2964625382962993 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441093,4899.50509067835,2791.14294318225,1.7553759124540949 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441082,3681.876291519544,2791.14294318225,1.3191285313828274 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441097,3234.359425365523,2791.14294318225,1.158793903144907 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441092,572.312901454012,222.01180748199775,2.577848934905947 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441087,713.6540543965763,222.01180748199775,3.2144869342340914 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441090,1026.7474146910597,222.01180748199775,4.6247423789579996 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441093,955.9110862923112,222.01180748199775,4.305676788698831 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441082,416.8047639889233,222.01180748199775,1.8773990839325998 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441097,947.3929349733264,222.01180748199775,4.267308778386247 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441092,17825.579152015132,4330.453784028004,4.116330537404913 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441087,16039.608489678556,4330.453784028004,3.703909402944648 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441090,15365.907295784791,4330.453784028004,3.548336516708436 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441093,21999.844720171845,4330.453784028004,5.080263135774313 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441082,13930.684347613847,4330.453784028004,3.2169109849398088 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441097,12623.924280458796,4330.453784028004,2.915150446130973 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441092,293.99025504812056,100.4664893584531,2.9262518967811895 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441087,261.7347141352413,100.4664893584531,2.605194187699755 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441090,440.91524759677606,100.4664893584531,4.388679751948335 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441093,281.724311271782,100.4664893584531,2.8041619954154213 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441082,397.4454565762929,100.4664893584531,3.956000245596841 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441097,249.9636394546349,100.4664893584531,2.488029999364194 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441092,548.059669392186,219.8603821991507,2.492762288094954 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441087,97.89073881714673,219.8603821991507,0.44524046505330267 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441090,547.1990220007298,219.8603821991507,2.4888477702411795 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441093,772.9645523373239,219.8603821991507,3.515706397877397 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441082,673.3478466763769,219.8603821991507,3.062615646990256 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441097,294.54,219.8603821991507,1.3396683706899233 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441092,83.2147630066932,115.26780159034894,0.7219254801304422 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441087,73.31216950482671,115.26780159034894,0.6360160295706112 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441090,9.181313537619424,115.26780159034894,0.07965202260253873 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441093,111.14738514482664,115.26780159034894,0.9642535349102443 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441082,27.520361455066254,115.26780159034894,0.23875150801323566 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441097,91.3211896203496,115.26780159034894,0.7922523754282799 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441092,1306.638604574077,1760.6737631139824,0.7421241981042048 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441087,723.566428971103,1760.6737631139824,0.4109599655142137 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441090,840.6311766908376,1760.6737631139824,0.47744857355292847 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441093,1366.61758482829,1760.6737631139824,0.7761901230420153 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441082,1356.6677926485045,1760.6737631139824,0.770538995395183 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441097,862.8102503694121,1760.6737631139824,0.49004549760735855 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441092,2835.4164766059207,518.6000624505415,5.46744337670868 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441087,2828.384452836228,518.6000624505415,5.453883749013179 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441090,2822.092203465435,518.6000624505415,5.441750604753496 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441093,3376.3807228837013,518.6000624505415,6.510567520816109 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441082,1238.479600281404,518.6000624505415,2.388120808218215 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441097,4961.700354512112,518.6000624505415,9.567488925987753 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441092,3707.8319034795354,841.89306662726494,4.404160160545805 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441087,2088.4053249903727,841.89306662726494,2.480606395010237 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441090,2701.4830167785913,841.89306662726494,3.208819651646604 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441093,29164.62941078812,841.89306662726494,34.64172656466395 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441082,3646.687262176616,841.89306662726494,4.331532598059903 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441097,2271.2445188541074,841.89306662726494,2.6977826625333945 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441092,910.6349052686664,246.94010350613598,3.6876752392145935 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441087,732.3286019741058,246.94010350613598,2.965612274297556 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441090,788.3836161159587,246.94010350613598,3.1926106975830635 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441093,926.0433609896608,246.94010350613598,3.750072782190481 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441082,1183.909165045492,246.94010350613598,4.7943171167257335 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441097,989.159962322051,246.94010350613598,4.0056675617999495 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441092,2061.435478953967,6405.278640912654,0.321833849004927 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441087,1818.4162246551527,6405.278640912654,0.2838933833479657 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441090,1512.3118611693674,6405.278640912654,0.23610399265220508 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441093,2416.1566190945728,6405.278640912654,0.3772133508231435 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441082,2742.1239809783706,6405.278640912654,0.4281037773225834 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441097,1718.4384815663736,6405.278640912654,0.26828473481077514 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441092,130.52116111526172,184.84349394551683,0.7061171498615646 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441087,195.0089585440047,184.84349394551683,1.0549949818709021 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441090,158.81701590257356,184.84349394551683,0.8591972187529919 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441093,152.25514907290557,184.84349394551683,0.823697636432815 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441082,999.0406993452486,184.84349394551683,5.404792335508 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441097,113.26445806203849,184.84349394551683,0.6127586946361419 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441092,19442.0402500666,66689.05961878091,0.2915326795909917 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441087,15136.0682599805,66689.05961878091,0.2269647877253602 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441090,15072.18577298676,66689.05961878091,0.22600687217880855 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441093,30046.297755904747,66689.05961878091,0.45054313147704267 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441082,27146.747297301234,66689.05961878091,0.40706447882879115 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441097,17445.223021895144,66689.05961878091,0.26159047858252055 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441092,1979.4933389983228,426.591426110135,4.640255799438567 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441087,1895.501620994484,426.591426110135,4.4433654897347 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441090,2428.104888076138,426.591426110135,5.691874565358151 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441093,1659.127771438083,426.591426110135,3.8892665672322697 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441082,2833.303476076093,426.591426110135,6.641726257631363 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441097,2228.788388861126,426.591426110135,5.224644126545829 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441092,305517.1447677694,6086.038398766024,50.199674196882256 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441087,166972.14712420022,6086.038398766024,27.435276642036087 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441090,176138.27384372515,6086.038398766024,28.94136748782888 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441093,303068.8036317177,6086.038398766024,49.7973860456034 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441082,324396.6619317501,6086.038398766024,53.301777063635214 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441097,134439.47284690506,6086.038398766024,22.089816731055027 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441092,392.3495158492729,118.38689307733607,3.3141296781305947 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441087,436.17441995951594,118.38689307733607,3.6843134288065627 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441090,430.82476502600144,118.38689307733607,3.6391255300919654 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441093,505.9569082110048,118.38689307733607,4.273757804257007 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441082,186.60846084910244,118.38689307733607,1.5762594658785474 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441097,717.8983334659504,118.38689307733607,6.06400180632314 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441092,572.8454586419908,43.003791743375764,13.320812779962154 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441087,140.1326405424843,43.003791743375764,3.258611272669232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441090,375.53238082893984,43.003791743375764,8.732541145904564 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441093,5761.258742372662,43.003791743375764,133.97094788182525 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441082,529.2312538226313,43.003791743375764,12.306618378695717 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441097,315.0447848960696,43.003791743375764,7.32597689934164 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441092,66.06900981824072,56.77751951238643,1.163647344682384 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441087,38.102820582824286,56.77751951238643,0.6710899121704653 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441090,124.50447772233724,56.77751951238643,2.1928481341136377 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441093,44.7572393900704,56.77751951238643,0.7882915593081922 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441082,80.49461507805053,56.77751951238643,1.417719825898524 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441097,75.5752666602368,56.77751951238643,1.3310772874420749 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441092,229.9399750979589,232.93832449773902,0.9871281404369798 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441087,328.0315826669387,232.93832449773902,1.4082336316887292 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441090,163.83240264713191,232.93832449773902,0.7033295315418229 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441093,315.9965619633626,232.93832449773902,1.3565675062045437 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441082,160.81581175323467,232.93832449773902,0.6903793615755813 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441097,300.304602404898,232.93832449773902,1.2892022085778025 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441092,82.81713466174155,55.88566907011774,1.481902892811999 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441087,57.91329899272752,55.88566907011774,1.0362817508736593 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441090,75.64090737353513,55.88566907011774,1.3534938139262715 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441093,74.34446171050496,55.88566907011774,1.33029563656521 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441082,74.63643632844494,55.88566907011774,1.3355201354894988 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441097,15.183504796452036,55.88566907011774,0.27168870032497666 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441092,1051.3063883074706,226.42114305345407,4.643145839340964 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441087,1222.611641378677,226.42114305345407,5.399723828308913 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441090,2479.7764951477184,226.42114305345407,10.952053601117482 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441093,2242.0975663687263,226.42114305345407,9.902333042455343 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441082,1660.5294590026904,226.42114305345407,7.333809186762512 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441097,1909.8073185850967,226.42114305345407,8.434756987929456 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441092,301.88397796518376,212.71806341276286,1.4191741553203283 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441087,273.267516834515,212.71806341276286,1.2846465055685499 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441090,357.5895794371451,212.71806341276286,1.6810494308763537 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441093,457.37836252678784,212.71806341276286,2.150162309626149 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441082,841.0044295369325,212.71806341276286,3.953610784360277 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441097,498.5492850742732,212.71806341276286,2.3437092133867217 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441092,12146.278130017288,10996.969545575432,1.1045113910408413 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441087,9628.751341028546,10996.969545575432,0.8755822502848177 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441090,9912.073534671124,10996.969545575432,0.9013459111250509 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441093,13087.375913020922,10996.969545575432,1.190089311312729 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441082,9063.810216293668,10996.969545575432,0.8242098133244755 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441097,8358.314380456512,10996.969545575432,0.7600561541810791 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441092,176.52474470060062,147.8550055811589,1.1939044201226223 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441087,51.21056679477001,147.8550055811589,0.34635666606944926 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441090,173.41490168913833,147.8550055811589,1.1728713614227242 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441093,150.94462512338023,147.8550055811589,1.020896279636102 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441082,59.929240339683176,147.8550055811589,0.40532439266513365 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441097,114.60107368042075,147.8550055811589,0.7750909293193677 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441092,213.13110687118396,92.19915296117537,2.311638448142061 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441087,219.83772515793305,92.19915296117537,2.384379011057788 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441090,169.5530973951357,92.19915296117537,1.8389875823103679 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441093,387.97903618802735,92.19915296117537,4.208054236153378 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441082,397.299337301113,92.19915296117537,4.309143029420388 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441097,202.52364818270985,92.19915296117537,2.196589032309132 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441092,15645.99680018911,1229.7970051816276,12.722422265029314 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441087,13043.1019100115,1229.7970051816276,10.605898253984751 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441090,11121.211321185274,1229.7970051816276,9.043127666051515 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441093,14240.235077314865,1229.7970051816276,11.579337904804653 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441082,16643.079225860958,1229.7970051816276,13.53319219004193 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441097,12551.069567363662,1229.7970051816276,10.2058059293371 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441092,237826.32567857663,50083.06853493704,4.748637266757593 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441087,150376.87846689616,50083.06853493704,3.0025492220389007 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441090,166815.07624156275,50083.06853493704,3.3307678846633686 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441093,378173.3466433892,50083.06853493704,7.550922052221747 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441082,211105.71456273328,50083.06853493704,4.215111428635204 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441097,149057.4402806763,50083.06853493704,2.976204227117125 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441092,10.632701264122542,35.678906774941794,0.29801084801146877 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441087,12.95888466001004,35.678906774941794,0.3632085686300062 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441090,60.38524260250709,35.678906774941794,1.6924633645142173 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441093,67.09947346519637,35.678906774941794,1.880648246552275 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441082,4.895481083835383,35.678906774941794,0.13720939138397606 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441097,79.89645766228521,35.678906774941794,2.2393191071201355 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441092,65.60698357464686,67.70693010562654,0.9689847623027119 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441087,16.451305795972345,67.70693010562654,0.24297816737972616 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441090,191.8064152222119,67.70693010562654,2.832891919970132 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441093,95.7622199434624,67.70693010562654,1.4143636374307336 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441082,21.45379192897057,67.70693010562654,0.31686257072210294 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441097,173.7837222251407,67.70693010562654,2.566705091399485 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441092,7.106090672741199,64.01321127549492,0.11100975144269166 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441087,95.30942886828004,64.01321127549492,1.488902477616612 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441090,118.82156596540842,64.01321127549492,1.8562037991506737 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441093,88.5424459145673,64.01321127549492,1.3831901907483664 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441082,85.46707985142878,64.01321127549492,1.3351475132781954 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441097,35.682716661411455,64.01321127549492,0.5574273802300441 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441092,831.4478894383806,1060.427767412219,0.7840683872956079 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441087,659.5680857223493,1060.427767412219,0.6219830392898001 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441090,882.4153667202168,1060.427767412219,0.8321315169571529 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441093,763.9909995693885,1060.427767412219,0.7204554831997368 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441082,840.7441515744147,1060.427767412219,0.7928349081485274 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441097,685.1585402199923,1060.427767412219,0.6461152388455434 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441092,36.27686350171449,57.09593719876665,0.6353668103463256 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441087,5.425096191658428,57.09593719876665,0.0950172018855243 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441090,6.450591343879064,57.09593719876665,0.11297811473735483 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441093,1.0830214489727783,57.09593719876665,0.018968450333033033 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441082,24.404460586832,57.09593719876665,0.4274290218211738 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441097,32.290341851726225,57.09593719876665,0.565545351139691 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441092,132.42018055597822,50.205845180981015,2.6375450921826458 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441087,3.902560319526301,50.205845180981015,0.07773119455430798 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441090,35.217245745642565,50.205845180981015,0.7014570837059341 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441093,57.033449055712694,50.205845180981015,1.1359922106702849 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441082,338.49054429351077,50.205845180981015,6.742054497306577 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441097,34.68857514366009,50.205845180981015,0.6909270229116832 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441092,13431.570913413996,1506.8779059558976,8.91350975439088 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441087,18721.27732461321,1506.8779059558976,12.423884676135886 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441090,13577.405895802724,1506.8779059558976,9.010289315503508 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441093,19862.492271827716,1506.8779059558976,13.1812220441495 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441082,9606.157836310693,1506.8779059558976,6.3748746984361455 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441097,16886.817749016223,1506.8779059558976,11.206493692867546 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441092,55379.65012415763,16162.128318216166,3.42650726648048 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441087,70278.28357803822,16162.128318216166,4.348330999131364 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441090,50174.52917316899,16162.128318216166,3.104450613513432 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441093,97010.05349069058,16162.128318216166,6.002306848495415 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441082,126211.63940162669,16162.128318216166,7.809097720092648 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441097,48396.26311280831,16162.128318216166,2.994423887741405 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441092,16.381467300234807,24.995311385825953,0.6553816052687471 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441087,64.51923582056311,24.995311385825953,2.581253532898571 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441090,44.9959958556032,24.995311385825953,1.8001774477240158 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441093,21.319243691550675,24.995311385825953,0.852929709995137 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441082,471.5183968783067,24.995311385825953,18.864273767186987 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441097,76.6218508871469,24.995311385825953,3.065448943780581 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441092,701.0515003038938,522.7489803443298,1.3410863084651412 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441087,291.71236263819657,522.7489803443298,0.5580352589995459 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441090,431.972675057665,522.7489803443298,0.8263481925361743 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441093,3050.754489043185,522.7489803443298,5.835983624556632 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441082,1041.1913058896507,522.7489803443298,1.9917615242478866 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441097,139.34098729896672,522.7489803443298,0.266554297642406 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441092,3.90961303227455,2.8430683750443606,1.375138588502483 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441087,2.211771214987916,2.8430683750443606,0.7779521711128055 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441090,5.31464916918754,2.8430683750443606,1.869335685289178 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441093,5.42044323349891,2.8430683750443606,1.9065469128628798 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441082,10.003789456201456,2.8430683750443606,3.518659468063397 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441097,3.572509211116418,2.8430683750443606,1.2565681650412912 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441092,1388.629848299393,1771.7543971110147,0.7837597866632438 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441087,885.247586356773,1771.7543971110147,0.49964463912167456 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441090,1295.1955518670443,1771.7543971110147,0.731024319160129 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441093,3497.536045740827,1771.7543971110147,1.9740524146257716 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441082,2376.3582469223065,1771.7543971110147,1.3412458582279498 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441097,853.729011642475,1771.7543971110147,0.4818551674174183 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441092,260.23612159906014,73.62821549612136,3.5344618886324777 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441087,36.7544667844716,73.62821549612136,0.49918997135558424 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441090,21.960959269164672,73.62821549612136,0.29826825383703004 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441093,408.1100507533895,73.62821549612136,5.542848594162766 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441082,422.94577518440343,73.62821549612136,5.744343691267157 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441097,2.9350309752733197,73.62821549612136,0.03986285631800941 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441092,465.6330566056321,1923.334023596175,0.24209682296110455 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441087,361.4732560846531,1923.334023596175,0.18794096690952541 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441090,458.47256577945535,1923.334023596175,0.23837386546213185 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441093,841.1343065249996,1923.334023596175,0.43733137156918767 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441082,597.7888876105199,1923.334023596175,0.31080866884099384 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441097,142.8419478282749,1923.334023596175,0.07426788382872497 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441092,45.40024812769357,51.40813337414527,0.883133565602807 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441087,48.3500166881924,51.40813337414527,0.9405129794599604 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441090,111.27531200270803,51.40813337414527,2.1645468275000974 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441093,39.72336949147496,51.40813337414527,0.7727059296701301 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441082,21.036413702358715,51.40813337414527,0.4092039979210483 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441097,13.628310434914118,51.40813337414527,0.2651002777270301 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441092,38.89582895745878,89.1451395839603,0.43632024290931987 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441087,20.46171557688217,89.1451395839603,0.2295325989995287 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441090,78.89192443693042,89.1451395839603,0.8849829032196085 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441093,20.781048587224372,89.1451395839603,0.23311476861452426 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441082,75.86538262880858,89.1451395839603,0.8510321817080746 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441097,31.674622130313736,89.1451395839603,0.35531518911899135 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441092,26927.073973011666,4771.656231796832,5.64312948480614 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441087,17366.218315321028,4771.656231796832,3.6394529429001934 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441090,21132.16411865817,4771.656231796832,4.428685364599404 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441093,9825.710474490828,4771.656231796832,2.059182388080548 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441082,7081.048160181691,4771.656231796832,1.4839812040514968 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441097,20475.21007817235,4771.656231796832,4.291006955138957 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441092,632870.1758331918,209884.98459768714,3.015318971227472 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441087,528239.0610812029,209884.98459768714,2.516802533986626 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441090,813511.8604764784,209884.98459768714,3.875988851874461 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441093,1027568.7263792888,209884.98459768714,4.895865839802493 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441082,875578.2153499601,209884.98459768714,4.171704884121609 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441097,558945.5851157311,209884.98459768714,2.66310420532051 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441092,100.5739850967951,22.903585106474594,4.391189616352417 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441087,38.04444540664015,22.903585106474594,1.6610694452321964 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441090,29.229958378183547,22.903585106474594,1.2762175983497255 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441093,30.914028387888013,22.903585106474594,1.3497462621757392 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441082,3.3312314639341363,22.903585106474594,0.14544585262297793 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441097,15.32958339313856,22.903585106474594,0.669309338336078 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441092,1.0376717979984975,83.56495705722055,0.012417547193711338 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441087,30.61075290174452,83.56495705722055,0.36631087934125317 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441090,92.41086922813967,83.56495705722055,1.1058567189218076 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441093,71.69629558055419,83.56495705722055,0.8579708301825684 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441082,29.13201730310547,83.56495705722055,0.34861523692470175 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441097,33.86375186765851,83.56495705722055,0.40523866774048034 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441092,2410.3603858147367,1829.6496491832456,1.3173890350487154 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441087,1995.8274859003527,1829.6496491832456,1.0908249493509803 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441090,2571.267911785902,1829.6496491832456,1.4053334817043877 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441093,2505.9788889681668,1829.6496491832456,1.3696495884263056 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441082,2757.4120419655674,1829.6496491832456,1.5070710631384945 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441097,2647.9887457432305,1829.6496491832456,1.4472654625027752 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441092,155749.20751638562,96234.19538703516,1.6184393384284317 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441087,178327.48257271323,96234.19538703516,1.8530573446945224 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441090,187731.76814937376,96234.19538703516,1.950780254298934 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441093,257763.5005843459,96234.19538703516,2.6785021638895756 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441082,226381.65360905748,96234.19538703516,2.352403453872032 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441097,118321.5948018695,96234.19538703516,1.2295171620233654 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441092,160.72110191634252,77.99112650544876,2.0607613855290823 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441087,138.8876132272364,77.99112650544876,1.7808130161773361 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441090,126.23577390325958,77.99112650544876,1.6185914931545484 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441093,132.21762798230338,77.99112650544876,1.695290655573056 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441082,484.2139634455513,77.99112650544876,6.208577631093997 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441097,180.3981622412669,77.99112650544876,2.3130600918896023 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441092,119.11970867129438,110.33780757772625,1.079591042149191 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441087,294.8876629544588,110.33780757772625,2.6725894725316923 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441090,289.5723616276462,110.33780757772625,2.62441648954879 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441093,172.4205030296598,110.33780757772625,1.5626602233164737 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441082,96.8016971221251,110.33780757772625,0.8773211943144168 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441097,265.5015128909663,110.33780757772625,2.4062605440473037 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441092,65.43554888681206,67.31067174214355,0.9721422650108916 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441087,52.822985796277855,67.31067174214355,0.7847639078485843 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441090,60.822357142000506,67.31067174214355,0.9036064500292206 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441093,50.07833409146212,67.31067174214355,0.7439880303572698 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441082,79.97236261123876,67.31067174214355,1.188108223278474 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441097,51.96143886930819,67.31067174214355,0.7719643486602566 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441092,6116.747570962708,2375.529574917848,2.574898513386953 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441087,5814.562494101014,2375.529574917848,2.4476910561309664 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441090,6609.608153426286,2375.529574917848,2.782372496311633 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441093,5207.072801678217,2375.529574917848,2.191962944455571 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441082,5652.266228357896,2375.529574917848,2.3793710202717073 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441097,6081.494210245091,2375.529574917848,2.5600583021389682 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441092,329.4504052530731,194.62377093849457,1.6927552254507838 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441087,268.00489438148765,194.62377093849457,1.377040908667745 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441090,175.84317492393626,194.62377093849457,0.903503071983466 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441093,204.06581640343208,194.62377093849457,1.0485143485783215 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441082,1005.22429493755,194.62377093849457,5.1649615568039895 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441097,201.0665758199108,194.62377093849457,1.0331038950193412 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441092,5773.787213329951,3728.1507253933823,1.54870004959918 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441087,4269.972721727862,3728.1507253933823,1.1453326424395862 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441090,3702.923948993086,3728.1507253933823,0.9932334344133485 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441093,7398.204997637492,3728.1507253933823,1.984416817497865 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441082,4647.237959280495,3728.1507253933823,1.2465263079700548 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441097,3736.712182015072,3728.1507253933823,1.0022964352174324 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441092,153.07522277507078,68.78582331086372,2.2253891195468873 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441087,111.58586650260854,68.78582331086372,1.622221863919817 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441090,70.83462960973408,68.78582331086372,1.0297852987760456 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441093,132.1926654999562,68.78582331086372,1.9218010214479515 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441082,324.24154832771137,68.78582331086372,4.7137845085079055 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441097,120.053824185954,68.78582331086372,1.7453280110262668 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441092,410.3517924520429,696.3940975413478,0.589252255153812 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441087,259.7910459589621,696.3940975413478,0.3730517631843329 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441090,362.60769434026486,696.3940975413478,0.5206932333580488 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441093,1075.5220475326346,696.3940975413478,1.544415800377711 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441082,915.4725368641524,696.3940975413478,1.3145897417802237 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441097,197.60669166535345,696.3940975413478,0.28375698812355415 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441092,174.5690413566519,81.2393188807366,2.1488245317877173 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441087,105.53064439077605,81.2393188807366,1.2990094678870994 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441090,31.615828060215147,81.2393188807366,0.3891690439530736 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441093,69.02088349563886,81.2393188807366,0.8495994851577348 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441082,127.8966317152389,81.2393188807366,1.574319350252032 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441097,53.950571959583165,81.2393188807366,0.6640943412977811 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441092,118.55590325947504,543.8205698619286,0.21800555151780188 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441087,61.97489631333532,543.8205698619286,0.11396203039739784 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441090,262.0242294803568,543.8205698619286,0.48182110791962596 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441093,453.83011068406046,543.8205698619286,0.8345217813281394 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441082,986.7245036526872,543.8205698619286,1.8144302704533743 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441097,167.64214083235836,543.8205698619286,0.30826737737213816 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441092,1975489.707325161,306516.0644612488,6.44497935466254 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441087,1336959.7908056497,306516.0644612488,4.361793543041769 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441090,2420563.371837377,306516.0644612488,7.897019610022417 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441093,1292392.214072868,306516.0644612488,4.216393083163373 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441082,1484917.5814993507,306516.0644612488,4.84450165478058 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441097,1772201.6958569402,306516.0644612488,5.781757960946906 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441092,1458264.0687496972,335923.8645439917,4.341055288612062 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441087,1160278.0754919415,335923.8645439917,3.4539912103803347 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441090,1444188.0770672683,335923.8645439917,4.299152961423916 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441093,1811373.106957391,335923.8645439917,5.3922132308649315 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441082,1014517.9212128924,335923.8645439917,3.020082906554065 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441097,1289454.000744457,335923.8645439917,3.8385305030199586 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441092,14.791555697513653,33.931355493730415,0.43592587099111696 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441087,61.610006709899054,33.931355493730415,1.8157248896609184 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441090,153.80886465029883,33.931355493730415,4.532941947418473 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441093,30.403852328417152,33.931355493730415,0.8960400162626851 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441082,720.7835819224321,33.931355493730415,21.242404596999172 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441097,142.72802511549747,33.931355493730415,4.206375579126797 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441092,31.541502865601643,76.3332642617619,0.4132078350198621 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441087,268.8783782560514,76.3332642617619,3.52242735662416 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441090,6.148931716005882,76.3332642617619,0.08055376349319972 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441093,31.542359749295475,76.3332642617619,0.41321906058059393 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441082,10.395892910323806,76.3332642617619,0.1361908600511859 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441097,24.638249048642994,76.3332642617619,0.32277211366401876 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441092,402.9155170185674,130.67426801703346,3.0833577500204337 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441087,299.9729433752604,130.67426801703346,2.2955777593195226 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441090,385.1453102408088,130.67426801703346,2.9473691805230153 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441093,320.35878477882426,130.67426801703346,2.4515827763203184 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441082,430.057764805772,130.67426801703346,3.291066950914267 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441097,276.8509837509903,130.67426801703346,2.1186342801239384 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441092,6638.838099541705,5444.214081294075,1.2194300224806132 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441087,7637.128352976883,5444.214081294075,1.4027972153441766 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441090,8083.368183068333,5444.214081294075,1.4847631012237743 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441093,9610.312387573136,5444.214081294075,1.7652341080034808 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441082,8009.729179154643,5444.214081294075,1.4712369975816146 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441097,6067.28446161216,5444.214081294075,1.1144463408334564 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441092,133.2793325573338,100.67607722942154,1.323843123661003 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441087,124.68896462945096,100.67607722942154,1.2385163194758637 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441090,166.74864070494542,100.67607722942154,1.6562886168573805 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441093,179.1771047725988,100.67607722942154,1.779738640037478 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441082,103.959438271694,100.67607722942154,1.0326131205409435 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441097,197.03624358288505,100.67607722942154,1.9571307206763442 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441092,623.6551273524049,599.1099853739104,1.040969342153721 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441087,633.8529174394912,599.1099853739104,1.0579909080365226 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441090,606.4883645540261,599.1099853739104,1.0123155670248274 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441093,1697.5059513025776,599.1099853739104,2.8333795008326352 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441082,672.3295653647779,599.1099853739104,1.122213920279046 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441097,519.0436742778022,599.1099853739104,0.8663579091472862 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441092,101.66103053970949,114.30018844822946,0.8894213729643614 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441087,84.42163492638691,114.30018844822946,0.7385957632486705 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441090,129.45616276219536,114.30018844822946,1.1325979818557392 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441093,183.9603271979092,114.30018844822946,1.6094490279972833 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441082,90.42795479051496,114.30018844822946,0.7911444068307283 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441097,110.15105389079416,114.30018844822946,0.9636996700201016 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441092,6951.014425879745,1759.6959467320276,3.9501224281323353 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441087,3958.531472359112,1759.6959467320276,2.2495542367478842 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441090,5282.890417650742,1759.6959467320276,3.0021609286886872 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441093,4853.13914972079,1759.6959467320276,2.7579418812287813 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441082,6218.891068620265,1759.6959467320276,3.5340713719148544 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441097,5021.455388783061,1759.6959467320276,2.8535926323570404 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441092,31.29147653287268,38.77498679262034,0.8070016039006899 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441087,116.87826589140504,38.77498679262034,3.0142696505998376 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441090,76.19756012687128,38.77498679262034,1.9651214978975367 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441093,88.22657352683193,38.77498679262034,2.2753476100119063 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441082,1100.8065753182343,38.77498679262034,28.389605422837693 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441097,33.252313734084204,38.77498679262034,0.857571245914977 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441092,1162.6517093632008,2284.874121495706,0.5088471607364151 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441087,576.1314743486299,2284.874121495706,0.2521502033431441 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441090,811.5734547781366,2284.874121495706,0.35519394575963376 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441093,2089.964549590297,2284.874121495706,0.9146957068349049 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441082,1681.1216285788882,2284.874121495706,0.7357611575899008 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441097,634.3065716687587,2284.874121495706,0.2776111671541599 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441092,419.22573080102615,306.4947439651267,1.3678072432091237 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441087,507.67168721548103,306.4947439651267,1.656379749446028 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441090,483.4376481379031,306.4947439651267,1.5773113818647055 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441093,529.924713638584,306.4947439651267,1.72898466963231 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441082,852.4750901951608,306.4947439651267,2.7813693610751 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441097,494.0545655238129,306.4947439651267,1.6119511843244756 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441092,21335.63703680868,53872.22448470133,0.39604150823338635 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441087,17921.179557551965,53872.22448470133,0.3326608420010804 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441090,19060.791693931904,53872.22448470133,0.35381482528802577 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441093,37944.72730644071,53872.22448470133,0.7043467699615092 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441082,31093.60718221808,53872.22448470133,0.5771732554137998 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441097,14216.24419540768,53872.22448470133,0.26388819714405554 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441092,265.15507106379624,320.29657233769314,0.8278423622474472 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441087,82.04563446890646,320.29657233769314,0.2561552060020318 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441090,197.31494654963927,320.29657233769314,0.6160382707486716 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441093,65.51216596462824,320.29657233769314,0.20453595705531888 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441082,77.76714681598007,320.29657233769314,0.242797312029893 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441097,212.5260721040049,320.29657233769314,0.6635290242192654 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441092,3601.245428906508,6299.521117687065,0.5716697129239473 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441087,2653.3540440860384,6299.521117687065,0.42119932523700226 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441090,2897.521331445879,6299.521117687065,0.4599589837568056 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441093,25869.367989820945,6299.521117687065,4.106561039566632 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441082,14695.952389569784,6299.521117687065,2.3328681839494423 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441097,1882.1696027135629,6299.521117687065,0.2987797909636377 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441092,2678.0408400463134,1965.7827420843205,1.362327984020648 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441087,3097.5123627203775,1965.7827420843205,1.5757144960160163 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441090,1487.2698070052863,1965.7827420843205,0.7565789317228074 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441093,2354.6111478702137,1965.7827420843205,1.1977982599306056 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441082,4475.591669740847,1965.7827420843205,2.276747869398515 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441097,3593.7161935694926,1965.7827420843205,1.828134979839671 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441092,3843.832997421975,6243.797224888628,0.6156242521938304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441087,2899.7059850189394,6243.797224888628,0.46441386236252447 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441090,3003.3496232454545,6243.797224888628,0.4810133185097192 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441093,20922.83748035681,6243.797224888628,3.3509796565710888 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441082,12554.188587816148,6243.797224888628,2.010665647143927 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441097,1780.6860050158632,6243.797224888628,0.28519279868952274 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441092,672.3110911970348,477.14850073021523,1.4090185553724845 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441087,1041.1163675741795,477.14850073021523,2.1819546031914236 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441090,444.95088262286384,477.14850073021523,0.9325207601866567 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441093,661.7863301035331,477.14850073021523,1.3869609337360447 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441082,1172.801598952844,477.14850073021523,2.4579383507608634 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441097,977.742914644124,477.14850073021523,2.049137560209898 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441092,270.1192343788121,205.1372392304115,1.3167732752579964 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441087,228.7222236134866,205.1372392304115,1.1149717353687514 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441090,276.71157206658347,205.1372392304115,1.3489095061661585 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441093,866.1767613922666,205.1372392304115,4.222425750886562 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441082,704.9475873270202,205.1372392304115,3.436468141872663 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441097,130.55275874659785,205.1372392304115,0.6364166703050933 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441092,117.99349195018232,44.32085041603382,2.66225694774792 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441087,14.031644485535285,44.32085041603382,0.31659240185651083 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441090,27.006671057825265,44.32085041603382,0.6093446042735485 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441093,28.257953370964213,44.32085041603382,0.6375769667258329 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441082,15.529197805853698,44.32085041603382,0.35038131398841 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441097,21.52014140929264,44.32085041603382,0.48555344058802996 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441092,134.38882276924676,73.02499011367847,1.8403127827890537 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441087,6.7436528508234685,73.02499011367847,0.09234719293115386 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441090,85.87200659013178,73.02499011367847,1.1759263021666182 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441093,156.0098343461711,73.02499011367847,2.136389667472869 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441082,173.57579832799968,73.02499011367847,2.3769369644253717 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441097,3.495117765773666,73.02499011367847,0.04786194096476828 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441092,1249.3290734978327,446.9213615105917,2.795411410354402 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441087,300858.20405433903,446.9213615105917,673.1792882699542 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441090,33870.849090034666,446.9213615105917,75.78704444905338 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441093,1047.7255633587058,446.9213615105917,2.3443174875718613 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441082,814.5562550137513,446.9213615105917,1.82259414108235 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441097,852.8144638851121,446.9213615105917,1.908198035114285 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441092,3145.0588885805455,2631.000022355788,1.1953853522830726 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441087,1991.9282145830211,2631.000022355788,0.7570992769507678 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441090,2563.7230959159915,2631.000022355788,0.9744291425814747 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441093,4211.791685263677,2631.000022355788,1.6008330100630155 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441082,2698.224179204967,2631.000022355788,1.0255508005617524 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441097,2919.9052860854204,2631.000022355788,1.1098081570789755 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441092,6.126412181633669,48.89133349009634,0.12530671070517363 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441087,37.67124409715211,48.89133349009634,0.7705096467614854 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441090,49.31198855384586,48.89133349009634,1.0086038779006656 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441093,72.71383389031566,48.89133349009634,1.4872540530121745 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441082,18.502957614080188,48.89133349009634,0.37845066381403225 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441097,17.352598717651844,48.89133349009634,0.35492177199803454 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441092,383.5138709944069,307.70649021557807,1.2463626318889747 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441087,139.2185025546091,307.70649021557807,0.45243927892802366 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441090,394.25021165881526,307.70649021557807,1.2812541307874428 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441093,526.6113206589844,307.70649021557807,1.711407907873644 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441082,415.9129741098767,307.70649021557807,1.3516548637582833 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441097,490.1409372213155,307.70649021557807,1.5928846248186852 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441092,317.7055694501555,154.19153082843468,2.0604605696771965 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441087,240.76251314204103,154.19153082843468,1.5614509554998313 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441090,565.4442406333178,154.19153082843468,3.6671549831259824 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441093,354.5845391588346,154.19153082843468,2.299636933713127 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441082,285.2552812034517,154.19153082843468,1.8500061557910636 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441097,226.3199620338725,154.19153082843468,1.467784649506421 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441092,8561.934704497258,6593.957266089812,1.2984516518673843 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441087,8655.910781337823,6593.957266089812,1.3127034998925222 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441090,9321.121084154813,6593.957266089812,1.4135853036369763 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441093,10462.34914843435,6593.957266089812,1.5866571053225036 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441082,9209.204309151342,6593.957266089812,1.3966126769596674 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441097,8435.610576867562,6593.957266089812,1.2792940925244793 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441092,309.720723028337,127.96554716912783,2.420344615250145 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441087,192.03746975591957,127.96554716912783,1.5006966640959227 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441090,171.24075534339266,127.96554716912783,1.3381785889374538 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441093,205.6344212233801,127.96554716912783,1.60695144726416 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441082,376.8208749243743,127.96554716912783,2.9447056904022975 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441097,233.83335629797048,127.96554716912783,1.8273149411764766 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441092,1085.6180863664472,1681.9358703135756,0.6454574788062802 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441087,647.2074203326472,1681.9358703135756,0.3847991066460718 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441090,934.2791186501812,1681.9358703135756,0.5554784431085334 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441093,2288.321013597323,1681.9358703135756,1.3605280997846219 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441082,1405.4907855968752,1681.9358703135756,0.8356387484231722 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441097,603.5882911673119,1681.9358703135756,0.35886522299734325 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441092,35.594269358928784,45.403354316773296,0.7839568220134617 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441087,36.202588953218,45.403354316773296,0.7973549421180921 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441090,36.61571488254719,45.403354316773296,0.8064539599229632 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441093,49.10047771938935,45.403354316773296,1.0814284199537705 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441082,58.76489901137128,45.403354316773296,1.2942854089893057 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441097,39.68495420979591,45.403354316773296,0.8740533559022787 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441092,159.71049559809308,171.72890790902974,0.9300152056093945 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441087,138.69502829107557,171.72890790902974,0.807639377550498 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441090,165.3925855748992,171.72890790902974,0.9631027623055338 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441093,188.5066234335665,171.72890790902974,1.09769884248856 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441082,162.77519286532092,171.72890790902974,0.9478613405702674 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441097,142.64757264724287,171.72890790902974,0.8306555627944004 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441092,849.6165986965196,385.5886159476326,2.2034276001859645 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441087,995.8973192260356,385.5886159476326,2.5827975153739757 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441090,242.70037209202283,385.5886159476326,0.6294282612456182 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441093,698.2942865152229,385.5886159476326,1.8109826318369817 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441082,223.86062386693771,385.5886159476326,0.5805685505438796 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441097,1074.899821904423,385.5886159476326,2.7876855732960926 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441092,347.4985148086675,430.1288265554666,0.8078940386104448 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441087,217.06854506194136,430.1288265554666,0.504659375657887 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441090,301.2520775990607,430.1288265554666,0.7003763965589812 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441093,454.7068911918098,430.1288265554666,1.0571411705492233 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441082,380.5763659966604,430.1288265554666,0.8847962342918761 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441097,472.85374392026984,430.1288265554666,1.0993305138531413 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441092,572751.6948632166,54695.927744901994,10.471560104702688 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441087,426240.32968944096,54695.927744901994,7.792907941472284 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441090,389565.6526013261,54695.927744901994,7.1223886066661715 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441093,230806.87142748825,54695.927744901994,4.219818201163997 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441082,279844.8620947267,54695.927744901994,5.116374721714269 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441097,316657.07772652723,54695.927744901994,5.789408659514724 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441092,330319.0084429191,97212.60478924697,3.3979030719219745 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441087,332676.98452948435,97212.60478924697,3.4221589396839507 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441090,343689.9056359241,97212.60478924697,3.53544590622821 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441093,763315.8069077473,97212.60478924697,7.85202503896059 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441082,341575.44853300345,97212.60478924697,3.5136950529566136 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441097,295306.1442255056,97212.60478924697,3.0377351256631533 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441092,534018.1689894078,62941.57202670208,8.484347495528997 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441087,399182.8091438339,62941.57202670208,6.3421169235253 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441090,566278.53170993,62941.57202670208,8.996892093348007 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441093,320244.91843745974,62941.57202670208,5.087971401502338 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441082,366763.00768593326,62941.57202670208,5.827039202807632 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441097,431448.9775258986,62941.57202670208,6.854753760247082 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441092,64918.6525999353,14728.399701289269,4.407719366432768 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441087,82740.23365054087,14728.399701289269,5.617734127849484 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441090,71856.32348049807,14728.399701289269,4.878759738860702 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441093,203876.68651613456,14728.399701289269,13.842419451604641 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441082,71143.48410611357,14728.399701289269,4.83036076892223 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441097,59343.8521128222,14728.399701289269,4.029212495341735 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441092,44425.68868831987,3575.9352491809864,12.42351597347712 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441087,36558.789488184775,3575.9352491809864,10.223560255057194 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441090,32852.185085021156,3575.9352491809864,9.187019002244364 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441093,22374.411389872563,3575.9352491809864,6.256939746041845 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441082,14959.808496531698,3575.9352491809864,4.183467387995354 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441097,39134.050323343195,3575.9352491809864,10.943724535366309 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441092,127871.14303994928,12966.336321671553,9.861778984263212 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441087,91615.84503500097,12966.336321671553,7.065669342686795 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441090,109408.84712853446,12966.336321671553,8.437915261049625 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441093,587091.443446493,12966.336321671553,45.27812860023117 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441082,138915.34370970374,12966.336321671553,10.713538524951318 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441097,80294.19748413558,12966.336321671553,6.192512325161134 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441092,394.9792684775225,103.34580193186551,3.8219188500557286 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441087,413.6458289520099,103.34580193186551,4.002541189091755 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441090,552.5612801110395,103.34580193186551,5.346722070774928 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441093,688.9391766662702,103.34580193186551,6.666348935203759 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441082,215.2642386226754,103.34580193186551,2.0829509723539252 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441097,772.1205791820058,103.34580193186551,7.4712331294410435 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441092,1720.014389711895,211.8154700640626,8.120343566934393 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441087,685.3915823184819,211.8154700640626,3.2357956768275162 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441090,1266.5856663128895,211.8154700640626,5.979665535901682 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441093,5202.629960357052,211.8154700640626,24.562086795565694 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441082,1528.230118751333,211.8154700640626,7.2149126703971485 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441097,1207.56654686809,211.8154700640626,5.701030932740027 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441092,61.76072598928194,76.10596635595309,0.8115096482767536 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441087,66.7587783423201,76.10596635595309,0.877181928550575 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441090,114.08773783990428,76.10596635595309,1.4990643086549575 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441093,26.300800122671692,76.10596635595309,0.3455813174969878 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441082,154.50979592921837,76.10596635595309,2.030192944486966 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441097,9.05116054859322,76.10596635595309,0.1189283965761671 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441092,4414.075320219448,1382.686999693948,3.192389399189032 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441087,4249.289112668329,1382.686999693948,3.073211155965805 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441090,5362.844862634177,1382.686999693948,3.878567502132601 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441093,5498.663910143518,1382.686999693948,3.976795841257366 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441082,4040.924951154763,1382.686999693948,2.92251605175228 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441097,3624.782499324587,1382.686999693948,2.6215495626464396 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441092,29.772950742542896,30.899530320120164,0.9635405598109141 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441087,31.237163774121793,30.899530320120164,1.0109268150843633 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441090,33.19126904453063,30.899530320120164,1.0741674291054903 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441093,35.282507946447176,30.899530320120164,1.1418460921871374 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441082,36.40667886409598,30.899530320120164,1.178227581031866 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441097,30.048403167692783,30.899530320120164,0.9724550132765879 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441092,30.710731855007623,31.68183515511672,0.9693482623290444 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441087,30.27333151363863,31.68183515511672,0.9555422331256398 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441090,33.766396655303716,31.68183515511672,1.0657967409394318 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441093,33.82949192754407,31.68183515511672,1.067788269268881 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441082,30.1329683874227,31.68183515511672,0.951111835532549 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441097,31.96935142338754,31.68183515511672,1.0090751140791914 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441092,762.0710969207622,628.1906149122311,1.2131207930052195 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441087,713.0682809317493,628.1906149122311,1.1351145082474323 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441090,389.2445618728579,628.1906149122311,0.6196281075088044 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441093,1100.156700943292,628.1906149122311,1.75131031064035 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441082,1494.1722099000856,628.1906149122311,2.3785331624364474 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441097,1353.1855901080896,628.1906149122311,2.1541002969252454 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441092,37650.40312877642,10551.186365326936,3.568357322594766 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441087,39813.95567732835,10551.186365326936,3.7734103349898214 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441090,31504.825685361673,10551.186365326936,2.985903631547264 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441093,51142.25787948673,10551.186365326936,4.84706232159345 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441082,44806.27488493857,10551.186365326936,4.246562740298088 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441097,30242.744336977095,10551.186365326936,2.866288518640909 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441092,70.31483534542282,102.14043933131707,0.6884132847455232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441087,163.6685582502166,102.14043933131707,1.6023874512554062 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441090,207.2110537496312,102.14043933131707,2.0286877078871015 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441093,50.91147617649591,102.14043933131707,0.49844583114972024 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441082,159.40300051250065,102.14043933131707,1.5606257575947828 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441097,96.00675892465736,102.14043933131707,0.9399485605621527 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441092,9262.758964620814,2995.2816068385046,3.0924501200398256 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441087,11029.648322492088,2995.2816068385046,3.682341018390519 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441090,9348.536993594722,2995.2816068385046,3.12108783770152 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441093,15778.600078874437,2995.2816068385046,5.267818572667904 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441082,7310.153843854735,2995.2816068385046,2.440556449572213 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441097,9191.635176426997,2995.2816068385046,3.0687048441260565 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441092,54.58862288538409,35.73806763844074,1.5274643116592916 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441087,37.99119500112443,35.73806763844074,1.0630455844865034 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441090,38.82454647644576,35.73806763844074,1.0863638982731436 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441093,43.73083013299505,35.73806763844074,1.2236484237317045 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441082,55.68957058035651,35.73806763844074,1.55827033357717 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441097,40.66443156022508,35.73806763844074,1.137846398737167 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441092,270.17700035959075,271.6614200921023,0.9945357727571024 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441087,181.98382704017436,271.6614200921023,0.6698920552593585 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441090,294.23398098771827,271.6614200921023,1.0830907859053491 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441093,307.2631622030711,271.6614200921023,1.1310518884091036 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441082,273.50739643933605,271.6614200921023,1.006795136190512 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441097,230.7063647603488,271.6614200921023,0.8492422835827467 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441092,234.3075192104985,166.02715311669658,1.4112602355218924 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441087,223.0193287120522,166.02715311669658,1.3432702092729203 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441090,239.4348988664959,166.02715311669658,1.4421430131865403 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441093,210.23993281927304,166.02715311669658,1.2662984871607137 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441082,250.02239858095052,166.02715311669658,1.5059127009496793 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441097,158.52862487439955,166.02715311669658,0.9548355308060574 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441092,2114.84916662926,1793.9624976146763,1.1788703328198038 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441087,1351.6870539189715,1793.9624976146763,0.7534644986816772 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441090,1660.58,1793.9624976146763,0.9256492274548509 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441093,2666.3474778375867,1793.9624976146763,1.4862894187492035 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441082,1849.364046628415,1793.9624976146763,1.0308822225032033 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441097,1541.5852141517075,1793.9624976146763,0.8593185287883445 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441092,91.91680100680294,59.13775760336051,1.5542828259281132 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441087,163.2577581572177,59.13775760336051,2.760634910308817 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441090,193.9770997793468,59.13775760336051,3.2800888576188423 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441093,134.70803586615202,59.13775760336051,2.2778685111742756 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441082,257.4304510526433,59.13775760336051,4.353064124940963 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441097,191.79198287782748,59.13775760336051,3.2431392506321353 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441092,298.87779824940844,238.79765196261823,1.2515943762135284 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441087,333.47287732343494,238.79765196261823,1.3964663160743194 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441090,444.7630640779035,238.79765196261823,1.8625102065389127 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441093,790.6809583575689,238.79765196261823,3.311091846419593 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441082,406.9173305278331,238.79765196261823,1.704025676900427 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441097,422.0511737981253,238.79765196261823,1.7674008531046774 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441092,757.0924284143514,386.8144501381946,1.9572496015696157 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441087,558.8930800172405,386.8144501381946,1.444860914108996 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441090,680.3113203768859,386.8144501381946,1.758753635325246 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441093,952.497114347366,386.8144501381946,2.4624134750061013 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441082,1067.27120159098,386.8144501381946,2.759129606481048 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441097,1042.0846231813002,386.8144501381946,2.694016789726965 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441092,11607.108021436168,5555.372966797932,2.089348112324203 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441087,11386.158635501211,5555.372966797932,2.0495759157038367 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441090,13307.635745852407,5555.372966797932,2.3954531631604943 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441093,40884.52930974674,5555.372966797932,7.3594571514992655 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441082,12962.411494406677,5555.372966797932,2.333310755529362 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441097,11160.22696362449,5555.372966797932,2.008906878138399 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441092,26.45405044296356,84.54153084580483,0.3129118928685247 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441087,54.52188567342935,84.54153084580483,0.6449124486859806 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441090,61.80464433220731,84.54153084580483,0.7310566027593315 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441093,182.7907464670575,84.54153084580483,2.1621414308246827 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441082,115.3422333521725,84.54153084580483,1.364326292630601 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441097,111.78254876351195,84.54153084580483,1.322220542320105 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441092,98.18731291626015,122.00200397429413,0.8048008206238011 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441087,59.479004318230785,122.00200397429413,0.48752481418881477 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441090,170.770169032611,122.00200397429413,1.3997324918416285 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441093,458.5203443793824,122.00200397429413,3.758301744584399 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441082,153.76036531850568,122.00200397429413,1.2603101613880296 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441097,101.03984612607736,122.00200397429413,0.8281818563190692 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441092,123.14040597426488,143.84455848940917,0.8560657925988304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441087,142.66297070910102,143.84455848940917,0.9917856622960461 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441090,127.53572244909007,143.84455848940917,0.8866218075150902 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441093,140.87330099975,143.84455848940917,0.9793439701796024 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441082,94.6644702785412,143.84455848940917,0.6581025467536963 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441097,120.7105582494877,143.84455848940917,0.8391736157219687 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441092,3135.555226879049,5334.764851653101,0.5877588448734389 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441087,915.8684010984912,5334.764851653101,0.17167924483394767 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441090,2532.314509692511,5334.764851653101,0.4746815614389853 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441093,2553.145162543648,5334.764851653101,0.47858626078945105 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441082,5198.6650548270045,5334.764851653101,0.9744881357265592 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441097,4580.076940006524,5334.764851653101,0.858533987414137 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441092,308.4776008572053,159.70733471984832,1.93151805706559 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441087,222.34371745850513,159.70733471984832,1.3921947783333235 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441090,245.0149082277634,159.70733471984832,1.5341493780329998 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441093,344.09158093788454,159.70733471984832,2.1545133261504557 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441082,359.9346759348061,159.70733471984832,2.2537141238139617 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441097,291.01182748194486,159.70733471984832,1.8221569346982416 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441092,79984.41732375676,82077.5827732141,0.9744977205866199 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441087,30154.81602795384,82077.5827732141,0.36739405583219514 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441090,55112.80956564648,82077.5827732141,0.6714721328712481 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441093,287922.3988307304,82077.5827732141,3.5079298037599305 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441082,86030.7144686961,82077.5827732141,1.0481633542547757 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441097,51889.82052769391,82077.5827732141,0.6322045408070677 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441092,190910.40712453067,170961.68742491837,1.1166853228936058 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441087,241608.6483590605,170961.68742491837,1.413232707270559 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441090,206234.79227818892,170961.68742491837,1.2063216933838554 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441093,233393.4572552745,170961.68742491837,1.365179887790792 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441082,221549.3824838457,170961.68742491837,1.2959007706398782 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441097,212675.64329002015,170961.68742491837,1.2439959296928522 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441092,322167.55759991537,55195.40432138408,5.836854744718296 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441087,327595.928853416,55195.40432138408,5.9352029916464835 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441090,339134.65653822577,55195.40432138408,6.144255318134095 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441093,484317.03660992417,55195.40432138408,8.774589887772372 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441082,247427.74229829723,55195.40432138408,4.48275984822232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441097,293071.3628162693,55195.40432138408,5.309705878949892 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441092,2235.0728097218753,546.121028905539,4.092632752489137 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441087,2339.886825188055,546.121028905539,4.284557270898972 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441090,2265.997671566635,546.121028905539,4.149259141527359 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441093,2379.3830511006267,546.121028905539,4.356878649901215 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441082,1907.932515471138,546.121028905539,3.493607487143931 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441097,2326.2845346902845,546.121028905539,4.259650171963357 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441092,1762.4659146426025,1228.731327313693,1.4343785947866923 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441087,1502.1914096977343,1228.731327313693,1.2225548224459222 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441090,2103.473685540834,1228.731327313693,1.7119069391186936 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441093,4528.359475474929,1228.731327313693,3.6853943370802056 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441082,1967.084533377906,1228.731327313693,1.600906959602335 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441097,1234.3283993359892,1228.731327313693,1.0045551634420624 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441092,84.00851941551173,76.68368758811918,1.0955200780997314 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441087,81.34680150315677,76.68368758811918,1.0608097244890458 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441090,38.50584142376986,76.68368758811918,0.5021386247175686 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441093,180.7148908806037,76.68368758811918,2.356627550976074 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441082,176.58961747321632,76.68368758811918,2.3028315803187307 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441097,200.01089234524207,76.68368758811918,2.608258661470922 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441092,234.68937388639543,81.06808963980528,2.894966131916355 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441087,276.83355936300444,81.06808963980528,3.4148277157264633 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441090,168.48202795644437,81.06808963980528,2.078278009325607 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441093,316.68907193599915,81.06808963980528,3.9064578102565957 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441082,299.4090245747052,81.06808963980528,3.6933030728245044 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441097,168.27556231944203,81.06808963980528,2.0757311917316597 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441092,26.81129349247395,34.254424530644805,0.7827103756622139 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441087,55.906989999970705,34.254424530644805,1.632110034426502 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441090,69.78774522660581,34.254424530644805,2.03733521093522 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441093,91.70951057242864,34.254424530644805,2.677304080539528 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441082,63.09084069470442,34.254424530644805,1.8418304075802496 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441097,105.34684568507376,34.254424530644805,3.075423018443297 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441092,87.29914489750695,60.87738129746832,1.4340160998537796 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441087,96.16000009498244,60.87738129746832,1.5795686024191944 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441090,140.7208060807619,60.87738129746832,2.311544995556732 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441093,286.09409574038904,60.87738129746832,4.699513836550106 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441082,217.6421979998537,60.87738129746832,3.5750913288529493 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441097,116.01495594781844,60.87738129746832,1.9057152833320559 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441092,110.52738145024652,81.37032235510941,1.3583254711452706 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441087,203.0683287114682,81.37032235510941,2.4956067867748484 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441090,170.21266501922358,81.37032235510941,2.09182734064142 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441093,240.70128623810487,81.37032235510941,2.958096751634544 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441082,269.2974690430942,81.37032235510941,3.309529337586365 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441097,225.92212842711945,81.37032235510941,2.776468396440282 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441092,503.2985453285079,592.3362991324378,0.8496837794098747 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441087,483.64745839556247,592.3362991324378,0.8165082219407018 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441090,433.05978462435087,592.3362991324378,0.731104585787887 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441093,1144.3487696592624,592.3362991324378,1.9319240967256721 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441082,807.6538541262132,592.3362991324378,1.3635055884792795 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441097,412.4642527904161,592.3362991324378,0.6963345879604704 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441092,7927.659159735956,1509.2244087879828,5.252803435708042 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441087,9244.215116414662,1509.2244087879828,6.125142863173304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441090,10525.253738091027,1509.2244087879828,6.9739487890628356 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441093,8956.071536478457,1509.2244087879828,5.934221235973009 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441082,5275.584840630441,1509.2244087879828,3.495560242672672 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441097,7353.193438297849,1509.2244087879828,4.872167051819019 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441092,948271.7952537342,911297.6405793307,1.0405730828523798 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441087,570284.259839707,911297.6405793307,0.6257936314606999 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441090,831566.494346878,911297.6405793307,0.9125081173459794 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441093,1166297.476939851,911297.6405793307,1.2798205822176951 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441082,981231.0266998973,911297.6405793307,1.0767404446214832 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441097,734118.8122465623,911297.6405793307,0.8055752364067 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441092,4339.220980808406,749.6106308195243,5.788633194895436 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441087,4643.550897282939,749.6106308195243,6.194617187067237 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441090,4324.692855659968,749.6106308195243,5.769252299599761 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441093,4533.644605634003,749.6106308195243,6.047999346910969 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441082,2882.7068192826027,749.6106308195243,3.84560557276387 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441097,3284.879829258142,749.6106308195243,4.382114786268295 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441092,22696.947035182093,2138.7943755926544,10.612028577498398 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441087,19003.7276198818,2138.7943755926544,8.885252288273815 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441090,26407.720123830164,2138.7943755926544,12.347012141600874 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441093,83477.12061302304,2138.7943755926544,39.029988841209544 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441082,26411.501066061417,2138.7943755926544,12.348779932967075 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441097,17306.817760560276,2138.7943755926544,8.0918567759767 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441092,1959.863346961691,613.8984432679271,3.192487891855326 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441087,1529.6009879630055,613.8984432679271,2.4916189391531547 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441090,2228.1880532459013,613.8984432679271,3.6295711085122284 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441093,2394.750515112603,613.8984432679271,3.900890353076606 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441082,2427.2413879417977,613.8984432679271,3.9538158380415758 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441097,2305.5466255886986,613.8984432679271,3.755583111297248 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441092,5814.51053654301,6365.76448478505,0.9134033391339558 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441087,5163.162633125637,6365.76448478505,0.8110828865042403 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441090,5099.502634383328,6365.76448478505,0.8010825167301993 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441093,7457.406010547711,6365.76448478505,1.171486320044013 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441082,4896.787798089788,6365.76448478505,0.7692379775899196 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441097,4308.182664386109,6365.76448478505,0.6767738069297393 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441092,151.95262805901635,70.21289390855102,2.1641698497277075 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441087,142.9072898622528,70.21289390855102,2.0353425404795704 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441090,56.78461229734475,70.21289390855102,0.80874906496952 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441093,95.67823464724084,70.21289390855102,1.362687525340534 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441082,51.531322975130735,70.21289390855102,0.7339296261203512 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441097,94.27169763441594,70.21289390855102,1.3426550649970412 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441092,2372.1331105568484,2003.7789126851078,1.1838297606287003 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441087,1697.8532415954571,2003.7789126851078,0.8473256360005788 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441090,1985.7329282864855,2003.7789126851078,0.9909940241987873 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441093,2235.3476045389234,2003.7789126851078,1.1155659890359404 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441082,1740.4123032668322,2003.7789126851078,0.8685650359173814 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441097,877.3887518918114,2003.7789126851078,0.43786704528000603 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441092,1573.1817118312426,700.7857837159185,2.244882456789352 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441087,1182.2076198649704,700.7857837159185,1.6869743184519403 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441090,1310.4037268194463,700.7857837159185,1.8699062641810842 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441093,2070.2057294104434,700.7857837159185,2.954120613624854 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441082,3142.454263071273,700.7857837159185,4.48418666030638 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441097,1854.6316219736475,700.7857837159185,2.6465029186800257 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441092,5038.956453792114,4688.560133729121,1.0747343128953963 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441087,3971.966117068184,4688.560133729121,0.8471611760920335 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441090,3740.020398662065,4688.560133729121,0.797690611187145 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441093,6082.210587405577,4688.560133729121,1.2972448713306775 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441082,4110.88349033248,4688.560133729121,0.8767901814373922 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441097,3468.459748341517,4688.560133729121,0.7397707717108498 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441092,992.2693871994916,384.65137963543384,2.5796589840388666 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441087,856.3535504413497,384.65137963543384,2.2263108772753846 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441090,861.1473360255529,384.65137963543384,2.2387735534491884 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441093,1225.389456276049,384.65137963543384,3.185714444693927 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441082,1321.684724284611,384.65137963543384,3.436058712534144 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441097,1259.9398167464935,384.65137963543384,3.275536975691192 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441092,276.3047202461488,772.5530415852671,0.3576514561112538 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441087,154.66390692717667,772.5530415852671,0.2001984311780181 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441090,138.22894357542478,772.5530415852671,0.17892485840426062 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441093,1869.385237428766,772.5530415852671,2.419750019484508 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441082,933.9938384477964,772.5530415852671,1.2089705019234087 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441097,64.2151556127242,772.5530415852671,0.08312070777814255 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441092,200.78602024034575,216.68366112664066,0.9266320275205081 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441087,169.98300560903488,216.68366112664066,0.7844754178751318 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441090,201.77790860901763,216.68366112664066,0.9312096147899617 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441093,297.01878019439204,216.68366112664066,1.3707483926109203 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441082,163.92158159111634,216.68366112664066,0.756501808852641 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441097,258.5805813246213,216.68366112664066,1.1933552349085241 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441092,1130.5952759238812,615.8359185894908,1.8358709549020689 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441087,1352.44217414195,615.8359185894908,2.196107978306268 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441090,1377.315974566065,615.8359185894908,2.2364982830502425 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441093,1669.331267836774,615.8359185894908,2.710675388438217 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441082,1328.2664878967878,615.8359185894908,2.1568512777543836 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441097,942.7664402636902,615.8359185894908,1.5308727727720077 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441092,0.17517039313622207,101.73138829665541,0.001721891306795241 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441087,61.12856003555137,101.73138829665541,0.6008819997353861 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441090,0.11071262906047692,101.73138829665541,0.001088283871027412 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441093,16.794894833077837,101.73138829665541,0.16509058919065195 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441082,0.07802855154304658,101.73138829665541,7.670056690419893e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441097,17.0604471522851,101.73138829665541,0.16770091746448712 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441092,324.6830202202758,93.53234569214308,3.471344782573435 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441087,446.2832424954837,93.53234569214308,4.771432162777165 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441090,424.9472828858015,93.53234569214308,4.543318995596386 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441093,163.48,93.53234569214308,1.7478445428716822 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441082,308.7745546094181,93.53234569214308,3.3012596051609107 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441097,410.4633331981583,93.53234569214308,4.388464013820174 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441092,136.23121361468247,42.30806113801961,3.2199824324320074 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441087,124.56494933416424,42.30806113801961,2.9442367715174145 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441090,138.04354565188004,42.30806113801961,3.2628189980520976 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441093,266.8462282118295,42.30806113801961,6.3072194998799285 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441082,172.1523062168182,42.30806113801961,4.069019037653694 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441097,334.4363718335236,42.30806113801961,7.904790785437022 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441092,670.4801298800302,205.3077634331321,3.2657319853294435 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441087,418.6860932438583,205.3077634331321,2.0393096015593324 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441090,308.86,205.3077634331321,1.5043756496845502 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441093,2690.4711364625095,205.3077634331321,13.104575742644943 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441082,568.8945506780587,205.3077634331321,2.77093540529141 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441097,349.8531904752014,205.3077634331321,1.7040426753718312 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441092,1690.5192331541843,761.179367641068,2.220920987904843 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441087,986.6956245542704,761.179367641068,1.2962721619900028 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441090,648.0107891295845,761.179367641068,0.8513246899187528 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441093,659.8467528127093,761.179367641068,0.8668741966267511 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441082,197.72444139286583,761.179367641068,0.259760642232886 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441097,1022.578935354228,761.179367641068,1.3434138901100932 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441092,1085997.5638002837,258075.7105503754,4.208058020974822 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441087,753879.6626106956,258075.7105503754,2.921156977551133 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441090,1056438.0929720688,258075.7105503754,4.093520039987863 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441093,1217734.249477758,258075.7105503754,4.718515535153631 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441082,1003817.9634506224,258075.7105503754,3.8896258826910444 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441097,933531.0136860274,258075.7105503754,3.61727576646081 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441092,264.0499700025532,131.47736122215045,2.008330312900042 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441087,402.30289150442104,131.47736122215045,3.059864358128323 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441090,539.6687277819262,131.47736122215045,4.104651346554454 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441093,382.3353877249065,131.47736122215045,2.9079940772380906 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441082,605.251749846041,131.47736122215045,4.603467427547307 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441097,442.44780882286256,131.47736122215045,3.365201466701796 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441092,2998.365687701826,3004.2024881525895,0.9980571214910509 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441087,3428.6742581095937,3004.2024881525895,1.1412926630714662 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441090,3642.038491928081,3004.2024881525895,1.2123145847494865 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441093,2847.650980591355,3004.2024881525895,0.9478891625386062 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441082,3148.9357243461213,3004.2024881525895,1.0481769244131525 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441097,2645.7499761450267,3004.2024881525895,0.8806829721294884 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441092,237.3153984243303,96.13121274223809,2.4686612355620348 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441087,189.44194709748373,96.13121274223809,1.9706601185344956 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441090,349.76212782399983,96.13121274223809,3.6383825590740884 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441093,131.44653628484608,96.13121274223809,1.367365838162272 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441082,418.3604667230239,96.13121274223809,4.351973253939871 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441097,156.92243395937248,96.13121274223809,1.6323775544175982 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441092,343.4474430213451,490.807523353751,0.699759939852846 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441087,282.3147400180799,490.807523353751,0.5752045895486421 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441090,122.75102527492083,490.807523353751,0.25010012975381324 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441093,533.7073650869868,490.807523353751,1.0874066506562403 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441082,419.03293527154193,490.807523353751,0.8537622496253439 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441097,181.5450938909381,490.807523353751,0.36989060935826146 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441092,136.10195601624036,78.64120835950264,1.7306696941132953 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441087,101.821714127325,78.64120835950264,1.2947628381020588 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441090,229.66536878182333,78.64120835950264,2.920420140696778 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441093,160.4648382216506,78.64120835950264,2.040467606856918 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441082,126.47394384306844,78.64120835950264,1.6082400878799048 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441097,93.89014389913972,78.64120835950264,1.1939051530074114 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441092,2014.823108670228,1710.8868039225827,1.1776484008473296 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441087,2542.9323930036317,1710.8868039225827,1.4863241607646995 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441090,1863.6021100719297,1710.8868039225827,1.0892609059811635 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441093,3048.4260421369127,1710.8868039225827,1.7817812582034815 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441082,1875.112353295426,1710.8868039225827,1.0959885534193847 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441097,2041.4765916333688,1710.8868039225827,1.193227153867127 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441092,229.41111056565032,158.21676846284709,1.4499797511634887 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441087,212.6366233106987,158.21676846284709,1.3439575676874644 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441090,246.09682665860993,158.21676846284709,1.55544086160753 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441093,350.0133158633938,158.21676846284709,2.2122390645690944 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441082,175.5205464753461,158.21676846284709,1.1093675353163488 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441097,309.9397007264695,158.21676846284709,1.9589560811896523 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441092,1033.1150794593457,1068.4447009417866,0.9669335984807642 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441087,848.3376119303828,1068.4447009417866,0.7939929985918885 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441090,1129.9426489668592,1068.4447009417866,1.0575583817963297 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441093,1702.8511204866145,1068.4447009417866,1.5937662651006896 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441082,1430.012645235532,1068.4447009417866,1.338405856639131 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441097,777.5143983282404,1068.4447009417866,0.7277067288956518 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441092,145.8458439785936,101.193417409009,1.4412582133589382 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441087,141.98250955330377,101.193417409009,1.4030804887182653 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441090,203.97793138469956,101.193417409009,2.0157233208188887 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441093,185.52173454995503,101.193417409009,1.8333379709878093 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441082,138.4485948122321,101.193417409009,1.3681581110423726 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441097,180.92306725014484,101.193417409009,1.787893638564258 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441092,11153.372607984553,8195.704907369402,1.3608802090904566 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441087,9998.887530350608,8195.704907369402,1.220015562219648 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441090,10572.801115021366,8195.704907369402,1.290041702882022 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441093,13526.339051020432,8195.704907369402,1.6504180182058334 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441082,12055.443711106482,8195.704907369402,1.4709465320385664 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441097,8644.087200055237,8195.704907369402,1.05470942374739 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441092,68.21371531945293,54.484574340672744,1.2519821645836258 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441087,39.121376454929965,54.484574340672744,0.7180266511823669 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441090,22.52434908690304,54.484574340672744,0.41340781972648377 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441093,39.33734253572693,54.484574340672744,0.7219904534770606 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441082,16.380254643575082,54.484574340672744,0.3006402241697834 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441097,42.62255158446186,54.484574340672744,0.7822865847855972 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441092,250.30978111391883,181.8259570369428,1.3766449256915596 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441087,197.94436909245945,181.8259570369428,1.088647475411015 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441090,9.325113017656273,181.8259570369428,0.05128592842088892 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441093,368.24774879338054,181.8259570369428,2.02527601006143 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441082,250.39969828399677,181.8259570369428,1.3771394489793412 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441097,69.1496547699925,181.8259570369428,0.3803068379062231 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441092,1075.7922559632057,598.5025834222519,1.7974730364768021 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441087,840.4273258025396,598.5025834222519,1.4042167052929937 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441090,628.0403444438643,598.5025834222519,1.0493527711321058 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441093,665.7736155641414,598.5025834222519,1.112398900197276 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441082,733.4919831808963,598.5025834222519,1.2255452248623087 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441097,584.6600975208956,598.5025834222519,0.9768714684200617 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441092,18555.732707256193,15066.853658787537,1.2315598948181072 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441087,14075.80224202263,15066.853658787537,0.9342230674559655 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441090,17772.405614420164,15066.853658787537,1.1795698038159845 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441093,22151.129563101626,15066.853658787537,1.4701894678709035 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441082,15478.220018607955,15066.853658787537,1.0273027381254543 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441097,11914.562378076536,15066.853658787537,0.7907797240154072 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441092,62.3766739628857,62.8704966822211,0.9921453981534227 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441087,63.72653594059967,62.8704966822211,1.0136159137203165 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441090,61.84129939849439,62.8704966822211,0.983629884635256 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441093,66.29881789033993,62.8704966822211,1.054529889042348 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441082,63.515759145232984,62.8704966822211,1.0102633587622722 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441097,62.669584207245514,62.8704966822211,0.9968043440790503 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441092,97.33589894535368,100.49015468400951,0.9686112958172434 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441087,95.29527225108131,100.49015468400951,0.9483045632752436 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441090,107.97240656920326,100.49015468400951,1.0744575616260281 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441093,109.62133293950616,100.49015468400951,1.0908663966555685 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441082,96.37202080209444,100.49015468400951,0.9590195288795752 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441097,100.52,100.49015468400951,1.0002969974131728 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441092,162.27274405109816,109.95671552102958,1.4757874794838062 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441087,140.60561113292215,109.95671552102958,1.2787360050421919 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441090,139.59049859445554,109.95671552102958,1.269504076517804 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441093,178.24695055628888,109.95671552102958,1.6210647045218314 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441082,132.23474129736152,109.95671552102958,1.2026072320436962 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441097,160.77749103716036,109.95671552102958,1.4621889192971678 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441092,264.50818321187836,243.54938966397899,1.0860556192598794 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441087,241.10791021319287,243.54938966397899,0.9899754236536803 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441090,293.044876067527,243.54938966397899,1.203225663886229 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441093,345.8614176476295,243.54938966397899,1.420087392232059 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441082,265.59332954120765,243.54938966397899,1.0905111686284343 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441097,266.0450619690906,243.54938966397899,1.092365956392453 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441092,173.6502276684407,49.66723175069083,3.4962735298011722 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441087,187.0616202753841,49.66723175069083,3.7662984966498 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441090,169.57525125468072,49.66723175069083,3.414227958302147 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441093,184.1728710806592,49.66723175069083,3.7081364229263194 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441082,248.22986232741823,49.66723175069083,4.997859827852507 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441097,159.51849932121488,49.66723175069083,3.211745323796833 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441092,503.33404267287534,318.9289567276793,1.5782011387026615 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441087,360.4191374399216,318.9289567276793,1.130092234765842 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441090,332.03138265567503,318.9289567276793,1.0410825848566123 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441093,861.5497289882888,318.9289567276793,2.7013844645154994 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441082,361.56268088946825,318.9289567276793,1.1336778089993007 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441097,332.28461699276704,318.9289567276793,1.0418765997359456 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441092,50.328863250941474,52.85511393128503,0.9522042335652168 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441087,58.04721976922577,52.85511393128503,1.0982328000407076 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441090,50.72224932882206,52.85511393128503,0.9596469585660938 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441093,66.16713720017793,52.85511393128503,1.2518587564904196 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441082,108.3605793010594,52.85511393128503,2.050143708741882 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441097,55.878387442646265,52.85511393128503,1.0571992620296247 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441092,127.10836405000556,145.91831693350866,0.8710925860522752 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441087,123.55326632581534,145.91831693350866,0.8467289708537105 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441090,146.7817602270923,145.91831693350866,1.005917305734667 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441093,142.04486701743076,145.91831693350866,0.9734546697256456 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441082,123.84320316049146,145.91831693350866,0.8487159512463656 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441097,142.90282699868197,145.91831693350866,0.9793343975026743 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441092,1422.957938797946,261.347965154705,5.444687269539772 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441087,1195.550212855748,261.347965154705,4.5745533627860535 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441090,1735.1567011307577,261.347965154705,6.639258507727931 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441093,1626.879549094929,261.347965154705,6.224955867293236 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441082,1329.6961238596546,261.347965154705,5.0878380593954144 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441097,1354.2319532455629,261.347965154705,5.18171990527619 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441092,7221.307224811585,7540.877985370558,0.9576215447088593 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441087,6528.212630859926,7540.877985370558,0.8657098873002294 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441090,6472.0574570343515,7540.877985370558,0.8582631186435137 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441093,11327.732924309988,7540.877985370558,1.5021769277113353 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441082,7993.008734312546,7540.877985370558,1.0599573086607594 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441097,5503.522605546968,7540.877985370558,0.7298251763553134 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441092,3463.310981471342,5107.556668860965,0.6780758797226805 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441087,2646.5671879480324,5107.556668860965,0.5181669748440094 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441090,3701.625058841104,5107.556668860965,0.724734995386082 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441093,6681.600649644365,5107.556668860965,1.3081794452482163 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441082,5451.06189180212,5107.556668860965,1.0672543145796873 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441097,3485.1951573245387,5107.556668860965,0.68236054600678 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441092,105978.12661257056,180330.65339424144,0.5876878091318156 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441087,51903.91306382424,180330.65339424144,0.2878263461417797 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441090,73533.83353142465,180330.65339424144,0.4077722347662321 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441093,303467.5603307097,180330.65339424144,1.6828395761826724 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441082,127150.6441812467,180330.65339424144,0.7050972299383186 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441097,73512.66323691083,180330.65339424144,0.40765483767308486 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441092,437.3752782101443,98.01831453553807,4.462179137466877 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441087,381.0222307618481,98.01831453553807,3.8872554845217477 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441090,418.6991874625323,98.01831453553807,4.271642390981191 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441093,343.30126036429186,98.01831453553807,3.502419542623564 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441082,561.3310543062299,98.01831453553807,5.726797659867031 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441097,404.5034650378622,98.01831453553807,4.126815146277619 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441092,1835.319181359193,1812.4793707702274,1.0126014182325616 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441087,1686.8081411460932,1812.4793707702274,0.930663360007938 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441090,1749.8164582324532,1812.4793707702274,0.9654269651018731 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441093,2178.6030361973694,1812.4793707702274,1.202001562793818 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441082,3090.2916649416666,1812.4793707702274,1.705007910588479 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441097,1459.668529390142,1812.4793707702274,0.8053435271761711 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441092,7122.185454896477,434.5650550234931,16.389227280392905 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441087,5528.558631572886,434.5650550234931,12.722050628930589 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441090,12074.288606238431,434.5650550234931,27.784766553734244 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441093,10622.319402826002,434.5650550234931,24.44356553761956 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441082,31949.074667035627,434.5650550234931,73.51965901931167 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441097,8268.85272664775,434.5650550234931,19.027882318334886 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441092,3005811.0325083486,9833.502392298877,305.6704430013008 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441087,3012371.775570632,9833.502392298877,306.3376257405272 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441090,3074802.237756336,9833.502392298877,312.68637715127545 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441093,4167277.911211656,9833.502392298877,423.7836881470905 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441082,2985483.141169602,9833.502392298877,303.6032353546472 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441097,2517544.127288616,9833.502392298877,256.01703511662686 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441092,65.86275387411114,42.4088060383901,1.5530442855309252 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441087,50.88175084863685,42.4088060383901,1.1997921092750574 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441090,89.47730054093303,42.4088060383901,2.10987549283832 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441093,73.19524952967161,42.4088060383901,1.7259445942291427 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441082,130.4094256308151,42.4088060383901,3.075055343759582 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441097,66.06115538471458,42.4088060383901,1.5577225948052738 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441092,1487.5850090086656,385.8715169071063,3.855130383636953 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441087,1499.676045908182,385.8715169071063,3.886464743313019 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441090,1656.4062299420566,385.8715169071063,4.29263668699552 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441093,2881.7730572555174,385.8715169071063,7.4682191636063875 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441082,2378.3354403383937,385.8715169071063,6.163542360943287 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441097,1215.1767967235662,385.8715169071063,3.1491746435798853 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441092,934.6894918060603,1002.6445024002205,0.9322242226118197 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441087,1050.864824196827,1002.6445024002205,1.0480931393740975 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441090,1394.9822672177097,1002.6445024002205,1.3913029631921143 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441093,1371.2745115051127,1002.6445024002205,1.3676577373360475 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441082,361.82568345828446,1002.6445024002205,0.3608713582851286 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441097,1075.5460578175291,1002.6445024002205,1.0727092755635625 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441092,33425.39554731394,6245.085755978491,5.352271666616497 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441087,19852.833609377572,6245.085755978491,3.1789529215627232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441090,20431.756649260493,6245.085755978491,3.27165349646335 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441093,52656.26526503323,6245.085755978491,8.431632057994527 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441082,26261.216391754857,6245.085755978491,4.205101005476938 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441097,21518.03731979212,6245.085755978491,3.4455951704414405 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441092,331.70992720166066,289.8012081128336,1.1446119543867117 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441087,306.88598507954003,289.8012081128336,1.0589534359706827 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441090,513.4961108106339,289.8012081128336,1.771890856337304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441093,414.3790473780873,289.8012081128336,1.429873429708925 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441082,432.8195224283426,289.8012081128336,1.493504893395148 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441097,426.2830281872642,289.8012081128336,1.470949796804476 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441092,35576.46685093174,19122.271903916942,1.8604728052028365 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441087,44767.16706563687,19122.271903916942,2.3411008530041304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441090,35335.34271215681,19122.271903916942,1.8478632083941258 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441093,44295.57089086202,19122.271903916942,2.3164387115418363 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441082,47367.288045817375,19122.271903916942,2.477074287188376 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441097,26738.705371019863,19122.271903916942,1.3983017031330256 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441092,141.8585423616405,111.01681566749893,1.2778113073114448 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441087,54.184679861070975,111.01681566749893,0.48807632911537363 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441090,218.09214720326304,111.01681566749893,1.9644965124604206 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441093,163.1434572962279,111.01681566749893,1.469538252518888 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441082,170.63598519257854,111.01681566749893,1.5370282796044348 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441097,138.89856042103972,111.01681566749893,1.2511488425055177 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441092,1732.735934411492,1048.3386659324408,1.6528398605524264 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441087,1567.0340231153143,1048.3386659324408,1.4947784280393035 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441090,1886.485972747094,1048.3386659324408,1.799500518345535 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441093,2222.8706410038644,1048.3386659324408,2.120374563335161 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441082,2226.548906237389,1048.3386659324408,2.1238832245655974 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441097,1196.100446504822,1048.3386659324408,1.1409485172818223 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441092,116571.9019278272,5453.602601951663,21.375210193370158 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441087,71280.53993923882,5453.602601951663,13.070358282748707 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441090,89258.63476357123,5453.602601951663,16.366912164012195 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441093,67044.51013856563,5453.602601951663,12.293618554929658 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441082,65788.07106464506,5453.602601951663,12.063231567533304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441097,93765.40213411818,5453.602601951663,17.193295694219206 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441092,216301.82012211537,64173.361133824874,3.3705858053943465 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441087,246220.0887216433,64173.361133824874,3.836795897415823 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441090,143365.59112131913,64173.361133824874,2.234035877010549 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441093,871232.3171899978,64173.361133824874,13.576230102287466 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441082,168029.0598743933,64173.361133824874,2.6183615273632217 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441097,129313.06055806804,64173.361133824874,2.015058246495818 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441092,21.31580971504395,44.60879663763593,0.47783870719928917 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441087,12.031316431948506,44.60879663763593,0.26970726266571876 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441090,7.887037449426394,44.60879663763593,0.17680453282553224 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441093,76.8138938299561,44.60879663763593,1.7219449888757836 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441082,41.42788697674704,44.60879663763593,0.9286932197089308 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441097,16.10946944809962,44.60879663763593,0.3611276398903853 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441092,135.0453313665478,136.29080299882398,0.9908616604725198 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441087,134.6435081794913,136.29080299882398,0.9879133823920101 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441090,147.3500842904014,136.29080299882398,1.0811447364623192 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441093,165.0777401589196,136.29080299882398,1.2112170192462952 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441082,138.9969163340617,136.29080299882398,1.0198554361387178 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441097,139.0660553956614,136.29080299882398,1.0203627268735176 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441092,46.97711476422548,82.77341642135346,0.567538671173014 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441087,237.51053697810244,82.77341642135346,2.869405991037851 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441090,291.9725558215063,82.77341642135346,3.5273710865724848 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441093,96.73200474021095,82.77341642135346,1.1686361264563743 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441082,114.93601475206953,82.77341642135346,1.3885619287114375 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441097,29.790662889409635,82.77341642135346,0.35990616525675256 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441092,4242.354295510943,2141.365658987758,1.9811442654386926 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441087,4594.851739812127,2141.365658987758,2.1457576479414326 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441090,3620.7476501255414,2141.365658987758,1.6908591183054185 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441093,6264.566400202042,2141.365658987758,2.925500543967515 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441082,5558.055515701566,2141.365658987758,2.595565821452889 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441097,3747.861565921661,2141.365658987758,1.7502202625652024 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441092,475.0948049622094,285.0677067828484,1.6666033845921209 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441087,377.3940256599571,285.0677067828484,1.3238750538216477 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441090,0.15497539460336762,285.0677067828484,5.43644162126792e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441093,391.5299350964723,285.0677067828484,1.3734629555732947 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441082,429.38286213288086,285.0677067828484,1.506248697822392 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441097,0.10437364878611408,285.0677067828484,3.6613634691922916e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441092,321933.21576016635,724296.655045942,0.44447701576054655 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441087,170283.26471862834,724296.655045942,0.23510154787036439 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441090,227781.94350009688,724296.655045942,0.31448708469549497 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441093,840398.6369429802,724296.655045942,1.1602961729675167 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441082,747344.152601233,724296.655045942,1.0318205218741885 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441097,151935.35570995937,724296.655045942,0.20976951177597544 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441092,172.17906619594697,126.94877083842833,1.35628777702058 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441087,28.50573290125792,126.94877083842833,0.2245451666289708 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441090,62.3803668283931,126.94877083842833,0.49138220414742373 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441093,9.65189557953546,126.94877083842833,0.07602984665223524 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441082,72.84861921811722,126.94877083842833,0.5738426511496826 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441097,23.633474885918275,126.94877083842833,0.18616544870684362 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441092,12653.002823000388,94593.87687362579,0.13376133044958471 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441087,12543.762860551367,94593.87687362579,0.13260649922731688 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441090,10885.31638486334,94593.87687362579,0.11507421774673378 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441093,28068.663118389577,94593.87687362579,0.29672811862747056 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441082,27615.829148772176,94593.87687362579,0.2919409803413173 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441097,7014.226299528292,94593.87687362579,0.0741509549175055 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441092,17.155633683544288,34.2642969985689,0.500685412698262 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441087,64.81347782731646,34.2642969985689,1.8915747149291722 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441090,1034.0688162095062,34.2642969985689,30.17919253538736 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441093,190.71706115967888,34.2642969985689,5.566057904752706 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441082,26.502877617231732,34.2642969985689,0.7734837699526905 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441097,125.49980662603843,34.2642969985689,3.662699007987239 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441092,292.7853620689132,74.66086218948179,3.9215373822747086 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441087,158.06268896809286,74.66086218948179,2.1170755913177857 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441090,31.20352777207909,74.66086218948179,0.4179368796048412 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441093,218.4436363527699,74.66086218948179,2.9258118637631294 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441082,23.76440992689695,74.66086218948179,0.3182980912621295 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441097,7.314198076948728,74.66086218948179,0.09796562566322936 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441092,1198.2549692142586,347.6986105145094,3.4462460676536284 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441087,788.0379326593263,347.6986105145094,2.266439694691968 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441090,1084.4476733412148,347.6986105145094,3.118930132439977 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441093,954.7601928832704,347.6986105145094,2.745941927896857 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441082,1164.3359055215385,347.6986105145094,3.3486930068503997 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441097,618.2552979648167,347.6986105145094,1.778135659069644 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441092,8330.321223875293,2521.321340016667,3.303950627657888 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441087,9545.43787044802,2521.321340016667,3.7858870739518355 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441090,10367.984487122369,2521.321340016667,4.112123402348164 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441093,6813.737291089486,2521.321340016667,2.7024469998911145 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441082,9328.821368779125,2521.321340016667,3.6999731929121964 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441097,9195.193936959771,2521.321340016667,3.6469742238008376 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441092,176.0621788599627,79.44971561377609,2.2160202525562545 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441087,177.46037621509072,79.44971561377609,2.2336187718753795 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441090,205.37453456338707,79.44971561377609,2.5849624882455386 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441093,153.99158934000715,79.44971561377609,1.9382270679054006 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441082,677.7766777850134,79.44971561377609,8.530888657674327 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441097,189.2419198207921,79.44971561377609,2.3819080831043116 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441092,41.30684875246438,42.37178439720435,0.9748668681319395 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441087,87.93965779954063,42.37178439720435,2.0754296532610224 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441090,301.37238533602857,42.37178439720435,7.112572425812513 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441093,228.07204497872175,42.37178439720435,5.382639608488372 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441082,101.44033196186442,42.37178439720435,2.39405381210609 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441097,114.98016914106988,42.37178439720435,2.7136022420773047 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441092,2900.0148068085928,1321.2949146990686,2.1948277969941974 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441087,2846.173279720743,1321.2949146990686,2.15407873598679 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441090,5148.867102470434,1321.2949146990686,3.896834117191099 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441093,4314.620168592557,1321.2949146990686,3.2654482512522445 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441082,1687.3125995082598,1321.2949146990686,1.2770143748661544 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441097,3771.312290574164,1321.2949146990686,2.854254753135941 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441092,85753.22605516974,23354.026662177774,3.6718818255889243 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441087,97545.46510533006,23354.026662177774,4.176815695055557 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441090,74813.36666226196,23354.026662177774,3.2034461441899196 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441093,110005.7739579025,23354.026662177774,4.710355757881301 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441082,69180.0619602287,23354.026662177774,2.962232721617422 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441097,45113.42159943212,23354.026662177774,1.931719195666332 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441092,77885.46518049896,13473.54115415771,5.780623244429308 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441087,57502.61054038045,13473.54115415771,4.267817189442888 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441090,92045.62258130674,13473.54115415771,6.831583585054995 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441093,48010.027372858,13473.54115415771,3.56328205210127 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441082,59401.28489031931,13473.54115415771,4.4087359225521094 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441097,68618.72986406588,13473.54115415771,5.092850430259107 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441092,111879.15414812676,49612.48263442616,2.2550605857102117 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441087,101212.47522568368,49612.48263442616,2.0400606833460944 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441090,113412.86070759875,49612.48263442616,2.2859743089917743 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441093,181634.17673083485,49612.48263442616,3.6610580056882434 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441082,158085.52232788678,49612.48263442616,3.1864062012932015 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441097,92176.59946538268,49612.48263442616,1.8579316045236816 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441077,121.07406653909734,73.06854961986588,1.6569928809176708 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441066,119.30638699616884,73.06854961986588,1.6328008098812983 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441075,137.3938855621154,73.06854961986588,1.8803423124846144 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441072,147.34035270246602,73.06854961986588,2.0164674606105377 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441055,62.70635092094633,73.06854961986588,0.8581852417650524 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441077,30.86936986032912,990.9231863649335,0.03115213195643266 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441066,68.23751398476783,990.9231863649335,0.06886256666885336 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441075,287.5580046756008,990.9231863649335,0.29019202359212937 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441072,83.0147520831177,990.9231863649335,0.08377516363064022 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441055,75.74619483372989,990.9231863649335,0.07644002671044006 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441065,1249.3113970522948,990.9231863649335,1.2607550355494488 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441077,58.31457817035037,50.719124328797626,1.149755224327486 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441066,59.831002080716,50.719124328797626,1.1796536882783832 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441075,58.80112826285307,50.719124328797626,1.1593482545491542 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441072,47.71140585428407,50.719124328797626,0.9406985330619003 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441055,54.591186479625335,50.719124328797626,1.0763432374290658 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441077,308.2754962891483,319.2477137201226,0.96563102268418 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441066,320.6926211179418,319.2477137201226,1.0045259757101532 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441075,340.6790062402421,319.2477137201226,1.0671306061064163 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441072,310.3199837482791,319.2477137201226,0.9720351013079761 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441055,336.5887473521794,319.2477137201226,1.0543184269982253 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441065,310.4302274054259,319.2477137201226,0.9723804245551253 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441077,66.2605181409528,44.58166891160943,1.4862727160870828 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441066,133.8649353190993,44.58166891160943,3.0026900873654774 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441075,34.587801870279,44.58166891160943,0.7758301273748874 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441072,214.083271904794,44.58166891160943,4.802047055018279 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441055,10.466249346577175,44.58166891160943,0.23476575915828218 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441077,2337.9831421017034,1543.2839395802719,1.5149403697789834 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441066,4153.600474111503,1543.2839395802719,2.691403939084055 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441075,1550.0924771438076,1543.2839395802719,1.0044117206101344 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441072,2091.955283289622,1543.2839395802719,1.355521968211872 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441055,1930.4076077006785,1543.2839395802719,1.2508440982193418 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441065,2989.648638380867,1543.2839395802719,1.9371993459570143 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441077,33.387014852256414,31.276034215973343,1.0674951504946542 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441066,41.633153363799295,31.276034215973343,1.3311519317412803 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441075,22.96879260498044,31.276034215973343,0.7343895471648315 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441072,41.182569636612925,31.276034215973343,1.3167452546007288 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441055,12.933045494493298,31.276034215973343,0.4135129602808822 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441077,100.33291243357372,130.468422036268,0.7690206631431694 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441066,67.37715328827316,130.468422036268,0.5164249880292371 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441075,99.6589428789845,130.468422036268,0.7638548954878983 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441072,26.826925542891768,130.468422036268,0.2056200659454158 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441055,48.71603525334575,130.468422036268,0.3733933046251109 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441065,28.025869650015416,130.468422036268,0.21480960076473293 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441077,102.72984589774552,95.42663227533711,1.076532236842816 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441066,112.91588567033814,95.42663227533711,1.1832743436291329 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441075,150.13122470114777,95.42663227533711,1.5732633660168367 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441072,108.90360361708906,95.42663227533711,1.1412286174248136 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441055,90.930080797889,95.42663227533711,0.9528794910788209 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441077,580.7283383858994,569.3868516791151,1.019918771698606 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441066,643.4411734869858,569.3868516791151,1.1300597679582614 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441075,573.5433719556446,569.3868516791151,1.0072999934302522 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441072,517.4217762953878,569.3868516791151,0.9087350274589535 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441055,674.6880555415344,569.3868516791151,1.184937891614264 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441065,631.7726473541978,569.3868516791151,1.1095666250302545 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441077,2359.5522545176013,5328.634617598269,0.44280616402651807 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441066,162.02996766883587,5328.634617598269,0.030407408144239825 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441075,2376.3946268579084,5328.634617598269,0.4459668934720469 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441072,1097.076114342441,5328.634617598269,0.20588315639418284 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441055,15801.77417902226,5328.634617598269,2.9654452431089116 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441077,732744.9999639314,656386.6079991342,1.1163314288168686 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441066,917172.7816714084,656386.6079991342,1.3973057501389763 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441075,649137.7415557747,656386.6079991342,0.9889564071615412 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441072,834788.8102983461,656386.6079991342,1.2717943969683294 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441055,829250.1514786555,656386.6079991342,1.2633562924241581 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441065,830839.2424026555,656386.6079991342,1.2657772603486015 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441077,2313.147519715591,5223.837669019135,0.44280616402651807 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441066,158.84336408111923,5223.837669019135,0.030407408144239825 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441075,2329.658657254722,5223.837669019135,0.4459668934720468 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441072,1075.5001877884906,5223.837669019135,0.20588315639418292 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441055,15491.004566365938,5223.837669019135,2.9654452431089116 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441077,732744.9999639314,656386.6079991342,1.1163314288168686 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441066,917172.7816714084,656386.6079991342,1.3973057501389763 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441075,649137.7415557747,656386.6079991342,0.9889564071615412 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441072,834788.8102983461,656386.6079991342,1.2717943969683294 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441055,829250.1514786555,656386.6079991342,1.2633562924241581 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441065,830839.2424026555,656386.6079991342,1.2657772603486015 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441077,52.43108596949835,50.79723336807032,1.0321642044870698 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441066,48.499082885871694,50.79723336807032,0.954758353362544 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441075,36.07728311102058,50.79723336807032,0.7102214179581229 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441072,31.50800199853949,50.79723336807032,0.6202700405007591 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441055,36.603999415818706,50.79723336807032,0.7205904138635023 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441077,71.14352033412581,124.85055234194422,0.5698294400754906 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441066,46.03681165605901,124.85055234194422,0.36873534632007143 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441075,244.3505438698855,124.85055234194422,1.9571442759872726 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441072,203.86509921608865,124.85055234194422,1.632873026125965 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441055,99.46322286773992,124.85055234194422,0.7966582526229218 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441065,76.01271798543051,124.85055234194422,0.6088296492052733 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441077,155.5247718079159,149.81706398084205,1.038097848638949 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441066,172.432236815806,149.81706398084205,1.1509519158502257 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441075,155.70248200521024,149.81706398084205,1.0392840299227917 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441072,96.03512789175436,149.81706398084205,0.6410159519881855 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441055,240.1238227529733,149.81706398084205,1.602780193207359 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441077,3224.4071702280185,2791.14294318225,1.1552282473042363 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441066,4004.8781077617305,2791.14294318225,1.4348523845918373 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441075,3715.973813849689,2791.14294318225,1.331344861045711 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441072,3204.848086428394,2791.14294318225,1.1482206936970663 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441055,4101.359360504295,2791.14294318225,1.4694193181766018 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441065,3361.5972484754425,2791.14294318225,1.2043801829234886 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441077,263.45567467459455,222.01180748199775,1.1866741578416156 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441066,318.22591207229164,222.01180748199775,1.4333738177330753 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441075,166.59087577880905,222.01180748199775,0.7503694405637295 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441072,293.19187240429477,222.01180748199775,1.3206138706296906 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441055,1022.3830569766594,222.01180748199775,4.60508415553331 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441077,6914.399259846241,4330.453784028004,1.5966916181737336 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441066,8519.609034995363,4330.453784028004,1.9673709638509953 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441075,4645.267311113441,4330.453784028004,1.0726975838528892 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441072,5617.397934488942,4330.453784028004,1.2971845941890825 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441055,6150.312121888079,4330.453784028004,1.4202465673625826 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441065,9916.923183153038,4330.453784028004,2.2900424938674067 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441077,20.324890910171337,100.4664893584531,0.20230517697950426 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441066,19.742524794792445,100.4664893584531,0.19650855644366494 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441075,111.17403169379511,100.4664893584531,1.1065782471719372 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441072,27.32796497287128,100.4664893584531,0.2720107485329579 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441055,1.605999318698813,100.4664893584531,0.015985422890301148 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441077,244.40065581365064,219.8603821991507,1.111617533677674 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441066,518.3900870829617,219.8603821991507,2.3578149091608567 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441075,60.798858659851895,219.8603821991507,0.2765339441863608 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441072,222.0319856515859,219.8603821991507,1.0098771931109813 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441055,340.61467612498893,219.8603821991507,1.5492317111341067 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441065,777.7916911402975,219.8603821991507,3.5376618714133303 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441077,186.3608396214368,115.26780159034894,1.6167640663760199 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441066,114.98219917888171,115.26780159034894,0.997522270681606 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441075,69.24065445359591,115.26780159034894,0.6006938060610435 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441072,124.46153356131023,115.26780159034894,1.0797597580947624 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441055,177.5873488588275,115.26780159034894,1.5406500896924924 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441077,1776.9307007739549,1760.6737631139824,1.0092333616826434 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441066,1144.6511862170148,1760.6737631139824,0.6501211128361163 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441075,1385.3735077379097,1760.6737631139824,0.786842819357798 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441072,1898.385352916362,1760.6737631139824,1.078215279109299 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441055,1451.3838129158412,1760.6737631139824,0.8243343220772931 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441065,827.5711575610602,1760.6737631139824,0.47003094775342824 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441077,981.0150160320404,518.6000624505415,1.8916600422229974 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441066,628.9933061489887,518.6000624505415,1.2128677794152316 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441075,294.59806639997134,518.6000624505415,0.5680640781412689 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441072,479.7634182363009,518.6000624505415,0.9251125346365642 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441055,3441.7777292572296,518.6000624505415,6.636670487453845 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441077,888.6461748275806,841.89306662726494,1.0555333094589017 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441066,1409.46351719179,841.89306662726494,1.6741597871072718 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441075,985.5265133607608,841.89306662726494,1.1706077083030395 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441072,696.8837627226233,841.89306662726494,0.8277580495043532 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441055,1199.3598085710787,841.89306662726494,1.4245987478859672 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441065,3959.6738413636585,841.89306662726494,4.703297839506668 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441077,268.27475815473093,246.94010350613598,1.0863960707300215 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441066,325.2366371566126,246.94010350613598,1.3170669022114956 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441075,282.4464827238203,246.94010350613598,1.1437853905200215 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441072,225.22621535090488,246.94010350613598,0.9120681985350688 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441055,533.3215223472649,246.94010350613598,2.15972017009385 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441077,7929.117383401563,6405.278640912654,1.237903583578026 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441066,3761.527032809614,6405.278640912654,0.5872542388372435 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441075,3358.1865823031553,6405.278640912654,0.5242842303304802 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441072,6743.30266388732,6405.278640912654,1.052772727296451 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441055,4254.803408767803,6405.278640912654,0.6642651549287728 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441065,3489.756068799222,6405.278640912654,0.5448250208053377 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441077,210.46563322089477,184.84349394551683,1.1386153157380272 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441066,345.81840662290267,184.84349394551683,1.8708714017537111 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441075,212.77220929824378,184.84349394551683,1.1510938511093012 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441072,123.6671413159096,184.84349394551683,0.6690370251947351 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441055,155.10601690562615,184.84349394551683,0.8391207804768293 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441077,40198.710761498776,66689.05961878091,0.6027781916747563 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441066,35564.25577915387,66689.05961878091,0.5332847094028943 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441075,71093.73819747986,66689.05961878091,1.0660479935371365 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441072,64691.21386026093,66689.05961878091,0.9700423762167227 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441055,57409.36911900156,66689.05961878091,0.8608513817284955 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441065,42165.872206363056,66689.05961878091,0.6322757053015685 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441077,737.1512417774027,426.591426110135,1.7280029476895513 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441066,1075.197168694805,426.591426110135,2.5204378308747737 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441075,727.6383122502789,426.591426110135,1.7057030866401457 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441072,860.7493717474982,426.591426110135,2.0177371580020336 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441055,658.6458392141041,426.591426110135,1.5439734577414093 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441077,6793.744514623467,6086.038398766024,1.1162835443169292 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441066,612711.5025053015,6086.038398766024,100.6749320920374 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441075,2724.3889352053698,6086.038398766024,0.44764570262286774 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441072,287306.31287942204,6086.038398766024,47.20744334075757 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441055,335226.09500470007,6086.038398766024,55.0811666046453 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441065,3809.933798898146,6086.038398766024,0.626012119751106 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441077,150.69066486986247,118.38689307733607,1.2728661167873037 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441066,107.53287190804834,118.38689307733607,0.9083173746083752 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441075,31.020752171867173,118.38689307733607,0.26202860270691375 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441072,114.67702432406078,118.38689307733607,0.9686631800460224 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441055,589.8796535950706,118.38689307733607,4.982643249280413 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441077,11.581552081450656,43.003791743375764,0.2693146723099053 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441066,618.4319357136427,43.003791743375764,14.380869933612423 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441075,69.3695736809496,43.003791743375764,1.6131036559499472 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441072,35.47075176188978,43.003791743375764,0.8248284703256111 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441055,103.12605867636948,43.003791743375764,2.3980689724239226 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441065,128.7799211525828,43.003791743375764,2.9946178216347596 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441077,73.4029789526354,56.77751951238643,1.2928176430219358 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441066,90.27126111567526,56.77751951238643,1.5899120266425506 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441075,43.64598518403374,56.77751951238643,0.7687194783934168 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441072,10.704580407971587,56.77751951238643,0.18853554188178837 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441055,54.2299928953212,56.77751951238643,0.9551314210457985 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441077,365.8191578194755,232.93832449773902,1.5704550060976603 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441066,132.9947050670977,232.93832449773902,0.5709438554340962 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441075,176.1367603507458,232.93832449773902,0.7561519158795849 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441072,126.7451716769466,232.93832449773902,0.5441147219987702 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441055,282.67357092486276,232.93832449773902,1.2135125103795725 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441065,278.48083578555287,232.93832449773902,1.1955131745109462 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441077,69.78634660658744,55.88566907011774,1.2487342062421947 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441066,99.40065970333852,55.88566907011774,1.7786431004095895 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441075,33.3813178697488,55.88566907011774,0.5973144533326864 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441072,18.1362569025791,55.88566907011774,0.32452428689409063 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441055,43.95077708471968,55.88566907011774,0.7864409215460267 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441077,60.6624891801438,226.42114305345407,0.2679188363863283 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441066,158.06951508763743,226.42114305345407,0.6981217078756642 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441075,137.13516328127815,226.42114305345407,0.6056641240827184 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441072,218.29910613165816,226.42114305345407,0.9641286285712354 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441055,159.76110895051374,226.42114305345407,0.7055927145142843 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441065,639.8157375007914,226.42114305345407,2.825777349554949 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441077,204.60432864712016,212.71806341276286,0.961856860506018 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441066,290.0175299472491,212.71806341276286,1.3633892923540425 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441075,178.70788116054365,212.71806341276286,0.840116153247291 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441072,288.487661436743,212.71806341276286,1.3561972914211575 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441055,439.6452737861909,212.71806341276286,2.0667980270819477 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441077,18537.198548424043,10996.969545575432,1.685664261558529 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441066,11124.83245381758,10996.969545575432,1.0116271039682558 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441075,8954.829039927035,10996.969545575432,0.8142997034605738 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441072,13799.884548111018,10996.969545575432,1.254880673345442 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441055,7559.76306804031,10996.969545575432,0.6874405750338681 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441065,9477.187177793325,10996.969545575432,0.8617998930083804 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441077,193.44636379498067,147.8550055811589,1.308351807465837 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441066,147.54195991290936,147.8550055811589,0.997882752315222 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441075,184.22120337991026,147.8550055811589,1.2459585162897284 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441072,168.24903014636527,147.8550055811589,1.137932594740676 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441055,382.800840724225,147.8550055811589,2.5890286177298356 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441077,179.06186496134814,92.19915296117537,1.9421204990543703 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441066,130.3175574478207,92.19915296117537,1.4134355171646402 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441075,148.65529638137698,92.19915296117537,1.612328222190664 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441072,91.83823121689628,92.19915296117537,0.9960854114957968 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441055,279.3093526209468,92.19915296117537,3.0294134344006682 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441065,260.2549159711992,92.19915296117537,2.822747363859094 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441077,1607.9385725458278,1229.7970051816276,1.3074829144736393 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441066,1427.1504255415564,1229.7970051816276,1.1604764197086184 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441075,827.2630639170159,1229.7970051816276,0.6726826138227895 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441072,1459.8470726870885,1229.7970051816276,1.18706344749269 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441055,8779.262595757542,1229.7970051816276,7.13879002694509 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441077,90054.54329155055,50083.06853493704,1.7981035492809339 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441066,126049.84669028998,50083.06853493704,2.5168155701633954 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441075,86506.21791548106,50083.06853493704,1.7272547478822287 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441072,69434.42239411465,50083.06853493704,1.386385148219871 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441055,91803.02088271268,50083.06853493704,1.8330151000766368 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441065,108272.861806417,50083.06853493704,2.1618655760057477 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441077,31.52043334702651,35.678906774941794,0.8834472856989025 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441066,80.07949939357682,35.678906774941794,2.2444493576753506 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441075,12.198169111659528,35.678906774941794,0.34188741231910763 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441072,127.09796262383377,35.678906774941794,3.562271776586437 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441055,11.6531801626465,35.678906774941794,0.3266125903507454 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441077,62.37033577563431,67.70693010562654,0.9211809733262629 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441066,12.631737693851742,67.70693010562654,0.1865649154989827 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441075,29.67078199095724,67.70693010562654,0.43822370833634294 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441072,214.85344444468495,67.70693010562654,3.173285867628347 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441055,21.918844124823032,67.70693010562654,0.3237311762714456 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441065,85.33075866999297,67.70693010562654,1.26029578562892 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441077,43.84987637378829,64.01321127549492,0.685012913741676 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441066,90.1257288317556,64.01321127549492,1.4079238806483199 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441075,82.90093888754424,64.01321127549492,1.2950598358635974 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441072,25.760760731785098,64.01321127549492,0.4024288145913818 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441055,21.813936570205797,64.01321127549492,0.34077241456181173 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441077,489.639413349133,1060.427767412219,0.4617376387116011 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441066,928.1407035837548,1060.427767412219,0.8752512260676776 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441075,902.3742234691478,1060.427767412219,0.8509530315970769 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441072,682.5652651901497,1060.427767412219,0.6436697398596285 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441055,641.4785327916082,1060.427767412219,0.6049243074396475 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441065,682.8529225736163,1060.427767412219,0.643941005279402 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441077,9.470098897202782,57.09593719876665,0.16586292058285626 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441066,52.173054797858754,57.09593719876665,0.9137787618097941 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441075,19.149505880603513,57.09593719876665,0.3353917427423745 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441072,60.99994030543554,57.09593719876665,1.0683761979959796 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441055,116.56219534445374,57.09593719876665,2.041514704254152 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441077,348.8639601608881,50.205845180981015,6.948672189529135 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441066,60.88873342316851,50.205845180981015,1.2127817628341488 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441075,5.887209601164481,50.205845180981015,0.11726143798480809 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441072,114.05992786485638,50.205845180981015,2.271845587972784 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441055,8.509814493822498,50.205845180981015,0.16949848096663828 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441065,5.51647316854787,50.205845180981015,0.10987710989949874 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441077,934.086910913122,1506.8779059558976,0.6198822792617548 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441066,1226.0708413183947,1506.8779059558976,0.8136497565412434 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441075,722.0685083005967,1506.8779059558976,0.4791818271716898 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441072,1076.9283069765966,1506.8779059558976,0.7146752253251999 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441055,8733.165152840284,1506.8779059558976,5.7955360008416505 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441077,30827.069744919216,16162.128318216166,1.9073644966779746 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441066,39833.73150616749,16162.128318216166,2.4646340334565533 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441075,22748.3562759562,16162.128318216166,1.4075099410216145 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441072,16945.960063630548,16162.128318216166,1.0484980523592882 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441055,25753.415980604117,16162.128318216166,1.5934421181137208 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441065,35663.23444976913,16162.128318216166,2.206592705341503 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441077,83.8479681618037,24.995311385825953,3.354547853696723 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441066,27.334111231869027,24.995311385825953,1.0935695423010146 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441075,54.71129483996765,24.995311385825953,2.1888623028314296 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441072,37.687012165681786,24.995311385825953,1.5077632594348431 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441055,64.27545653826206,24.995311385825953,2.5715005324842894 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441077,1740.2575282095106,522.7489803443298,3.3290500673252765 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441066,2741.3666920177056,522.7489803443298,5.244135895228324 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441075,1155.0073303050976,522.7489803443298,2.2094874858374767 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441072,998.7577077349272,522.7489803443298,1.910587576999299 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441055,4581.02810233977,522.7489803443298,8.763342014215485 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441065,2387.5758914048192,522.7489803443298,4.567346816883594 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441077,3.4364136081056325,2.8430683750443606,1.2086988966813061 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441066,3.215363017936294,2.8430683750443606,1.1309481847710134 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441075,3.3958845125935544,2.8430683750443606,1.1944434901396166 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441072,3.193722631554908,2.8430683750443606,1.1233365541217686 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441055,3.142536366059859,2.8430683750443606,1.1053326728418291 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441077,2369.950112606163,1771.7543971110147,1.3376290283069447 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441066,3518.1608346288235,1771.7543971110147,1.9856932994581316 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441075,2080.5925447971235,1771.7543971110147,1.1743120537415874 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441072,1870.304823305785,1771.7543971110147,1.0556230741436086 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441055,4931.602916632451,1771.7543971110147,2.7834574163743113 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441065,3910.029875204595,1771.7543971110147,2.206869011630623 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441077,128.9233780975643,73.62821549612136,1.7510050627854186 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441066,60.68713104970555,73.62821549612136,0.8242374290994798 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441075,29.254019704241834,73.62821549612136,0.3973207758346785 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441072,5.870031560869887,73.62821549612136,0.07972529989103312 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441055,82.73586812957684,73.62821549612136,1.123697859198221 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441077,673.1588480770346,1923.334023596175,0.3499958092658229 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441066,642.836648978757,1923.334023596175,0.33423037345162027 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441075,1251.9374381603102,1923.334023596175,0.6509204448114979 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441072,1390.5991288898683,1923.334023596175,0.7230148855214344 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441055,1057.5326511920796,1923.334023596175,0.549843468798387 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441065,5720.864678981983,1923.334023596175,2.974451971834478 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441077,45.17933412493172,51.40813337414527,0.8788363077904282 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441066,54.654548646214074,51.40813337414527,1.063149837564449 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441075,8.309830805116686,51.40813337414527,0.16164428193955696 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441072,49.61363745524703,51.40813337414527,0.965093151586773 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441055,12.187837380628332,51.40813337414527,0.23707994398329915 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441077,34.63439117523429,89.1451395839603,0.38851687637568055 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441066,42.806120886074375,89.1451395839603,0.4801845741209248 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441075,50.6557888610498,89.1451395839603,0.568239492331943 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441072,111.5327789659108,89.1451395839603,1.2511369603147569 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441055,95.54634626427276,89.1451395839603,1.0718065697152626 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441065,41.37562527925051,89.1451395839603,0.4641377586299179 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441077,9034.984880706748,4771.656231796832,1.8934693619587306 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441066,5396.9759872185905,4771.656231796832,1.1310487857978582 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441075,3810.2806039346733,4771.656231796832,0.7985237030581016 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441072,3953.255862576281,4771.656231796832,0.8284871479703451 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441055,23026.001616227335,4771.656231796832,4.825578477927481 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441077,310190.9489093691,209884.98459768714,1.4779091963341302 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441066,591475.0977571468,209884.98459768714,2.8180915318496997 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441075,308179.8543274676,209884.98459768714,1.4683273075403396 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441072,246887.74265308108,209884.98459768714,1.1763001680483325 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441055,281491.46369286964,209884.98459768714,1.3411700900492696 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441065,109507.86652834404,209884.98459768714,0.5217517905735443 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441077,132.91900180717488,22.903585106474594,5.803414670203755 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441066,201.9276131956667,22.903585106474594,8.816419449485398 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441075,98.53611096221212,22.903585106474594,4.302213409129431 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441072,14.04277004468447,22.903585106474594,0.6131254115633946 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441055,9.060576479443013,22.903585106474594,0.3955964290010513 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441077,385.10193011419017,83.56495705722055,4.608414144825015 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441066,86.45492936705345,83.56495705722055,1.034583543289013 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441075,73.12314271919305,83.56495705722055,0.8750455369602173 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441072,29.125040559110392,83.56495705722055,0.34853174805280174 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441055,40.09432168285488,83.56495705722055,0.47979826825496436 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441065,109.76373272272552,83.56495705722055,1.3135139008994587 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441077,1982.3549252350624,1829.6496491832456,1.0834614846180985 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441066,2022.542876862483,1829.6496491832456,1.1054263190580473 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441075,1822.1094982674454,1829.6496491832456,0.9958789099764722 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441072,1212.2387432831715,1829.6496491832456,0.6625523874607984 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441055,1227.234682686248,1829.6496491832456,0.6707484589927284 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441077,135615.09896244053,96234.19538703516,1.4092194403145688 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441066,100911.86414344623,96234.19538703516,1.0486071373860237 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441075,92479.87265499817,96234.19538703516,0.9609876435612327 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441072,81624.40581279134,96234.19538703516,0.8481850498620985 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441055,95613.61768813193,96234.19538703516,0.9935513806042916 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441065,60639.020325852136,96234.19538703516,0.6301192635525639 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441077,56.47020648944649,77.99112650544876,0.7240593772613512 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441066,140.77597035025744,77.99112650544876,1.8050254773589183 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441075,118.90841259214501,77.99112650544876,1.5246402753759123 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441072,128.53044638968117,77.99112650544876,1.648013718338862 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441055,102.40491429058844,77.99112650544876,1.3130328907793636 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441077,45.16212235197282,110.33780757772625,0.4093077734951264 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441066,102.35268282970532,110.33780757772625,0.9276302028894683 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441075,1.615204711762703,110.33780757772625,0.014638723998796966 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441072,157.55236273644866,110.33780757772625,1.4279091292027226 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441055,161.7928424512287,110.33780757772625,1.466340921603463 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441065,184.86092404994585,110.33780757772625,1.6754087117393792 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441077,68.71223754466399,67.31067174214355,1.020822341632388 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441066,70.96380974764439,67.31067174214355,1.0542727907915617 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441075,55.08158930018965,67.31067174214355,0.8183188174261345 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441072,41.58425347291822,67.31067174214355,0.6177958471759257 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441055,53.71182943437541,67.31067174214355,0.7979690002223846 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441077,2929.32291799028,2375.529574917848,1.2331241626792138 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441066,4458.199162592489,2375.529574917848,1.8767180209687204 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441075,2809.4435469841505,2375.529574917848,1.1826598905135957 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441072,2804.0198196352017,2375.529574917848,1.1803767249381316 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441055,3132.14426776335,2375.529574917848,1.318503587930143 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441065,1927.6197101431576,2375.529574917848,0.811448415753704 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441077,216.09035978991128,194.62377093849457,1.1102978775300814 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441066,233.455760009577,194.62377093849457,1.1995233618372043 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441075,211.13296123821158,194.62377093849457,1.0848261762687472 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441072,272.8677140737698,194.62377093849457,1.4020266525408247 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441055,264.9887561027315,194.62377093849457,1.3615436327480974 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441077,4496.998231582671,3728.1507253933823,1.2062275811309002 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441066,6029.612684068717,3728.1507253933823,1.6173199873598167 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441075,3436.26702393256,3728.1507253933823,0.921708181090231 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441072,3744.283506136904,3728.1507253933823,1.0043272876908214 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441055,4525.4815804054515,3728.1507253933823,1.2138676555057837 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441065,4948.83761465725,3728.1507253933823,1.327424232327695 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441077,97.03517710413333,68.78582331086372,1.4106856970454846 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441066,102.6565310655932,68.78582331086372,1.4924082626976436 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441075,152.29998636003015,68.78582331086372,2.2141188260804983 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441072,46.81420441309118,68.78582331086372,0.6805792554306399 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441055,133.45603204117322,68.78582331086372,1.9401676917937796 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441077,712.3129688407842,696.3940975413478,1.022858998023732 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441066,856.2898499993953,696.3940975413478,1.229605266647961 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441075,608.8472586021182,696.3940975413478,0.8742854954567855 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441072,787.2957101318326,696.3940975413478,1.1305318538905158 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441055,873.5478755380365,696.3940975413478,1.2543872479995715 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441065,1496.262173038429,696.3940975413478,2.148585374748369 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441077,93.09498168403806,81.2393188807366,1.1459350344961183 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441066,223.80180070184176,81.2393188807366,2.754845852787048 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441075,57.434175369607196,81.2393188807366,0.70697509729154 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441072,27.678482383815965,81.2393188807366,0.3407030335206203 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441055,45.16575016061328,81.2393188807366,0.5559592421856573 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441077,241.998483567119,543.8205698619286,0.444996929094757 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441066,496.6827966784124,543.8205698619286,0.9133210919265448 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441075,246.4902956924683,543.8205698619286,0.4532566610252534 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441072,304.89,543.8205698619286,0.5606444788901769 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441055,235.87353059360615,543.8205698619286,0.4337341094940422 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441065,576.2189135753615,543.8205698619286,1.0595754289354273 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441077,176004.893642957,306516.0644612488,0.5742109926679173 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441066,207664.2934409871,306516.0644612488,0.6774988900043148 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441075,155173.15872862225,306516.0644612488,0.5062480460897343 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441072,106545.41678106178,306516.0644612488,0.34760141191402955 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441055,704157.5104213952,306516.0644612488,2.2972939824836427 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441077,464438.05564529746,335923.8645439917,1.3825693993957846 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441066,862095.9174171847,335923.8645439917,2.5663431759677406 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441075,365098.66275694914,335923.8645439917,1.0868494361142265 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441072,362847.4856792418,335923.8645439917,1.0801479858294625 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441055,456134.31179030327,335923.8645439917,1.357850274821928 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441065,1012812.3383076744,335923.8645439917,3.015005616473667 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441077,34.96852459651669,33.931355493730415,1.0305666864083256 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441066,0.9215219222541012,33.931355493730415,0.02715841760062822 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441075,17.730073258916804,33.931355493730415,0.5225277033861154 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441072,31.82945499002164,33.931355493730415,0.9380543313662448 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441055,54.87633441484245,33.931355493730415,1.6172750429903129 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441077,175.74678477581728,76.3332642617619,2.302361709216924 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441066,70.53359817476634,76.3332642617619,0.9240217729048328 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441075,225.64201995516532,76.3332642617619,2.956011669845457 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441072,32.09198872471377,76.3332642617619,0.4204194466866238 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441055,141.38054593109163,76.3332642617619,1.8521485658764665 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441065,48.40201097169421,76.3332642617619,0.6340880537443561 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441077,147.2549230144662,130.67426801703346,1.12688538645781 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441066,161.69081100742017,130.67426801703346,1.2373576945259315 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441075,91.09770515790497,130.67426801703346,0.6971357600872907 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441072,33.48517966120614,130.67426801703346,0.2562492231205101 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441055,326.9080488882798,130.67426801703346,2.5017017799224797 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441077,6781.603645534662,5444.214081294075,1.2456533751741616 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441066,7496.852099637579,5444.214081294075,1.3770310990150478 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441075,7158.339963338118,5444.214081294075,1.3148527696465233 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441072,6556.378769733315,5444.214081294075,1.2042837904300194 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441055,7451.653625830651,5444.214081294075,1.3687289872442734 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441065,5657.034312112381,5444.214081294075,1.0390910841565801 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441077,57.84526338605677,100.67607722942154,0.5745681097033456 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441066,52.13988250856703,100.67607722942154,0.5178974384326696 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441075,38.144589065579744,100.67607722942154,0.3788843399078365 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441072,124.91971748278682,100.67607722942154,1.240808352098569 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441055,57.92006650297154,100.67607722942154,0.5753111175655243 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441077,588.42765328467965,599.1099853739104,0.9821696644188567 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441066,617.5790791277647,599.1099853739104,1.0308275512088612 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441075,507.9024788022968,599.1099853739104,0.8477616651395151 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441072,618.5283645380281,599.1099853739104,1.032412043928793 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441055,576.4189368686508,599.1099853739104,0.9621254042509442 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441065,624.0343790905584,599.1099853739104,1.041602367386837 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441077,72.52371456267255,114.30018844822946,0.6345021434109102 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441066,216.8205518381331,114.30018844822946,1.8969395832303346 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441075,148.30462983143843,114.30018844822946,1.2975011838988417 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441072,140.8113778303042,114.30018844822946,1.2319435316948981 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441055,18.99148057130553,114.30018844822946,0.166154411721792 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441077,1778.0414168105217,1759.6959467320276,1.0104253636047544 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441066,4675.075561813416,1759.6959467320276,2.656751906768671 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441075,2276.0099061107703,1759.6959467320276,1.29341089313617 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441072,1984.435357359279,1759.6959467320276,1.1277149106609128 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441055,2631.161851809355,1759.6959467320276,1.495236638292966 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441065,2170.56130879855,1759.6959467320276,1.23348656501116 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441077,99.17908009398546,38.77498679262034,2.5578108027327873 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441066,81.4889981289803,38.77498679262034,2.1015867410814772 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441075,180.90745364947762,38.77498679262034,4.665570993409286 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441072,175.79167549007337,38.77498679262034,4.533635986267572 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441055,59.3903649731244,38.77498679262034,1.531666929785456 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441077,812.5206491816652,2284.874121495706,0.35560849568805986 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441066,1402.1832501172814,2284.874121495706,0.6136807436898956 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441075,1454.8474792108068,2284.874121495706,0.6367298161084017 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441072,1190.493640953787,2284.874121495706,0.5210324847893484 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441055,2339.309928598113,2284.874121495706,1.0238244227943607 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441065,1123.0626805454383,2284.874121495706,0.49152059186974734 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441077,387.4904224886654,306.4947439651267,1.2642644943130068 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441066,273.4312095673409,306.4947439651267,0.8921236495933261 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441075,306.92134140915573,306.4947439651267,1.00139185892231 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441072,403.61696192813656,306.4947439651267,1.3168805334360334 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441055,538.661914003539,306.4947439651267,1.7574915218279519 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441077,48759.25908810583,53872.22448470133,0.9050908804026185 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441066,61534.31562126797,53872.22448470133,1.1422271162896294 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441075,51888.118081660534,53872.22448470133,0.9631701415336165 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441072,60562.3120876732,53872.22448470133,1.1241843578386432 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441055,73597.50847765165,53872.22448470133,1.366149424524913 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441065,73561.24911542474,53872.22448470133,1.3654763622451624 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441077,80.94371079445523,320.29657233769314,0.252714882971383 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441066,77.35095791767942,320.29657233769314,0.2414979259788245 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441075,119.65371232189787,320.29657233769314,0.3735716290955037 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441072,345.3116562369095,320.29657233769314,1.078099755225737 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441055,163.7176185188938,320.29657233769314,0.511143835614588 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441077,11733.22308592751,6299.521117687065,1.862557941584532 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441066,16458.849689483963,6299.521117687065,2.6127144241603877 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441075,9920.713953379369,6299.521117687065,1.57483620866436 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441072,9037.107827240585,6299.521117687065,1.4345706059889602 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441055,18291.90626474763,6299.521117687065,2.903697903859666 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441065,16426.3947399337,6299.521117687065,2.6075624532495927 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441077,2290.628821513618,1965.7827420843205,1.1652502448387876 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441066,1445.3850640572596,1965.7827420843205,0.7352720283446568 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441075,1148.95393678246,1965.7827420843205,0.5844765610080713 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441072,1105.7591107506062,1965.7827420843205,0.5625032141538536 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441055,1871.2561009130284,1965.7827420843205,0.9519139937757998 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441077,9861.739541335051,6243.797224888628,1.579445838187187 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441066,13620.926600640383,6243.797224888628,2.1815132859128594 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441075,9478.33520568993,6243.797224888628,1.5180402028284954 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441072,8181.78360911079,6243.797224888628,1.3103858620675706 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441055,13564.692087274769,6243.797224888628,2.17250682536647 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441065,10962.62432214656,6243.797224888628,1.7557623874215584 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441077,569.6914786224346,477.14850073021523,1.1939500548583808 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441066,327.60735683042276,477.14850073021523,0.6865941239028547 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441075,299.90656528230693,477.14850073021523,0.6285392594199457 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441072,374.7294959231535,477.14850073021523,0.7853519299540448 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441055,528.8700863158579,477.14850073021523,1.1083972505550983 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441077,216.16943770137513,205.1372392304115,1.0537795990252758 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441066,433.5515066399584,205.1372392304115,2.1134705149901647 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441075,320.85899272405925,205.1372392304115,1.5641187037896533 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441072,322.3671368923636,205.1372392304115,1.5714705828242073 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441055,285.22508845392707,205.1372392304115,1.3904110707737485 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441065,192.65504052706513,205.1372392304115,0.9391519611447715 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441077,74.90201827968107,44.32085041603382,1.6899950604870162 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441066,5.557214404327442,44.32085041603382,0.12538600573234995 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441075,22.848551985458418,44.32085041603382,0.5155260282910222 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441072,13.51623383370737,44.32085041603382,0.30496332328536824 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441055,2.4234626899966867,44.32085041603382,0.05467996816956287 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441077,12.146682170547134,73.02499011367847,0.1663359646011361 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441066,122.01138036202438,73.02499011367847,1.670816800825149 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441075,61.415892585758726,73.02499011367847,0.8410256884684574 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441072,181.95951973035653,73.02499011367847,2.4917431614451298 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441055,95.69583506277988,73.02499011367847,1.3104532422915711 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441065,113.92958860020345,73.02499011367847,1.5601452108771054 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441077,112.61146617462948,446.9213615105917,0.25197154549517026 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441066,77.18778542319642,446.9213615105917,0.172709993459033 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441075,90.63581540125304,446.9213615105917,0.20280036535936546 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441072,197.1661334383432,446.9213615105917,0.4411651588367197 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441055,118.3878978982552,446.9213615105917,0.264896485364013 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441077,2519.8577880783546,2631.000022355788,0.9577566577981564 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441066,4481.74721588383,2631.000022355788,1.7034386840753004 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441075,2834.592103978731,2631.000022355788,1.0773820144025112 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441072,2983.076149149382,2631.000022355788,1.1338183670855109 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441055,1803.3058099835812,2631.000022355788,0.6854069915092238 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441065,1481.565112081992,2631.000022355788,0.563118623904611 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441077,43.00997711529457,48.89133349009634,0.8797055438057723 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441066,78.66104987045732,48.89133349009634,1.6088955701400796 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441075,27.100943989762133,48.89133349009634,0.5543097734336051 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441072,44.03322130178998,48.89133349009634,0.9006344920150225 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441055,88.8276727971105,48.89133349009634,1.8168388230831103 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441077,134.4783538944312,307.70649021557807,0.4370345058377421 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441066,74.11077735688207,307.70649021557807,0.24084892491204954 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441075,175.82327022350424,307.70649021557807,0.5713992906042479 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441072,419.4191572782304,307.70649021557807,1.3630494338432277 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441055,303.39859990641935,307.70649021557807,0.98600000179996 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441065,291.1466309839145,307.70649021557807,0.9461829380977249 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441077,171.69008234427235,154.19153082843468,1.1134858148292717 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441066,117.3411253984614,154.19153082843468,0.7610088878942654 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441075,113.93656512530562,154.19153082843468,0.738928814787371 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441072,84.75438001591374,154.19153082843468,0.5496694893717474 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441055,86.55101629965645,154.19153082843468,0.5613214671041806 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441077,7145.138670182975,6593.957266089812,1.083588865054931 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441066,8077.605394905217,6593.957266089812,1.2250011744002705 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441075,7139.814037156246,6593.957266089812,1.0827813631540448 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441072,7017.776778811139,6593.957266089812,1.064273924688725 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441055,7536.5537283146605,6593.957266089812,1.142948524563885 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441065,7007.459956673553,6593.957266089812,1.0627093373368108 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441077,151.34649413931834,127.96554716912783,1.1827128276901648 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441066,130.9185034932939,127.96554716912783,1.0230761825310937 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441075,108.71341233737093,127.96554716912783,0.8495522016850989 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441072,124.69642935920427,127.96554716912783,0.9744531408473339 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441055,216.62002721918768,127.96554716912783,1.6927996012308544 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441077,1799.2981663631026,1681.9358703135756,1.06977810398184 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441066,2097.9732851032713,1681.9358703135756,1.2473562887460927 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441075,1786.906803181488,1681.9358703135756,1.0624107819570683 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441072,1751.7597516792312,1681.9358703135756,1.041513997410994 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441055,1937.1345907910552,1681.9358703135756,1.1517291622004 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441065,3452.9554479951917,1681.9358703135756,2.0529649845397686 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441077,46.3080425522443,45.403354316773296,1.0199255814704595 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441066,51.589833523378054,45.403354316773296,1.136255994732074 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441075,47.30807973814751,45.403354316773296,1.041951204928279 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441072,78.77298174647831,45.403354316773296,1.7349595185608857 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441055,57.1872151179868,45.403354316773296,1.259537229760582 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441077,165.8554023500918,171.72890790902974,0.965797805212566 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441066,165.7681084863866,171.72890790902974,0.9652894815717296 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441075,161.24243084538986,171.72890790902974,0.9389358658869775 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441072,154.25726077486098,171.72890790902974,0.8982603025495041 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441055,169.40391896447352,171.72890790902974,0.9864612838172369 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441065,157.96850754941815,171.72890790902974,0.9198713802634737 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441077,27.487043788986252,385.5886159476326,0.07128593182512243 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441066,21.741040037528233,385.5886159476326,0.056384029865863355 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441075,53.21262543106949,385.5886159476326,0.13800362155478257 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441072,146.56286523233092,385.5886159476326,0.38010163985815354 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441055,183.6733062430907,385.5886159476326,0.47634525151031865 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441077,196.53309527633573,430.1288265554666,0.45691681920089144 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441066,612.2614593906352,430.1288265554666,1.4234374019842215 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441075,326.89269225701634,430.1288265554666,0.7599878735745752 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441072,391.24957673174487,430.1288265554666,0.909610220419142 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441055,370.83800347157165,430.1288265554666,0.8621556626215816 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441065,298.10451174588087,430.1288265554666,0.6930586683369832 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441077,28505.755211538068,54695.927744901994,0.5211677795189238 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441066,36752.67245655363,54695.927744901994,0.6719453160748189 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441075,27678.701957112222,54695.927744901994,0.5060468502555394 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441072,25768.759422524312,54695.927744901994,0.4711275680834598 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441055,243527.97032589937,54695.927744901994,4.452396738961937 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441077,214045.34545232824,97212.60478924697,2.2018270770171213 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441066,368533.0872253352,97212.60478924697,3.7910010540742136 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441075,208049.67641324113,97212.60478924697,2.140151237221598 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441072,138829.51980477865,97212.60478924697,1.4281020460850267 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441055,137279.46330975974,97212.60478924697,1.4121570305350435 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441065,300485.7182069482,97212.60478924697,3.0910160144190066 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441077,39289.897352750035,62941.57202670208,0.6242280910315021 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441066,44392.22359940592,62941.57202670208,0.7052925780209802 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441075,32138.966483764776,62941.57202670208,0.5106158846831832 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441072,32543.137611801645,62941.57202670208,0.5170372547732948 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441055,220587.4903612849,62941.57202670208,3.5046390367832525 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441077,37186.15321930601,14728.399701289269,2.5247925079091162 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441066,64635.775305078445,14728.399701289269,4.388513118599061 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441075,35836.02433326517,14728.399701289269,2.4331241044557084 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441072,20676.556924417997,14728.399701289269,1.4038563145871203 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441055,20880.464583294928,14728.399701289269,1.4177008369393405 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441065,48847.09369370362,14728.399701289269,3.316524176718787 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441077,5102.364131245482,3575.9352491809864,1.4268614434263318 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441066,5429.53604585414,3575.9352491809864,1.5183541276642782 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441075,1693.673082395661,3575.9352491809864,0.47363080267842406 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441072,1153.802242379019,3575.9352491809864,0.32265747615068807 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441055,29199.45158721092,3575.9352491809864,8.165542593059707 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441077,19300.490325870785,12966.336321671553,1.488507612872305 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441066,26220.907014612745,12966.336321671553,2.0222294381480674 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441075,24484.912066285113,12966.336321671553,1.888344668752865 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441072,17261.666534046162,12966.336321671553,1.3312678389496593 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441055,19368.333774405997,12966.336321671553,1.4937398887328206 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441065,46136.26675391073,12966.336321671553,3.5581574940949148 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441077,139.95167726176695,103.34580193186551,1.3542076663552836 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441066,105.32849539675176,103.34580193186551,1.0191850411707426 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441075,60.4542042640023,103.34580193186551,0.5849701016772693 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441072,80.44663002758661,103.34580193186551,0.7784218470782586 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441055,536.3158138343401,103.34580193186551,5.189526848782168 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441077,207.0042051085663,211.8154700640626,0.977285582804499 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441066,336.26457220867974,211.8154700640626,1.5875354718282764 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441075,297.5151210627889,211.8154700640626,1.4045958067784514 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441072,257.88015665786446,211.8154700640626,1.2174755535082957 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441055,419.0358259668209,211.8154700640626,1.9783060502619825 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441065,758.4729046658638,211.8154700640626,3.580819212291091 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441077,79.6233401039563,76.10596635595309,1.0462167937209048 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441066,69.27284484262289,76.10596635595309,0.9102156921394152 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441075,66.12575767394472,76.10596635595309,0.868864306441755 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441072,7.861387100214552,76.10596635595309,0.10329527994488998 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441055,64.51537076813571,76.10596635595309,0.8477045080328219 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441077,2919.3851311826666,1382.686999693948,2.111385390785377 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441066,3768.9669242796017,1382.686999693948,2.7258279893525046 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441075,1644.8328260521146,1382.686999693948,1.1895915897207332 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441072,2167.200919765044,1382.686999693948,1.5673835945841283 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441055,3025.178907959082,1382.686999693948,2.1878985689665793 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441065,2097.4400424856744,1382.686999693948,1.5169304715745022 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441077,32.93963184922719,30.899530320120164,1.0660237067674332 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441066,33.68939212826886,30.899530320120164,1.0902881622874403 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441075,27.79435202708752,30.899530320120164,0.8995072656165678 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441072,23.990311442375184,30.899530320120164,0.7763972848077223 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441055,19.962912513270087,30.899530320120164,0.6460587687402899 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441077,30.45461914215572,31.68183515511672,0.9612643646760848 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441066,31.21695702215314,31.68183515511672,0.9853266665050335 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441075,32.585554834790294,31.68183515511672,1.028524852656069 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441072,29.656799710180675,31.68183515511672,0.9360821292383691 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441055,31.53886490933266,31.68183515511672,0.9954873117329199 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441065,30.04848514002971,31.68183515511672,0.9484452208311167 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441077,413.2100984470312,628.1906149122311,0.6577782103681439 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441066,859.9325586531971,628.1906149122311,1.368903861725703 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441075,681.6838711475687,628.1906149122311,1.0851544976405154 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441072,1378.220270768582,628.1906149122311,2.193952341935485 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441055,1317.810568368746,628.1906149122311,2.097787736852558 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441077,16512.70038674138,10551.186365326936,1.5650088828878082 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441066,18796.780521521407,10551.186365326936,1.7814850264886755 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441075,14800.808687360231,10551.186365326936,1.4027625117113187 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441072,13033.743809519732,10551.186365326936,1.235287043393615 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441055,18352.70965430652,10551.186365326936,1.7393977339474136 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441065,36737.30848683922,10551.186365326936,3.4818177989505057 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441077,104.32045811547523,102.14043933131707,1.0213433464593464 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441066,184.65069858167627,102.14043933131707,1.8078118695252263 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441075,129.20004224095385,102.14043933131707,1.2649254603444817 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441072,64.6630667117272,102.14043933131707,0.633079974347643 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441055,112.09188126706115,102.14043933131707,1.0974290104966573 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441077,3671.31905016243,2995.2816068385046,1.2257007961389905 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441066,6737.667590348246,2995.2816068385046,2.2494270905832456 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441075,1819.726261146155,2995.2816068385046,0.6075309436653809 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441072,4358.793488489064,2995.2816068385046,1.4552199294174997 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441055,4634.7664252249015,2995.2816068385046,1.5473558194472605 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441065,1706.36380527416,2995.2816068385046,0.5696839326821137 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441077,40.88646966067468,35.73806763844074,1.1440593283979403 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441066,38.5100030909846,35.73806763844074,1.07756254424798 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441075,33.12279655694198,35.73806763844074,0.9268211390734032 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441072,18.255042577361483,35.73806763844074,0.510801052872985 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441055,19.51178537116204,35.73806763844074,0.5459664346869916 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441077,261.96,271.6614200921023,0.9642885615159739 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441066,273.9512287348804,271.6614200921023,1.008428906253975 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441075,237.84234578997868,271.6614200921023,0.8755102057161528 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441072,238.7070355217293,271.6614200921023,0.8786931741754116 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441055,252.3975059862137,271.6614200921023,0.9290885172456307 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441065,331.41868775791056,271.6614200921023,1.2199696506244744 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441077,182.5762118561284,166.02715311669658,1.0996768205005591 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441066,179.59129795445924,166.02715311669658,1.081698352246206 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441075,123.9010553358151,166.02715311669658,0.746269830024297 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441072,129.47287591895272,166.02715311669658,0.7798295248003758 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441055,236.79524162474272,166.02715311669658,1.4262440641760863 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441077,1624.9326666139918,1793.9624976146763,0.9057785036056031 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441066,5076.478978020064,1793.9624976146763,2.8297575812035936 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441075,1549.8061915285068,1793.9624976146763,0.8639011091866138 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441072,1541.3191959914866,1793.9624976146763,0.859170243547948 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441055,1428.7501788689078,1793.9624976146763,0.7964214306422964 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441065,1468.5364443258609,1793.9624976146763,0.8185992997504046 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441077,24.801665334270407,59.13775760336051,0.4193879906745238 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441066,78.10023666280654,59.13775760336051,1.320649274303368 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441075,66.75499705319872,59.13775760336051,1.128805009836987 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441072,49.12033493989345,59.13775760336051,0.8306086826853608 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441055,162.33373669993043,59.13775760336051,2.745010011855874 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441077,372.1739031122116,238.79765196261823,1.5585325067202598 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441066,493.85003628276303,238.79765196261823,2.068069062756409 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441075,256.26267634752975,238.79765196261823,1.073137337161278 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441072,217.9724016406684,238.79765196261823,0.912791226585386 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441055,278.33608878977134,238.79765196261823,1.165572971518759 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441065,707.9916059379558,238.79765196261823,2.9648181216153078 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441077,330.3058562974579,386.8144501381946,0.8539129191772742 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441066,568.3022708168853,386.8144501381946,1.4691857313341106 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441075,382.89906838415027,386.8144501381946,0.9898778813649658 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441072,500.053727533029,386.8144501381946,1.2927483121542593 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441055,1014.576340356256,386.8144501381946,2.622901859001868 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441077,5824.49868777819,5555.372966797932,1.0484442219431003 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441066,6912.631851824236,5555.372966797932,1.244314628943557 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441075,5003.580236069319,5555.372966797932,0.9006740440243273 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441072,6698.0250982593,5555.372966797932,1.2056841436732522 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441055,7580.618016160582,5555.372966797932,1.3645560903771294 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441065,9180.875798965306,5555.372966797932,1.6526119585193362 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441077,27.510558282982092,84.54153084580483,0.32540880213251117 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441066,147.0974629192311,84.54153084580483,1.7399432142708884 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441075,183.53778836245525,84.54153084580483,2.1709778203237122 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441072,59.37567248941604,84.54153084580483,0.7023254948826423 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441055,192.3447213124444,84.54153084580483,2.2751506790581026 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441077,57.292930682207015,122.00200397429413,0.4696064721549874 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441066,185.0367281271245,122.00200397429413,1.5166695800022416 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441075,146.4086408975582,122.00200397429413,1.200051114966985 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441072,138.94152448548508,122.00200397429413,1.1388462480891717 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441055,321.0702048216462,122.00200397429413,2.6316797623200996 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441065,134.3998319695951,122.00200397429413,1.101619871735166 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441077,205.659283796876,143.84455848940917,1.4297328029410168 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441066,131.52184994844112,143.84455848940917,0.9143331616407628 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441075,95.72922162408264,143.84455848940917,0.6655046435498697 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441072,103.97577869619325,143.84455848940917,0.7228342857602685 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441055,170.15610490855747,143.84455848940917,1.1829165224980376 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441077,4173.380811907995,5334.764851653101,0.7822989256245805 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441066,3263.2267263110884,5334.764851653101,0.6116908274410449 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441075,713.9419398386744,5334.764851653101,0.13382819293664705 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441072,2239.108180852469,5334.764851653101,0.41972012696279004 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441055,1287.5263311170297,5334.764851653101,0.2413464073712752 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441065,5068.371400534402,5334.764851653101,0.9500646310518915 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441077,101.91648592903474,159.70733471984832,0.6381453056480606 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441066,137.57698859573532,159.70733471984832,0.8614318737274459 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441075,89.87412000061698,159.70733471984832,0.5627425951242018 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441072,83.84725975012513,159.70733471984832,0.5250056917999812 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441055,104.28757196135903,159.70733471984832,0.652991749842271 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441077,49837.329291933005,82077.5827732141,0.6071978195268848 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441066,61749.95509352035,82077.5827732141,0.7523364237484873 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441075,32477.697642577263,82077.5827732141,0.39569510389109935 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441072,51962.0008986379,82077.5827732141,0.6330839571897776 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441055,55179.87368420073,82077.5827732141,0.672289214908612 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441065,123721.5350702318,82077.5827732141,1.5073730352425552 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441077,343787.1174755355,170961.68742491837,2.01090152217009 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441066,107095.46748743096,170961.68742491837,0.6264296352038775 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441075,114636.84908388852,170961.68742491837,0.6705411651615444 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441072,177139.41807562477,170961.68742491837,1.0361351759201574 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441055,150871.2215215679,170961.68742491837,0.8824855661759091 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441077,173914.3579319071,55195.40432138408,3.1508847533621265 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441066,266796.431182295,55195.40432138408,4.833671108355872 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441075,125215.52638004096,55195.40432138408,2.2685860882720146 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441072,101149.5409821536,55195.40432138408,1.8325717915425388 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441055,142553.59420111106,55195.40432138408,2.5827076720204807 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441065,194558.5038377513,55195.40432138408,3.5249040428239873 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441077,599.2347033431801,546.121028905539,1.0972562337401368 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441066,643.8265195706196,546.121028905539,1.1789081274912423 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441075,412.48704685275027,546.121028905539,0.7553033577179775 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441072,534.5260383430989,546.121028905539,0.9787684598308233 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441055,2016.2953230850096,546.121028905539,3.6920301844552528 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441077,1938.7947500053967,1228.731327313693,1.5778833882620018 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441066,1092.3127529830404,1228.731327313693,0.8889760753240523 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441075,692.1666665854762,1228.731327313693,0.5633181568656849 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441072,1600.4501835463125,1228.731327313693,1.3025224863805562 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441055,865.19324248503,1228.731327313693,0.7041354145145415 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441065,1141.9939204225775,1228.731327313693,0.9294089725206691 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441077,67.26758583253442,76.68368758811918,0.8772085426282548 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441066,118.90240198250386,76.68368758811918,1.550556653210894 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441075,135.1431350138103,76.68368758811918,1.7623452818242977 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441072,301.0569726452753,76.68368758811918,3.92595846801607 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441055,2396.0837623581174,76.68368758811918,31.246329404864838 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441077,102.89187928086396,81.06808963980528,1.269203206070653 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441066,146.47010008233963,81.06808963980528,1.806754059866501 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441075,218.7579071522634,81.06808963980528,2.6984465543005838 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441072,78.01289558612481,81.06808963980528,0.9623132348713898 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441055,150.31390522292273,81.06808963980528,1.854168587057922 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441065,284.93781726715923,81.06808963980528,3.5147962476132135 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441077,75.23973564438586,34.254424530644805,2.1964968518760153 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441066,31.924062665588263,34.254424530644805,0.9319690259875262 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441075,104.86323988504304,34.254424530644805,3.061304964887965 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441072,48.46746884841873,34.254424530644805,1.4149257946242422 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441055,250.84203272798248,34.254424530644805,7.322908972053329 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441077,41.7495953645352,60.87738129746832,0.6857981482569361 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441066,32.29649401071298,60.87738129746832,0.5305171366176371 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441075,28.6009010692551,60.87738129746832,0.46981161902318086 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441072,56.338902325797555,60.87738129746832,0.9254488469289742 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441055,17.057487742953974,60.87738129746832,0.2801941768750709 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441065,216.2617441686688,60.87738129746832,3.552415356237775 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441077,124.8262625159693,81.37032235510941,1.5340514686818272 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441066,127.04873151110696,81.37032235510941,1.561364485649347 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441075,173.37878190559132,81.37032235510941,2.130737311681604 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441072,72.31065111865121,81.37032235510941,0.8886612345355994 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441055,330.9730588131184,81.37032235510941,4.067491061037145 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441077,955.3848195607952,592.3362991324378,1.612909458630333 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441066,951.0785033751304,592.3362991324378,1.6056394058039705 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441075,827.2202657531133,592.3362991324378,1.3965381945437025 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441072,531.9609898380786,592.3362991324378,0.8980725824454999 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441055,802.5517969798623,592.3362991324378,1.3548921417703346 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441065,1552.7096048298083,592.3362991324378,2.6213311713362426 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441077,437.8220808035293,1509.2244087879828,0.2900974025162582 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441066,704.3210342447751,1509.2244087879828,0.46667747363720163 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441075,288.05501566892707,1509.2244087879828,0.19086294522645325 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441072,620.5505888497713,1509.2244087879828,0.41117184776259924 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441055,3832.064351228338,1509.2244087879828,2.539095133178879 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441077,966797.058977302,911297.6405793307,1.0609015275872866 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441066,1447047.2467113603,911297.6405793307,1.5878975016235557 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441075,902666.1381463364,911297.6405793307,0.9905283388778368 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441072,1085208.6519234572,911297.6405793307,1.1908388693221763 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441055,1085609.303196811,911297.6405793307,1.1912785185163726 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441065,929446.0984694436,911297.6405793307,1.019914962007995 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441077,1352.4199507813155,749.6106308195243,1.8041632484624182 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441066,784.7244888282191,749.6106308195243,1.0468427961998164 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441075,217.59688760073135,749.6106308195243,0.2902798848554748 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441072,2298.9075489182414,749.6106308195243,3.0668022229152787 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441055,3897.11798287441,749.6106308195243,5.1988563430775 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441077,4060.086515595063,2138.7943755926544,1.898306149449277 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441066,7240.126739418148,2138.7943755926544,3.385143902583869 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441075,4541.295633506554,2138.7943755926544,2.1232969776480606 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441072,3099.1433074965853,2138.7943755926544,1.4490141468778739 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441055,4087.223408255902,2138.7943755926544,1.9109940884912524 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441065,5318.136298089417,2138.7943755926544,2.486511260165333 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441077,369.99854380796154,613.8984432679271,0.602703179761088 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441066,847.9077115150578,613.8984432679271,1.3811856355286454 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441075,436.85426697348646,613.8984432679271,0.711606735224816 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441072,706.0370965271387,613.8984432679271,1.1500877779861043 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441055,1476.080307222413,613.8984432679271,2.4044372866705563 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441077,9349.697555947876,6365.76448478505,1.4687470104014668 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441066,5151.229837571378,6365.76448478505,0.8092083597945608 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441075,3910.450891428649,6365.76448478505,0.6142939941895591 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441072,7242.3029754053505,6365.76448478505,1.1376957147433484 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441055,4069.951497242732,6365.76448478505,0.6393499958992216 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441065,4327.025058257602,6365.76448478505,0.6797337646718972 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441077,48.326281226085975,70.21289390855102,0.6882821450007269 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441066,160.84996230875632,70.21289390855102,2.290889227814136 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441075,183.8099643490026,70.21289390855102,2.61789472156505 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441072,47.27664635137498,70.21289390855102,0.6733328270580982 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441055,245.99097432471876,70.21289390855102,3.5035014315904767 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441077,763.5633003696627,2003.7789126851078,0.3810616508317632 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441066,961.4520606323248,2003.7789126851078,0.4798194324462462 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441075,2032.3533663102385,2003.7789126851078,1.0142602826311014 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441072,1761.6341240122222,2003.7789126851078,0.8791559352481625 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441055,1675.9014509147123,2003.7789126851078,0.8363704400247268 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441065,2055.841032141939,2003.7789126851078,1.0259819679343103 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441077,419.59056119996023,700.7857837159185,0.5987429696063185 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441066,875.454252749048,700.7857837159185,1.249246593027258 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441075,514.6838494456877,700.7857837159185,0.734438199811325 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441072,828.1429918438491,700.7857837159185,1.1817348626175301 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441055,1510.8638980383876,700.7857837159185,2.155956831811039 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441077,8366.155450949209,4688.560133729121,1.7843762716753413 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441066,5370.545364250648,4688.560133729121,1.1454572856206708 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441075,2509.315052215788,4688.560133729121,0.5351995027565029 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441072,5863.254203034137,4688.560133729121,1.2505447377872714 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441055,3211.3562208201624,4688.560133729121,0.68493442106414 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441065,3098.9810738332317,4688.560133729121,0.6609664770084559 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441077,499.38641494768535,384.65137963543384,1.2982831763686782 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441066,449.1300552474973,384.65137963543384,1.1676288686996918 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441075,256.3355807814504,384.65137963543384,0.6664101426710103 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441072,269.9388041665169,384.65137963543384,0.7017752137594316 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441055,886.8513961748005,384.65137963543384,2.3055978559477506 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441077,797.595715844442,772.5530415852671,1.0324154755870065 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441066,835.1157911135616,772.5530415852671,1.0809818176366464 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441075,517.3801183896512,772.5530415852671,0.6697017428447308 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441072,405.0898817274579,772.5530415852671,0.5243521932115103 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441055,1176.4272596924382,772.5530415852671,1.5227786266667558 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441065,1240.4356092666214,772.5530415852671,1.6056316427429582 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441077,211.2893350262492,216.68366112664066,0.9751050629643979 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441066,197.309370228886,216.68366112664066,0.9105872090354271 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441075,195.8602489843217,216.68366112664066,0.903899481695813 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441072,166.30104735391444,216.68366112664066,0.7674830971991002 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441055,264.7965017739836,216.68366112664066,1.2220418484586313 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441077,926.4364242148748,615.8359185894908,1.5043559432791493 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441066,1032.4766514241676,615.8359185894908,1.676545034575037 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441075,895.0636765806702,615.8359185894908,1.4534125885848328 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441072,706.35102093796,615.8359185894908,1.1469792514794928 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441055,645.5325324777971,615.8359185894908,1.0482216333797536 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441065,584.7021540115903,615.8359185894908,0.9494447081793975 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441077,100.89344524210576,101.73138829665541,0.9917631807785208 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441066,94.79698750339573,101.73138829665541,0.9318361725976007 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441075,117.0804998181496,101.73138829665541,1.1508788170346715 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441072,210.63100721913392,101.73138829665541,2.0704623297277736 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441055,516.9019595147977,101.73138829665541,5.0810469430288085 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441077,243.7711665087399,93.53234569214308,2.606276627671674 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441066,150.9817937041629,93.53234569214308,1.6142201137680405 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441075,131.56672646200548,93.53234569214308,1.4066441452783682 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441072,96.71958855186097,93.53234569214308,1.0340763704377578 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441055,259.5876155642775,93.53234569214308,2.775378011139556 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441065,98.96959696808894,93.53234569214308,1.0581323095845612 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441077,77.48946469808868,42.30806113801961,1.8315531984625442 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441066,61.64733857969771,42.30806113801961,1.4571062091119817 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441075,39.027613875230614,42.30806113801961,0.9224628315609325 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441072,50.85139827966447,42.30806113801961,1.201931662946556 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441055,9.460071609415484,42.30806113801961,0.22359974328661233 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441077,197.50107894274456,205.3077634331321,0.9619756975584114 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441066,278.57861370836724,205.3077634331321,1.3568829987235196 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441075,192.10105706001912,205.3077634331321,0.9356736143228488 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441072,164.6377854479891,205.3077634331321,0.8019072571584024 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441055,228.66374961092723,205.3077634331321,1.1137608524258367 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441065,268.89175094003826,205.3077634331321,1.3097008434735358 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441077,1143.3510670997955,761.179367641068,1.502078374303676 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441066,929.4510800025448,761.179367641068,1.2210670960288363 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441075,626.976071899341,761.179367641068,0.8236903134176777 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441072,654.9950561448475,761.179367641068,0.8605002762682719 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441055,2096.5016823369015,761.179367641068,2.7542807536074743 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441077,343288.5415955382,258075.7105503754,1.3301853973914743 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441066,722383.9474790195,258075.7105503754,2.7991163753398363 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441075,361634.5751138789,258075.7105503754,1.401273193601415 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441072,275929.9564441258,258075.7105503754,1.0691822018262556 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441055,414824.6964198375,258075.7105503754,1.607375973256752 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441065,253452.59466751895,258075.7105503754,0.9820862030254721 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441077,104.59111542877828,131.47736122215045,0.7955066519174819 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441066,109.15257168133438,131.47736122215045,0.8302005049896382 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441075,132.43868676156896,131.47736122215045,1.0073117191467982 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441072,177.70002272511388,131.47736122215045,1.351563653797884 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441055,275.6719746833255,131.47736122215045,2.096725794622064 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441077,2600.780849201599,3004.2024881525895,0.8657142317996442 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441066,3545.2743354992776,3004.2024881525895,1.180104986092138 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441075,2517.42565089895,3004.2024881525895,0.837968033388795 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441072,3562.129979879023,3004.2024881525895,1.1857156746013904 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441055,2716.7159550808833,3004.2024881525895,0.9043052077197055 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441065,2028.8599127409784,3004.2024881525895,0.675340600622633 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441077,54.66238149581507,96.13121274223809,0.56862261420111615 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441066,99.24945769486638,96.13121274223809,1.0324373828611673 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441075,80.6516835720067,96.13121274223809,0.8389749933589468 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441072,26.08878293323918,96.13121274223809,0.27138722366056556 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441055,18.89005132909516,96.13121274223809,0.1965027881188402 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441077,330.76729187263413,490.807523353751,0.6739246570885031 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441066,824.1353321605778,490.807523353751,1.679141604287471 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441075,466.0667431152606,490.807523353751,0.9495916850063066 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441072,285.8713714355705,490.807523353751,0.5824510787491084 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441055,446.8677647937762,490.807523353751,0.9104745618817561 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441065,282.32763463395685,490.807523353751,0.5752308617944073 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441077,82.40668779576056,78.64120835950264,1.0478817596373176 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441066,63.62906451372321,78.64120835950264,0.8091058853374621 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441075,75.60105563924557,78.64120835950264,0.9613414800754431 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441072,66.28054518027167,78.64120835950264,0.842822059361994 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441055,289.050960211465,78.64120835950264,3.6755661089296754 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441077,1756.502312723974,1710.8868039225827,1.0266619093073883 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441066,2053.3219657257673,1710.8868039225827,1.2001506826857726 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441075,1656.6687720916154,1710.8868039225827,0.9683099830411571 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441072,1757.0274537442583,1710.8868039225827,1.0269688501401075 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441055,1668.9873777461307,1710.8868039225827,0.9755101120188733 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441065,1857.607947259473,1710.8868039225827,1.085757364543639 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441077,141.59440553846386,158.21676846284709,0.8949393096201018 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441066,137.32893340547244,158.21676846284709,0.8679796379340184 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441075,115.45791804039271,158.21676846284709,0.7297451411890319 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441072,185.9300617204147,158.21676846284709,1.1751602786911637 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441055,343.0570899117585,158.21676846284709,2.1682726378798223 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441077,796.2188172396337,1068.4447009417866,0.7452129403962622 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441066,882.8184172273644,1068.4447009417866,0.8262649591964837 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441075,576.1481916096383,1068.4447009417866,0.5392400665207935 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441072,560.7877639387902,1068.4447009417866,0.5248636297643489 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441055,722.2917514534732,1068.4447009417866,0.6760216516744434 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441065,2283.1092081258394,1068.4447009417866,2.1368529471982782 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441077,104.7884050243138,101.193417409009,1.035525903832009 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441066,152.37512743949608,101.193417409009,1.5057810215423213 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441075,125.3282338274285,101.193417409009,1.2385018416847224 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441072,107.19479929871471,101.193417409009,1.0593060501697358 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441055,111.16355296196514,101.193417409009,1.0985255346467677 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441077,9209.16164675795,8195.704907369402,1.1236570558411967 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441066,10746.519404008082,8195.704907369402,1.311237962502169 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441075,10603.911505576483,8195.704907369402,1.2938376412310397 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441072,8252.354002929158,8195.704907369402,1.0069120467610808 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441055,8137.884400361284,8195.704907369402,0.9929450233187231 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441065,8045.294961451212,8195.704907369402,0.9816477108902562 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441077,2.018396031248862,54.484574340672744,0.037045274844739476 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441066,19.447206780517664,54.484574340672744,0.35693050768683937 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441075,30.852433822858206,54.484574340672744,0.5662599771808597 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441072,11.364679677018335,54.484574340672744,0.208585270501684 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441055,61.6803625835979,54.484574340672744,1.1320701928940922 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441077,251.43147216561235,181.8259570369428,1.3828139626650078 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441066,276.66900273990046,181.8259570369428,1.5216144452009552 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441075,205.5087619916634,181.8259570369428,1.1302498572847264 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441072,89.6440823900616,181.8259570369428,0.4930213697258197 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441055,216.85463673869387,181.8259570369428,1.192649499953596 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441065,91.16401822276934,181.8259570369428,0.5013806593315328 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441077,661.7284596833438,598.5025834222519,1.105640105844765 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441066,796.51707609076,598.5025834222519,1.3308498545424092 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441075,571.4312304344211,598.5025834222519,0.9547681935923549 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441072,636.1116105698354,598.5025834222519,1.0628385376927436 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441055,886.2988034980729,598.5025834222519,1.4808604474690743 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441077,24766.09958995846,15066.853658787537,1.6437472713829653 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441066,20424.275283494204,15066.853658787537,1.355576668230399 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441075,16453.80386081008,15066.853658787537,1.0920530744793968 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441072,14495.099502807778,15066.853658787537,0.962052186280691 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441055,15474.652675870751,15066.853658787537,1.0270659705283174 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441065,17013.40388393978,15066.853658787537,1.1291942079769883 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441077,66.13052542133515,62.8704966822211,1.0518530775347912 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441066,67.37790698471481,62.8704966822211,1.0716935691676879 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441075,881.6574818837147,62.8704966822211,14.02338979983015 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441072,60.0823498868991,62.8704966822211,0.9556525406596565 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441055,63.16010052378525,62.8704966822211,1.004606355235715 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441077,98.18736375125413,100.49015468400951,0.9770844124979557 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441066,100.1368101145716,100.49015468400951,0.9964837891776662 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441075,103.0255501316059,100.49015468400951,1.0252302870422374 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441072,94.742057279937,100.49015468400951,0.9427993973922385 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441055,101.44895980676505,100.49015468400951,1.0095412841762508 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441065,98.77241736345194,100.49015468400951,0.9829064118175658 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441077,113.4153191545208,109.95671552102958,1.031454228303407 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441066,116.89782131224892,109.95671552102958,1.0631258014422214 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441075,116.59460476115946,109.95671552102958,1.0603682022391836 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441072,114.97597535963251,109.95671552102958,1.0456475970095978 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441055,172.7677036071102,109.95671552102958,1.571233760379718 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441077,244.54397943149937,243.54938966397899,1.0040837292546394 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441066,251.866057037394,243.54938966397899,1.0341477652023245 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441075,249.58816368888077,243.54938966397899,1.0247948641268754 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441072,230.6427294320914,243.54938966397899,0.9470059840852211 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441055,254.2357468469378,243.54938966397899,1.043877577347669 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441065,241.77468616832908,243.54938966397899,0.9927131679611333 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441077,43.72154444380527,49.66723175069083,0.8802895370386158 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441066,61.320318202001,49.66723175069083,1.2346232322712063 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441075,31.4887010993735,49.66723175069083,0.633993479995702 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441072,87.57883467873806,49.66723175069083,1.7633121797153495 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441055,113.37464841238588,49.66723175069083,2.2826850705406776 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441077,325.615586624078,318.9289567276793,1.0209658914794248 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441066,482.0864213196916,318.9289567276793,1.5115793381261582 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441075,461.6139962996821,318.9289567276793,1.447388161413753 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441072,238.62374822448325,318.9289567276793,0.748203457825984 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441055,432.27803994426705,318.9289567276793,1.3554054306626413 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441065,631.2323786235212,318.9289567276793,1.9792256717614554 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441077,48.06981449027492,52.85511393128503,0.9094638326344108 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441066,51.734686950038885,52.85511393128503,0.9788019190971232 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441075,48.09317201837838,52.85511393128503,0.9099057487777347 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441072,41.67068150255811,52.85511393128503,0.7883945072322163 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441055,44.60758122771665,52.85511393128503,0.8439596078765303 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441077,122.61807074036916,145.91831693350866,0.8403199359559715 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441066,132.60524554909327,145.91831693350866,0.9087635352148297 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441075,137.06836876597367,145.91831693350866,0.9393499846111322 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441072,142.96958479986014,145.91831693350866,0.9797918986758037 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441055,146.56777517174612,145.91831693350866,1.004450834219349 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441065,125.32793405255433,145.91831693350866,0.8588910336024719 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441077,260.546131236778,261.347965154705,0.9969319297456465 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441066,283.8491908433456,261.347965154705,1.086096808426731 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441075,177.07878718561435,261.347965154705,0.6775594639919715 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441072,314.30182279923247,261.347965154705,1.2026182128993483 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441055,987.5881906437075,261.347965154705,3.7788248707393017 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441077,8593.1843689544,7540.877985370558,1.139546931487996 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441066,7272.89292492938,7540.877985370558,0.9644623529301131 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441075,5047.718624869106,7540.877985370558,0.6693807584026387 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441072,7714.926033120724,7540.877985370558,1.0230806078665935 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441055,7220.661443370891,7540.877985370558,0.9575359072748699 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441065,6071.491941998021,7540.877985370558,0.805143904168298 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441077,5997.702917517014,5107.556668860965,1.174280249122436 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441066,4624.652102227931,5107.556668860965,0.9054529204585945 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441075,5025.586374406462,5107.556668860965,0.9839511727879109 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441072,7476.065213312398,5107.556668860965,1.4637263368787317 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441055,10431.800029192407,5107.556668860965,2.042424725856013 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441077,130579.68567670965,180330.65339424144,0.7241125300601805 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441066,190685.8004728277,180330.65339424144,1.0574231107339676 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441075,296013.3612137382,180330.65339424144,1.6415032921030326 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441072,89810.2556722474,180330.65339424144,0.49803100017556606 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441055,100775.73892338024,180330.65339424144,0.5588386501493059 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441065,876255.7648084234,180330.65339424144,4.859161480953216 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441077,241.9651357983576,98.01831453553807,2.4685706640122786 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441066,343.2590323906497,98.01831453553807,3.501988725445751 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441075,125.94008992218981,98.01831453553807,1.2848628393475208 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441072,186.09256066036525,98.01831453553807,1.8985488736688538 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441055,519.4979119353026,98.01831453553807,5.300008619786565 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441077,2097.234574605015,1812.4793707702274,1.1571081075056753 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441066,2972.0881101574855,1812.4793707702274,1.6397914139538445 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441075,1041.1793834280916,1812.4793707702274,0.5744503359426564 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441072,1663.1906848932713,1812.4793707702274,0.9176328910085665 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441055,2936.523377495732,1812.4793707702274,1.6201692691530238 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441065,2439.64156277753,1812.4793707702274,1.3460244580553682 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441077,172.01743152416972,434.5650550234931,0.3958381594094589 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441066,302.12974272532404,434.5650550234931,0.6952462910506934 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441075,207.44749037249642,434.5650550234931,0.4773680901730158 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441072,428.83150223834394,434.5650550234931,0.9868062267803858 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441055,1039.4496820141171,434.5650550234931,2.3919311274532262 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441077,19117.287111471047,9833.502392298877,1.9440974689183765 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441066,28925.052805675536,9833.502392298877,2.941480222583587 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441075,12035.125915114942,9833.502392298877,1.2238900683585812 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441072,11763.047820186815,9833.502392298877,1.1962215852409885 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441055,16561.027102479493,9833.502392298877,1.684143293182019 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441065,16180.415849110132,9833.502392298877,1.6454377294687852 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441077,42.927820007525035,42.4088060383901,1.0122383537198645 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441066,45.18255235833027,42.4088060383901,1.065404961352349 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441075,67.81840910182235,42.4088060383901,1.5991586521070764 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441072,34.277630056747334,42.4088060383901,0.8082668025531747 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441055,36.63769005492834,42.4088060383901,0.8639170369890273 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441077,428.9905440547951,385.8715169071063,1.111744519246465 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441066,470.6780788707327,385.8715169071063,1.2197792743122902 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441075,377.2430861322037,385.8715169071063,0.9776391094008118 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441072,402.5819155776288,385.8715169071063,1.0433056028712928 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441055,450.8644407498495,385.8715169071063,1.1684315141052233 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441065,347.05179571750034,385.8715169071063,0.8993972877273776 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441077,1576.38453079983,1002.6445024002205,1.5722267733240833 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441066,1304.578100734908,1002.6445024002205,1.301137240180235 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441075,1148.5559606541456,1002.6445024002205,1.14552661277714 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441072,976.87958343563,1002.6445024002205,0.9743030367164911 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441055,1250.794971525826,1002.6445024002205,1.2474959654509257 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441077,18353.61091423331,6245.085755978491,2.938888532741635 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441066,26597.375517732264,6245.085755978491,4.258928789291692 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441075,7427.130585860665,6245.085755978491,1.1892759965306463 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441072,12951.737688442669,6245.085755978491,2.073908701100513 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441055,14949.92780792868,6245.085755978491,2.3938706996324184 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441065,23679.86963906765,6245.085755978491,3.791760524088663 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441077,292.49011304018217,289.8012081128336,1.0092784462316722 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441066,322.82752336300405,289.8012081128336,1.1139619653942634 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441075,347.4836055840897,289.8012081128336,1.199041259513306 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441072,401.78524694109456,289.8012081128336,1.3864167425577474 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441055,273.98717753729903,289.8012081128336,0.9454314539317676 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441077,25952.82813013282,19122.271903916942,1.3572042203215786 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441066,29194.58825752227,19122.271903916942,1.5267322002435364 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441075,20384.11592567913,19122.271903916942,1.0659881853004984 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441072,21479.659684681108,19122.271903916942,1.1232796914827514 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441055,27634.79909642488,19122.271903916942,1.4451629615602453 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441065,15155.72649960416,19122.271903916942,0.7925693440484816 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441077,77.473206194718,111.01681566749893,0.6978510933582732 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441066,102.29630918450742,111.01681566749893,0.9214487784525376 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441075,103.12512192697788,111.01681566749893,0.928914428926181 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441072,105.48063499321349,111.01681566749893,0.9501320530498137 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441055,145.48806027982064,111.01681566749893,1.3105047141287574 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441077,1385.1020238299575,1048.3386659324408,1.3212352733341033 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441066,1318.3222540520444,1048.3386659324408,1.2575347040924678 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441075,863.3931226183391,1048.3386659324408,0.8235822551201977 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441072,1113.89338585827,1048.3386659324408,1.0625320061695156 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441055,1520.7678449284126,1048.3386659324408,1.4506455731800862 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441065,555.8431054954026,1048.3386659324408,0.5302133018255223 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441077,8262.727902869405,5453.602601951663,1.5150953426478946 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441066,6058.055063443492,5453.602601951663,1.11083544321244 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441075,1456.6484545388998,5453.602601951663,0.26709838630662486 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441072,21.978516206596115,5453.602601951663,0.004030091264576326 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441055,65419.08207780813,5453.602601951663,11.995571891211291 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441077,110640.6941789285,64173.361133824874,1.7240906853577809 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441066,119745.54672061054,64173.361133824874,1.8659696890567627 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441075,58400.547521422646,64173.361133824874,0.9100434586811839 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441072,68354.5896073756,64173.361133824874,1.0651552045845214 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441055,115747.85582356366,64173.361133824874,1.8036745119550017 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441065,185786.4108752778,64173.361133824874,2.8950705961597576 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441077,31.056993860470676,44.60879663763593,0.69620783794621 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441066,26.21448746537698,44.60879663763593,0.5876528721077429 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441075,24.144442726423236,44.60879663763593,0.5412484654664018 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441072,46.863241812773445,44.60879663763593,1.0505381302582697 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441055,171.83671208535316,44.60879663763593,3.8520813166337797 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441077,135.23217853173276,136.29080299882398,0.9922326052543666 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441066,143.4595890334343,136.29080299882398,1.0525991914118533 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441075,137.57777678112288,136.29080299882398,1.0094428512708227 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441072,127.25178781692205,136.29080299882398,0.9336784655823039 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441055,138.94021338739137,136.29080299882398,1.0194393923160776 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441065,137.58144617510806,136.29080299882398,1.009469774540071 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441077,90.9179451800094,82.77341642135346,1.0983954645196312 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441066,53.24926842237431,82.77341642135346,0.6433136473588559 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441075,70.93182493423276,82.77341642135346,0.8569396794395711 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441072,87.10215709554096,82.77341642135346,1.0522962668612383 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441055,2.6373421052674995,82.77341642135346,0.031862187394105575 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441077,2834.4386768676936,2141.365658987758,1.3236593502706855 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441066,3749.2761507136806,2141.365658987758,1.750880861929016 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441075,2115.3501597887766,2141.365658987758,0.9878509776740891 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441072,2195.14865301501,2141.365658987758,1.025116212077799 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441055,3259.4676682479617,2141.365658987758,1.5221443636061394 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441065,3676.3473400842145,2141.365658987758,1.716823712313597 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441077,492.213941459236,285.0677067828484,1.72665626357384 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441066,434.1548407145897,285.0677067828484,1.522988505482696 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441075,304.2450268303864,285.0677067828484,1.067272860416092 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441072,610.3746776934414,285.0677067828484,2.141156866141969 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441055,738.8518783344582,285.0677067828484,2.5918469919754252 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441077,791409.3060531972,724296.655045942,1.0926590652320467 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441066,1056403.7722617784,724296.655045942,1.4585236103220314 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441075,648998.8428710497,724296.655045942,0.8960400939997213 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441072,645679.4961657891,724296.655045942,0.8914572387813026 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441055,1016504.3125385486,724296.655045942,1.4034364309939715 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441065,520733.16626356775,724296.655045942,0.7189501188991929 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441077,106.90064026959118,126.94877083842833,0.8420770013255738 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441066,176.65095931976015,126.94877083842833,1.391513743323985 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441075,136.26473114698535,126.94877083842833,1.0733836196052164 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441072,127.36595861043016,126.94877083842833,1.0032862686991495 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441055,16.356132601402862,126.94877083842833,0.12884041722798423 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441077,91207.5849072357,94593.87687362579,0.9642017847422188 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441066,49058.26850066781,94593.87687362579,0.5186199162363119 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441075,197013.7910739547,94593.87687362579,2.0827330223198106 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441072,151730.5928709386,94593.87687362579,1.6040212948840813 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441055,176962.31542994652,94593.87687362579,1.8707586714768247 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441065,84833.48238726147,94593.87687362579,0.8968179039812071 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441077,15.486828805746974,34.2642969985689,0.45198151318831387 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441066,6.361805352058155,34.2642969985689,0.18566863789220203 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441075,20.03456763972655,34.2642969985689,0.5847068054705259 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441072,16.748246856552786,34.2642969985689,0.4887958698598807 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441055,27.66799363930241,34.2642969985689,0.807487561774812 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441077,34.27705496499656,74.66086218948179,0.45910339044846316 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441066,54.19640489200312,74.66086218948179,0.7259011388652072 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441075,78.85690365070988,74.66086218948179,1.0562013528664986 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441072,36.371621388372645,74.66086218948179,0.4871578002416462 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441055,130.9846929156979,74.66086218948179,1.7543956642674696 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441065,32.76566716926106,74.66086218948179,0.43886001592246654 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441077,276.48248587342783,347.6986105145094,0.7951785756759309 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441066,439.7549592200877,347.6986105145094,1.2647590353305043 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441075,411.2099234100906,347.6986105145094,1.1826619692313405 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441072,61.18400693098366,347.6986105145094,0.17596851146585313 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441055,744.2078191946517,347.6986105145094,2.1403819189654083 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441077,3475.0023643208433,2521.321340016667,1.378246520650903 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441066,3677.136274269441,2521.321340016667,1.4584163533257264 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441075,3098.964490421851,2521.321340016667,1.229103344043154 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441072,3644.8359817366536,2521.321340016667,1.4456054941860603 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441055,3306.205486435859,2521.321340016667,1.3112987360881194 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441065,2059.928972943114,2521.321340016667,0.8170037433346345 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441077,120.99992568116387,79.44971561377609,1.522974937624361 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441066,120.0344799529414,79.44971561377609,1.5108232801795978 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441075,102.32578512659671,79.44971561377609,1.2879314209760877 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441072,175.27901031229982,79.44971561377609,2.2061628409643737 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441055,322.336575187436,79.44971561377609,4.057114272811126 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441077,58.03075313117316,42.37178439720435,1.369561229406283 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441066,40.929752198351835,42.37178439720435,0.9659671590572037 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441075,86.49205099021525,42.37178439720435,2.0412652481051023 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441072,79.40048342951751,42.37178439720435,1.873899920881224 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441055,127.1013495017992,42.37178439720435,2.9996695043644475 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441065,491.0241193915975,42.37178439720435,11.588469222551666 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441077,806.8885561767977,1321.2949146990686,0.6106801344653404 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441066,1142.540692150759,1321.2949146990686,0.8647128505833827 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441075,726.9554831572366,1321.2949146990686,0.55018412246202 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441072,1624.5325690662708,1321.2949146990686,1.2295003568043446 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441055,6955.493787017208,1321.2949146990686,5.264149365625429 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441077,23351.87642173764,23354.026662177774,0.9999079284925364 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441066,28319.704291457205,23354.026662177774,1.2126261865291705 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441075,35049.081268988455,23354.026662177774,1.5007725124229225 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441072,19885.151500737273,23354.026662177774,0.8514656503729012 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441055,33592.66005342363,23354.026662177774,1.438409767161373 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441065,71144.49632651525,23354.026662177774,3.046348167519005 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441077,7740.703840546299,13473.54115415771,0.5745114630208145 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441066,8405.184380288929,13473.54115415771,0.6238289017060098 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441075,7459.58636804485,13473.54115415771,0.5536470540814689 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441072,7214.806523934586,13473.54115415771,0.5354796071341806 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441055,37641.74007448791,13473.54115415771,2.7937525587230123 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441077,71051.4768437319,49612.48263442616,1.4321290342851982 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441066,106925.84771905695,49612.48263442616,2.1552206630526687 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441075,85966.11105520271,49612.48263442616,1.7327516481819984 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441072,83792.26350143814,49612.48263442616,1.6889351036687406 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441055,111609.863490367,49612.48263442616,2.2496327045911784 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441065,106292.4721114152,49612.48263442616,2.142454206427048 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441054,65.53557362728144,73.06854961986588,0.8969053576159068 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441061,105.12726051639444,73.06854961986588,1.4387484227251233 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441060,76.06230032158318,73.06854961986588,1.0409718095855478 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441071,68.55795184073072,73.06854961986588,0.9382689569917395 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441059,78.46162121927664,73.06854961986588,1.0738083844207644 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441073,70.95502387216874,73.06854961986588,0.971074754341059 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441054,1119.0747063083463,990.9231863649335,1.1293253823371712 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441061,513.7050712406941,990.9231863649335,0.5184105875301507 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441060,16.612418565676844,990.9231863649335,0.016764587603018185 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441071,72.70464024908745,990.9231863649335,0.07337061161702604 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441059,30.58945670296932,990.9231863649335,0.030869654806627914 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441073,8.440364313051607,990.9231863649335,0.008517677686011095 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441054,55.68598469024459,50.719124328797626,1.0979287483208153 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441061,57.56633954645995,50.719124328797626,1.1350026308276495 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441060,54.30306902454077,50.719124328797626,1.070662590160458 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441071,60.129595250872335,50.719124328797626,1.1855408792365836 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441059,45.919001723491625,50.719124328797626,0.9053587247644858 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441073,43.5344479728772,50.719124328797626,0.8583438406912506 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441054,332.9258860982894,319.2477137201226,1.042845012792036 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441061,360.4715297650615,319.2477137201226,1.1291279914414014 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441060,331.4323779807957,319.2477137201226,1.0381668019441328 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441071,339.39416597007136,319.2477137201226,1.0631060188816597 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441059,359.85954816375454,319.2477137201226,1.1272110423921013 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441073,375.44459016189694,319.2477137201226,1.176029064662436 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441054,62.42773721462811,44.58166891160943,1.4003005885311626 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441061,67.61110020264142,44.58166891160943,1.516567276489619 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441060,34.89657068082295,44.58166891160943,0.7827560415024212 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441071,55.05655170727241,44.58166891160943,1.2349594138440887 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441059,142.01882096947796,44.58166891160943,3.1855878085464653 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441073,42.50396983996197,44.58166891160943,0.9533956641289755 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441054,2798.217451879764,1543.2839395802719,1.813157890207033 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441061,2000.119202245336,1543.2839395802719,1.2960150436019635 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441060,5142.77781939477,1543.2839395802719,3.3323600975161156 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441071,2299.498221099316,1543.2839395802719,1.4900033377686237 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441059,3342.8983502039086,1543.2839395802719,2.166094173903656 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441073,3315.1663023976416,1543.2839395802719,2.148124669332897 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441054,36.01829875728617,31.276034215973343,1.1516261463510884 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441061,36.90110037475832,31.276034215973343,1.1798522830593443 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441060,35.06554236466671,31.276034215973343,1.121163320212701 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441071,36.101725056875416,31.276034215973343,1.1542935657244386 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441059,17.29076185847636,31.276034215973343,0.5528438081080496 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441073,33.90601333668971,31.276034215973343,1.084089277513745 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441054,104.29549313643356,130.468422036268,0.7993926155360505 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441061,120.81447793614343,130.468422036268,0.9260055119127528 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441060,37.44449612215134,130.468422036268,0.287000452199402 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441071,40.04711755669715,130.468422036268,0.30694873848910914 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441059,30.865399434289156,130.468422036268,0.23657371609590785 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441073,51.24768602266588,130.468422036268,0.3927976227720444 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441054,94.48356346657562,95.42663227533711,0.990117341602914 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441061,98.31365030725382,95.42663227533711,1.0302537977405166 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441060,91.7327166924781,95.42663227533711,0.9612905171776276 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441071,100.2707255356276,95.42663227533711,1.0507624878379203 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441059,87.2802897674624,95.42663227533711,0.9146324006869504 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441073,87.42474321014166,95.42663227533711,0.9161461651281229 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441054,589.1088041837194,569.3868516791151,1.0346371758435313 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441061,694.2452530137252,569.3868516791151,1.2192857122822631 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441060,616.3588893462428,569.3868516791151,1.0824958242864366 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441071,604.906906349586,569.3868516791151,1.0623829906955573 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441059,619.9187343736355,569.3868516791151,1.0887478917813125 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441073,784.4596664071806,569.3868516791151,1.377727048128734 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441054,3488.8653737832296,5328.634617598269,0.6547390887453524 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441061,3191.23583743436,5328.634617598269,0.5988843421342931 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441060,3459.8919175389124,5328.634617598269,0.6493017753764397 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441059,1151.9937280195188,5328.634617598269,0.2161892887560655 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441073,31573.571690412664,5328.634617598269,5.925264904847905 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441054,513415.6641422221,656386.6079991342,0.78218485551871475 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441061,861829.0941038529,656386.6079991342,1.3129900634794633 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441060,558077.7968286827,656386.6079991342,0.8502272746390627 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441071,937411.9886186369,656386.6079991342,1.4281400278353535 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441059,922636.1455801144,656386.6079991342,1.4056291434595074 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441073,561299.5811856204,656386.6079991342,0.8551356385783555 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441054,3420.250715167235,5223.837669019135,0.6547390887453525 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441061,3128.4745858268643,5223.837669019135,0.5988843421342932 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441060,3391.8470727724475,5223.837669019135,0.6493017753764398 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441059,1129.3377502423898,5223.837669019135,0.21618928875606547 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441073,30952.622008861577,5223.837669019135,5.925264904847906 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441054,513415.6641422221,656386.6079991342,0.78218485551871475 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441061,861829.0941038529,656386.6079991342,1.3129900634794633 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441060,558077.7968286827,656386.6079991342,0.8502272746390627 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441071,937411.9886186369,656386.6079991342,1.4281400278353535 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441059,922636.1455801144,656386.6079991342,1.4056291434595074 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441073,561299.5811856204,656386.6079991342,0.8551356385783555 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441054,51.339216321758975,50.79723336807032,1.010669536857677 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441061,53.08597674271191,50.79723336807032,1.045056457269191 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441060,46.589721295062,50.79723336807032,0.9171704481911205 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441071,50.65457098417463,50.79723336807032,0.9971915324037044 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441059,34.2588680122988,50.79723336807032,0.6744238955705201 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441073,77.03887400453806,50.79723336807032,1.5165958635251673 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441054,48.697552147693855,124.85055234194422,0.3900467497678314 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441061,144.18904816355695,124.85055234194422,1.1548931539257263 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441060,71.26023215789704,124.85055234194422,0.5707642523096533 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441071,91.69152094571854,124.85055234194422,0.7344102146588123 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441059,90.21044388251856,124.85055234194422,0.7225474152124506 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441073,99.59164047440096,124.85055234194422,0.7976868232159403 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441054,202.53166435689823,149.81706398084205,1.3518597880332048 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441061,196.00795292428677,149.81706398084205,1.3083152727472447 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441060,162.9385597177184,149.81706398084205,1.0875834527003831 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441071,162.4301835508409,149.81706398084205,1.0841901398602483 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441059,149.14757992916893,149.81706398084205,0.9955313231091036 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441073,154.1432689117058,149.81706398084205,1.0288765833204219 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441054,3375.102394372052,2791.14294318225,1.2092187548531699 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441061,3216.9327452718703,2791.14294318225,1.1525503389676515 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441060,3556.527177191255,2791.14294318225,1.2742189309503338 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441071,3075.779176438328,2791.14294318225,1.101978379126494 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441059,3578.3478201610997,2791.14294318225,1.2820367473123173 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441073,3947.55190902685,2791.14294318225,1.4143137737425049 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441054,560.2719530902881,222.01180748199775,2.52361331338523 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441061,394.0854128286287,222.01180748199775,1.7750651071141064 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441060,220.6137019892342,222.01180748199775,0.9937025624509772 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441071,242.20904666853056,222.01180748199775,1.090973716288358 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441059,362.45681540838825,222.01180748199775,1.632601524753492 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441073,336.0811677254758,222.01180748199775,1.5137986197095736 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441054,12625.257065223175,4330.453784028004,2.915458216362651 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441061,6690.035267214762,4330.453784028004,1.544880883359059 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441060,10122.793034286822,4330.453784028004,2.3375825119350497 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441071,9111.155484962184,4330.453784028004,2.1039724563201263 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441059,10586.6517346839,4330.453784028004,2.444698006876463 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441073,10882.807113495835,4330.453784028004,2.5130870010978645 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441054,81.95314210664328,100.4664893584531,0.8157261454040035 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441061,26.78036060459739,100.4664893584531,0.26656013139911844 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441060,60.49194112255582,100.4664893584531,0.6021106292141591 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441071,41.76402129759706,100.4664893584531,0.41570101199204584 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441059,89.14184289150718,100.4664893584531,0.8872793650971433 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441073,72.5521622880804,100.4664893584531,0.7221528566527537 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441054,612.9518827886446,219.8603821991507,2.7879142056317794 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441061,326.1851677040045,219.8603821991507,1.4836013857582775 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441060,382.9571291914637,219.8603821991507,1.7418196282610803 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441071,297.6273780135882,219.8603821991507,1.3537108188231737 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441059,200.11432629261307,219.8603821991507,0.9101882034906519 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441073,444.2631863994419,219.8603821991507,2.0206604844206355 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441054,217.46616162263572,115.26780159034894,1.8866167188256984 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441061,211.45733135649635,115.26780159034894,1.8344874148636587 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441060,136.36641572350234,115.26780159034894,1.1830399629563155 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441071,141.92515379308725,115.26780159034894,1.2312645147642882 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441059,102.89839675725582,115.26780159034894,0.892689852131883 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441073,63.99609040398533,115.26780159034894,0.5551948551202659 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441054,1381.5374106908698,1760.6737631139824,0.7846640528381815 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441061,1632.9320224882465,1760.6737631139824,0.9274472401975208 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441060,1820.7009239750764,1760.6737631139824,1.0340932898068114 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441071,2159.364651159724,1760.6737631139824,1.226442227060057 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441059,1457.341358024158,1760.6737631139824,0.8277179955511228 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441073,1482.8768569897331,1760.6737631139824,0.8422212496465392 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441054,1841.874499000748,518.6000624505415,3.551627993057572 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441061,1339.4472977096598,518.6000624505415,2.5828136066555176 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441060,440.93207517982586,518.6000624505415,0.8502352913269794 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441071,544.8044707333247,518.6000624505415,1.0505291267397068 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441059,780.474704924867,518.6000624505415,1.5049645409545247 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441073,440.57144691909974,518.6000624505415,0.8495399033260177 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441054,1553.7929729285745,841.89306662726494,1.8455942144211672 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441061,969.7646338490072,841.89306662726494,1.1518857587627045 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441060,1950.76717098961,841.89306662726494,2.3171198912525095 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441071,4.9091500017270695,841.89306662726494,0.005831084963549794 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441059,1746.52,841.89306662726494,2.074515243363139 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441073,1336.7421128094527,841.89306662726494,1.5877813534735694 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441054,749.0975382513494,246.94010350613598,3.0335191717158074 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441061,452.3942501722359,246.94010350613598,1.83199992123189 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441060,288.12647013033984,246.94010350613598,1.1667868687160425 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441071,323.38100011611743,246.94010350613598,1.3095523794015176 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441059,397.3157328913496,246.94010350613598,1.6089558854561552 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441073,341.08595148114046,246.94010350613598,1.3812497307577467 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441054,4388.023125031389,6405.278640912654,0.6850635813098934 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441061,3623.63657346354,6405.278640912654,0.5657266102864227 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441060,2986.31252225029,6405.278640912654,0.46622679350367596 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441071,2858.1325915817297,6405.278640912654,0.44621518466439264 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441059,4247.619343563699,6405.278640912654,0.6631435698101774 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441073,4038.6930011935738,6405.278640912654,0.6305257316047256 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441054,824.5046170958145,184.84349394551683,4.4605552486409925 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441061,1227.6893194220877,184.84349394551683,6.641777285296029 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441060,177.5291418580726,184.84349394551683,0.9604294858784689 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441071,416.14081082988343,184.84349394551683,2.2513143521975527 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441059,127.93361347335508,184.84349394551683,0.6921185633456155 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441073,184.32152887404231,184.84349394551683,0.9971761782882748 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441054,37444.63559867446,66689.05961878091,0.5614809357445091 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441061,44736.2138037347,66689.05961878091,0.6708178831649941 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441060,47066.18044560014,66689.05961878091,0.7057556473977541 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441071,48229.197323702,66689.05961878091,0.7231950427760978 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441059,30369.484494128923,66689.05961878091,0.45538930474851524 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441073,50212.98273613502,66689.05961878091,0.7529418321861309 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441054,883.7848269430466,426.591426110135,2.071736028550363 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441061,526.2637421372964,426.591426110135,1.233648193392027 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441060,531.9248568900902,426.591426110135,1.2469187712946692 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441071,332.4391987006098,426.591426110135,0.7792917962087276 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441059,438.28800579067473,426.591426110135,1.02741869377731 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441073,621.7119206751456,426.591426110135,1.4573943183626843 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441054,529618.342009701,6086.038398766024,87.02185351263702 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441061,322446.88076570106,6086.038398766024,52.98140754929822 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441060,218003.7167400749,6086.038398766024,35.82029925809805 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441071,327213.0044215739,6086.038398766024,53.76453170060807 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441059,112785.02230743684,6086.038398766024,18.531763179526536 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441073,533277.6711506466,6086.038398766024,87.62311970604252 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441054,266.640061832191,118.38689307733607,2.2522768771202464 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441061,245.73232605012487,118.38689307733607,2.0756717205983315 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441060,81.9575477794193,118.38689307733607,0.6922856546786869 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441071,92.21277259936798,118.38689307733607,0.7789103185530016 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441059,202.6796380122179,118.38689307733607,1.7120107872061288 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441073,77.49543778503116,118.38689307733607,0.6545947424636558 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441054,152.60043763988588,43.003791743375764,3.548534476925333 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441061,67.67652054133345,43.003791743375764,1.5737337987587625 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441060,181.04471435929096,43.003791743375764,4.209970958832457 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441071,152.8441825244474,43.003791743375764,3.5542024628093705 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441059,98.29380796110048,43.003791743375764,2.285700957433399 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441073,214.45406836154933,43.003791743375764,4.9868641733105665 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441054,57.29810560686525,56.77751951238643,1.0091688770300233 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441061,101.27215706165636,56.77751951238643,1.783666456925141 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441060,78.5937406610152,56.77751951238643,1.3842404764419025 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441071,84.62164282530381,56.77751951238643,1.4904075336866907 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441059,29.994111157308772,56.77751951238643,0.528274419434004 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441073,34.42766299158088,56.77751951238643,0.6063608147599727 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441054,133.12323321368072,232.93832449773902,0.5714956244350116 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441061,247.67740584905297,232.93832449773902,1.0632746087750666 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441060,120.50171972416403,232.93832449773902,0.5173116960637092 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441071,64.68680625757253,232.93832449773902,0.2776992854097755 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441059,78.77076607386186,232.93832449773902,0.33816146932329483 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441073,184.9314675892832,232.93832449773902,0.7939074344594516 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441054,64.67150018182994,55.88566907011774,1.157210806596749 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441061,104.4819088053341,55.88566907011774,1.8695653204803615 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441060,61.47791599370038,55.88566907011774,1.1000658490205466 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441071,57.505972628500665,55.88566907011774,1.0289931852895953 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441059,51.74241382665211,55.88566907011774,0.9258619371941805 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441073,29.032955620811183,55.88566907011774,0.5195062724288865 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441054,139.91929285742478,226.42114305345407,0.6179603678813347 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441061,143.78628399107143,226.42114305345407,0.6350391224600699 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441060,48.97625382258769,226.42114305345407,0.21630600906835476 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441071,182.11077831491,226.42114305345407,0.8043011171969785 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441059,224.7289836680605,226.42114305345407,0.9925264957036539 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441073,123.1652934301692,226.42114305345407,0.5439655138614508 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441054,394.862830360927,212.71806341276286,1.8562731534215144 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441061,273.34485490414744,212.71806341276286,1.2850100763363148 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441060,254.76321295403213,212.71806341276286,1.1976566957535897 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441071,247.5406925692985,212.71806341276286,1.1637032069484623 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441059,250.20766213934456,212.71806341276286,1.1762407861613335 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441073,355.2867680533623,212.71806341276286,1.6702237804974558 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441054,9814.903615921456,10996.969545575432,0.8925098478489855 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441061,5023.279735438255,10996.969545575432,0.45678763723223575 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441060,9394.052624560789,10996.969545575432,0.8542401236657451 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441071,8150.76588389622,10996.969545575432,0.7411829095385314 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441059,10815.806672187033,10996.969545575432,0.9835261093851725 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441073,10968.82516175812,10996.969545575432,0.9974407145804424 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441054,151.1131736422698,147.8550055811589,1.022036237787854 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441061,159.16052404605068,147.8550055811589,1.0764635490050154 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441060,149.2476761730777,147.8550055811589,1.0094191643119876 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441071,153.9195914015266,147.8550055811589,1.0410171153592684 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441059,742.712286690448,147.8550055811589,5.023247496905113 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441073,93.97454195747164,147.8550055811589,0.635585799669719 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441054,207.93657111513187,92.19915296117537,2.2552980633422193 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441061,359.23223196479483,92.19915296117537,3.896263907284114 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441060,316.1402470425425,92.19915296117537,3.4288845058659887 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441071,268.86052125818094,92.19915296117537,2.9160845042838606 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441059,235.3842209020696,92.19915296117537,2.5529976506529164 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441073,287.641801564553,92.19915296117537,3.1197878974623294 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441054,5577.142330345374,1229.7970051816276,4.535010499169081 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441061,3961.250103152194,1229.7970051816276,3.221060131437839 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441060,1672.231546143034,1229.7970051816276,1.3597622527110185 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441071,1786.6051348087617,1229.7970051816276,1.4527642588826273 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441059,2650.897379482265,1229.7970051816276,2.1555568669568816 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441073,1446.3988835052196,1229.7970051816276,1.1761281556313452 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441054,133007.54451475263,50083.06853493704,2.655738723795827 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441061,79434.10997279323,50083.06853493704,1.5860471871323427 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441060,142976.44018251155,50083.06853493704,2.8547859459284886 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441071,89282.33996145596,50083.06853493704,1.7826850984414866 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441059,125535.02631426396,50083.06853493704,2.5065362404201132 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441073,138813.44508737608,50083.06853493704,2.771664140158312 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441054,22.982339747217345,35.678906774941794,0.6441436082161135 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441061,76.83537547651221,35.678906774941794,2.153523816219494 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441060,86.15515044013193,35.678906774941794,2.4147362749533823 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441071,167.475980186654,35.678906774941794,4.693977347542404 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441059,23.05965634236719,35.678906774941794,0.6463106195440544 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441073,14.494742309159632,35.678906774941794,0.4062552252677108 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441054,132.43804044164241,67.70693010562654,1.9560485202184146 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441061,117.9407122538025,67.70693010562654,1.7419296971492946 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441060,72.98872709283864,67.70693010562654,1.0780096952996128 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441071,158.54021235978288,67.70693010562654,2.3415655105386026 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441059,111.6311430695288,67.70693010562654,1.648740282499562 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441073,150.9670331289406,67.70693010562654,2.2297131607270293 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441054,42.05899156109435,64.01321127549492,0.6570361136872862 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441061,92.47547414486448,64.01321127549492,1.4446310738399915 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441060,82.31896608926048,64.01321127549492,1.2859683876033452 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441071,74.78972085696694,64.01321127549492,1.1683482107325147 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441059,85.60200467798484,64.01321127549492,1.3372552785951919 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441073,68.86481714303535,64.01321127549492,1.0757906964963917 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441054,662.1016740311218,1060.427767412219,0.6243722527625436 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441061,437.5385425761739,1060.427767412219,0.41260570122933227 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441060,804.1400413104627,1060.427767412219,0.7583166586375045 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441071,655.9224304772453,1060.427767412219,0.6185451292716566 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441059,694.7206970256965,1060.427767412219,0.6551325025381369 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441073,642.327525058177,1060.427767412219,0.6057249204494715 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441054,66.07455549612702,57.09593719876665,1.15725494208289 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441061,77.18027621313527,57.09593719876665,1.3517647664570163 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441060,47.69095760507429,57.09593719876665,0.8352776037119587 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441071,31.73145042450103,57.09593719876665,0.5557567137226442 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441059,41.79887680828779,57.09593719876665,0.7320814555118766 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441073,0.6413156910116034,57.09593719876665,0.011232247380036992 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441054,90.26765576845304,50.205845180981015,1.7979511238792618 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441061,92.73436394517437,50.205845180981015,1.847083016148566 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441060,424.6581290373248,50.205845180981015,8.45834040850275 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441071,96.99816060344702,50.205845180981015,1.9320093159230765 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441059,68.3160887286426,50.205845180981015,1.3607198222115002 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441073,707.4595880187655,50.205845180981015,14.091179731533838 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441054,7772.836504161435,1506.8779059558976,5.158239080578122 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441061,2694.018276318674,1506.8779059558976,1.7878145705571986 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441060,938.984789061856,1506.8779059558976,0.6231326276339588 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441071,1360.9218412663,1506.8779059558976,0.9031400857941376 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441059,1936.1921205065937,1506.8779059558976,1.2849031184635744 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441073,2083.0095714488607,1506.8779059558976,1.3823346690636427 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441054,45882.41942935869,16162.128318216166,2.838884738815314 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441061,27754.643577937062,16162.128318216166,1.71726415181688 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441060,31173.87959347698,16162.128318216166,1.9288226760544418 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441071,55836.10436459402,16162.128318216166,3.4547494776205765 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441059,51713.01997955766,16162.128318216166,3.1996417155822514 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441073,61447.863996486856,16162.128318216166,3.801966101656897 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441054,149.8112116131347,24.995311385825953,5.993572526489423 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441061,158.07191701458032,24.995311385825953,6.32406272418826 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441060,112.06986672595195,24.995311385825953,4.4836355505258165 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441071,92.12553591855436,24.995311385825953,3.6857126721292146 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441059,82.5855538322092,24.995311385825953,3.3040418083785443 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441073,227.1482757715311,24.995311385825953,9.08763536750095 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441054,3320.6441889615257,522.7489803443298,6.352272914572208 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441061,5353.807125354403,522.7489803443298,10.241640494119952 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441060,3820.7454455646016,522.7489803443298,7.308948633525622 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441071,3635.582174031896,522.7489803443298,6.954737954031345 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441059,6547.424000965408,522.7489803443298,12.524986651629014 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441073,7671.266901400793,522.7489803443298,14.674857703878835 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441054,4.314013178288821,2.8430683750443606,1.5173793272634568 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441061,4.723325868826156,2.8430683750443606,1.6613479683732395 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441060,4.520032401264415,2.8430683750443606,1.5898430164184456 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441071,4.238951945557781,2.8430683750443606,1.4909778402679605 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441059,2.30634061764792,2.8430683750443606,0.8112153185946271 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441073,4.941287325928949,2.8430683750443606,1.7380121312952417 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441054,4384.65584755647,1771.7543971110147,2.4747537552078307 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441061,4677.957653419828,1771.7543971110147,2.640296906302367 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441060,5141.217267579599,1771.7543971110147,2.9017663373449274 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441071,3704.598894018982,1771.7543971110147,2.090921236069527 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441059,5843.332707157834,1771.7543971110147,3.2980489376438684 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441073,6366.455757359286,1771.7543971110147,3.5933060291766705 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441054,115.03482714210617,73.62821549612136,1.562374238829217 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441061,8682814.35755509,73.62821549612136,117927.8120357608 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441060,4.119070713433125,73.62821549612136,0.05594418777744399 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441071,57.85636240669279,73.62821549612136,0.785790637690256 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441059,1.4556628235971645,73.62821549612136,0.0197704482417321 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441073,309.69663674721363,73.62821549612136,4.2062222296223934 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441054,636.8264645284471,1923.334023596175,0.33110549530951144 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441061,984.8643901754308,1923.334023596175,0.5120610242905025 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441060,1290.1549471687767,1923.334023596175,0.6707908929705799 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441071,1187.0825231005642,1923.334023596175,0.6172003970901547 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441059,1180.803852534881,1923.334023596175,0.6139359248307061 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441073,1305.8928040928802,1923.334023596175,0.6789734846218614 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441054,5.493249611168042,51.40813337414527,0.10685565202666483 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441061,34.74761250975517,51.40813337414527,0.6759166347640783 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441060,48.057456310573784,51.40813337414527,0.9348220438352534 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441071,49.13250393504921,51.40813337414527,0.9557340582173219 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441059,13.703370954928294,51.40813337414527,0.2665603680879831 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441073,39.4815498175419,51.40813337414527,0.7680020110864088 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441054,91.800845410579,89.1451395839603,1.0297908089999395 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441061,43.27,89.1451395839603,0.48538821299670143 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441060,366.5262212411524,89.1451395839603,4.111567079839995 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441071,136.20394975153425,89.1451395839603,1.5278898029348214 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441059,29.12375024644967,89.1451395839603,0.3267003718023214 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441073,75.21425794346136,89.1451395839603,0.8437280853951852 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441054,6460.538321288779,4771.656231796832,1.3539404364961924 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441061,7030.889166506088,4771.656231796832,1.4734693416626352 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441060,10400.676310793611,4771.656231796832,2.179678460800831 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441059,5454.9150964410355,4771.656231796832,1.1431911335295235 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441073,52.87996773678891,4771.656231796832,0.011082099205808932 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441054,323168.93619649025,209884.98459768714,1.5397430017013778 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441061,201838.76557843183,209884.98459768714,0.9616636748232442 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441060,233462.87455786797,209884.98459768714,1.1123371927028296 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441071,466793.836484822,209884.98459768714,2.2240458857959 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441059,499727.0356187055,209884.98459768714,2.3809565823710304 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441073,304691.6178179324,209884.98459768714,1.4517075549829017 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441054,38.033376826772525,22.903585106474594,1.6605861767912005 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441061,75.74694319757852,22.903585106474594,3.3072090175160254 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441060,2.3862070120287475,22.903585106474594,0.10418486891618521 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441071,286.36852351930935,22.903585106474594,12.503218259850335 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441059,11.743692049528397,22.903585106474594,0.5127447076487857 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441073,3.109329819961933,22.903585106474594,0.13575734128553346 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441054,48.196108807614294,83.56495705722055,0.576750237238946 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441061,144.93134574150025,83.56495705722055,1.7343555342493562 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441060,38.609223324403864,83.56495705722055,0.46202648435475713 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441071,25.7220000134972,83.56495705722055,0.3078084512851988 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441059,129.17566978248598,83.56495705722055,1.5458114780581267 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441073,2.4300714361279363,83.56495705722055,0.02908002973619625 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441054,2045.432995947798,1829.6496491832456,1.1179369760002293 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441061,2664.512876939471,1829.6496491832456,1.4562967714222816 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441060,1800.734985407904,1829.6496491832456,0.9841966117457246 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441071,1861.305454371452,1829.6496491832456,1.0173015665607552 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441059,1187.734927114189,1829.6496491832456,0.6491597599815861 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441073,1850.911381756883,1829.6496491832456,1.0116206578582565 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441054,205125.65340787463,96234.19538703516,2.1315256243677134 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441061,182028.23906317557,96234.19538703516,1.8915130773535698 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441060,246163.2297635685,96234.19538703516,2.557960076182359 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441071,167346.1322735556,96234.19538703516,1.738946656129062 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441059,228782.4826052467,96234.19538703516,2.3773512282731537 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441073,263764.13830126723,96234.19538703516,2.740856690706036 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441054,65.57592462113612,77.99112650544876,0.8408126354804574 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441061,77.64515293431349,77.99112650544876,0.9955639367369427 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441060,78.21722618564046,77.99112650544876,1.0028990436517915 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441071,70.7300455283569,77.99112650544876,0.9068986267741038 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441059,70.003641932469307,77.99112650544876,0.8975847005822974 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441073,127.186476635339,77.99112650544876,1.6307813764743258 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441054,125.937010092804,110.33780757772625,1.1413767670169543 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441061,114.746024302142,110.33780757772625,1.039952005764755 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441060,21.069702159482787,110.33780757772625,0.19095632423764147 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441071,127.23713356613872,110.33780757772625,1.1531598856222327 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441059,109.0051449971031,110.33780757772625,0.987921976973447 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441073,134.099036991502,110.33780757772625,1.215349841866646 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441054,66.39123766440807,67.31067174214355,0.9863404412117934 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441061,61.06235516882179,67.31067174214355,0.9071719771679286 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441060,57.58183753975936,67.31067174214355,0.8554637184478888 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441071,66.51137350289162,67.31067174214355,0.988125237520821 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441059,38.433542972530056,67.31067174214355,0.5709873631890472 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441073,70.3543578078752,67.31067174214355,1.045218477055043 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441054,3487.9600902747216,2375.529574917848,1.4682873777293823 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441061,3029.3546360524374,2375.529574917848,1.2752333913406235 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441060,3302.7496823636434,2375.529574917848,1.3903214328442368 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441071,3504.888606367222,2375.529574917848,1.4754135849849102 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441059,4326.8490295382935,2375.529574917848,1.821425030958803 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441073,3269.970426295683,2375.529574917848,1.3765227176381363 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441054,376.29065610218936,194.62377093849457,1.9334259853648892 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441061,368.46676869527533,194.62377093849457,1.8932259246570606 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441060,303.1137198843429,194.62377093849457,1.5574342148582332 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441071,210.98101732218592,194.62377093849457,1.084045470421291 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441059,221.5596894123343,194.62377093849457,1.138399941301888 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441073,238.06434061288604,194.62377093849457,1.223202795141194 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441054,5115.6872591872825,3728.1507253933823,1.372178228831532 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441061,2471.293793785157,3728.1507253933823,0.6628738953477784 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441060,6886.360674372918,3728.1507253933823,1.8471250712768035 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441071,5280.682303336552,3728.1507253933823,1.4164347668050228 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441059,4357.196694513474,3728.1507253933823,1.1687286849309764 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441073,4688.8231923380345,3728.1507253933823,1.2576806941847247 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441054,83.65473482304529,68.78582331086372,1.2161624415685848 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441061,94.62901162510026,68.78582331086372,1.3757051536250928 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441060,83.48265138213799,68.78582331086372,1.2136607132672514 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441071,65.35601166132133,68.78582331086372,0.9501378120598769 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441059,209.7301587726104,68.78582331086372,3.049031743427378 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441073,73.3329950727917,68.78582331086372,1.066106234439878 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441054,976.2405523323434,696.3940975413478,1.401850698877269 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441061,908.1375582602795,696.3940975413478,1.304056943426864 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441060,972.2531737272355,696.3940975413478,1.3961249487320775 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441071,633.1168254965047,696.3940975413478,0.909135829455984 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441059,673.2622445315629,696.3940975413478,0.9667833873212697 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441073,980.5500177392996,696.3940975413478,1.4080389555298898 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441054,58.983647005264,81.2393188807366,0.7260480247483974 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441061,85.70780778046313,81.2393188807366,1.0550040172824011 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441060,67.5450986972011,81.2393188807366,0.8314335918591427 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441071,63.902174894241256,81.2393188807366,0.7865917116815424 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441059,191.7445902072673,81.2393188807366,2.3602436954051518 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441073,30.064003289200187,81.2393188807366,0.37006715102247045 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441054,390.6461279939073,543.8205698619286,0.7183364323513711 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441061,199.94220867917608,543.8205698619286,0.36766209253530024 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441060,549.8749680711869,543.8205698619286,1.0111330805504388 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441071,309.59854096404274,543.8205698619286,0.569302740870297 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441059,204.5693684863953,543.8205698619286,0.37617070744185666 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441073,536.783425869505,543.8205698619286,0.9870598054166833 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441054,230745.05607008527,306516.0644612488,0.752799225957885 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441061,190893.03802855537,306516.0644612488,0.6227831430763034 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441060,292068.92851461656,306516.0644612488,0.9528666271634885 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441059,246550.2265017283,306516.0644612488,0.804363147931838 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441073,636328.4133547338,306516.0644612488,2.076003469746955 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441054,945289.7852522888,335923.8645439917,2.8140000905725953 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441061,597059.9912001651,335923.8645439917,1.7773669995451478 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441060,771570.2785421845,335923.8645439917,2.2968605686576393 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441071,701039.2572027452,335923.8645439917,2.086899238773609 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441059,671158.9368495964,335923.8645439917,1.9979495584830749 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441073,716043.67,335923.8645439917,2.1315653502974894 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441054,74.18442093453402,33.931355493730415,2.1863087947736504 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441061,46.10405564820206,33.931355493730415,1.3587448829363988 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441060,10.174813667904251,33.931355493730415,0.299864639058828 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441071,3.1575625579723106,33.931355493730415,0.09305736573228682 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441059,22.418802756939304,33.931355493730415,0.6607104971412558 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441073,352.1101906656278,33.931355493730415,10.377133054135962 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441054,12.787522821962186,76.3332642617619,0.16752228462431837 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441061,193.71906238373592,76.3332642617619,2.5378066070833136 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441060,35.75685830843495,76.3332642617619,0.46843088205710154 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441071,16.914101196388643,76.3332642617619,0.22158231224577055 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441059,69.96119978817887,76.3332642617619,0.9165230972995999 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441073,86.81261095213699,76.3332642617619,1.137284142001832 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441054,172.84431110234462,130.67426801703346,1.3227111483020841 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441061,172.05873806482708,130.67426801703346,1.3166994594712338 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441060,142.09759791551085,130.67426801703346,1.0874183576600434 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441071,148.16900422246542,130.67426801703346,1.133880498975908 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441059,53.200263573396015,130.67426801703346,0.4071211905810051 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441073,179.2171966827914,130.67426801703346,1.3714803947432892 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441054,7717.190789158357,5444.214081294075,1.4175031829982705 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441061,7396.1542334467695,5444.214081294075,1.3585347899634255 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441060,8380.404653331976,5444.214081294075,1.5393231287738003 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441071,8137.551372661476,5444.214081294075,1.4947155367423028 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441059,7594.194389124832,5444.214081294075,1.3949110515727023 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441073,7976.919551304999,5444.214081294075,1.4652104844137406 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441054,109.68099781931744,100.67607722942154,1.089444492055202 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441061,86.64882353669634,100.67607722942154,0.8606694452271937 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441060,47.856372190770955,100.67607722942154,0.47534998887288216 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441071,47.782752963195684,100.67607722942154,0.47461874040153473 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441059,146.23340653825335,100.67607722942154,1.4525139493170296 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441073,97.9941637014888,100.67607722942154,0.9733609651693007 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441054,580.3824183331794,599.1099853739104,0.9687410200164784 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441061,1154.791138801295,599.1099853739104,1.9275110864336178 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441060,556.893931682752,599.1099853739104,0.9295353862866917 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441071,541.930195751438,599.1099853739104,0.9045587771554401 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441059,624.4651520379429,599.1099853739104,1.0423213888651983 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441073,658.4524912265016,599.1099853739104,1.099051104640753 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441054,91.4986151009143,114.30018844822946,0.8005114982146964 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441061,92.86421555335968,114.30018844822946,0.8124589890367602 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441060,136.6713214231243,114.30018844822946,1.1957226254708015 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441071,139.36689491134987,114.30018844822946,1.2193059066956307 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441059,103.41456728933412,114.30018844822946,0.9047628765386873 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441073,160.40540922841615,114.30018844822946,1.4033695955021923 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441054,3185.675113628583,1759.6959467320276,1.8103554307463028 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441061,2330.4923084723614,1759.6959467320276,1.3243721523598284 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441060,2242.8316537291885,1759.6959467320276,1.2745563561104993 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441071,2787.2072380107625,1759.6959467320276,1.5839141092453786 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441059,2578.24,1759.6959467320276,1.4651622087259504 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441073,2456.020991060929,1759.6959467320276,1.3957075912018 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441054,75.17340061480436,38.77498679262034,1.9387086065780783 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441061,39.03810282865992,38.77498679262034,1.0067857156843611 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441060,34.26563143822589,38.77498679262034,0.8837045289399642 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441071,45.45027088064038,38.77498679262034,1.1721543871496685 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441059,128.73817851776886,38.77498679262034,3.3201346838955037 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441073,80.96660730254499,38.77498679262034,2.0881143747534314 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441054,2509.959533082582,2284.874121495706,1.098511077467818 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441061,2374.6641385829885,2284.874121495706,1.039297577158651 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441060,2142.869493623232,2284.874121495706,0.9378501307636519 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441071,1433.6202645700134,2284.874121495706,0.6274394948425205 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441059,1704.677410941631,2284.874121495706,0.7460706018350494 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441073,1919.7723366584737,2284.874121495706,0.840209234547139 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441054,412.1942161396312,306.4947439651267,1.3448655295261152 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441061,408.8488150375851,306.4947439651267,1.3339504937288724 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441060,452.5814692936483,306.4947439651267,1.4766369675335884 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441071,456.3850286489276,306.4947439651267,1.4890468356640254 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441059,395.7337143831771,306.4947439651267,1.2911598719885522 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441073,470.0700163025684,306.4947439651267,1.5336968269708842 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441054,54656.4849733383,53872.22448470133,1.014557789215845 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441061,67036.17734500617,53872.22448470133,1.244355101097471 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441060,70249.17638314825,53872.22448470133,1.3039962068597644 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441071,51433.17383862114,53872.22448470133,0.954725265767096 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441059,56727.00075666491,53872.22448470133,1.0529916167240185 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441073,64086.23776596717,53872.22448470133,1.1895970210802493 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441054,357.65056486217657,320.29657233769314,1.116623141646051 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441061,59.61026920469683,320.29657233769314,0.1861096070108702 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441060,101.78312484043744,320.29657233769314,0.31777775234237 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441071,106.0280164528405,320.29657233769314,0.3310307558991099 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441059,543.1059851719154,320.29657233769314,1.695634708820147 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441073,90.08779118164364,320.29657233769314,0.28126367548717573 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441054,35178.47973443219,6299.521117687065,5.584310152665753 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441061,42439.54455145844,6299.521117687065,6.736947739138712 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441060,44000.95312714767,6299.521117687065,6.984809210910794 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441071,29144.67143770967,6299.521117687065,4.626489997133375 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441059,22334.13660388902,6299.521117687065,3.545370542719798 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441073,37459.46317083136,6299.521117687065,5.946398539034503 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441054,2376.732863697342,1965.7827420843205,1.209051647883169 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441061,2545.85742718481,1965.7827420843205,1.2950858569881614 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441060,2424.0647422934658,1965.7827420843205,1.233129526675582 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441071,2293.7424020273147,1965.7827420843205,1.1668341332548573 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441059,1252.0688506970307,1965.7827420843205,0.6369314491841868 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441073,1925.6512469374409,1965.7827420843205,0.9795849794141909 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441054,24633.246645118295,6243.797224888628,3.9452348879823984 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441061,29460.4755463191,6243.797224888628,4.718358794370455 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441060,31760.40386126534,6243.797224888628,5.086712895586044 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441071,20524.17556919289,6243.797224888628,3.287130383956212 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441059,17637.834679051037,6243.797224888628,2.824857061139689 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441073,28146.854820391705,6243.797224888628,4.507970679796342 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441054,582.2213505324422,477.14850073021523,1.2202099548493317 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441061,595.879131763637,477.14850073021523,1.2488337086917796 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441060,554.6636208570948,477.14850073021523,1.162454917092378 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441071,516.8742271973607,477.14850073021523,1.083256525811881 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441059,372.02456237648425,477.14850073021523,0.7796829746025564 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441073,469.328415120615,477.14850073021523,0.9836107928713334 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441054,367.663861947794,205.1372392304115,1.7922823926416964 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441061,408.3694697648886,205.1372392304115,1.990713491596742 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441060,616.7428123242083,205.1372392304115,3.006488800560871 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441071,349.17136554066707,205.1372392304115,1.7021354428411484 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441059,334.7132373921984,205.1372392304115,1.6316551721564618 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441073,526.6270515821492,205.1372392304115,2.567193814042892 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441054,82.70275173077658,44.32085041603382,1.8660010120396395 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441061,121.9588626489196,44.32085041603382,2.7517265915276505 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441060,88.99270484543761,44.32085041603382,2.0079196136823896 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441071,14.368115136695655,44.32085041603382,0.3241841030084961 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441059,11.152753590301993,44.32085041603382,0.2516367237003037 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441073,153.44894395331724,44.32085041603382,3.4622292332595785 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441054,33.19838395978384,73.02499011367847,0.45461675390991085 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441061,98.48481504916192,73.02499011367847,1.3486453732598933 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441060,71.28164801141807,73.02499011367847,0.976126773868144 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441071,95.44263837718565,73.02499011367847,1.3069859814922191 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441059,56.53818161777433,73.02499011367847,0.7742305959885921 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441073,64.28642445036637,73.02499011367847,0.8803345861504572 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441054,124.90101546033364,446.9213615105917,0.27946978197275896 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441061,88.85444414451189,446.9213615105917,0.1988144935480022 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441060,83.3893523625627,446.9213615105917,0.18658618617088957 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441071,83.46753356344637,446.9213615105917,0.18676111896134606 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441059,18.36952220356823,446.9213615105917,0.04110235890600384 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441073,518.3998397655893,446.9213615105917,1.1599352468036004 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441054,1889.5819701847267,2631.000022355788,0.718199146381155 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441061,1905.3374901119023,2631.000022355788,0.7241875613539029 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441060,4374.122182092617,2631.000022355788,1.6625321721495248 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441071,2302.05050217501,2631.000022355788,0.8749716771624206 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441059,2061.8429764693096,2631.000022355788,0.7836727324020099 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441073,1991.6520951354016,2631.000022355788,0.7569943284728988 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441054,19.694950645827905,48.89133349009634,0.40283112036241364 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441061,50.92182527348251,48.89133349009634,1.041530709809694 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441060,33.34906480113309,48.89133349009634,0.6821058543614571 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441071,43.04325519192908,48.89133349009634,0.8803861977020553 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441059,67.76347551266025,48.89133349009634,1.386001785498175 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441073,32.34399570381479,48.89133349009634,0.6615486507514986 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441054,203.02673780319196,307.70649021557807,0.6598064852676723 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441061,98.76146217015648,307.70649021557807,0.3209599579812715 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441060,257.44710762607355,307.70649021557807,0.8366645352384573 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441071,203.57216142141135,307.70649021557807,0.6615790303246104 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441059,189.84140035966664,307.70649021557807,0.6169561136869892 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441073,170.59606517827928,307.70649021557807,0.5544116572216604 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441054,171.47751840298324,154.19153082843468,1.11210724403393 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441061,151.71313980607283,154.19153082843468,0.983926542469317 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441060,131.3470741568606,154.19153082843468,0.8518436353226652 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441071,168.238101252833,154.19153082843468,1.0910981968265663 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441059,157.56815378841117,154.19153082843468,1.021898887324321 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441073,107.30806516769242,154.19153082843468,0.695940072656076 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441054,7780.898146255672,6593.957266089812,1.1800043330990089 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441061,7756.602863117068,6593.957266089812,1.1763198562123378 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441060,8491.713617750811,6593.957266089812,1.2878023431271584 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441071,7553.9705090474545,6593.957266089812,1.1455898490417311 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441059,7872.939746470532,6593.957266089812,1.193962810004553 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441073,8890.298536483342,6593.957266089812,1.348249340680858 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441054,160.42609400042772,127.96554716912783,1.2536662996360877 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441061,144.79848189533772,127.96554716912783,1.1315427089446377 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441060,132.72944029683552,127.96554716912783,1.0372279354333664 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441071,116.64859697348868,127.96554716912783,0.9115625225227075 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441059,86.83540187744481,127.96554716912783,0.6785842267581393 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441073,220.5850369795212,127.96554716912783,1.7237845799852771 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441054,2139.0203522770894,1681.9358703135756,1.2717609452483443 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441061,1855.1195308650613,1681.9358703135756,1.1029668631296852 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441060,2208.5962456660386,1681.9358703135756,1.313127500666404 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441071,1775.475631557356,1681.9358703135756,1.0556143446933808 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441059,1571.0243140228977,1681.9358703135756,0.9340572026268755 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441073,2496.359570011342,1681.9358703135756,1.4842180454513567 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441054,45.26377348572766,45.403354316773296,0.9969257594918693 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441061,44.06044771379113,45.403354316773296,0.9704227446806488 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441060,44.610629214367165,45.403354316773296,0.982540384640408 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441071,49.419170916484475,45.403354316773296,1.088447575297925 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441059,36.90810320713072,45.403354316773296,0.8128937555940843 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441073,44.89312851843725,45.403354316773296,0.9887623765685621 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441054,169.6007103410382,171.72890790902974,0.9876072258660207 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441061,177.168773627557,171.72890790902974,1.0316770530061772 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441060,158.73204883758967,171.72890790902974,0.9243175815319054 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441071,180.21689913849377,171.72890790902974,1.0494266884522458 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441059,145.54690530536706,171.72890790902974,0.8475387579036366 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441073,184.74763068475715,171.72890790902974,1.0758097336915684 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441054,20.505083217658324,385.5886159476326,0.05317865302445327 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441061,650.7361791633354,385.5886159476326,1.6876436498626113 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441060,152.9481887994941,385.5886159476326,0.3966615778414636 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441071,49.67031171353505,385.5886159476326,0.12881685210405913 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441059,20.3398333177295,385.5886159476326,0.05275008772689463 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441073,0.3276240269187819,385.5886159476326,8.496724575584385e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441054,230.8379372723867,430.1288265554666,0.5366716272447258 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441061,214.76648859237568,430.1288265554666,0.49930735940731186 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441060,318.417924514164,430.1288265554666,0.7402850142923468 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441071,251.78240412726856,430.1288265554666,0.5853651012966934 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441059,262.4918054440216,430.1288265554666,0.610263226359632 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441073,194.44806078399856,430.1288265554666,0.4520693540611229 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441054,51122.428151153785,54695.927744901994,0.9346660758655605 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441061,33794.81219317453,54695.927744901994,0.6178670622571975 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441060,54398.71779824203,54695.927744901994,0.9945661412299993 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441059,73827.27403935282,54695.927744901994,1.3497764291279253 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441073,112.73728214812398,54695.927744901994,0.002061164090202891 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441054,457884.4313903272,97212.60478924697,4.710134373860287 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441061,328365.0883072166,97212.60478924697,3.377803619387619 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441060,456487.8974707156,97212.60478924697,4.695768603879745 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441071,406959.151933112,97212.60478924697,4.186279678601177 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441059,270647.3372108142,97212.60478924697,2.7840765896312187 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441073,356683.40274721873,97212.60478924697,3.6691065270855985 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441054,62922.787248901535,62941.57202670208,0.9997015521348501 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441061,43593.219337164584,62941.57202670208,0.6925981975580586 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441060,70562.4010046053,62941.57202670208,1.1210778303196842 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441059,78799.0739455742,62941.57202670208,1.2519400359454764 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441073,10888.259889459876,62941.57202670208,0.17298995781104234 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441054,116047.50502573542,14728.399701289269,7.879165922933029 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441061,62304.97791490972,14728.399701289269,4.230261208178359 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441060,106904.4205868592,14728.399701289269,7.258386705617528 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441071,91250.59423710284,14728.399701289269,6.1955539018346375 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441059,49145.21539254555,14728.399701289269,3.3367654591994516 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441073,67663.87453734806,14728.399701289269,4.594109062060899 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441054,7994.342398871952,3575.9352491809864,2.235594842133379 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441061,5898.8911260548575,3575.9352491809864,1.649607924921434 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441060,4404.542973776813,3575.9352491809864,1.2317177652435418 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441059,4752.370631029001,3575.9352491809864,1.3289867684593728 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441073,15277.255343350613,3575.9352491809864,4.272240485017069 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441054,44229.930617324986,12966.336321671553,3.4111355374455603 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441061,18865.028821080552,12966.336321671553,1.4549236078004624 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441060,64779.47276742957,12966.336321671553,4.995973508658654 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441071,43371.70158640213,12966.336321671553,3.344946522319643 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441059,38045.05014095465,12966.336321671553,2.934140315130286 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441073,42587.09549469051,12966.336321671553,3.284435513485154 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441054,253.20170538396513,103.34580193186551,2.450043452668717 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441061,216.19107805676833,103.34580193186551,2.091919304078749 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441060,90.61795221599668,103.34580193186551,0.8768421215187809 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441071,93.0436364915474,103.34580193186551,0.9003136533101733 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441059,100.49465111254489,103.34580193186551,0.9724115468067068 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441073,82.02190978272561,103.34580193186551,0.7936646506144638 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441054,442.3289504559683,211.8154700640626,2.088274998621149 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441061,388.40066694854977,211.8154700640626,1.833674692557063 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441060,609.7278579073296,211.8154700640626,2.87858038755583 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441071,536.0928485325163,211.8154700640626,2.5309428455361527 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441059,454.64,211.8154700640626,2.14639657746668 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441073,446.0817441432345,211.8154700640626,2.1059922771850386 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441054,136.71756816296676,76.10596635595309,1.7964106456979843 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441061,128.46608616533828,76.10596635595309,1.6879896848624607 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441060,52.24782690616549,76.10596635595309,0.6865142039166633 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441071,60.865652857288545,76.10596635595309,0.7997487683503748 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441059,62.07378918065943,76.10596635595309,0.8156231653420686 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441073,90.60767030673291,76.10596635595309,1.1905462166126939 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441054,4652.359543383384,1382.686999693948,3.3647235740360357 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441061,3474.7024056157957,1382.686999693948,2.5130072144924385 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441060,3092.3776587095717,1382.686999693948,2.236498686538643 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441071,3719.9103081198377,1382.686999693948,2.6903487983493184 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441059,3936.044096988596,1382.686999693948,2.846663126115905 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441073,4098.937449992092,1382.686999693948,2.9644724011286536 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441054,30.923363649981567,30.899530320120164,1.000771316897522 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441061,32.67530356506923,30.899530320120164,1.0574692633367562 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441060,32.71429082366967,30.899530320120164,1.0587310060945434 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441071,34.0849329978406,30.899530320120164,1.1030890322512854 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441059,24.85511450287834,30.899530320120164,0.8043848642804122 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441073,31.44131930868531,30.899530320120164,1.0175338907404803 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441054,29.99668965388348,31.68183515511672,0.9468103570079626 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441061,35.11959692642221,31.68183515511672,1.1085089217361919 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441060,31.664123534612933,31.68183515511672,0.9994409534543354 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441071,30.41809074494109,31.68183515511672,0.9601113886241678 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441059,30.813390797145136,31.68183515511672,0.9725885715357203 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441073,35.980719732117414,31.68183515511672,1.1356892539827008 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441054,650.957466351773,628.1906149122311,1.0362419477449893 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441061,767.7822574231351,628.1906149122311,1.222212238128402 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441060,775.8554150598471,628.1906149122311,1.2350636839237836 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441071,575.1595139567454,628.1906149122311,0.9155811951076425 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441059,515.7725527208366,628.1906149122311,0.8210446645926075 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441073,933.1817308133076,628.1906149122311,1.4855072786206602 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441054,24554.295687625676,10551.186365326936,2.3271596991515033 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441061,6816.092782122631,10551.186365326936,0.6460025011520523 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441060,21697.88669584568,10551.186365326936,2.056440474518465 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441071,28627.032949516288,10551.186365326936,2.7131577396443096 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441059,23853.69789573611,10551.186365326936,2.2607597922944076 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441073,31151.73258495792,10551.186365326936,2.9524388543953712 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441054,155.26068676116594,102.14043933131707,1.5200706769778087 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441061,127.04710402516616,102.14043933131707,1.2438472446065985 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441060,109.75545803747782,102.14043933131707,1.0745543954579988 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441071,131.31010030655088,102.14043933131707,1.285583860478757 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441059,185.92116734815625,102.14043933131707,1.8202503197100635 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441073,124.55355359061164,102.14043933131707,1.219434284853546 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441054,7504.517298771063,2995.2816068385046,2.505446326528216 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441061,4103.791821963763,2995.2816068385046,1.3700854746326447 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441060,11245.851581317163,2995.2816068385046,3.7545222978840607 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441071,6556.58656872542,2995.2816068385046,2.1889716658881513 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441059,4935.277850572787,2995.2816068385046,1.6476840906394552 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441073,4881.7643970407335,2995.2816068385046,1.6298181733214048 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441054,37.15849689535065,35.73806763844074,1.0397455528732076 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441061,38.97407494897534,35.73806763844074,1.0905479093965862 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441060,41.084442759798854,35.73806763844074,1.1495988864156557 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441071,38.7643456990692,35.73806763844074,1.0846793982048801 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441059,21.633551190083313,35.73806763844074,0.605336343558031 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441073,40.95500987419821,35.73806763844074,1.1459771772927645 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441054,249.042721247528,271.6614200921023,0.9167393778737305 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441061,265.89051861500053,271.6614200921023,0.9787570076194654 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441060,250.41596793226043,271.6614200921023,0.9217943712705362 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441071,224.79788934532036,271.6614200921023,0.8274928742885405 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441059,233.69828456758404,271.6614200921023,0.8602556980242264 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441073,357.04011264203183,271.6614200921023,1.3142834655026958 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441054,157.57026672656522,166.02715311669658,0.9490632331436339 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441061,184.38080764697224,166.02715311669658,1.1105461015607208 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441060,181.78043784722365,166.02715311669658,1.0948837851809363 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441071,172.75553267164565,166.02715311669658,1.0405257780347523 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441059,138.8634364281587,166.02715311669658,0.8363899146698905 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441073,273.5893724467459,166.02715311669658,1.6478592044184868 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441054,1575.89728809875,1793.9624976146763,0.8784449453063404 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441061,1588.209847324527,1793.9624976146763,0.8853082767539866 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441060,2361.040115863918,1793.9624976146763,1.3161033851060155 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441071,1496.25402467219,1793.9624976146763,0.8340497790013274 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441059,1717.0718700402942,1793.9624976146763,0.9571392224326769 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441073,1661.0684329731855,1793.9624976146763,0.925921492328746 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441054,95.44041810540936,59.13775760336051,1.613866030320804 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441061,57.48330769086914,59.13775760336051,0.9720237969862192 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441060,71.8937577574242,59.13775760336051,1.215699760542473 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441071,92.7535102353805,59.13775760336051,1.5684313033558406 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441059,38.04057039035521,59.13775760336051,0.643253514032354 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441073,248.2344532166425,59.13775760336051,4.197562830866223 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441054,276.17077061439994,238.79765196261823,1.1565053858135597 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441061,91.12066163860212,238.79765196261823,0.38158106199832437 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441060,333.376101704395,238.79765196261823,1.3960610540533382 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441071,365.0145567766726,238.79765196261823,1.5285516996365296 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441059,270.4546317542842,238.79765196261823,1.1325682205477532 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441073,448.0186748016125,238.79765196261823,1.8761435513266524 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441054,539.4712070296926,386.8144501381946,1.3946511223584312 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441061,454.7356575001703,386.8144501381946,1.1755911841910507 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441060,444.01319833465186,386.8144501381946,1.1478712808583604 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441071,414.6272815083327,386.8144501381946,1.0719022553583548 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441059,347.80470252290354,386.8144501381946,0.8991512659329187 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441073,641.6895213513299,386.8144501381946,1.6589078332572056 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441054,9951.071893612096,5555.372966797932,1.79125181208991 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441061,5878.320599257813,5555.372966797932,1.0581324844236382 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441060,9928.21307849946,5555.372966797932,1.7871370901352812 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441071,8529.067808081503,5555.372966797932,1.5352826640184307 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441059,6652.485526715902,5555.372966797932,1.1974867513801393 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441073,8343.192294618551,5555.372966797932,1.5018239719425164 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441054,53.32674437418255,84.54153084580483,0.6307757127256794 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441061,102.84070935789634,84.54153084580483,1.2164519417736517 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441060,144.8402032769979,84.54153084580483,1.7132432051789046 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441071,34.72835095611777,84.54153084580483,0.4107845056586302 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441059,35.74402717484195,84.54153084580483,0.4227984378474933 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441073,51.2398759019919,84.54153084580483,0.6060911766010983 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441054,283.726976751135,122.00200397429413,2.325592756746163 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441061,101.49581576064348,122.00200397429413,0.8319192509495884 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441060,208.73541661848105,122.00200397429413,1.7109179342862408 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441071,115.1951136107306,122.00200397429413,0.9442067331533527 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441059,132.7418791100228,122.00200397429413,1.0880303174199628 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441073,109.78863517798467,122.00200397429413,0.8998920640772194 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441054,79.64965365232345,143.84455848940917,0.5537203109298556 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441061,175.21400368284523,143.84455848940917,1.2180787756093374 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441060,125.005308194181,143.84455848940917,0.8690304972737968 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441071,324.89112506353973,143.84455848940917,2.25862645396809 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441059,60.65245666633885,143.84455848940917,0.4216527709027276 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441073,214.8716186782043,143.84455848940917,1.4937764829944862 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441054,2611.18112789971,5334.764851653101,0.48946508431211827 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441061,476.6760975185409,5334.764851653101,0.08935278513181921 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441060,2264.687110948709,5334.764851653101,0.424514889395161 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441071,1289.598174715708,5334.764851653101,0.2417347738047153 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441059,5480.034921914801,5334.764851653101,1.027230829155794 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441073,3814.538628654013,5334.764851653101,0.7150340708029501 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441054,144.38437528306616,159.70733471984832,0.9040560067973019 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441061,152.11180609594288,159.70733471984832,0.952440953089417 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441060,149.42759612150996,159.70733471984832,0.9356338979899037 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441071,122.99924642848518,159.70733471984832,0.7701540235722117 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441059,130.362456888609,159.70733471984832,0.816258421175741 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441073,147.07003268873592,159.70733471984832,0.9208721249197465 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441054,130881.8019736375,82077.5827732141,1.5946108249224729 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441061,68003.40535229421,82077.5827732141,0.8285259269902259 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441060,59217.36225201338,82077.5827732141,0.7214803391034912 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441071,60278.564458837216,82077.5827732141,0.7344095966543137 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441059,40031.64852261881,82077.5827732141,0.48772937957041146 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441073,84097.53700958466,82077.5827732141,1.0246103036678338 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441054,262261.13667955325,170961.68742491837,1.5340345584429906 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441061,479462.63602084294,170961.68742491837,2.804503413850601 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441060,232356.7056764866,170961.68742491837,1.3591156543686504 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441071,85806.08804213691,170961.68742491837,0.5019024398657773 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441059,55680.42354228882,170961.68742491837,0.3256894827195837 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441073,109277.5675863888,170961.68742491837,0.63919331420018 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441054,356300.7938032956,55195.40432138408,6.4552619585622955 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441061,237121.16955875143,55195.40432138408,4.296031027838395 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441060,347092.6667051618,55195.40432138408,6.288434172601748 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441071,304587.83448936045,55195.40432138408,5.518354983249131 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441059,262471.62916456134,55195.40432138408,4.755316722317645 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441073,275816.1961288334,55195.40432138408,4.997086252377996 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441054,1704.5529056813416,546.121028905539,3.1211999089238023 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441061,977.5609977880828,546.121028905539,1.7900079763402934 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441060,602.9183565575639,546.121028905539,1.1040013561936086 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441071,621.720617013706,546.121028905539,1.1384300990197602 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441059,820.502205758922,546.121028905539,1.5024182595628301 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441073,603.9423371496698,546.121028905539,1.1058763629007444 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441054,1357.6038518348423,1228.731327313693,1.1048825904055821 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441061,827.6781994571974,1228.731327313693,0.6736038880580217 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441060,1673.8687449314089,1228.731327313693,1.362274003862907 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441071,971.2467565074865,1228.731327313693,0.7904468087672748 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441059,1571.0990299043533,1228.731327313693,1.2786351214298082 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441073,1634.6908562992023,1228.731327313693,1.3303891745586367 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441054,83.35445127431933,76.68368758811918,1.0869906481549234 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441061,101.98006292838286,76.68368758811918,1.329879484619137 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441060,122.16072789694344,76.68368758811918,1.5930471230477203 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441071,85.73262589979836,76.68368758811918,1.1180034319721623 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441059,229.13391179857288,76.68368758811918,2.988039816620311 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441073,129.7353069656141,76.68368758811918,1.691824050800008 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441054,157.654352941282,81.06808963980528,1.9447152836801531 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441061,103.27189127175568,81.06808963980528,1.2738907717031993 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441060,116.13253991508842,81.06808963980528,1.4325308568522888 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441071,145.87,81.06808963980528,1.7993516394442866 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441059,149.63366812592935,81.06808963980528,1.8457776517341005 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441073,207.36810543635875,81.06808963980528,2.5579498216587906 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441054,56.26018601424694,34.254424530644805,1.6424209948094521 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441061,41.73080718550854,34.254424530644805,1.218260349058709 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441060,50.29049028082557,34.254424530644805,1.4681458226172952 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441071,42.99926387925889,34.254424530644805,1.2552907972746923 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441059,22.090283243059087,34.254424530644805,0.6448884646506499 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441073,28.21793941205705,34.254424530644805,0.8237750246486443 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441054,93.85431260654444,60.87738129746832,1.5416943141482913 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441061,124.05292008323822,60.87738129746832,2.0377505970086323 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441060,155.3788818330487,60.87738129746832,2.552325322172003 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441071,62.75657427989707,60.87738129746832,1.0308684924084752 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441059,116.10921043690212,60.87738129746832,1.9072635511299614 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441073,56.137440327192,60.87738129746832,0.9221395390331378 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441054,127.56050850532142,81.37032235510941,1.5676539653933377 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441061,119.6239292656734,81.37032235510941,1.4701174310656024 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441060,89.68447120721814,81.37032235510941,1.1021766734046454 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441071,96.13668200611224,81.37032235510941,1.1814710722978428 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441059,138.29128884309927,81.37032235510941,1.6995298143170705 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441073,93.47526869804253,81.37032235510941,1.1487636523068663 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441054,860.0260665586833,592.3362991324378,1.4519219366064782 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441061,1107.2480251977704,592.3362991324378,1.8692895012841442 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441060,882.0842953458895,592.3362991324378,1.489161303532857 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441071,901.2015454005036,592.3362991324378,1.5214356214880695 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441059,728.2950777261686,592.3362991324378,1.2295297093777 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441073,1139.5408027455112,592.3362991324378,1.923807142014652 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441054,1388.610615078159,1509.2244087879828,0.9200822667540307 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441061,1219.356416847626,1509.2244087879828,0.8079357912232933 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441060,1088.0196794682267,1509.2244087879828,0.720913121423729 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441071,812.5770786842087,1509.2244087879828,0.5384070612380085 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441059,963.4557840863852,1509.2244087879828,0.6383780824616468 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441073,2235.286928651637,1509.2244087879828,1.4810832077959402 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441054,1238052.1383728872,911297.6405793307,1.3585595783895938 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441061,1028900.648532936,911297.6405793307,1.1290500520541704 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441060,869273.829984676,911297.6405793307,0.9538857462991571 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441071,1162838.7250122654,911297.6405793307,1.276025168103173 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441059,777909.2660899205,911297.6405793307,0.8536280919101114 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441073,1390222.1343305907,911297.6405793307,1.5255412418787762 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441054,287.9967303094517,749.6106308195243,0.38419509872024427 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441061,724.3117230624648,749.6106308195243,0.9662506016898386 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441060,644.1634221350046,749.6106308195243,0.8593306920297571 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441071,691.463999064818,749.6106308195243,0.9224308869644278 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441059,1211.713286963257,749.6106308195243,1.6164569139561578 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441073,1651.378238318653,749.6106308195243,2.2029813484812193 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441054,9005.529504142592,2138.7943755926544,4.210563487033289 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441061,4361.079330923149,2138.7943755926544,2.0390362816971153 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441060,9251.692806570569,2138.7943755926544,4.325657909029683 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441071,9821.20747502072,2138.7943755926544,4.591936273583705 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441059,8133.311196797567,2138.7943755926544,3.8027550893216873 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441073,6922.639397371988,2138.7943755926544,3.236701702777642 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441054,1257.7033297002624,613.8984432679271,2.0487156198103538 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441061,727.5961707964674,613.8984432679271,1.1852060854288868 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441060,500.1991834000132,613.8984432679271,0.8147914184915249 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441071,595.8606646403813,613.8984432679271,0.9706176504838058 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441059,1003.8139446492185,613.8984432679271,1.6351465876109388 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441073,959.6962411592808,613.8984432679271,1.5632817637565426 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441054,4947.20076960726,6365.76448478505,0.7771573675764585 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441061,3362.987238704689,6365.76448478505,0.528292752071277 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441060,4445.971784871871,6365.76448478505,0.6984191443931492 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441071,4700.532960001709,6365.76448478505,0.7384082416552724 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441059,5638.68082250118,6365.76448478505,0.8857821925360752 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441073,5946.265329875516,6365.76448478505,0.9341007421948789 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441054,90.14778784799688,70.21289390855102,1.283920699315002 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441061,50.79804297978684,70.21289390855102,0.7234859603700268 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441060,54.83385960745214,70.21289390855102,0.7809656681986452 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441071,112.03052589541444,70.21289390855102,1.595583370218708 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441059,84.82454466109428,70.21289390855102,1.2081049496631522 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441073,41.10136811049518,70.21289390855102,0.5853820548121513 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441054,2925.7838876800447,2003.7789126851078,1.460133086119481 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441061,1876.612070947789,2003.7789126851078,0.9365364906615808 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441060,2206.468885372992,2003.7789126851078,1.10115386054057 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441071,1592.431621733806,2003.7789126851078,0.7947142330188077 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441059,1918.55012779456,2003.7789126851078,0.9574659737404166 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441073,1638.8090637570117,2003.7789126851078,0.8178592225830801 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441054,1403.2729767951912,700.7857837159185,2.0024278594156586 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441061,846.8874639473863,700.7857837159185,1.208482654223896 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441060,757.4229949051451,700.7857837159185,1.0808195778300576 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441071,785.8387805686879,700.7857837159185,1.121368039747861 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441059,968.0293664067468,700.7857837159185,1.3813484646817014 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441073,961.0688082963312,700.7857837159185,1.3714159599532132 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441054,3454.32899322949,4688.560133729121,0.7367568922448766 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441061,2782.262572331867,4688.560133729121,0.5934151408908027 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441060,3588.4011406769887,4688.560133729121,0.7653524831349229 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441071,3790.471512738978,4688.560133729121,0.808451081915455 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441059,4173.998568756746,4688.560133729121,0.8902516870220645 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441073,4431.903020088462,4688.560133729121,0.9452588627808591 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441054,1176.483926718219,384.65137963543384,3.0585719667332816 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441061,622.7055925204852,384.65137963543384,1.6188830340623637 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441060,476.17647349421384,384.65137963543384,1.2379429756511622 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441071,492.5019670196934,384.65137963543384,1.2803852867666263 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441059,489.7872599464902,384.65137963543384,1.273327708874208 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441073,477.8764263245909,384.65137963543384,1.242362439405558 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441054,2438.4298806091574,772.5530415852671,3.1563268142800087 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441061,3353.867382789878,772.5530415852671,4.341277818164812 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441060,3077.599392378904,772.5530415852671,3.9836739055013193 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441071,2047.2020228292072,772.5530415852671,2.649917756622095 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441059,1751.1154509680412,772.5530415852671,2.266660483757567 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441073,2735.8384479121883,772.5530415852671,3.5412952906098063 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441054,206.46512783357167,216.68366112664066,0.9528412375906056 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441061,183.3984292859387,216.68366112664066,0.8463879017567069 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441060,179.68866145831106,216.68366112664066,0.8292672392741791 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441071,196.36499916874735,216.68366112664066,0.9062289152202478 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441059,183.6789014832284,216.68366112664066,0.8476822872947368 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441073,140.2776641620082,216.68366112664066,0.6473845948173406 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441054,1263.97543486699,615.8359185894908,2.0524548775297107 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441061,855.7046311002139,615.8359185894908,1.389501010366719 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441060,1318.1152404652755,615.8359185894908,2.1403675892830085 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441071,1119.4911040144543,615.8359185894908,1.81783989894343 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441059,1037.6820917246548,615.8359185894908,1.6849976761689371 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441073,1056.8394113332558,615.8359185894908,1.716105507054279 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441054,86.85921657602967,101.73138829665541,0.8538094095673057 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441061,126.00320286994456,101.73138829665541,1.2385872736004637 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441060,85.82330958023667,101.73138829665541,0.843626642840755 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441071,67.35417383670581,101.73138829665541,0.6620785871937245 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441059,97.23638045506966,101.73138829665541,0.9558149366007077 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441073,20.609521231639217,101.73138829665541,0.20258763373542588 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441054,105.75078746634186,93.53234569214308,1.1306333299328892 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441061,210.58266732975716,93.53234569214308,2.2514421697802725 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441060,140.90741401290143,93.53234569214308,1.5065099989760864 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441071,396.86008339047066,93.53234569214308,4.243025024698036 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441059,214.66800212272864,93.53234569214308,2.29512047981024 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441073,197.53645435281703,93.53234569214308,2.1119587335380015 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441054,117.0902672417613,42.30806113801961,2.76756400771435 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441061,92.89170198384748,42.30806113801961,2.1956029060469406 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441060,55.10202901504263,42.30806113801961,1.3024002408261126 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441071,63.2585933542996,42.30806113801961,1.4951900808674272 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441059,20.375836936156535,42.30806113801961,0.4816064926654378 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441073,48.52043949679435,42.30806113801961,1.1468367538400872 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441054,366.3072872866844,205.3077634331321,1.784186243916632 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441061,97.3188553849832,205.3077634331321,0.47401449296231585 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441060,496.8584357188962,205.3077634331321,2.420066476836961 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441071,314.6805315832312,205.3077634331321,1.5327259248319725 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441059,436.78688233276705,205.3077634331321,2.1274737741470102 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441073,363.144729070587,205.3077634331321,1.7687822564433213 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441054,506.01061383287333,761.179367641068,0.6647718466161595 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441061,404.0407586393407,761.179367641068,0.530808868206035 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441060,1027.1800043589406,761.179367641068,1.349458548176656 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441059,345.1378724173861,761.179367641068,0.4534251545558641 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441073,1442.6933447224774,761.179367641068,1.8953395297529603 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441054,594269.13968468,258075.7105503754,2.302693029178664 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441061,493743.308106939,258075.7105503754,1.913172328592939 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441060,379439.55071879225,258075.7105503754,1.4702644813399712 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441071,642397.7801544535,258075.7105503754,2.489183421347434 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441059,571416.8446730928,258075.7105503754,2.2141442271125875 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441073,462320.7151421661,258075.7105503754,1.7914150624877303 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441054,140.9027829330392,131.47736122215045,1.0716885524874742 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441061,122.6888862601795,131.47736122215045,0.9331559830507891 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441060,127.08646453128787,131.47736122215045,0.9666034011479474 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441071,119.47444024720136,131.47736122215045,0.9087073176448348 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441059,148.51798862776732,131.47736122215045,1.1296088333931817 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441073,194.1943812118628,131.47736122215045,1.4770176356349491 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441054,2158.3371681407943,3004.2024881525895,0.718439311814846 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441061,2023.582797370934,3004.2024881525895,0.6735840228317367 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441060,3437.0851848691686,3004.2024881525895,1.1440923833941623 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441071,2189.125434147428,3004.2024881525895,0.7286877108918226 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441059,2371.107707232299,3004.2024881525895,0.7892636120844149 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441073,2503.7656195964787,3004.2024881525895,0.8334210591564184 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441054,74.3403658662615,96.13121274223809,0.7733218352877167 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441061,104.407797571109,96.13121274223809,1.0860967483169424 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441060,94.99740784417097,96.13121274223809,0.9882056528184321 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441071,75.0565319806773,96.13121274223809,0.7807717164864082 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441059,58.31212472526687,96.13121274223809,0.6065888805712082 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441073,145.556636939354,96.13121274223809,1.5141454350486874 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441054,365.6631578136378,490.807523353751,0.7450235385859906 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441061,491.6210742059787,490.807523353751,1.0016575761648245 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441060,703.8786226358236,490.807523353751,1.4341235395621696 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441071,374.26979199793107,490.807523353751,0.7625591992569661 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441059,427.7974148454122,490.807523353751,0.8716195137397598 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441073,549.3074703865713,490.807523353751,1.119191219060952 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441054,79.41998426277236,78.64120835950264,1.0099028984868799 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441061,75.0657128765436,78.64120835950264,0.9545340724342138 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441060,67.74278913359268,78.64120835950264,0.8614159236199853 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441071,82.20101457520457,78.64120835950264,1.0452664231636488 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441059,85.57610400436228,78.64120835950264,1.0881839914406866 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441073,58.1714970572956,78.64120835950264,0.7397075689804864 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441054,1632.9739245069948,1710.8868039225827,0.954460529336625 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441061,1639.358944092853,1710.8868039225827,0.9581925235113531 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441060,2446.4210955137028,1710.8868039225827,1.4299140597173037 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441071,1853.494930302376,1710.8868039225827,1.0833533381944573 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441059,1822.8858221165635,1710.8868039225827,1.0654625530673325 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441073,1987.4291840485307,1710.8868039225827,1.1616368654500777 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441054,238.7840273618749,158.21676846284709,1.5092207335655883 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441061,166.88752439145065,158.21676846284709,1.0548030149575434 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441060,159.92740992245405,158.21676846284709,1.0108120111175742 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441071,161.51410897462773,158.21676846284709,1.0208406513659452 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441059,164.99392408439266,158.21676846284709,1.0428346229504555 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441073,157.97388385810206,158.21676846284709,0.9984648618025461 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441054,773.3821311744542,1068.4447009417866,0.7238391752916666 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441061,677.8479401312753,1068.4447009417866,0.6344249164545273 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441060,836.2206580169159,1068.4447009417866,0.782652258258967 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441071,993.3955835291498,1068.4447009417866,0.9297585384189895 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441059,920.9750828601796,1068.4447009417866,0.8619773040648533 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441073,844.8684182274611,1068.4447009417866,0.7907460418707184 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441054,157.42976804236451,101.193417409009,1.5557313121075496 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441061,144.54500352952752,101.193417409009,1.428403222566323 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441060,125.72530669109112,101.193417409009,1.2424257418140925 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441071,143.33731622208197,101.193417409009,1.41646877724006 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441059,156.15262680257203,101.193417409009,1.5431105184581912 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441073,109.60485989341078,101.193417409009,1.083122427325524 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441054,8181.839673314555,8195.704907369402,0.9983082316638341 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441061,10993.771386559012,8195.704907369402,1.3414064453044972 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441060,8443.796525474509,8195.704907369402,1.0302709310436529 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441071,8581.792610372246,8195.704907369402,1.0471085412867516 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441059,8147.868874142052,8195.704907369402,0.9941632801854131 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441073,9836.305969464953,8195.704907369402,1.2001781519269146 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441054,57.02726053343664,54.484574340672744,1.0466680014211982 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441061,102.80035420631653,54.484574340672744,1.886779064539301 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441060,21.103236941156464,54.484574340672744,0.38732498503531293 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441071,55.701323371332784,54.484574340672744,1.0223319911256374 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441059,126.91114755900324,54.484574340672744,2.3293041947152378 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441073,150.03255407855298,54.484574340672744,2.7536702983206323 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441054,363.321245491792,181.8259570369428,1.9981814005685314 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441061,163.5634875343011,181.8259570369428,0.8995607128913327 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441060,256.82118895574877,181.8259570369428,1.4124561374015958 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441071,114.59378717971526,181.8259570369428,0.6302388781401133 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441059,114.27548996348222,181.8259570369428,0.6284883183112524 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441073,148.84540844515112,181.8259570369428,0.81861473945059 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441054,586.8888655207692,598.5025834222519,0.9805953754868105 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441061,721.1585242818803,598.5025834222519,1.204938030773867 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441060,640.7839149868281,598.5025834222519,1.0706451947505566 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441071,691.5630951460572,598.5025834222519,1.1554889056479642 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441059,559.9230025593187,598.5025834222519,0.9355398256723735 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441073,755.633437550415,598.5025834222519,1.262539976401915 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441054,16888.46269152819,15066.853658787537,1.1209017538760142 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441061,15396.279761673097,15066.853658787537,1.0218642929934763 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441060,17364.342582953686,15066.853658787537,1.1524863104266079 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441071,14231.639165286915,15066.853658787537,0.9445660977125444 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441059,15718.867594086752,15066.853658787537,1.0432747241106266 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441073,19259.354150910403,15066.853658787537,1.2782598535214185 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441054,64.50635005437843,62.8704966822211,1.0260194122598674 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441061,65.0760106726698,62.8704966822211,1.0350802698696093 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441060,61.90013179555487,62.8704966822211,0.984565655786514 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441071,67.96188426700759,62.8704966822211,1.0809821435087574 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441059,61.74885419681709,62.8704966822211,0.9821594779014813 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441073,66.7192552561272,62.8704966822211,1.0612172446061567 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441054,97.36108592164382,100.49015468400951,0.9688619370504004 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441061,106.70776193367,100.49015468400951,1.0618728000689392 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441060,100.51262149705856,100.49015468400951,1.0002235722804855 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441071,95.7911735244262,100.49015468400951,0.9532393877354531 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441059,97.02251684788348,100.49015468400951,0.9654927604895227 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441073,112.99016964163155,100.49015468400951,1.1243904439885504 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441054,135.98790349102174,109.95671552102958,1.2367403195579592 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441061,125.33712534339152,109.95671552102958,1.1398769483926645 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441060,109.17097549235471,109.95671552102958,0.9928540969512263 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441071,121.9282361342628,109.95671552102958,1.1088748473115644 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441059,104.91617573729756,109.95671552102958,0.9541588727905573 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441073,119.41252033689344,109.95671552102958,1.0859957008633585 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441054,257.7510035892593,243.54938966397899,1.0583110224372727 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441061,259.52,243.54938966397899,1.0655744215087353 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441060,254.90160700017276,243.54938966397899,1.0466115614243838 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441071,257.5288435124599,243.54938966397899,1.0573988457444634 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441059,266.1032480859962,243.54938966397899,1.0926048652929674 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441073,286.2040663941034,243.54938966397899,1.1751376868115924 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441054,79.93430912511752,49.66723175069083,1.609397309001537 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441061,57.82488068651589,49.66723175069083,1.1642460964358374 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441060,47.38646051340186,49.66723175069083,0.9540789539320913 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441071,41.922678864360606,49.66723175069083,0.8440711790581623 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441059,89.10099165005334,49.66723175069083,1.793959286825242 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441073,85.7189752529643,49.66723175069083,1.725865771687024 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441054,466.9035896967432,318.9289567276793,1.4639736525881328 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441061,606.374822368635,318.9289567276793,1.9012849400388385 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441060,449.35957815069094,318.9289567276793,1.4089645003115259 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441071,345.59217684733534,318.9289567276793,1.083602380897708 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441059,391.6200665297555,318.9289567276793,1.2279225773285436 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441073,511.03383116561054,318.9289567276793,1.6023437834212149 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441054,46.749560156813395,52.85511393128503,0.8844850891361384 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441061,47.03188585691972,52.85511393128503,0.8898265911991814 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441060,44.34485007062135,52.85511393128503,0.8389888276141536 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441071,51.07986989016496,52.85511393128503,0.9664130126854328 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441059,46.11890967508062,52.85511393128503,0.8725534058073946 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441073,52.36771529952206,52.85511393128503,0.990778590839921 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441054,152.2851092161066,145.91831693350866,1.0436325775707729 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441061,137.6646951094652,145.91831693350866,0.943436698027401 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441060,167.6147771935196,145.91831693350866,1.148689079726005 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441071,134.84322567093068,145.91831693350866,0.924100746943068 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441059,126.28995561555053,145.91831693350866,0.8654839109273561 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441073,140.06441917212135,145.91831693350866,0.9598823651176378 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441054,919.5421873020532,261.347965154705,3.5184593335468675 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441061,535.9369806320552,261.347965154705,2.0506644477404183 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441060,343.3814470225055,261.347965154705,1.3138860553945417 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441071,294.7375146192096,261.347965154705,1.1277589800430996 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441059,452.5358418067655,261.347965154705,1.731545304126959 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441073,298.0326095269949,261.347965154705,1.1403670556630294 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441054,6979.843974316009,7540.877985370558,0.9256009695233147 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441061,6193.392977989959,7540.877985370558,0.8213092679665757 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441060,5576.073276760316,7540.877985370558,0.739446160987885 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441071,5963.090222737775,7540.877985370558,0.7907686922273878 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441059,8394.601211928724,7540.877985370558,1.1132127092116335 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441073,6637.910054820918,7540.877985370558,0.8802569233580739 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441054,6209.140029445376,5107.556668860965,1.2156771685570107 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441061,6191.257453229817,5107.556668860965,1.2121759687906757 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441060,5767.37682885374,5107.556668860965,1.1291850884426744 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441071,5686.623318431528,5107.556668860965,1.113374493346483 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441059,4281.986384918474,5107.556668860965,0.8383629712861118 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441073,4448.404078383047,5107.556668860965,0.87094561387903 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441054,174272.6567779625,180330.65339424144,0.9664061738686497 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441061,131753.22379906016,180330.65339424144,0.730620231886031 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441060,88498.9165775155,180330.65339424144,0.49075914112082714 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441071,125828.28021888951,180330.65339424144,0.6977642339253435 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441059,96551.86605326532,180330.65339424144,0.5354157168286983 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441073,221601.13124663496,180330.65339424144,1.2288600250461434 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441054,551.841501451112,98.01831453553807,5.629983580783092 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441061,783.5878627132315,98.01831453553807,7.99430051849269 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441060,230.25848643992535,98.01831453553807,2.3491373783665863 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441071,246.74677546258783,98.01831453553807,2.5173537887465507 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441059,274.82265066901914,98.01831453553807,2.8037887814259235 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441073,254.64482769110433,98.01831453553807,2.5979310998943865 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441054,2224.351914897743,1812.4793707702274,1.2272426107407153 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441061,2875.3235032729385,1812.4793707702274,1.586403436995284 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441060,2773.5268176234813,1812.4793707702274,1.5302391091187146 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441071,2304.3420730899957,1812.4793707702274,1.2713756141184367 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441059,3341.942098432769,1812.4793707702274,1.8438511093301901 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441073,4283.748212494788,1812.4793707702274,2.3634741898741587 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441054,545.2261856199764,434.5650550234931,1.2546480194789267 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441061,548.688075857219,434.5650550234931,1.2626143531664236 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441060,245.3834840724326,434.5650550234931,0.564664556516554 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441071,287.8241800265561,434.5650550234931,0.6623270249168931 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441059,608.1674433863241,434.5650550234931,1.3994853851132734 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441073,834.5679464342962,434.5650550234931,1.9204672276034218 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441054,451944.0306792525,9833.502392298877,45.95961974171006 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441061,48654.74673267409,9833.502392298877,4.947855280004623 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441060,139525.74504815982,9833.502392298877,14.188814878148566 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441071,175725.538055117,9833.502392298877,17.870086470181445 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441059,443318.46,9833.502392298877,45.08245814300972 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441073,461760.36147615034,9833.502392298877,46.95787350779298 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441054,85.57386012060017,42.4088060383901,2.017832335179052 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441061,54.247177015513,42.4088060383901,1.279148886351725 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441060,43.75376604746442,42.4088060383901,1.0317141682285704 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441071,44.04632630915789,42.4088060383901,1.03861274163874 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441059,46.902829067691776,42.4088060383901,1.1059691005031718 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441073,35.18775274966473,42.4088060383901,0.8297275032409875 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441054,789.1769094447176,385.8715169071063,2.045180519594303 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441061,465.6073105521253,385.8715169071063,1.2066381947134346 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441060,554.9783456340141,385.8715169071063,1.4382464662910535 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441071,555.3706256250604,385.8715169071063,1.4392630740836951 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441059,788.1854243606117,385.8715169071063,2.0426110501189374 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441073,886.4844973791511,385.8715169071063,2.2973566550976114 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441054,1694.4973332256857,1002.6445024002205,1.6900280499910443 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441061,1038.0955294224725,1002.6445024002205,1.03535752396526 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441060,867.1458333696194,1002.6445024002205,0.8648587124287499 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441071,884.71379116090975,1002.6445024002205,0.8823803342490807 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441059,1333.836019017823,1002.6445024002205,1.3303179899004747 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441073,890.2788544772244,1002.6445024002205,0.8879307195581234 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441054,27130.626690346035,6245.085755978491,4.344316115174813 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441061,14129.493925040912,6245.085755978491,2.2624979827562157 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441060,28224.55007314785,6245.085755978491,4.519481585361445 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441071,19885.577315583716,6245.085755978491,3.1841960371075815 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441059,23650.26818137323,6245.085755978491,3.787020563926214 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441073,24706.164799612536,6245.085755978491,3.95609696407468 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441054,240.59360357595375,289.8012081128336,0.8302022104831221 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441061,350.59675265833147,289.8012081128336,1.2097836131926243 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441060,285.112216979692,289.8012081128336,0.9838199738238637 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441071,294.25345756045783,289.8012081128336,1.0153631155529579 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441059,347.3474584869021,289.8012081128336,1.1985714647250987 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441073,310.32092404409735,289.8012081128336,1.0708061780172926 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441054,41690.68590083422,19122.271903916942,2.1802161432656146 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441061,10548.865033177386,19122.271903916942,0.5516533331490068 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441060,31933.99721366352,19122.271903916942,1.6699897048907806 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441071,29181.553405836337,19122.271903916942,1.5260505421355757 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441059,35145.56404633642,19122.271903916942,1.8379387252169193 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441073,48693.867021180966,19122.271903916942,2.546447789564517 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441054,62.62729362472669,111.01681566749893,0.5641243918605867 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441061,119.2801718798008,111.01681566749893,1.074433374463298 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441060,95.0143352491545,111.01681566749893,0.8558553465785518 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441071,92.00481236822075,111.01681566749893,0.8287466345979504 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441059,115.52727317088883,111.01681566749893,1.0406285973550076 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441073,223.8880202288304,111.01681566749893,2.0167036757691426 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441054,1703.601702620156,1048.3386659324408,1.6250490017983779 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441061,1475.9948915440464,1048.3386659324408,1.4079370908552995 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441060,1716.9410478800737,1048.3386659324408,1.637773272774354 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441071,1564.168162427669,1048.3386659324408,1.4920447115593372 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441059,1918.2944377650156,1048.3386659324408,1.8298423020186858 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441073,2274.623198917579,1048.3386659324408,2.169740822155428 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441054,12891.3947627198,5453.602601951663,2.3638309762626264 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441061,11210.290854585925,5453.602601951663,2.0555753091679496 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441060,7338.336058986854,5453.602601951663,1.345594205261804 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441059,6267.459125963299,5453.602601951663,1.1492328252374648 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441073,12704.4452372802,5453.602601951663,2.329550971083537 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441054,162283.9825163263,64173.361133824874,2.528837194266714 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441061,117309.41,64173.361133824874,1.8280078825132298 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441060,138519.44743956497,64173.361133824874,2.158519438473877 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441071,185705.7238228873,64173.361133824874,2.89381326677939 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441059,278285.57218574744,64173.361133824874,4.336465587417503 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441073,180156.6953263418,64173.361133824874,2.807343921890726 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441054,26.49358636854137,44.60879663763593,0.5939094610364143 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441061,118.1639701058991,44.60879663763593,2.648893918070982 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441060,55.86222693426837,44.60879663763593,1.252269308855062 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441059,39.40394012869036,44.60879663763593,0.8833221942473495 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441073,76.41123797703067,44.60879663763593,1.7129186110472967 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441054,137.2917540384443,136.29080299882398,1.0073442302605626 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441061,146.60730338739927,136.29080299882398,1.0756947656157276 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441060,141.90913185006914,136.29080299882398,1.0412230959655704 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441071,133.69638397070082,136.29080299882398,0.9809640931666861 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441059,133.86875287501485,136.29080299882398,0.9822288072964833 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441073,153.39082080814708,136.29080299882398,1.1254671440263704 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441054,87.05485644071626,82.77341642135346,1.0517248194464799 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441061,69.56241799597574,82.77341642135346,0.8403956367086762 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441060,70.03048369881942,82.77341642135346,0.8460504196460027 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441071,62.613575996605725,82.77341642135346,0.7564454713077784 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441059,19.453403391067845,82.77341642135346,0.23501994036396154 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441073,295.9437626860687,82.77341642135346,3.575347925469011 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441054,3688.3677886677106,2141.365658987758,1.7224371620918 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441061,1130.494611009285,2141.365658987758,0.5279316058256392 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441060,4401.153888877288,2141.365658987758,2.0553023582893135 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441071,3931.412709487392,2141.365658987758,1.8359371240434503 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441059,3344.847373313223,2141.365658987758,1.5620159776422124 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441073,4380.977294642483,2141.365658987758,2.045880056147631 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441054,408.48249646689584,285.0677067828484,1.4329314992457536 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441061,489.8262003669446,285.0677067828484,1.7182802145318827 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441060,535.0790046676269,285.0677067828484,1.8770242715539356 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441071,403.0364314273256,285.0677067828484,1.4138270377091167 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441059,695.7414803312104,285.0677067828484,2.4406183646090596 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441073,457.70705890337007,285.0677067828484,1.6056082397717202 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441054,748733.0312040838,724296.655045942,1.0337380767782116 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441061,1022470.8771105732,724296.655045942,1.4116741669139947 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441060,660708.1779239221,724296.655045942,0.912206584582409 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441071,603607.7343880711,724296.655045942,0.8333708711519375 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441059,947760.135776345,724296.655045942,1.3085248001265846 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441073,1094593.0025011844,724296.655045942,1.5112495617306896 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441054,37.25504351220197,126.94877083842833,0.293465177064358 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441061,154.67442103216663,126.94877083842833,1.218400304395429 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441060,116.04222845882424,126.94877083842833,0.9140870580504856 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441071,42.50988605724158,126.94877083842833,0.33485858725914913 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441059,89.2936049793842,126.94877083842833,0.7033829818882686 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441073,236.9342762099924,126.94877083842833,1.8663770798659094 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441054,53940.64610043887,94593.87687362579,0.5702340139045337 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441061,132675.9672068656,94593.87687362579,1.402585152357337 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441060,124138.96759520155,94593.87687362579,1.3123361859990896 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441071,114910.16616863072,94593.87687362579,1.2147738306798315 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441059,74918.95508356702,94593.87687362579,0.7920063915305661 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441073,118280.60038748028,94593.87687362579,1.2504044056202406 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441054,62.357155614381135,34.2642969985689,1.819887202617511 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441061,145.53160496584354,34.2642969985689,4.2473249917230715 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441060,296.7707739446466,34.2642969985689,8.661224654836538 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441071,10.299460313766742,34.2642969985689,0.3005886948212279 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441059,3.7148735146919254,34.2642969985689,0.10841820320571825 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441073,9.720546269115031,34.2642969985689,0.2836931476960121 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441054,72.38951823506954,74.66086218948179,0.9695778499229248 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441061,53.61990224240298,74.66086218948179,0.7181795209693806 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441060,181.91277877413447,74.66086218948179,2.4365212701730936 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441071,10.628528530952623,74.66086218948179,0.14235743091177386 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441059,59.9284379027074,74.66086218948179,0.8026754064346997 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441073,10.408910533472437,74.66086218948179,0.13941588977442645 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441054,307.77725922296935,347.6986105145094,0.8851840355862619 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441061,272.8014842675177,347.6986105145094,0.784591816066903 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441060,278.8576103917255,347.6986105145094,0.8020095621868721 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441071,280.6857634282815,347.6986105145094,0.8072674291477174 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441059,74.77612748594885,347.6986105145094,0.2150601849552932 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441073,475.4061634116164,347.6986105145094,1.3672938258456966 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441054,3754.9353290056674,2521.321340016667,1.4892728147776855 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441061,3324.869216867177,2521.321340016667,1.3187010969594213 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441060,4062.752482204317,2521.321340016667,1.6113584642001486 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441071,3460.8286374518125,2521.321340016667,1.3726249734708291 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441059,4117.455916339443,2521.321340016667,1.6330547998741902 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441073,3740.661721924165,2521.321340016667,1.4836116533640402 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441054,148.94013502370947,79.44971561377609,1.8746465468516311 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441061,154.9355322008546,79.44971561377609,1.9501080778442677 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441060,118.62668677391018,79.44971561377609,1.4931039822795922 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441071,91.2969228524934,79.44971561377609,1.1491157916324004 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441059,98.74799452564176,79.44971561377609,1.2428992824301497 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441073,109.20333577750192,79.44971561377609,1.3744962450006144 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441054,125.14245712126036,42.37178439720435,2.9534384473436797 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441061,75.56607528745191,42.37178439720435,1.7834055459896487 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441060,14.05411898698024,42.37178439720435,0.3316857948495442 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441071,228.88220642729797,42.37178439720435,5.401759913665552 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441059,137.3328359245503,42.37178439720435,3.241138835153975 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441073,153.58695996038605,42.37178439720435,3.624746093311085 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441054,1713.0188613911075,1321.2949146990686,1.2964697300611772 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441061,1393.6855106363275,1321.2949146990686,1.0547876141290882 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441060,1064.7941671871292,1321.2949146990686,0.805871690976455 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441071,922.9974852692848,1321.2949146990686,0.6985552392589826 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441059,1255.45949928708,1321.2949146990686,0.9501735648267571 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441073,1440.195722695579,1321.2949146990686,1.0899880917377107 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441054,69234.4907252239,23354.026662177774,2.96456331607047 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441061,30496.007043924583,23354.026662177774,1.3058136605330404 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441060,65072.9162089601,23354.026662177774,2.786368156132439 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441071,45481.058359818824,23354.026662177774,1.9474610960120269 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441059,45378.6771357532,23354.026662177774,1.943077217139805 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441073,37170.67969426239,23354.026662177774,1.591617592629579 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441054,10741.041497489918,13473.54115415771,0.7971951378331903 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441061,7690.259611063288,13473.54115415771,0.5707675156126422 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441060,12259.42239356192,13473.54115415771,0.9098886664831143 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441059,14087.037596675911,13473.54115415771,1.0455334225426614 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441073,77.02876486090567,13473.54115415771,0.00571703934248465 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441054,128240.8267960132,49612.48263442616,2.5848500213336782 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441061,116782.8195665875,49612.48263442616,2.3538999333516877 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441060,129784.96398764016,49612.48263442616,2.6159739867075755 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441071,125733.43499302217,49612.48263442616,2.5343104863245762 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441059,141368.29070246647,49612.48263442616,2.8494500415177946 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441073,138934.02072623913,49612.48263442616,2.800384365966654 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441068,41.29620933652499,73.06854961986588,0.565170782113039 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441062,93.94641296176776,73.06854961986588,1.2857298174182674 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441056,123.29900005177834,73.06854961986588,1.6874428285936005 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441070,54.15405733179127,73.06854961986588,0.7411404443296609 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441057,68.40720811394866,73.06854961986588,0.9362059117066436 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441067,191.50994716344587,73.06854961986588,2.6209627556556585 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441068,42.496978263941,990.9231863649335,0.042886248751364237 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441062,812.849944717556,990.9231863649335,0.8202956151418609 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441056,13.358263175769627,990.9231863649335,0.013480624290135539 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441070,23.90806523139534,990.9231863649335,0.02412706207743389 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441057,47.520704995474915,990.9231863649335,0.04795599260301713 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441067,124.75694342985696,990.9231863649335,0.1258997116492054 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441068,53.89399128082576,50.719124328797626,1.0625970379820908 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441062,55.73726256538894,50.719124328797626,1.0989397648914472 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441056,54.888936791071536,50.719124328797626,1.0822138102235797 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441070,64.38738353757003,50.719124328797626,1.2694892585322446 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441057,42.34840575116296,50.719124328797626,0.8349593237578455 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441067,47.69537609742299,50.719124328797626,0.9403824835032139 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441068,362.0171577294484,319.2477137201226,1.1339694606139634 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441062,382.06974482461027,319.2477137201226,1.1967814596773036 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441056,301.20260678765504,319.2477137201226,0.9434761592426397 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441070,336.1066221739476,319.2477137201226,1.0528082355152113 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441057,339.79917690307497,319.2477137201226,1.0643746604900337 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441067,324.75904062017406,319.2477137201226,1.0172634811877874 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441068,37.701360219555866,44.58166891160943,0.8456695574655377 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441062,11.233919012573343,44.58166891160943,0.2519851608706362 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441056,15.033621524656656,44.58166891160943,0.33721531498659935 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441070,55.625475837073765,44.58166891160943,1.2477208053238322 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441057,14.100161016326563,44.58166891160943,0.3162771013414163 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441067,94.57905779290289,44.58166891160943,2.1214786279181608 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441068,2098.276273760428,1543.2839395802719,1.3596177734675952 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441062,2061.739142553583,1543.2839395802719,1.335942848672627 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441056,2680.7515309371456,1543.2839395802719,1.7370436263765123 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441070,2580.629642812856,1543.2839395802719,1.672167756449738 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441057,1775.2803602148358,1543.2839395802719,1.150326465975963 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441067,1951.7750037715005,1543.2839395802719,1.2646895063926644 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441068,31.604565014776377,31.276034215973343,1.0105042345373585 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441062,32.40281003489275,31.276034215973343,1.036026812451303 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441056,30.622189489391182,31.276034215973343,0.9790943851107495 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441070,60.40758891173284,31.276034215973343,1.931433777524178 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441057,31.544306072323057,31.276034215973343,1.0085775534870307 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441067,29.80766653924276,31.276034215973343,0.9530513470284971 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441068,277.85941061380083,130.468422036268,2.1297062252853847 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441062,557.2921850530062,130.468422036268,4.271471796432768 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441056,43.458805892662056,130.468422036268,0.3330982717073197 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441070,36.03187111172015,130.468422036268,0.27617311951319456 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441057,342.28562232217473,130.468422036268,2.6235131611159144 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441067,54.197948882477235,130.468422036268,0.4154104727917313 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441068,99.11838499683564,95.42663227533711,1.0386868176469501 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441062,114.84932283406836,95.42663227533711,1.2035353244227505 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441056,108.79449077772684,95.42663227533711,1.1400851961726897 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441070,123.91527228499017,95.42663227533711,1.2985397192625847 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441057,106.57330713675672,95.42663227533711,1.116808846709143 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441067,254.24669420188755,95.42663227533711,2.664315905734811 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441068,584.72,569.3868516791151,1.026929227950501 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441062,604.6120426737998,569.3868516791151,1.0618651289379197 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441056,553.3304080347441,569.3868516791151,0.9718004664192355 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441070,556.8005831499609,569.3868516791151,0.977895048872243 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441057,638.8211993437415,569.3868516791151,1.121945822001097 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441067,644.28597302211,569.3868516791151,1.1315434684206673 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441068,3181.5743020479213,5328.634617598269,0.5970712068604782 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441062,3369.8764558731045,5328.634617598269,0.6324089936179526 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441056,1573.4544609359357,5328.634617598269,0.295282858340384 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441070,12926.246507703749,5328.634617598269,2.4258083796951886 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441057,5795.4297879746255,5328.634617598269,1.0876012719721344 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441067,7386.946220596332,5328.634617598269,1.3862737362776412 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441068,753686.5039463162,656386.6079991342,1.1482356506994889 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441062,909904.835997169,656386.6079991342,1.3862330902375284 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441056,794526.5389330232,656386.6079991342,1.2104551330731463 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441070,763047.5153667832,656386.6079991342,1.162497080330118 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441057,730251.1708188272,656386.6079991342,1.1125320991006422 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441067,872616.8202519653,656386.6079991342,1.3294250821356128 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441068,3119.003061484483,5223.837669019135,0.5970712068604783 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441062,3303.6019230879424,5223.837669019135,0.6324089936179526 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441056,1542.509718414139,5223.837669019135,0.295282858340384 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441070,12672.029191673995,5223.837669019135,2.4258083796951877 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441057,5681.4524934011615,5223.837669019135,1.0876012719721344 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441067,7241.668963139041,5223.837669019135,1.3862737362776412 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441068,753686.5039463162,656386.6079991342,1.1482356506994889 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441062,909904.835997169,656386.6079991342,1.3862330902375284 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441056,794526.5389330232,656386.6079991342,1.2104551330731463 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441070,763047.5153667832,656386.6079991342,1.162497080330118 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441057,730251.1708188272,656386.6079991342,1.1125320991006422 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441067,872616.8202519653,656386.6079991342,1.3294250821356128 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441068,46.33206318292077,50.79723336807032,0.9120981618665037 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441062,48.43796369569325,50.79723336807032,0.9535551541698717 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441056,47.59800977870497,50.79723336807032,0.9370197277047712 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441070,43.158525524728894,50.79723336807032,0.8496235456763498 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441057,67.31662627360056,50.79723336807032,1.3252026106585926 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441067,32.21775780454845,50.79723336807032,0.6342423724359681 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441068,47.3068599325812,124.85055234194422,0.37890789464043245 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441062,145.2117140786754,124.85055234194422,1.1630842743968441 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441056,46.451801334149955,124.85055234194422,0.3720592377270903 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441070,57.657383913607674,124.85055234194422,0.46181120413223326 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441057,101.86210172994303,124.85055234194422,0.8158722554223087 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441067,97.15287362050732,124.85055234194422,0.7781533345116671 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441068,138.96641913502756,149.81706398084205,0.927574038914539 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441062,142.10935069314905,149.81706398084205,0.9485525007439832 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441056,146.47042662374045,149.81706398084205,0.9776618412604218 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441070,187.46595786969925,149.81706398084205,1.2512991036433045 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441057,155.13651909377018,149.81706398084205,1.035506336672092 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441067,160.52336970945274,149.81706398084205,1.0714625253234156 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441068,3871.4532565294335,2791.14294318225,1.3870494400818811 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441062,3656.731381786328,2791.14294318225,1.3101197094610997 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441056,3181.7843196315803,2791.14294318225,1.1399574956931267 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441070,3050.881679451214,2791.14294318225,1.0930581992955293 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441057,3155.7183350052064,2791.14294318225,1.130618674587585 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441067,2875.595864591644,2791.14294318225,1.0302574691187645 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441068,167.651601226673,222.01180748199775,0.75514722900613 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441062,137.3064977950374,222.01180748199775,0.6184648436150008 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441056,94.83151337394084,222.01180748199775,0.42714626059530836 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441070,169.99984769635023,222.01180748199775,0.7657243532424959 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441057,256.5109646121607,222.01180748199775,1.155393343811051 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441067,212.5407442303017,222.01180748199775,0.9573398218810321 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441068,4674.701450437021,4330.453784028004,1.0794945942336815 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441062,4272.150523897668,4330.453784028004,0.986536454829428 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441056,4879.296277939475,4330.453784028004,1.1267401804253783 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441070,5138.819707317442,4330.453784028004,1.1866700266542347 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441057,3621.0675295904016,4330.453784028004,0.8361866238928519 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441067,3668.48594793015,4330.453784028004,0.8471366122092361 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441068,42.042458747700586,100.4664893584531,0.4184724579924141 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441062,66.06123420967052,100.4664893584531,0.6575449648088277 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441056,96.78195572468869,100.4664893584531,0.9633257451584835 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441070,21.48261368201555,100.4664893584531,0.21382864892758427 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441057,77.25626579482085,100.4664893584531,0.7689754692152048 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441067,180.91682109431528,100.4664893584531,1.80076782068919 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441068,309.8269929236668,219.8603821991507,1.4091988280227035 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441062,284.1669788298597,219.8603821991507,1.2924883327659267 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441056,583.6820612221015,219.8603821991507,2.6547850748908424 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441070,202.73050566321072,219.8603821991507,0.922087479496767 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441057,318.7566398971975,219.8603821991507,1.4498139078484182 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441067,600.4504851075591,219.8603821991507,2.7310535854689264 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441068,107.9874525254049,115.26780159034894,0.9368396988187758 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441062,183.00082364605183,115.26780159034894,1.5876144172196478 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441056,114.83344347765176,115.26780159034894,0.9962317480970024 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441070,128.52938016603864,115.26780159034894,1.11505015618169 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441057,142.81438961689796,115.26780159034894,1.238979035311587 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441067,189.1106393408747,115.26780159034894,1.6406198151757623 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441068,2012.043448475909,1760.6737631139824,1.142769030031632 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441062,2274.2349809937004,1760.6737631139824,1.2916844838827028 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441056,1450.9158374000572,1760.6737631139824,0.8240685286488976 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441070,1561.054353094333,1760.6737631139824,0.886623283539708 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441057,1437.3850035558728,1760.6737631139824,0.8163834968572877 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441067,2863.788707852585,1760.6737631139824,1.6265300067785409 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441068,271.6264593246401,518.6000624505415,0.5237686591110755 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441062,238.7271873230886,518.6000624505415,0.460330039674563 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441056,162.86376664703485,518.6000624505415,0.3140450193496979 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441070,229.18575438029316,518.6000624505415,0.44193159811304583 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441057,337.3688461348957,518.6000624505415,0.6505376118558998 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441067,237.06399532766773,518.6000624505415,0.4571229594679741 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441068,1345.8906689912103,841.89306662726494,1.5986480021542717 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441062,938.0267000364768,841.89306662726494,1.1141874630163375 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441056,686.3891190820779,841.89306662726494,0.8152925190747128 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441070,1630.7810954977117,841.89306662726494,1.9370406529546995 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441057,4.659186656242279,841.89306662726494,0.005534178675336522 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441067,812.2236034421866,841.89306662726494,0.9647586322287482 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441068,208.090265641282,246.94010350613598,0.842675056366903 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441062,189.26019923668773,246.94010350613598,0.7664214785266136 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441056,168.16595503739626,246.94010350613598,0.6809989655374776 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441070,209.01462279378595,246.94010350613598,0.8464183007382288 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441057,263.67480541164286,246.94010350613598,1.067768263104705 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441067,176.5040318658805,246.94010350613598,0.7147645496208141 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441068,13306.801080526611,6405.278640912654,2.0774741937894206 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441062,12154.525063214383,6405.278640912654,1.8975794410534106 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441056,3506.149204143537,6405.278640912654,0.5473843373102603 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441070,9420.601905611948,6405.278640912654,1.47075598638901 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441057,3406.803966175151,6405.278640912654,0.5318744362524304 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441067,4914.304358489098,6405.278640912654,0.767227256453731 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441068,185.9865257291358,184.84349394551683,1.0061837815290156 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441062,291.4740121180045,184.84349394551683,1.5768691983495906 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441056,266.65933299781676,184.84349394551683,1.4426222276257956 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441070,297.8484171464173,184.84349394551683,1.6113546156739984 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441057,281.70242181219373,184.84349394551683,1.5240050693654728 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441067,222.562867938157,184.84349394551683,1.2040611394402558 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441068,53906.16682316285,66689.05961878091,0.8083209919484581 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441062,56710.70395836981,66689.05961878091,0.8503749233014976 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441056,57152.34032032067,66689.05961878091,0.8569972443309949 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441070,40143.04765994175,66689.05961878091,0.6019435255109925 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441057,67377.76172821246,66689.05961878091,1.0103270628401182 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441067,105181.10094265024,66689.05961878091,1.5771867461305338 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441068,335.25262340370557,426.591426110135,0.785886923374667 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441062,528.4744849888525,426.591426110135,1.2388305358308207 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441056,740.3349923813702,426.591426110135,1.7354661792715793 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441070,1166.0723618905354,426.591426110135,2.733464131061756 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441057,1326.206411546704,426.591426110135,3.1088445064161028 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441067,804.3135357381125,426.591426110135,1.8854423378177771 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441068,11440.217329439674,6086.038398766024,1.8797478063495685 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441062,17226.07991780041,6086.038398766024,2.8304257694616397 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441056,6814.614924354587,6086.038398766024,1.1197127717328048 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441070,8769.393823486485,6086.038398766024,1.4409034660814044 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441057,4469.0518385756895,6086.038398766024,0.7343121330752387 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441067,6511.703596678604,6086.038398766024,1.0699412606399075 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441068,50.247340887763656,118.38689307733607,0.424433309985926 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441062,45.4297184226293,118.38689307733607,0.38373942622983104 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441056,32.98251215498501,118.38689307733607,0.27859935587159324 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441070,40.58214189048154,118.38689307733607,0.34279252403364713 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441057,46.18939319593599,118.38689307733607,0.3901563086528746 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441067,46.30988333017033,118.38689307733607,0.3911740744806814 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441068,61.82176766196505,43.003791743375764,1.4375887603326973 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441062,22.204849401705527,43.003791743375764,0.5163463150926901 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441056,47.943480524061215,43.003791743375764,1.1148663543476105 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441070,77.35900242671717,43.003791743375764,1.7988879419832422 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441057,64.7371443254419,43.003791743375764,1.5053822395885337 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441067,64.40499325850847,43.003791743375764,1.4976584772534463 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441068,66.42754430670094,56.77751951238643,1.1699620708546328 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441062,59.96761282100638,56.77751951238643,1.0561858520065148 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441056,46.876647420435766,56.77751951238643,0.8256198548830455 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441070,78.54611287679758,56.77751951238643,1.3834016271116278 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441057,70.54034301202493,56.77751951238643,1.242399168153798 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441067,37.73562405289892,56.77751951238643,0.6646226248870668 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441068,130.6271660300879,232.93832449773902,0.5607800533113039 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441062,161.96438352589945,232.93832449773902,0.6953101593528098 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441056,173.60308276204455,232.93832449773902,0.7452748839692526 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441070,215.863482368118,232.93832449773902,0.9266980125900806 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441057,588.3098963329343,232.93832449773902,2.5256037090566634 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441067,248.82856944338715,232.93832449773902,1.0682165331956888 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441068,51.79639215332847,55.88566907011774,0.9268278078292558 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441062,44.39590452978252,55.88566907011774,0.7944058873855581 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441056,51.93075529777044,55.88566907011774,0.9292320582690847 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441070,55.53543160260904,55.88566907011774,0.9937329645804316 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441057,91.26202098444736,55.88566907011774,1.6330129441582633 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441067,43.80648790580472,55.88566907011774,0.7838590578712101 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441068,72.94819263356516,226.42114305345407,0.3221792437305352 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441062,286.57616736682456,226.42114305345407,1.265677593099903 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441056,167.81505197893796,226.42114305345407,0.7411633459483056 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441070,207.37804199361724,226.42114305345407,0.9158952171911742 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441057,220.257165737518,226.42114305345407,0.9727764941347333 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441067,309.1895300310937,226.42114305345407,1.36555061007752 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441068,195.33649667213575,212.71806341276286,0.9182882428423602 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441062,118.19605695322396,212.71806341276286,0.5556465448064639 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441056,93.24417550683708,212.71806341276286,0.4383462974928651 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441070,212.68491199212104,212.71806341276286,0.9998441532415727 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441057,390.77576778250136,212.71806341276286,1.8370596343021015 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441067,239.2182631022915,212.71806341276286,1.1245789815137 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441068,20035.2576805468,10996.969545575432,1.8218889847346966 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441062,18134.729374383875,10996.969545575432,1.6490660721780648 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441056,8744.069086239904,10996.969545575432,0.7951344277167732 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441070,14024.69218849263,10996.969545575432,1.2753233634383743 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441057,7726.062768076334,10996.969545575432,0.7025628957192912 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441067,8257.784216268312,10996.969545575432,0.7509145298661652 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441068,129.18094078233722,147.8550055811589,0.8737001515408869 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441062,155.64545110963584,147.8550055811589,1.0526897652051468 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441056,120.97691445818262,147.8550055811589,0.8182131811004352 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441070,143.1844685943204,147.8550055811589,0.9684113705283058 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441057,202.00776887226144,147.8550055811589,1.3662558672143001 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441067,147.04974420887666,147.8550055811589,0.994553709094142 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441068,249.38171120237328,92.19915296117537,2.7048156430177484 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441062,268.97356382952313,92.19915296117537,2.9173105738052345 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441056,294.465525501725,92.19915296117537,3.1937985984071138 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441070,279.9031452645941,92.19915296117537,3.0358537608524454 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441057,140.02387119865352,92.19915296117537,1.5187110369399697 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441067,280.8714396209959,92.19915296117537,3.0463559653229084 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441068,801.2024089133041,1229.7970051816276,0.6514915921387979 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441062,728.0625233603607,1229.7970051816276,0.5920184553163991 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441056,486.7530925800867,1229.7970051816276,0.3957995429564398 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441070,1392.0449631925628,1229.7970051816276,1.1319306823218138 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441057,1119.1138378628352,1229.7970051816276,0.9099988316344569 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441067,901.1070843683884,1229.7970051816276,0.7327283125358601 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441068,94501.39500382656,50083.06853493704,1.8868930712163554 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441062,55621.73984900441,50083.06853493704,1.1105896958011607 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441056,61967.036431613495,50083.06853493704,1.237285139355757 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441070,85968.84271902565,50083.06853493704,1.7165250699256844 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441057,74897.82148817508,50083.06853493704,1.4954718965737435 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441067,35214.36435949568,50083.06853493704,0.7031191456436177 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441068,32.90934867182286,35.678906774941794,0.9223754774609837 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441062,37.70206238853018,35.678906774941794,1.05670452927132 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441056,8.622949418913716,35.678906774941794,0.24168199640494123 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441070,52.47857849887819,35.678906774941794,1.4708572443070267 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441057,71.33307072480581,35.678906774941794,1.9993065139233706 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441067,49.93879862542743,35.678906774941794,1.3996728918975938 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441068,63.92160580802903,67.70693010562654,0.9440925132524515 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441062,363.11816658206686,67.70693010562654,5.363087146553278 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441056,64.2133868415135,67.70693010562654,0.9484019839820986 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441070,44.61161729671498,67.70693010562654,0.6588929261320577 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441057,9.81728894276655,67.70693010562654,0.14499681092394884 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441067,67.59799859724053,67.70693010562654,0.9983911320714723 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441068,68.24430820484852,64.01321127549492,1.066097245319316 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441062,55.47076409307763,64.01321127549492,0.8665518099747722 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441056,63.98942921496099,64.01321127549492,0.9996284819951997 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441070,29.147976985119676,64.01321127549492,0.45534314564652834 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441057,105.35414142837786,64.01321127549492,1.645818719747759 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441067,84.13217476911946,64.01321127549492,1.3142939260934459 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441068,618.4956522562131,1060.427767412219,0.5832510909871204 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441062,1303.1227376465806,1060.427767412219,1.2288651596012188 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441056,935.8185856248356,1060.427767412219,0.8824915891334405 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441070,625.2015710030626,1060.427767412219,0.5895748774371998 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441057,1003.9476446858808,1060.427767412219,0.9467383593093118 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441067,1110.133416971173,1060.427767412219,1.046873206347898 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441068,129.03711560112262,57.09593719876665,2.2600052110872437 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441062,85.07244395863584,57.09593719876665,1.4899911995922808 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441056,18.40921436077885,57.09593719876665,0.3224259949826433 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441070,0.6755739642727631,57.09593719876665,0.011832259831744322 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441057,4.785785249491964,57.09593719876665,0.08382006644065286 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441067,121.81746235073294,57.09593719876665,2.133557453075039 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441068,53.83219971297284,50.205845180981015,1.0722297278119632 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441062,56.9105479469184,50.205845180981015,1.1335442664448414 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441056,106.46741675170745,50.205845180981015,2.12061795529815 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441070,214.1479043212624,50.205845180981015,4.265397854558694 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441057,19.846551519253843,50.205845180981015,0.39530360354877797 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441067,89.1342664990567,50.205845180981015,1.7753762769603278 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441068,649.4439789682787,1506.8779059558976,0.43098646307133937 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441062,470.5792663817569,1506.8779059558976,0.31228758781438365 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441056,371.8735626300757,1506.8779059558976,0.2467841363658294 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441070,664.6778656460604,1506.8779059558976,0.4410960324117419 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441057,998.15227559399,1506.8779059558976,0.6623975782303383 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441067,895.8593995047905,1506.8779059558976,0.5945135939440935 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441068,17850.853499658933,16162.128318216166,1.104486559455132 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441062,21944.1889885516,16162.128318216166,1.3577536668743393 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441056,22402.56526320828,16162.128318216166,1.3861148001132115 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441070,30973.21052212624,16162.128318216166,1.91640667072397 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441057,24658.799180822483,16162.128318216166,1.5257148498833417 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441067,13901.363724838377,16162.128318216166,0.8601196235504637 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441068,20.815844817286333,24.995311385825953,0.8327899779272339 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441062,18.004618313458245,24.995311385825953,0.7203198246079099 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441056,17.075050437364474,24.995311385825953,0.6831301348398962 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441070,35.78339176044301,24.995311385825953,1.4316041599999685 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441057,79.10109162941764,24.995311385825953,3.164637175685411 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441067,51.560616162328344,24.995311385825953,2.062811515585548 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441068,1037.3537945839837,522.7489803443298,1.9844205031269284 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441062,1272.6423493025677,522.7489803443298,2.434519046721603 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441056,1390.3336408897171,522.7489803443298,2.659658255046079 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441070,439.0635141968096,522.7489803443298,0.8399127128045332 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441057,2470.8504415815014,522.7489803443298,4.726648036604444 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441067,2870.8616792747066,522.7489803443298,5.491855148877952 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441068,2.921202286273869,2.8430683750443606,1.0274822483748 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441062,2.8874351673437575,2.8430683750443606,1.01560524983811 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441056,2.6838635448986854,2.8430683750443606,0.9440024617265171 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441070,2.4368013941096596,2.8430683750443606,0.8571026344280721 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441057,2.4302183778439184,2.8430683750443606,0.8547871726109997 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441067,2.991022489611826,2.8430683750443606,1.05204029416463 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441068,1847.515407984052,1771.7543971110147,1.0427604474957544 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441062,2496.6380967971822,1771.7543971110147,1.4091332866836102 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441056,3695.362861219188,1771.7543971110147,2.0857083054201917 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441070,1613.6858439548778,1771.7543971110147,0.9107841620633875 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441057,4172.04659251259,1771.7543971110147,2.3547544734842716 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441067,5475.312331307362,1771.7543971110147,3.0903337055267315 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441068,4.0579919632111565,73.62821549612136,0.05511463147473575 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441062,30.25655190470494,73.62821549612136,0.41093691733298654 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441056,38.625027857073,73.62821549612136,0.5245954638016145 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441070,1.7683663438410682,73.62821549612136,0.02401750921063982 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441057,21.391205351527734,73.62821549612136,0.29052999868854074 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441067,142.5279819540325,73.62821549612136,1.9357793882909018 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441068,831.244108017002,1923.334023596175,0.4321891558195254 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441062,804.9646297519326,1923.334023596175,0.4185256538262871 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441056,1235.439294026121,1923.334023596175,0.6423425566590585 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441070,768.2958156471482,1923.334023596175,0.3994604193662724 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441057,1368.7357229616566,1923.334023596175,0.7116474341791386 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441067,2125.9406749287973,1923.334023596175,1.105341375365365 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441068,44.295123943799815,51.40813337414527,0.8616364967275235 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441062,51.32180440697853,51.40813337414527,0.9983207138345513 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441056,57.898753127078486,51.40813337414527,1.126256670431795 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441070,14.515711976353392,51.40813337414527,0.28236216768869865 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441057,73.55914597570195,51.40813337414527,1.4308853706152478 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441067,60.9178227805069,51.40813337414527,1.184984141267116 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441068,98.3031308943862,89.1451395839603,1.102731246517378 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441062,150.34513975183043,89.1451395839603,1.6865208855299354 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441056,68.34588838273501,89.1451395839603,0.7666810406232438 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441070,131.1554224812184,89.1451395839603,1.471257132955535 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441057,6.338464974019246,89.1451395839603,0.07110275449228992 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441067,86.34355953470403,89.1451395839603,0.9685728233493017 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441068,6064.408504928361,4771.656231796832,1.2709231785217532 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441062,7592.891110254067,4771.656231796832,1.5912485605432771 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441056,3591.159811174998,4771.656231796832,0.7526023746733109 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441070,11552.161670352498,4771.656231796832,2.420996213719775 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441057,9551.205062824316,4771.656231796832,2.0016540586427953 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441067,6615.634078929213,4771.656231796832,1.3864439845529286 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441068,515657.8542661146,209884.98459768714,2.4568591948325444 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441062,477375.05104897165,209884.98459768714,2.274460233370273 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441056,290543.3586778196,209884.98459768714,1.3842979726955718 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441070,460661.32679948176,209884.98459768714,2.1948274560111534 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441057,325828.4846513991,209884.98459768714,1.5524144582136514 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441067,303364.93197136215,209884.98459768714,1.4453865413614972 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441068,20.194148491620656,22.903585106474594,0.881702510665546 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441062,12.98971008780263,22.903585106474594,0.567147458680195 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441056,29.81470521721076,22.903585106474594,1.3017483978428543 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441070,12.561772141787465,22.903585106474594,0.5484631372507873 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441057,60.67105652896246,22.903585106474594,2.6489764046507904 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441067,28.687441629894675,22.903585106474594,1.2525306189634497 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441068,11.148008294234284,83.56495705722055,0.13340530153806887 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441062,39.496811867409946,83.56495705722055,0.47264802446275134 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441056,52.52908843652451,83.56495705722055,0.6286018719611806 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441070,55.903793477055395,83.56495705722055,0.6689860851454233 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441057,44.175343222900395,83.56495705722055,0.5286347863812294 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441067,67.03129032921451,83.56495705722055,0.8021459316171883 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441068,2119.580653088793,1829.6496491832456,1.158462579999932 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441062,2833.3052712214553,1829.6496491832456,1.548550714332791 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441056,2730.3198332309644,1829.6496491832456,1.4922637426513745 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441070,1609.1254014186864,1829.6496491832456,0.8794718716432945 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441057,1793.5225973498998,1829.6496491832456,0.9802546614050002 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441067,1278.770414348552,1829.6496491832456,0.6989154535237904 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441068,134964.11797460972,96234.19538703516,1.402454890715409 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441062,167250.80987423257,96234.19538703516,1.7379561308907134 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441056,79055.06405213622,96234.19538703516,0.8214862059602844 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441070,103005.04902706714,96234.19538703516,1.070358084387789 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441057,88415.23414377384,96234.19538703516,0.9187506975891991 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441067,84285.10713900824,96234.19538703516,0.8758332399416858 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441068,74.04382004198571,77.99112650544876,0.9493877490897984 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441062,78.3557380666859,77.99112650544876,1.0046750390406487 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441056,76.29164003320476,77.99112650544876,0.9782092329167054 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441070,46.86029273292754,77.99112650544876,0.6008413371187002 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441057,108.88685065302874,77.99112650544876,1.3961440939748637 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441067,109.22896577116886,77.99112650544876,1.4005306842636476 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441068,79.01252871329785,110.33780757772625,0.7160965986897859 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441062,84.23375579681337,110.33780757772625,0.7634169796012652 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441056,104.59881207853698,110.33780757772625,0.9479870442853734 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441070,117.3931562728802,110.33780757772625,1.0639431655390097 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441057,121.92677104405556,110.33780757772625,1.1050316634048178 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441067,65.28408028792359,110.33780757772625,0.5916746192544649 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441068,69.48764182609447,67.31067174214355,1.0323421238803046 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441062,75.53383791970202,67.31067174214355,1.1221673467924984 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441056,64.28793004182569,67.31067174214355,0.9550926826002049 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441070,72.63689476440813,67.31067174214355,1.0791289536177633 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441057,141.6885747700376,67.31067174214355,2.1049942171551033 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441067,38.616780095185824,67.31067174214355,0.5737096227938498 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441068,4331.491824650672,2375.529574917848,1.8233794562631225 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441062,4035.407984308144,2375.529574917848,1.698740368007289 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441056,2769.8917899788116,2375.529574917848,1.1660102316657546 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441070,4017.9496627024855,2375.529574917848,1.6913911344763772 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441057,3015.246076392175,2375.529574917848,1.26929426946682 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441067,2539.5206369615576,2375.529574917848,1.0690334752196806 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441068,170.86750313531502,194.62377093849457,0.8779374806652623 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441062,199.50602433479605,194.62377093849457,1.0250855965474248 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441056,187.8335388065823,194.62377093849457,0.9651109825939087 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441070,236.4576217950195,194.62377093849457,1.2149472834422952 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441057,243.2911678372672,194.62377093849457,1.2500588528528338 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441067,188.25873894969175,194.62377093849457,0.967295711319794 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441068,3500.5337027525625,3728.1507253933823,0.9389464001306432 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441062,4181.879239557359,3728.1507253933823,1.1217033718818064 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441056,5339.801676397763,3728.1507253933823,1.4322923266023062 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441070,4526.900463148223,3728.1507253933823,1.214248241712534 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441057,3812.732255587403,3728.1507253933823,1.022687261439811 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441067,4128.495908247186,3728.1507253933823,1.1073843876876948 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441068,62.752529698449194,68.78582331086372,0.9122887054044805 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441062,108.79509449491452,68.78582331086372,1.5816499571901166 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441056,95.1587338259532,68.78582331086372,1.383406191067924 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441070,30.447994310581933,68.78582331086372,0.44264926761112294 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441057,102.7848974249528,68.78582331086372,1.4942744373420827 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441067,106.02398046621086,68.78582331086372,1.5413638357871615 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441068,772.6427388573562,696.3940975413478,1.1094906484492155 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441062,894.187528951464,696.3940975413478,1.2840251405180416 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441056,1090.9138463930378,696.3940975413478,1.5665179389724304 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441070,870.3787418972362,696.3940975413478,1.249836471862914 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441057,1399.9697018509776,696.3940975413478,2.0103124176290934 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441067,1525.5987925379338,696.3940975413478,2.190711836766182 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441068,51.85571396798333,81.2393188807366,0.6383080838492764 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441062,241.16400740331625,81.2393188807366,2.9685626458458754 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441056,210.02469962518921,81.2393188807366,2.5852592379992254 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441070,16.88622280971892,81.2393188807366,0.2078577595475504 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441057,68.64609167813856,81.2393188807366,0.8449860563074694 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441067,69.98394553942958,81.2393188807366,0.8614541148747139 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441068,386.3188966831313,543.8205698619286,0.7103793385035333 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441062,1025.3673220627236,543.8205698619286,1.885488300530919 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441056,610.8808711050553,543.8205698619286,1.123313285593726 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441070,393.13597308605006,543.8205698619286,0.7229148636026473 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441057,1261.9418540839863,543.8205698619286,2.3205114407577168 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441067,692.7428453307392,543.8205698619286,1.2738445062985035 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441068,264041.09852088155,306516.0644612488,0.861426623707231 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441062,286546.918550955,306516.0644612488,0.9348512256759111 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441056,201696.2756592217,306516.0644612488,0.6580284006116784 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441070,359865.0428227431,306516.0644612488,1.1740495345823512 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441057,447995.7352697709,306516.0644612488,1.4615734286462125 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441067,254029.5387411136,306516.0644612488,0.828764192792346 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441068,577519.5431834584,335923.8645439917,1.7191977234705453 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441062,486409.7280997851,335923.8645439917,1.447976102442362 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441056,441866.0813310603,335923.8645439917,1.3153756787445947 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441070,680121.4500028532,335923.8645439917,2.0246297503337582 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441057,362431.8693982005,335923.8645439917,1.078910752262846 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441067,447359.7608939961,335923.8645439917,1.331729621238062 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441068,31.020715882147165,33.931355493730415,0.914219766076806 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441062,15.63499652168922,33.931355493730415,0.46078313978874613 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441056,2.3462768390969493,33.931355493730415,0.06914774859290479 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441070,11.142867351359689,33.931355493730415,0.3283944065664746 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441057,337.51729739160186,33.931355493730415,9.947062016251188 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441067,17.77355229929316,33.931355493730415,0.5238090857459917 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441068,211.02917796927963,76.3332642617619,2.7645768854534865 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441062,165.02007103963467,76.3332642617619,2.1618369479621378 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441056,73.44010799780021,76.3332642617619,0.9620983552591111 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441070,47.63794517423896,76.3332642617619,0.6240784490871372 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441057,176.33319058621635,76.3332642617619,2.3100438883569145 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441067,215.80881182550783,76.3332642617619,2.8271922328050407 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441068,134.44694997314338,130.67426801703346,1.0288708864672436 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441062,152.79817640666656,130.67426801703346,1.1693057763044001 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441056,144.56778346431653,130.67426801703346,1.1063217392231504 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441070,61.89147850084825,130.67426801703346,0.47363172137899917 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441057,250.7363591465259,130.67426801703346,1.918789084885804 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441067,4.763657159000493,130.67426801703346,0.03645443920435466 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441068,8507.277698678006,5444.214081294075,1.5626273272221964 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441062,7701.975245985162,5444.214081294075,1.4147083731421566 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441056,7257.057799715508,5444.214081294075,1.3329853843643351 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441070,7773.536471071853,5444.214081294075,1.427852827790362 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441057,9224.617782990956,5444.214081294075,1.6943892442962656 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441067,9698.22880632993,5444.214081294075,1.7813827049256459 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441068,34.859341343636466,100.67607722942154,0.346252479267728 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441062,35.177476748366324,100.67607722942154,0.34941246934168463 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441056,31.7822443208241,100.67607722942154,0.31568814752682944 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441070,99.88223305309845,100.67607722942154,0.9921148678199482 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441057,136.09716776106504,100.67607722942154,1.3518322476046183 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441067,49.70318854337083,100.67607722942154,0.4936941318254461 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441068,534.1412428165303,599.1099853739104,0.8915579039851381 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441062,588.6500765004349,599.1099853739104,0.9825409204839954 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441056,566.8825435479727,599.1099853739104,0.9462078038879218 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441070,557.4356744077726,599.1099853739104,0.9304396321484636 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441057,509.50947203883135,599.1099853739104,0.8504439660120863 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441067,498.21634858949074,599.1099853739104,0.8315941325507187 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441068,126.03716165607798,114.30018844822946,1.1026855105594564 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441062,152.48004274773697,114.30018844822946,1.3340314204013801 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441056,151.34747382689693,114.30018844822946,1.3241226972731324 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441070,235.7050755660063,114.30018844822946,2.0621582410843122 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441057,204.47182890582536,114.30018844822946,1.7889019404236397 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441067,115.4367343837,114.30018844822946,1.0099435175995823 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441068,2387.571636756294,1759.6959467320276,1.356809192628027 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441062,2120.2874237280685,1759.6959467320276,1.2049169219635378 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441056,2258.322481238182,1759.6959467320276,1.2833594834563127 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441070,2570.4054891485484,1759.6959467320276,1.4607100129554247 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441057,2088.456434036555,1759.6959467320276,1.1868280073697255 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441067,1899.574001783724,1759.6959467320276,1.0794899001224998 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441068,144.0445852454831,38.77498679262034,3.714884185928277 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441062,161.91059797884594,38.77498679262034,4.175645470746125 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441056,163.56880585916073,38.77498679262034,4.2184103565005255 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441070,481.67716829082616,38.77498679262034,12.422368339336199 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441057,303.15704891822327,38.77498679262034,7.818366271524305 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441067,170.72460826298746,38.77498679262034,4.402957225390462 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441068,1257.7901781303317,2284.874121495706,0.5504855459201259 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441062,1476.146386327523,2284.874121495706,0.646051514365798 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441056,1244.4681219834918,2284.874121495706,0.5446550032125393 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441070,930.2288415279024,2284.874121495706,0.40712476577001255 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441057,1274.8222868351197,2284.874121495706,0.5579398334647012 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441067,2522.098895320631,2284.874121495706,1.1038240013281935 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441068,327.70348282876455,306.4947439651267,1.0691977245327606 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441062,370.28569244097656,306.4947439651267,1.2081306441036654 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441056,318.11741438939265,306.4947439651267,1.0379212715817026 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441070,339.9987420694968,306.4947439651267,1.1093134507656752 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441057,348.6509594209237,306.4947439651267,1.1375430289943034 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441067,301.8463806795662,306.4947439651267,0.9848337911918993 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441068,50413.616468588894,53872.22448470133,0.9357997920227963 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441062,52583.624891019346,53872.22448470133,0.9760804457954411 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441056,76224.54084684914,53872.22448470133,1.4149135584422625 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441070,48032.59371179046,53872.22448470133,0.8916021970733878 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441057,73408.90294105774,53872.22448470133,1.36264844533948 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441067,109539.6024772628,53872.22448470133,2.0333224314576044 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441068,76.02736047140817,320.29657233769314,0.23736551383151072 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441062,99.2659073897302,320.29657233769314,0.30991873145951987 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441056,136.6713272080835,320.29657233769314,0.42670243459236595 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441070,860.4722174416313,320.29657233769314,2.6864858751420653 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441057,862.5674822363359,320.29657233769314,2.6930275149086484 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441067,84.07168685961302,320.29657233769314,0.2624807572744646 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441068,8505.26930414333,6299.521117687065,1.3501453753783317 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441062,6775.077148574061,6299.521117687065,1.0754908225566202 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441056,8835.943124466548,6299.521117687065,1.4026372734362318 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441070,5444.977372290291,6299.521117687065,0.8643478243135839 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441057,11475.427155562376,6299.521117687065,1.8216348419474302 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441067,29086.719725224575,6299.521117687065,4.617290613338569 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441068,1353.1516338360332,1965.7827420843205,0.6883525859023901 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441062,1725.7371400449872,1965.7827420843205,0.877888030604637 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441056,1270.9361413795784,1965.7827420843205,0.6465293006041981 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441070,1178.740737865563,1965.7827420843205,0.5996292024701283 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441057,1515.9417047568263,1965.7827420843205,0.7711644182761888 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441067,1047.5562069464172,1965.7827420843205,0.5328952098926725 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441068,9404.154409852545,6243.797224888628,1.5061594845467277 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441062,8125.455571392829,6243.797224888628,1.3013644227592231 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441056,8717.154362873442,6243.797224888628,1.396130279203443 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441070,6291.30890807349,6243.797224888628,1.0076094212341609 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441057,5077.676705943493,6243.797224888628,0.8132353635225662 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441067,20268.702878687047,6243.797224888628,3.2462141464000833 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441068,320.27171654536727,477.14850073021523,0.671220209337831 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441062,432.0089818535917,477.14850073021523,0.9053973368719733 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441056,305.8331844439146,477.14850073021523,0.640960170630057 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441070,363.3610354639045,477.14850073021523,0.7615260970281297 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441057,393.63618854671455,477.14850073021523,0.824976266181921 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441067,309.8743385041304,477.14850073021523,0.6494295550125527 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441068,474.5132032922048,205.1372392304115,2.3131499920364456 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441062,32.77768125928116,205.1372392304115,0.15978415904517976 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441056,87.97880271047472,205.1372392304115,0.42887777490100837 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441070,496.72952237999647,205.1372392304115,2.4214497779316733 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441057,26.83049671613117,205.1372392304115,0.1307929112080668 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441067,109.99558510177911,205.1372392304115,0.5362048622397192 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441068,8.303813203761917,44.32085041603382,0.1873568112031955 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441062,95.79474228097918,44.32085041603382,2.1613922427427927 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441056,210.49062644770643,44.32085041603382,4.749246110394079 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441070,1.5694397584143416,44.32085041603382,0.03541086742881112 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441057,154.73912152223295,44.32085041603382,3.4913391794091893 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441067,49.73364813864681,44.32085041603382,1.12212756911936 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441068,18.799730217807923,73.02499011367847,0.25744242058153327 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441062,6.871906812166805,73.02499011367847,0.09410349527564829 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441056,385.28384994555944,73.02499011367847,5.2760548046057325 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441070,119.9070514151608,73.02499011367847,1.6420002416775505 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441057,54.2673119208307,73.02499011367847,0.7431334374212503 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441067,18.89330483291088,73.02499011367847,0.2587238259601206 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441068,64.52382722744379,446.9213615105917,0.1443740057744244 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441062,107.0984320169841,446.9213615105917,0.23963596560923384 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441056,105.88377218064782,446.9213615105917,0.23691812766067227 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441070,34.665175518985194,446.9213615105917,0.07756437374534324 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441057,2915.987518358979,446.9213615105917,6.524609851950145 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441067,92.85411626227312,446.9213615105917,0.2077638803131422 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441068,2932.9727015974913,2631.000022355788,1.1147748676076854 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441062,3077.067585508141,2631.000022355788,1.1695429720114352 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441056,3221.5865577058967,2631.000022355788,1.224472265424498 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441070,3445.311449705286,2631.000022355788,1.3095064311783495 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441057,2264.5594376212753,2631.000022355788,0.8607219378103983 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441067,3322.660996013078,2631.000022355788,1.2628890033372098 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441068,15.18918092558675,48.89133349009634,0.31067225705070084 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441062,33.4404939658611,48.89133349009634,0.6839759028588362 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441056,31.041584384322288,48.89133349009634,0.6349097512468179 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441070,377.9044201267019,48.89133349009634,7.729476640338557 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441057,391.4310778859328,48.89133349009634,8.006144442045601 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441067,46.7944718205799,48.89133349009634,0.9571117922168927 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441068,341.8596684229976,307.70649021557807,1.110992713164717 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441062,396.8552895847111,307.70649021557807,1.289720243816358 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441056,350.44321012980794,307.70649021557807,1.138887937931659 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441070,305.91376146691016,307.70649021557807,0.9941739001104204 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441057,118.68530292674906,307.70649021557807,0.38570945592859796 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441067,480.01167878632174,307.70649021557807,1.5599660522273264 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441068,160.43022220672472,154.19153082843468,1.0404606617806504 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441062,149.29961118675683,154.19153082843468,0.9682737461947831 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441056,129.8695827080291,154.19153082843468,0.8422614524304318 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441070,95.1415895907868,154.19153082843468,0.6170351191120128 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441057,85.38381641420122,154.19153082843468,0.5537516616863075 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441067,86.7530304315122,154.19153082843468,0.5626316177380732 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441068,7120.691650008356,6593.957266089812,1.0798813766396904 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441062,7989.325721380421,6593.957266089812,1.2116132087277016 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441056,7253.373625762634,6593.957266089812,1.1000031290866787 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441070,7369.322770125268,6593.957266089812,1.117587280709698 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441057,7174.8292734447605,6593.957266089812,1.0880915638234645 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441067,7497.157792052103,6593.957266089812,1.1369739732174342 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441068,134.99347268963717,127.96554716912783,1.0549204506680283 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441062,154.19426878852033,127.96554716912783,1.2049670571464588 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441056,122.99830495042433,127.96554716912783,0.961182972068736 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441070,144.86756632893244,127.96554716912783,1.132082576394299 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441057,198.72171864179316,127.96554716912783,1.552931418166401 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441067,160.5317722354368,127.96554716912783,1.2544921331307033 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441068,1894.646643939021,1681.9358703135756,1.1264678263778203 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441062,1875.0536596734971,1681.9358703135756,1.1148187590076886 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441056,2628.731020189413,1681.9358703135756,1.5629198868915968 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441070,2003.8161420967176,1681.9358703135756,1.1913748778799347 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441057,2362.794927257876,1681.9358703135756,1.4048067877982549 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441067,3303.404200580828,1681.9358703135756,1.964048843292075 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441068,45.95406847833192,45.403354316773296,1.0121293717137365 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441062,45.768631861851304,45.403354316773296,1.0080451664987022 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441056,44.31419674741762,45.403354316773296,0.9760115175245254 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441070,52.039640637752186,45.403354316773296,1.1461629084643918 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441057,45.95638746651087,45.403354316773296,1.0121804469748894 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441067,47.487422614027594,45.403354316773296,1.0459011966982446 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441068,153.97856662871928,171.72890790902974,0.8966374299095096 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441062,186.48835693831143,171.72890790902974,1.085946211438672 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441056,173.8461020980872,171.72890790902974,1.0123287000123415 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441070,167.9768404322994,171.72890790902974,0.9781512179724691 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441057,175.17538600245425,171.72890790902974,1.0200692948868586 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441067,184.49553419370224,171.72890790902974,1.074341742692706 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441068,219.73849050111139,385.5886159476326,0.5698780550382079 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441062,33.18107552977069,385.5886159476326,0.0860530476197385 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441056,26.611817250446915,385.5886159476326,0.06901608644499273 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441070,164.72119827670545,385.5886159476326,0.4271941428350584 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441057,30.03243896146832,385.5886159476326,0.07788725527505477 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441067,48.51500100895444,385.5886159476326,0.12582062592725338 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441068,353.26690334386296,430.1288265554666,0.821304877826662 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441062,535.4587302196642,430.1288265554666,1.2448798991402055 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441056,360.9254757337473,430.1288265554666,0.8391101768837265 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441070,468.3277840879752,430.1288265554666,1.0888081783274357 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441057,307.661490870424,430.1288265554666,0.7152775444841059 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441067,466.11739499266656,430.1288265554666,1.0836692781681283 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441068,43542.190189967005,54695.927744901994,0.7960773678260794 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441062,53209.2461673912,54695.927744901994,0.9728191542075202 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441056,32727.63182359559,54695.927744901994,0.5983559137388618 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441070,65718.03931580996,54695.927744901994,1.201516127897388 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441057,55650.95879454521,54695.927744901994,1.0174607340805593 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441067,61585.795641449775,54695.927744901994,1.1259667434234162 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441068,295446.67802463716,97212.60478924697,3.0391807591737074 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441062,224348.52356020332,97212.60478924697,2.3078131076374504 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441056,146079.77905865505,97212.60478924697,1.5026835190287327 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441070,193264.00701955392,97212.60478924697,1.9880550206276495 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441057,214213.11238272997,97212.60478924697,2.2035528504470734 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441067,378464.25947508385,97212.60478924697,3.8931603601773577 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441068,55721.18883600671,62941.57202670208,0.8852843524843608 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441062,64159.822091479466,62941.57202670208,1.019355253222156 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441056,42095.18874549387,62941.57202670208,0.6687978610962493 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441070,90330.995570388,62941.57202670208,1.4351563308915503 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441057,79780.06366446632,62941.57202670208,1.2675257559601585 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441067,65224.75883221429,62941.57202670208,1.0362747025851786 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441068,53694.43031819031,14728.399701289269,3.645639133047842 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441062,33943.97733436842,14728.399701289269,2.3046616076963944 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441056,21613.17686580089,14728.399701289269,1.4674490986219606 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441070,30003.66164486544,14728.399701289269,2.0371297801103965 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441057,34590.54498510431,14728.399701289269,2.3485609901037914 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441067,70444.14283115738,14728.399701289269,4.782878266468486 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441068,2801.523933001653,3575.9352491809864,0.7834381043793507 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441062,2159.0973310762815,3575.9352491809864,0.603785354214898 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441056,1381.059415003518,3575.9352491809864,0.38620929037230994 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441070,711.2345465399626,3575.9352491809864,0.19889469382949818 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441057,5027.768418969686,3575.9352491809864,1.406000967193469 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441067,1915.4660095067568,3575.9352491809864,0.5356545563696841 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441068,20130.00819160819,12966.336321671553,1.5524823429084966 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441062,10324.76555100457,12966.336321671553,0.7962746989485426 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441056,12509.883702133468,12966.336321671553,0.9647971016473493 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441070,20008.87714569351,12966.336321671553,1.5431403790021443 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441057,16580.885129631675,12966.336321671553,1.278764079404517 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441067,9834.388873571495,12966.336321671553,0.7584554826897855 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441068,59.76848575741865,103.34580193186551,0.5783349167566885 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441062,65.98920887489246,103.34580193186551,0.6385281999011266 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441056,44.901657565115514,103.34580193186551,0.4344797439833944 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441070,72.60855795651234,103.34580193186551,0.702578688241078 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441057,75.43188339132436,103.34580193186551,0.7298978960079635 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441067,58.08401255434237,103.34580193186551,0.5620355299254088 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441068,272.8005912521911,211.8154700640626,1.2879162752828386 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441062,227.97156332748648,211.8154700640626,1.0762743781582031 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441056,286.8957707011325,211.8154700640626,1.3544608928439563 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441070,471.46176631127287,211.8154700640626,2.225813658316276 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441057,287.1396795304344,211.8154700640626,1.355612408496841 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441067,259.09449666617473,211.8154700640626,1.2232085625653915 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441068,39.12994331274665,76.10596635595309,0.5141507977145061 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441062,88.43126729215768,76.10596635595309,1.16194920748471 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441056,68.30204663132938,76.10596635595309,0.8974598169068084 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441070,61.01456892672143,76.10596635595309,0.8017054621099204 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441057,33.49589393468272,76.10596635595309,0.4401217872724986 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441067,102.84606503932388,76.10596635595309,1.351353513577443 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441068,3132.2803657125955,1382.686999693948,2.2653575005810516 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441062,5238.82725202331,1382.686999693948,3.7888743100809528 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441056,4218.601001154757,1382.686999693948,3.0510166090290327 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441070,3582.545274380748,1382.686999693948,2.591002356407292 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441057,4238.689636783415,1382.686999693948,3.0655453025316874 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441067,4992.926076225237,1382.686999693948,3.6110313305400283 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441068,31.71826354031692,30.899530320120164,1.0264966234669153 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441062,29.474285793414623,30.899530320120164,0.9538748805583788 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441056,29.919859545093452,30.899530320120164,0.9682949622574424 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441070,29.508395177667232,30.899530320120164,0.9549787609054013 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441057,31.89967120498581,30.899530320120164,1.032367510913731 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441067,22.494675860765593,30.899530320120164,0.7279941030727652 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441068,30.707462651830223,31.68183515511672,0.9692450737617978 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441062,36.21088358260579,31.68183515511672,1.1429541062035864 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441056,31.88,31.68183515511672,1.0062548411073111 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441070,31.226853538350724,31.68183515511672,0.9856390384414802 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441057,31.25000305655712,31.68183515511672,0.9863697258556736 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441067,30.51557967150437,31.68183515511672,0.9631885123477768 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441068,392.25014971055504,628.1906149122311,0.6244126231738738 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441062,376.66014523094793,628.1906149122311,0.5995953079999033 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441056,362.7171783001875,628.1906149122311,0.5773998682722524 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441070,938.5118251008892,628.1906149122311,1.4939921145304202 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441057,1755.969379703305,628.1906149122311,2.7952811424103237 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441067,824.8721367099307,628.1906149122311,1.313092104735088 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441068,8909.741344986147,10551.186365326936,0.8444302883574432 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441062,10987.420492712286,10551.186365326936,1.0413445571219264 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441056,12773.579199546344,10551.186365326936,1.2106296635535303 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441070,12037.11621915567,10551.186365326936,1.1408305950041564 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441057,12441.206316137115,10551.186365326936,1.179128667182026 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441067,9250.235804036804,10551.186365326936,0.8767010157677353 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441068,162.12253172746466,102.14043933131707,1.587251168967281 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441062,167.3552582737668,102.14043933131707,1.638481872306323 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441056,136.38132796169432,102.14043933131707,1.3352334183653616 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441070,97.78767660133956,102.14043933131707,0.9573845309607659 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441057,211.62601888642277,102.14043933131707,2.071912165953809 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441067,100.94860779877666,102.14043933131707,0.9883314430568052 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441068,2880.0703101142567,2995.2816068385046,0.961535737921533 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441062,3919.1942072470024,2995.2816068385046,1.3084560057054802 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441056,7189.283188650849,2995.2816068385046,2.4002027629846396 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441070,4424.842135883623,2995.2816068385046,1.4772708268168508 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441057,3702.972778411529,2995.2816068385046,1.2362686600008828 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441067,5816.525410401687,2995.2816068385046,1.941896013090062 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441068,34.90903456873298,35.73806763844074,0.9768025211073238 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441062,37.33269755175189,35.73806763844074,1.0446199254376005 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441056,34.905433943721675,35.73806763844074,0.9767017706960892 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441070,34.86127839238688,35.73806763844074,0.9754662379923764 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441057,45.86755086624677,35.73806763844074,1.2834367915547429 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441067,16.21815377820789,35.73806763844074,0.4538061190740835 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441068,244.81786796819856,271.6614200921023,0.9011874703636502 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441062,273.2856816664484,271.6614200921023,1.0059789924303402 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441056,258.66718754049634,271.6614200921023,0.9521675453687887 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441070,295.1028049962187,271.6614200921023,1.0862889728551408 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441057,229.39155426141775,271.6614200921023,0.8444023968646206 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441067,281.5196942598586,271.6614200921023,1.0362888266004575 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441068,156.86492069393026,166.02715311669658,0.9448148555777114 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441062,139.49875427502013,166.02715311669658,0.8402165046880599 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441056,149.88061088147452,166.02715311669658,0.9027475811509397 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441070,158.73829799147265,166.02715311669658,0.9560984152989676 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441057,218.76545067583743,166.02715311669658,1.3176486289689755 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441067,93.04294849140544,166.02715311669658,0.5604080220902646 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441068,1745.3553357405806,1793.9624976146763,0.9729051404704805 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441062,2377.614699993913,1793.9624976146763,1.3253424768663133 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441056,1817.109710825133,1793.9624976146763,1.012902841191627 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441070,1820.592596887044,1793.9624976146763,1.014844289837595 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441057,1573.0495743152553,1793.9624976146763,0.8768575577286841 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441067,1592.0022471522184,1793.9624976146763,0.8874222561893059 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441068,46.99651175873021,59.13775760336051,0.794695532318588 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441062,46.33227397828854,59.13775760336051,0.7834634902635487 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441056,50.14816868919598,59.13775760336051,0.8479890127985897 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441070,182.39608564982427,59.13775760336051,3.0842577236891984 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441057,179.7745896674349,59.13775760336051,3.039929090196331 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441067,89.06381655717921,59.13775760336051,1.5060397987109024 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441068,299.0160401293298,238.79765196261823,1.2521732842504592 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441062,215.87498202378745,238.79765196261823,0.9040079759979418 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441056,294.53243454461114,238.79765196261823,1.2333975318598096 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441070,426.82047886210904,238.79765196261823,1.787373013738528 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441057,361.6856410286743,238.79765196261823,1.514611379366884 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441067,697.2635424386184,238.79765196261823,2.9198927908544476 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441068,306.5246819187244,386.8144501381946,0.7924333793869758 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441062,275.2448182934847,386.8144501381946,0.7115680869604272 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441056,273.6421297451252,386.8144501381946,0.7074247863474669 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441070,515.681880201214,386.8144501381946,1.333150506701546 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441057,618.5045964316022,386.8144501381946,1.5989697287953777 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441067,441.2729710244964,386.8144501381946,1.1407871936191778 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441068,6309.903156676287,5555.372966797932,1.1358198980316634 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441062,8436.255453353064,5555.372966797932,1.5185758910829072 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441056,8064.527348237882,5555.372966797932,1.451662632992615 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441070,6508.688600348181,5555.372966797932,1.1716024539212408 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441057,6833.477847499825,5555.372966797932,1.2300664398845178 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441067,11218.634661893277,5555.372966797932,2.019420609370823 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441068,55.67632807572368,84.54153084580483,0.6585677775018252 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441062,85.84778972672441,84.54153084580483,1.015451090935437 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441056,29.714209432969657,84.54153084580483,0.3514747028553973 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441070,185.0323644896458,84.54153084580483,2.188656422925746 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441057,16.296672826242887,84.54153084580483,0.19276529136864534 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441067,82.25472529080137,84.54153084580483,0.972950506903236 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441068,94.76731798436464,122.00200397429413,0.7767685357392339 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441062,406.8311416361629,122.00200397429413,3.334626714179895 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441056,126.38605168381147,122.00200397429413,1.0359342270348368 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441070,131.13,122.00200397429413,1.074818410586347 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441057,87.15123869846471,122.00200397429413,0.7143426817548629 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441067,293.5186969843505,122.00200397429413,2.40585144032712 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441068,91.9665228816526,143.84455848940917,0.6393465546937864 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441062,80.63212702845784,143.84455848940917,0.5605504154986477 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441056,107.9927733478258,143.84455848940917,0.7507602267469644 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441070,763.7239349025914,143.84455848940917,5.3093696621052375 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441057,124.5261642182265,143.84455848940917,0.8656995129043757 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441067,282.43552315994685,143.84455848940917,1.9634772849661999 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441068,1374.6767200939987,5334.764851653101,0.25768272047980206 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441062,4808.180311716296,5334.764851653101,0.9012918929737587 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441056,2363.1533611829104,5334.764851653101,0.44297235715096844 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441070,1588.3494816522152,5334.764851653101,0.29773561268778853 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441057,1895.0317508265089,5334.764851653101,0.3552231079574743 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441067,5198.696680545739,5334.764851653101,0.9744940639576273 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441068,90.18124309514288,159.70733471984832,0.5646656320032821 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441062,133.5840177660371,159.70733471984832,0.8364300737994558 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441056,195.37148591499772,159.70733471984832,1.2233094131694697 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441070,153.11071149765516,159.70733471984832,0.9586955525006746 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441057,117.77989810138637,159.70733471984832,0.7374733183544184 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441067,77.1340783164251,159.70733471984832,0.48297142051572245 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441068,38898.49218694437,82077.5827732141,0.4739234620788423 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441062,20254.413795284025,82077.5827732141,0.24677156795965027 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441056,47256.479149907726,82077.5827732141,0.5757537874925065 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441070,58453.27314509505,82077.5827732141,0.7121709871330566 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441057,34494.77644864232,82077.5827732141,0.4202703744815891 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441067,50001.837162107266,82077.5827732141,0.6092021167371086 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441068,196042.1534076917,170961.68742491837,1.1467022603750794 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441062,206269.88063684045,170961.68742491837,1.2065269344479794 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441056,214600.06416709637,170961.68742491837,1.255252374958821 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441070,201153.93894243575,170961.68742491837,1.1766024421745191 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441057,110020.64469650398,170961.68742491837,0.6435397681999483 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441067,66985.42716209103,170961.68742491837,0.3918154305274342 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441068,193437.334204822,55195.40432138408,3.504591307611448 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441062,125965.47500513012,55195.40432138408,2.2821732452882486 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441056,111789.75770648876,55195.40432138408,2.0253453902715344 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441070,182999.8791102739,55195.40432138408,3.3154912326527732 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441057,99093.51070725442,55195.40432138408,1.7953217650199025 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441067,133769.7460441958,55195.40432138408,2.4235667387324504 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441068,365.7054020244484,546.121028905539,0.6696416777016353 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441062,416.7415141486174,546.121028905539,0.7630936955198259 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441056,330.81885905205655,546.121028905539,0.6057610704261626 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441070,341.3301392490908,546.121028905539,0.6250082329426829 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441057,452.27705516857066,546.121028905539,0.828162680486709 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441067,474.4580028688054,546.121028905539,0.8687781238156114 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441068,2579.2285089105294,1228.731327313693,2.099098844130029 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441062,2099.040493729234,1228.731327313693,1.7082989967532198 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441056,828.5991719129155,1228.731327313693,0.6743534192494594 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441070,1985.9873111511715,1228.731327313693,1.6162909392837124 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441057,1213.011513271921,1228.731327313693,0.9872064676041593 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441067,1739.0287854850606,1228.731327313693,1.4153043442678412 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441068,60.14841725489289,76.68368758811918,0.7843704332264252 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441062,54.947498259807624,76.68368758811918,0.7165474169022721 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441056,55.35876460127695,76.68368758811918,0.7219105698022514 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441070,88.83244552667753,76.68368758811918,1.1584268873950265 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441057,231.5549871983453,76.68368758811918,3.0196120515495495 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441067,101.99880274382244,76.68368758811918,1.330123862739556 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441068,8.18830712225759,81.06808963980528,0.10100530502987265 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441062,68.426320679904,81.06808963980528,0.8440598635533402 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441056,93.12687618228198,81.06808963980528,1.1487488677240978 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441070,91.60125930928116,81.06808963980528,1.1299299109708387 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441057,91.31889616162046,81.06808963980528,1.1264468740704348 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441067,44.948212884874934,81.06808963980528,0.5544501305579661 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441068,36.31377500794144,34.254424530644805,1.0601192548266076 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441062,36.17443749682002,34.254424530644805,1.056051531808906 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441056,55.2991303717633,34.254424530644805,1.6143646004705585 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441070,65.38072301587495,34.254424530644805,1.9086796497598093 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441057,54.37970898466712,34.254424530644805,1.5875236478142485 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441067,27.9848763345994,34.254424530644805,0.8169711422115259 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441068,54.82077774839281,60.87738129746832,0.9005114310111203 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441062,26.161267555125512,60.87738129746832,0.42973707143039463 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441056,94.43263811621507,60.87738129746832,1.5511941562463727 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441070,36.6531459478692,60.87738129746832,0.6020815147873891 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441057,35.81918010516333,60.87738129746832,0.5883824064333222 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441067,85.5449484238213,60.87738129746832,1.4052008578657245 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441068,99.01952359627684,81.37032235510941,1.2168997335926026 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441062,152.3117357473314,81.37032235510941,1.8718339971989484 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441056,117.53630119896069,81.37032235510941,1.4444615407324897 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441070,69.58852367295893,81.37032235510941,0.8552076685805254 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441057,145.12128332972054,81.37032235510941,1.7834669831636483 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441067,39.45763732540854,81.37032235510941,0.48491435431717833 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441068,684.8957920551161,592.3362991324378,1.1562617267559747 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441062,614.72,592.3362991324378,1.0377888387058944 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441056,916.2111231718573,592.3362991324378,1.5467752432423625 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441070,830.7796688280059,592.3362991324378,1.402547286135938 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441057,979.539817466232,592.3362991324378,1.6536886544027602 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441067,1335.4995827904445,592.3362991324378,2.254630662929955 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441068,732.1965816560872,1509.2244087879828,0.4851475879879881 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441062,561.6403416478646,1509.2244087879828,0.37213839000848303 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441056,293.26217624387345,1509.2244087879828,0.1943131680989604 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441070,652.2043793248226,1509.2244087879828,0.4321453956927388 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441057,553.8032103043391,1509.2244087879828,0.3669455695784058 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441067,356.87380153295993,1509.2244087879828,0.23646172130197363 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441068,1071378.4603943266,911297.6405793307,1.1756624978346581 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441062,1329749.9528448188,911297.6405793307,1.4591829207408782 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441056,1032602.9338591932,911297.6405793307,1.133112704212365 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441070,1089666.0100237944,911297.6405793307,1.1957300902601604 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441057,918564.167726848,911297.6405793307,1.0079738241645153 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441067,988174.507226605,911297.6405793307,1.0843597779956964 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441068,453.2222319374797,749.6106308195243,0.6046101980197198 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441062,251.87485095976095,749.6106308195243,0.3360075759389839 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441056,140.6579884524022,749.6106308195243,0.18764140030755103 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441070,1915.3811967508,749.6106308195243,2.5551681339641323 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441057,1675.5612240146877,749.6106308195243,2.2352420778542754 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441067,64.46655012626209,749.6106308195243,0.08600004785922388 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441068,4994.575343990939,2138.7943755926544,2.3352293240470834 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441062,3200.7085827114593,2138.7943755926544,1.4965013089790602 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441056,2716.557081132338,2138.7943755926544,1.2701347600933293 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441070,3924.418916723302,2138.7943755926544,1.8348743392575342 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441057,3312.9921776862393,2138.7943755926544,1.548999855008604 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441067,3202.050296569652,2138.7943755926544,1.4971286314900525 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441068,526.938917376343,613.8984432679271,0.8583486782786452 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441062,314.33875238189876,613.8984432679271,0.512037057316189 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441056,191.46376739920024,613.8984432679271,0.31188182589288416 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441070,492.6033283740673,613.8984432679271,0.8024182725595832 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441057,824.0220055274614,613.8984432679271,1.3422773987518142 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441067,615.2110194343172,613.8984432679271,1.002138099844989 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441068,9490.580920784478,6365.76448478505,1.4908784237098496 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441062,9354.451575508743,6365.76448478505,1.4694938208705361 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441056,3987.339770450257,6365.76448478505,0.6263724930415637 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441070,6173.104047526935,6365.76448478505,0.9697349096532558 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441057,4174.910206713751,6365.76448478505,0.6558379934872384 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441067,5523.831499645705,6365.76448478505,0.8677404752953605 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441068,51.751379809109885,70.21289390855102,0.7370637631958826 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441062,112.34866822977078,70.21289390855102,1.6001144800568912 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441056,101.0688272520836,70.21289390855102,1.4394624922271537 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441070,45.90144644425303,70.21289390855102,0.6537466822552208 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441057,73.29885077861202,70.21289390855102,1.043951426843057 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441067,73.89149118345188,70.21289390855102,1.052392047530359 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441068,2169.9707891310795,2003.7789126851078,1.0829392281722692 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441062,2916.012634500875,2003.7789126851078,1.4552566732990286 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441056,760.486396967044,2003.7789126851078,0.3795261004857944 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441070,2084.7279413158035,2003.7789126851078,1.0403981837109075 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441057,1833.527017404792,2003.7789126851078,0.9150345907911694 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441067,2081.515869899161,2003.7789126851078,1.0387951768141346 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441068,581.2629579333883,700.7857837159185,0.8294445627182103 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441062,320.3306901501277,700.7857837159185,0.45710215246030445 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441056,209.7153776102631,700.7857837159185,0.2992574656669642 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441070,751.4778134097619,700.7857837159185,1.0723359846500435 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441057,999.4465340213673,700.7857837159185,1.4261798073611016 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441067,712.5791550721515,700.7857837159185,1.016828782247406 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441068,6055.498984352971,4688.560133729121,1.2915476844991713 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441062,6692.917484463182,4688.560133729121,1.4274995507287784 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441056,2930.676604901254,4688.560133729121,0.625069642131324 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441070,4281.027142834911,4688.560133729121,0.9130792867596064 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441057,2738.6198036094215,4688.560133729121,0.5841067887576002 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441067,3846.814933307875,4688.560133729121,0.8204682938018009 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441068,371.994661237156,384.65137963543384,0.967095611589191 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441062,331.7978557718737,384.65137963543384,0.8625936974055473 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441056,271.40562899327955,384.65137963543384,0.7055886014253043 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441070,250.95368847379427,384.65137963543384,0.6524185321046918 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441057,369.0417028770683,384.65137963543384,0.9594186383182607 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441067,295.8364015149828,384.65137963543384,0.7691026658876711 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441068,422.9358743800212,772.5530415852671,0.5474522157238073 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441062,304.76304335385134,772.5530415852671,0.39448818003289743 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441056,426.5967464111686,772.5530415852671,0.552190883276828 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441070,213.72191630973757,772.5530415852671,0.2766436798581278 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441057,652.62,772.5530415852671,0.8447575310309227 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441067,2088.304696819597,772.5530415852671,2.7031214485084774 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441068,179.02432315393384,216.68366112664066,0.8262013029644314 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441062,200.79834157871835,216.68366112664066,0.9266888907759495 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441056,189.83253540217643,216.68366112664066,0.8760814470973375 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441070,124.52175537697984,216.68366112664066,0.5746707191928199 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441057,216.8440593497949,216.68366112664066,1.0007402414299271 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441067,105.13468728284704,216.68366112664066,0.4851989611777933 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441068,1385.8668729557096,615.8359185894908,2.2503833101029507 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441062,994.75,615.8359185894908,1.6152841527632444 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441056,958.734373273692,615.8359185894908,1.5568016485130893 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441070,1214.6102306028422,615.8359185894908,1.9722952071142306 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441057,957.85546519259,615.8359185894908,1.5553744695282796 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441067,1007.6060120830366,615.8359185894908,1.6361598628265386 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441068,42.60237784430122,101.73138829665541,0.41877318846834066 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441062,42.96428570815936,101.73138829665541,0.4223306732320676 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441056,78.3795277585663,101.73138829665541,0.7704556978029873 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441070,53.758698454083095,101.73138829665541,0.5284376764555616 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441057,74.9389140684546,101.73138829665541,0.7366351263184161 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441067,13.50476191275919,101.73138829665541,0.13274921475934662 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441068,130.73486648978255,93.53234569214308,1.3977503239370224 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441062,67.13233189570333,93.53234569214308,0.7177445556285519 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441056,139.54700453436834,93.53234569214308,1.4919651966569956 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441070,149.44286807789,93.53234569214308,1.5977667081051676 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441057,239.23282629058843,93.53234569214308,2.5577550153399446 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441067,257.3418621086206,93.53234569214308,2.7513675638548416 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441068,37.11268471448466,42.30806113801961,0.8772012641613068 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441062,34.082654035839816,42.30806113801961,0.8055829815659377 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441056,20.673246172694473,42.30806113801961,0.48863610424625953 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441070,19.497504799020277,42.30806113801961,0.4608460958637286 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441057,14.703810306140324,42.30806113801961,0.3475415774353916 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441067,116.83065224943245,42.30806113801961,2.761427706845305 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441068,205.97949980017964,205.3077634331321,1.0032718507854494 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441062,233.7545179719968,205.3077634331321,1.1385566432714547 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441056,273.33588725429,205.3077634331321,1.3313470600604658 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441070,185.60282364606792,205.3077634331321,0.9040224321888247 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441057,278.5054567803321,205.3077634331321,1.3565266706099997 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441067,222.1428520498557,205.3077634331321,1.0819992792050785 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441068,1474.6845339082367,761.179367641068,1.9373679800049706 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441062,1279.9005848426432,761.179367641068,1.6814704119071404 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441056,906.0462090339198,761.179367641068,1.1903189281677473 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441070,4171.168378646528,761.179367641068,5.479875776944904 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441057,896.0153338922828,761.179367641068,1.1771408579676537 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441067,1932.1329676407036,761.179367641068,2.5383412238674805 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441068,569796.0748477469,258075.7105503754,2.207864016464753 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441062,476836.4168843501,258075.7105503754,1.8476609668823267 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441056,309316.9105839787,258075.7105503754,1.19855103730733 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441070,502401.03754542035,258075.7105503754,1.9467195749417634 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441057,427783.6170687255,258075.7105503754,1.6575896125847294 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441067,341717.0020618181,258075.7105503754,1.3240959458488684 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441068,99.27326605811449,131.47736122215045,0.7550597694942905 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441062,135.04617668839205,131.47736122215045,1.0271439541611393 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441056,110.39754515152774,131.47736122215045,0.8396696140333602 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441070,107.1213514745264,131.47736122215045,0.8147513037893196 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441057,139.79225153031055,131.47736122215045,1.063241992620394 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441067,132.07114854396931,131.47736122215045,1.0045162704537063 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441068,4378.216760949403,3004.2024881525895,1.4573640685724059 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441062,4227.204108104317,3004.2024881525895,1.4070969333041872 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441056,4356.0200866025325,3004.2024881525895,1.449975527209297 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441070,5761.753031480749,3004.2024881525895,1.9178976963779473 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441057,2955.0551685051623,3004.2024881525895,0.9836404770180289 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441067,3588.010629249994,3004.2024881525895,1.1943304898387235 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441068,65.92400976124729,96.13121274223809,0.6857711234540749 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441062,101.97643075875004,96.13121274223809,1.060804580008629 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441056,122.606491681149,96.13121274223809,1.2754077284960559 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441070,72.72817335232352,96.13121274223809,0.7565510855182237 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441057,162.60505489985638,96.13121274223809,1.691490726699332 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441067,49.0401934018758,96.13121274223809,0.5101380914996877 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441068,747.4656441320063,490.807523353751,1.5229302905230087 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441062,745.9408198997555,490.807523353751,1.51982352430673 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441056,584.8501491306116,490.807523353751,1.1916079548541865 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441070,598.7543512037169,490.807523353751,1.219937190677827 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441057,647.9786135487759,490.807523353751,1.3202295863784945 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441067,991.557315134961,490.807523353751,2.020256960120583 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441068,76.96983622659643,78.64120835950264,0.9787468660798591 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441062,69.52437649426969,78.64120835950264,0.8840705521263609 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441056,66.71392521729037,78.64120835950264,0.8483329110650544 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441070,67.56088176005015,78.64120835950264,0.8591027931717482 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441057,56.72778637459481,78.64120835950264,0.7213493734133357 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441067,81.05651285259032,78.64120835950264,1.0307129626244587 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441068,1699.368567220047,1710.8868039225827,0.9932676804355919 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441062,1933.773824617821,1710.8868039225827,1.1302757261229797 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441056,1713.2684460128792,1710.8868039225827,1.0013920512361403 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441070,1827.8483976356545,1710.8868039225827,1.0683631397734272 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441057,1615.9798940509045,1710.8868039225827,0.9445276510087731 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441067,1660.112031192284,1710.8868039225827,0.9703225411442262 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441068,106.38655663105396,158.21676846284709,0.6724101222939335 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441062,106.87800603478829,158.21676846284709,0.6755163000303959 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441056,93.84656311114668,158.21676846284709,0.593151813318599 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441070,115.70329743352532,158.21676846284709,0.7312960475532345 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441057,160.3190785206298,158.21676846284709,1.0132875300020832 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441067,110.5771343943816,158.21676846284709,0.6988964284171159 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441068,864.6979382643563,1068.4447009417866,0.8093052803782577 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441062,1056.5708432776198,1068.4447009417866,0.9888867831402969 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441056,770.474551828078,1068.4447009417866,0.7211178558412419 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441070,822.0928176426978,1068.4447009417866,0.7694294491030369 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441057,886.6174542518465,1068.4447009417866,0.8298206294348529 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441067,1160.2252669012855,1068.4447009417866,1.0859010914449747 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441068,122.03889121723888,101.193417409009,1.205996341876424 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441062,103.80314057979288,101.193417409009,1.0257894558520122 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441056,115.44827716633674,101.193417409009,1.140867460772786 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441070,126.38941043448082,101.193417409009,1.2489884586428512 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441057,141.6369232711379,101.193417409009,1.3996653823702996 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441067,121.29822526521724,101.193417409009,1.1986770322712548 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441068,7128.171906173322,8195.704907369402,0.8697448220425583 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441062,8540.069332349394,8195.704907369402,1.0420176700933128 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441056,8113.410367257944,8195.704907369402,0.9899588209871417 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441070,7843.157256168479,8195.704907369402,0.9569838524952358 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441057,7943.904765291978,8195.704907369402,0.9692765729216275 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441067,8266.71853556472,8195.704907369402,1.008664737078499 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441068,28.26206724702035,54.484574340672744,0.5187168586526465 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441062,8.345720799074797,54.484574340672744,0.15317584655965122 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441056,28.137512507531927,54.484574340672744,0.516430803544468 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441070,43.35245293509629,54.484574340672744,0.7956830618521263 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441057,53.176094499311304,54.484574340672744,0.9759843982045271 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441067,89.46020682118855,54.484574340672744,1.6419364178533462 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441068,132.4333439838511,181.8259570369428,0.7283522448719669 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441062,159.4959152056438,181.8259570369428,0.8771900217373141 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441056,209.6703439021581,181.8259570369428,1.153137579028708 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441070,250.94797353922857,181.8259570369428,1.3801548339340888 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441057,94.74314293563104,181.8259570369428,0.5210650034768217 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441067,67.95869691886365,181.8259570369428,0.37375684982676055 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441068,721.0516226917172,598.5025834222519,1.2047594156882784 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441062,575.7008946320178,598.5025834222519,0.9619021046494847 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441056,529.3350589151324,598.5025834222519,0.8844323710156473 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441070,676.5139402259284,598.5025834222519,1.130344227350876 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441057,819.6262561809797,598.5025834222519,1.3694615176000369 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441067,684.005215108997,598.5025834222519,1.1428609233361018 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441068,14576.430531117889,15066.853658787537,0.9674501963863161 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441062,17140.00919099107,15066.853658787537,1.1375971107938911 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441056,14089.894658010033,15066.853658787537,0.9351583931919518 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441070,15377.335383426049,15066.853658787537,1.0206069383608454 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441057,15326.815474739324,15066.853658787537,1.0172538886909654 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441067,15941.968728413583,15066.853658787537,1.0580821377471632 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441068,59.81301150738314,62.8704966822211,0.9513685220224675 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441062,59.54480650348683,62.8704966822211,0.9471025305312288 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441056,60.05485829255941,62.8704966822211,0.9552152672835824 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441070,67.2441357016405,62.8704966822211,1.0695658416940137 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441057,62.79823899307768,62.8704966822211,0.9988506900222429 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441067,63.51792368706426,62.8704966822211,1.0102977873407868 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441068,97.36685190671317,100.49015468400951,0.9689193156571652 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441062,116.85182467014384,100.49015468400951,1.1628186366871807 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441056,96.60844473926116,100.49015468400951,0.9613722363453976 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441070,99.10360522500054,100.49015468400951,0.9862021362852016 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441057,98.21854484061222,100.49015468400951,0.9773947024906038 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441067,97.25102560707312,100.49015468400951,0.9677667022493716 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441068,102.62673910729598,109.95671552102958,0.93333761945325 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441062,96.32978317136056,109.95671552102958,0.8760700309653864 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441056,94.56324406402094,109.95671552102958,0.8600042627313237 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441070,111.06818973553423,109.95671552102958,1.010108288604638 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441057,105.890892359808,109.95671552102958,0.9630234211529902 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441067,124.2147119129192,109.95671552102958,1.1296691732226463 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441068,241.103776891116,243.54938966397899,0.9899584524673326 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441062,281.0862264422411,243.54938966397899,1.1541241258294717 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441056,239.88372915055737,243.54938966397899,0.9849490055447108 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441070,244.648413398202,243.54938966397899,1.004512529207071 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441057,240.1499359628935,243.54938966397899,0.9860420356389492 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441067,234.4875081301248,243.54938966397899,0.9627924276617703 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441068,34.57193413423597,49.66723175069083,0.6960712911839525 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441062,41.21318169193419,49.66723175069083,0.8297861636180468 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441056,25.28178676635839,49.66723175069083,0.5090234723220052 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441070,170.70802577898365,49.66723175069083,3.4370352395693815 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441057,17.969569408372195,49.66723175069083,0.3617992945242464 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441067,58.48770875415065,49.66723175069083,1.1775914761614863 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441068,283.78451674216706,318.9289567276793,0.8898048005859792 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441062,321.8945573508688,318.9289567276793,1.0092986245388866 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441056,277.68784400991893,318.9289567276793,0.8706887165690179 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441070,357.476496827909,318.9289567276793,1.1208656012164613 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441057,437.1101444269232,318.9289567276793,1.3705564678473336 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441067,448.28259589859186,318.9289567276793,1.405587628348725 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441068,46.21088694064088,52.85511393128503,0.8742935830337617 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441062,45.08241580720487,52.85511393128503,0.8529433096259113 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441056,45.29286521130325,52.85511393128503,0.8569249376737097 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441070,47.93021078761314,52.85511393128503,0.9068225801182724 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441057,52.528191885199135,52.85511393128503,0.9938147508959887 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441067,69.58736260179046,52.85511393128503,1.3165682074256504 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441068,130.34808216931185,145.91831693350866,0.8932948577573591 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441062,154.88272282289708,145.91831693350866,1.0614344112362073 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441056,138.56409119755648,145.91831693350866,0.9496003936277354 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441070,149.8778655262318,145.91831693350866,1.0271353773531215 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441057,133.27470852498286,145.91831693350866,0.9133514648864324 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441067,142.38749652844473,145.91831693350866,0.9758027608920897 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441068,171.17582218581236,261.347965154705,0.6549728523215583 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441062,157.13571425892343,261.347965154705,0.6012509573813093 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441056,106.493414086326,261.347965154705,0.40747749470055067 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441070,226.01301854133243,261.347965154705,0.864797314980218 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441057,283.61772717780315,261.347965154705,1.0852111552118477 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441067,220.03632854508845,261.347965154705,0.8419286081482896 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441068,7508.068982253412,7540.877985370558,0.9956491799521493 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441062,7008.054064307299,7540.877985370558,0.9293419251581915 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441056,7724.611139033875,7540.877985370558,1.0243649551179268 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441070,7374.759731939514,7540.877985370558,0.977970966543509 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441057,6347.029212838835,7540.877985370558,0.8416830540359077 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441067,6819.213764501599,7540.877985370558,0.9042997085658989 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441068,6055.397443634302,5107.556668860965,1.1855761641475266 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441062,6845.942213357877,5107.556668860965,1.3403556058604806 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441056,3923.2079728663057,5107.556668860965,0.7681183444884263 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441070,5217.260274140164,5107.556668860965,1.0214786858749947 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441057,7131.945828991861,5107.556668860965,1.3963517766670916 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441067,6079.4454062139985,5107.556668860965,1.1902844746252759 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441068,255790.1987010689,180330.65339424144,1.4184510169874267 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441062,116937.7044330516,180330.65339424144,0.6484627113139813 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441056,274615.07829962217,180330.65339424144,1.5228419191675349 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441070,336887.0252726395,180330.65339424144,1.8681628382731599 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441057,352050.9788154357,180330.65339424144,1.9522525548985665 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441067,426013.60384896066,180330.65339424144,2.3624025967321467 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441068,109.073470957273,98.01831453553807,1.1127866406815914 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441062,167.73377838380176,98.01831453553807,1.7112493637399495 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441056,110.42557713883735,98.01831453553807,1.1265810645907488 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441070,174.98743333705542,98.01831453553807,1.7852524211035175 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441057,161.58318480605266,98.01831453553807,1.64849993158644 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441067,103.6749578692647,98.01831453553807,1.0577100653131077 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441068,1778.6781993076684,1812.4793707702274,0.9813508655559511 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441062,1526.6213879588513,1812.4793707702274,0.842283455789128 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441056,3874.142458937607,1812.4793707702274,2.1374822364412673 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441070,2238.93609568105,1812.4793707702274,1.235289146893626 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441057,3161.4287929184534,1812.4793707702274,1.7442564279090136 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441067,3825.4784427091727,1812.4793707702274,2.110632818448855 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441068,209.90510243620892,434.5650550234931,0.48302342770028117 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441062,192.5742880330716,434.5650550234931,0.44314259926551347 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441056,122.1217811256774,434.5650550234931,0.28102071189105476 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441070,336.3545553189584,434.5650550234931,0.7740027676656482 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441057,458.4620437523528,434.5650550234931,1.054990589907345 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441067,464.1386606399293,434.5650550234931,1.0680533450045528 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441068,12171.40538642915,9833.502392298877,1.237748759380097 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441062,10272.20832479845,9833.502392298877,1.044613395614074 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441056,6995.755688143969,9833.502392298877,0.7114205507920256 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441070,10839.64428059898,9833.502392298877,1.1023177549728431 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441057,10271.606719231862,9833.502392298877,1.0445522164387826 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441067,9735.035764291391,9833.502392298877,0.9899866167638705 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441068,42.65821773365968,42.4088060383901,1.0058811298541113 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441062,39.094190992034115,42.4088060383901,0.9218413495688734 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441056,39.02300532880638,42.4088060383901,0.9201627910364003 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441070,48.165347459423494,42.4088060383901,1.1357392947073859 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441057,34.81247895891605,42.4088060383901,0.8208785441260111 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441067,55.36006483834815,42.4088060383901,1.3053907904937025 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441068,361.6397191164906,385.8715169071063,0.9372024191242672 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441062,430.0606871737265,385.8715169071063,1.1145178338655615 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441056,366.9396267961648,385.8715169071063,0.9509373216694326 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441070,415.44545405224,385.8715169071063,1.0766419283345374 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441057,422.6763356226028,385.8715169071063,1.0953810195955893 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441067,443.362124628142,385.8715169071063,1.1489889903816763 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441068,1139.072551737131,1002.6445024002205,1.1360682166114877 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441062,1073.5039421824713,1002.6445024002205,1.0706725460645534 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441056,990.20062814777,1002.6445024002205,0.9875889468075063 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441070,632.6560674699379,1002.6445024002205,0.6309874197239689 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441057,1336.6833370045351,1002.6445024002205,1.3331577980078306 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441067,1091.5343535166194,1002.6445024002205,1.088655401693827 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441068,10949.639655152818,6245.085755978491,1.753320944339412 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441062,10358.880507719548,6245.085755978491,1.6587251020216778 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441056,10532.431111910828,6245.085755978491,1.6865150493454815 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441070,9267.22260038092,6245.085755978491,1.4839223931407672 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441057,8222.495058211358,6245.085755978491,1.3166344513908188 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441067,10561.00153903242,6245.085755978491,1.6910899148057743 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441068,308.83586645532864,289.8012081128336,1.0656817770583067 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441062,385.10415237858103,289.8012081128336,1.3288562697386734 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441056,353.246862665202,289.8012081128336,1.2189281920718078 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441070,386.1820365287905,289.8012081128336,1.3325756612388973 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441057,449.87501292064616,289.8012081128336,1.5523572722494936 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441067,314.007514180651,289.8012081128336,1.0835272779759868 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441068,19081.94773125957,19122.271903916942,0.9978912457233121 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441062,26070.91988252172,19122.271903916942,1.363379833396336 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441056,16303.308682926014,19122.271903916942,0.8525822017825454 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441070,14376.495407854514,19122.271903916942,0.7518194218810204 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441057,16257.55098320426,19122.271903916942,0.8501893009833271 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441067,17641.276326380084,19122.271903916942,0.922551275027446 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441068,92.00311271172058,111.01681566749893,0.8287313246965633 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441062,93.96747152760248,111.01681566749893,0.8464255704202496 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441056,98.514475952895,111.01681566749893,0.8873833694523442 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441070,60.67679500742861,111.01681566749893,0.5465549938773125 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441057,149.0203545978193,111.01681566749893,1.3423223653265548 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441067,102.20463749271802,111.01681566749893,0.920623032449662 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441068,1160.3730100241842,1048.3386659324408,1.1068684650604725 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441062,1525.1649026628595,1048.3386659324408,1.454839883546895 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441056,845.1421458796436,1048.3386659324408,0.8061728269155609 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441070,823.2461415365749,1048.3386659324408,0.7852864425298496 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441057,844.8880589379601,1048.3386659324408,0.8059304558670243 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441067,1087.2270049142155,1048.3386659324408,1.037095206201505 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441068,2522.9536644295276,5453.602601951663,0.4626214721854956 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441062,2611.1494964760745,5453.602601951663,0.4787935034983354 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441056,1695.70385217605,5453.602601951663,0.31093278625934606 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441070,4911.848288699244,5453.602601951663,0.9006612045662178 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441057,4571.0483609647845,5453.602601951663,0.8381704158878314 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441067,3227.0350094788732,5453.602601951663,0.5917253685341914 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441068,139252.11381947188,64173.361133824874,2.1699364246962287 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441062,91628.96783824764,64173.361133824874,1.4278349492582727 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441056,67048.1951588604,64173.361133824874,1.044797934442618 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441070,128934.19446964444,64173.361133824874,2.009154455861671 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441057,57912.41154760027,64173.361133824874,0.9024369383868138 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441067,65051.924051049886,64173.361133824874,1.0136904613020485 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441068,34.44812154668205,44.60879663763593,0.772227097415548 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441062,47.793794683486375,44.60879663763593,1.0713984300388704 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441056,41.740990081056474,44.60879663763593,0.9357120843255403 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441070,52.51872258173661,44.60879663763593,1.1773176265738396 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441057,17.78066096985158,44.60879663763593,0.39859091278087155 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441067,29.87632413618916,44.60879663763593,0.6697406428350692 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441068,131.82387921851745,136.29080299882398,0.9672250534737471 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441062,155.79652522262393,136.29080299882398,1.1431184041374256 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441056,130.7461754561747,136.29080299882398,0.9593176691262351 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441070,133.1060218984641,136.29080299882398,0.9766324577279997 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441057,131.5013849227826,136.29080299882398,0.9648588314790199 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441067,130.7561493179169,136.29080299882398,0.9593908498656741 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441068,105.29630422832562,82.77341642135346,1.2721029139635927 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441062,81.31519848455932,82.77341642135346,0.982383016192407 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441056,86.31942890283838,82.77341642135346,1.0428399918088935 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441070,126.46745497655084,82.77341642135346,1.5278752580753139 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441057,57.27275611646621,82.77341642135346,0.6919221000245108 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441067,56.880961879217594,82.77341642135346,0.6871887658915542 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441068,1600.5598594121152,2141.365658987758,0.7474481776123718 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441062,2259.533972958806,2141.365658987758,1.0551836224117404 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441056,3142.5472501753743,2141.365658987758,1.467543498227614 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441070,1885.743464547004,2141.365658987758,0.8806265555964932 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441057,2313.771832623351,2141.365658987758,1.0805122529690194 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441067,2701.4248937361463,2141.365658987758,1.2615430169049846 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441068,386.0397561022097,285.0677067828484,1.3542037449940874 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441062,455.8535707056623,285.0677067828484,1.599106317057901 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441056,424.3692308998695,285.0677067828484,1.4886611875091647 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441070,649.4782442669364,285.0677067828484,2.2783297750442117 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441057,367.3274018542001,285.0677067828484,1.2885619560338815 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441067,550.663185608357,285.0677067828484,1.9316926207563285 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441068,936392.9705166396,724296.655045942,1.2928307261853147 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441062,1179760.536544111,724296.655045942,1.6288360968190292 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441056,945875.8407469672,724296.655045942,1.3059232486542003 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441070,840856.3415314427,724296.655045942,1.160928102695859 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441057,915515.3071558028,724296.655045942,1.2640059853620778 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441067,1020450.8396322116,724296.655045942,1.4088852026625533 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441068,169.4554975378723,126.94877083842833,1.33483370038725 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441062,196.7390620617968,126.94877083842833,1.5497516105310918 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441056,193.84935575876432,126.94877083842833,1.5269888355633034 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441070,67.32925130588812,126.94877083842833,0.5303655235195633 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441057,177.58270624364332,126.94877083842833,1.3988532938980431 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441067,89.63564597177647,126.94877083842833,0.706077304882759 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441068,144968.3801185081,94593.87687362579,1.5325345033926554 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441062,189508.02897300196,94593.87687362579,2.0033857923613625 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441056,155231.1022278391,94593.87687362579,1.6410269602885879 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441070,68789.98102921774,94593.87687362579,0.7272138884963857 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441057,220812.62984867132,94593.87687362579,2.3343226554047414 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441067,338346.18297753145,94593.87687362579,3.5768296443706444 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441068,4.849162141834709,34.2642969985689,0.14152230066290988 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441062,20.592140883850984,34.2642969985689,0.6009795235171772 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441056,18.727646355283913,34.2642969985689,0.5465644415837891 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441070,32.239559706960534,34.2642969985689,0.9409082494325527 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441057,218.0501004856882,34.2642969985689,6.363769859185944 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441067,11.16405699652077,34.2642969985689,0.32582186049190076 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441068,126.04682233907177,74.66086218948179,1.688258327625223 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441062,152.46972242007186,74.66086218948179,2.042163965815436 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441056,403.0213061037942,74.66086218948179,5.398026412834163 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441070,135.07643152947713,74.66086218948179,1.809199995396071 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441057,65.65872484574744,74.66086218948179,0.8794262873513592 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441067,148.8187045472992,74.66086218948179,1.9932626034991698 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441068,406.5467315354916,347.6986105145094,1.1692503773135625 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441062,353.1128291472898,347.6986105145094,1.0155715854738927 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441056,358.22490263593875,347.6986105145094,1.0302741851796675 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441070,115.89567085837332,347.6986105145094,0.3333222145664485 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441057,959.7212596489134,347.6986105145094,2.7602102241040285 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441067,375.6913868286682,347.6986105145094,1.080508737934662 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441068,2897.7678517038125,2521.321340016667,1.1493052494786948 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441062,2899.489822917822,2521.321340016667,1.1499882132829031 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441056,2545.148223295274,2521.321340016667,1.009450157304602 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441070,3077.921821876823,2521.321340016667,1.2207574548417048 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441057,2767.2751051122145,2521.321340016667,1.0975495511785585 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441067,2887.6404013385854,2521.321340016667,1.1452885261025463 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441068,41.39236058942999,79.44971561377609,0.5209881529425237 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441062,67.86768090524531,79.44971561377609,0.8542218229598982 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441056,65.17294151047096,79.44971561377609,0.8203042768245022 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441070,41.75292185280386,79.44971561377609,0.525526385214199 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441057,65.81836711492618,79.44971561377609,0.8284279761916942 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441067,54.47987441412262,79.44971561377609,0.6857151594973884 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441068,72.87417400852495,42.37178439720435,1.719875031114647 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441062,15.383504546733484,42.37178439720435,0.3630601062849851 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441056,57.59671871278364,42.37178439720435,1.3593177519468314 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441070,73.19097754476138,42.37178439720435,1.727351788129802 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441057,189.82251976537344,42.37178439720435,4.479927443836841 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441067,192.8283270774482,42.37178439720435,4.550866332883795 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441068,683.4462988536288,1321.2949146990686,0.5172549226145224 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441062,575.5431799324564,1321.2949146990686,0.43559024827060594 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441056,441.91990296732735,1321.2949146990686,0.334459701654098 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441070,790.9052473586253,1321.2949146990686,0.5985834339934305 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441057,1351.908725156852,1321.2949146990686,1.0231695514129453 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441067,922.7084568944748,1321.2949146990686,0.6983364929582175 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441068,11821.620615580936,23354.026662177774,0.506191963663647 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441062,12279.248145818052,23354.026662177774,0.5257871939362172 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441056,20032.827570637688,23354.026662177774,0.8577890168756713 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441070,21774.31331278607,23354.026662177774,0.9323579881001817 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441057,14243.634031696893,23354.026662177774,0.6099005639470597 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441067,16580.082341818994,23354.026662177774,0.7099453375494645 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441068,10266.316378584475,13473.54115415771,0.7619612588199548 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441062,13789.386186629808,13473.54115415771,1.0234418723970449 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441056,9261.696340360571,13473.54115415771,0.6873988236939897 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441070,17104.858971359743,13473.54115415771,1.2695147308086463 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441057,17609.813163575953,13473.54115415771,1.3069921976778804 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441067,15875.507590754216,13473.54115415771,1.178272839271753 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441068,75127.38899609218,49612.48263442616,1.514284006903561 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441062,75002.04962647059,49612.48263442616,1.511757639284646 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441056,79859.77113021733,49612.48263442616,1.6096709313797277 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441070,75626.65657161394,49612.48263442616,1.5243473528401201 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441057,85855.63992641387,49612.48263442616,1.73052496806194 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441067,118853.66659350702,49612.48263442616,2.395640376823923 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441074,31.121229328935076,73.06854961986588,0.425918257456062 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441076,76.87070696210736,73.06854961986588,1.0520354839670685 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441058,217.63596840303833,73.06854961986588,2.978517700642404 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441069,41.16324734500644,73.06854961986588,0.5633510937216547 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441064,154.4377655130302,73.06854961986588,2.1136010816757973 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441063,63.32420453318565,73.06854961986588,0.8666410495709232 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441074,40.680846984904605,990.9231863649335,0.04105348178816639 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441076,112.44832979190966,990.9231863649335,0.11347835164137295 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441058,34.395342409672296,990.9231863649335,0.034710402262204516 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441069,35.93476030857261,990.9231863649335,0.03626392116264267 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441064,956.816579485988,990.9231863649335,0.9655809780735266 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441063,28.976500972230095,990.9231863649335,0.029241924470983907 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441074,56.28167279224787,50.719124328797626,1.1096735903283705 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441076,54.0428489218289,50.719124328797626,1.06553197905162 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441058,55.479365664345515,50.719124328797626,1.093854959022727 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441069,42.24780594704289,50.719124328797626,0.8329758548898125 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441064,48.298763243283226,50.719124328797626,0.9522791231602523 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441063,59.79431221043015,50.719124328797626,1.178930295065835 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441074,385.9363680598695,319.2477137201226,1.208893130549437 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441076,359.57734803128477,319.2477137201226,1.1263270888966124 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441058,355.3117178963225,319.2477137201226,1.1129655832330139 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441069,309.17786558432937,319.2477137201226,0.9684575716503917 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441064,360.527458466553,319.2477137201226,1.1293031804845421 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441063,318.29296540009096,319.2477137201226,0.9970093808694629 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441074,142.02526604386776,44.58166891160943,3.1857323763598098 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441076,155.85419316545216,44.58166891160943,3.495925499659042 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441058,12.998307489689012,44.58166891160943,0.29156170702044193 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441069,12.155056278308695,44.58166891160943,0.2726469550166037 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441064,118.26326090388672,44.58166891160943,2.6527329234435637 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441063,18.010320418345778,44.58166891160943,0.4039848856724999 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441074,3280.0251164432807,1543.2839395802719,2.12535427365061 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441076,3465.363894229833,1543.2839395802719,2.245448038014515 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441058,3426.31027922009,1543.2839395802719,2.220142509972563 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441069,4165.871840993144,1543.2839395802719,2.6993554032099496 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441064,3287.982824841465,1543.2839395802719,2.130510621224828 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441063,2539.822866107473,1543.2839395802719,1.645726234148611 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441074,39.604961860878745,31.276034215973343,1.2663038282728198 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441076,42.6113270040815,31.276034215973343,1.3624274327695607 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441058,30.804849124516945,31.276034215973343,0.9849346279581779 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441069,26.36697745088086,31.276034215973343,0.8430409453067639 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441064,43.41516581656987,31.276034215973343,1.3881288630384223 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441063,36.36004896688075,31.276034215973343,1.1625530499103651 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441074,39.98268655563759,130.468422036268,0.3064548948443868 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441076,61.33124220621188,130.468422036268,0.4700849542670397 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441058,1498.173022844402,130.468422036268,11.48303167511243 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441069,81.7275823748854,130.468422036268,0.6264165772784966 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441064,43.692713597855,130.468422036268,0.3348911017388496 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441063,72.39339656571428,130.468422036268,0.5548729373425713 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441074,102.02899156218132,95.42663227533711,1.0691878056410316 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441076,96.4182345706629,95.42663227533711,1.010391253172015 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441058,127.01482869605312,95.42663227533711,1.3310207608456066 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441069,82.08667719828726,95.42663227533711,0.8602072109329008 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441064,136.6148266133639,95.42663227533711,1.4316215856720726 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441063,119.04065982553448,95.42663227533711,1.2474574129585037 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441074,532.8951482196476,569.3868516791151,0.9359105266448392 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441076,517.2302610710738,569.3868516791151,0.908398674022359 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441058,575.2505595226215,569.3868516791151,1.0102982845954633 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441069,531.129198596117,569.3868516791151,0.9328090331377047 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441064,617.4539940842354,569.3868516791151,1.0844191295660777 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441063,538.7345446230337,569.3868516791151,0.9461661136612337 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441074,27298.30258570796,5328.634617598269,5.12294509658309 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441076,26596.420680462634,5328.634617598269,4.991226193784369 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441058,270.09840976903683,5328.634617598269,0.05068810852164903 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441069,84.76818302044722,5328.634617598269,0.015908049454262278 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441064,62350.8274134636,5328.634617598269,11.701088907005312 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441063,678.9926206027126,5328.634617598269,0.12742337753094982 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441074,528531.7723327196,656386.6079991342,0.8052141312630449 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441076,466984.7904652373,656386.6079991342,0.7114477729653089 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441058,812759.73,656386.6079991342,1.2382332608484177 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441069,449377.0912672224,656386.6079991342,0.6846225772903264 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441064,1080040.414568439,656386.6079991342,1.6454333488928579 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441063,776395.1713898901,656386.6079991342,1.1828321326612352 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441074,26761.433571847618,5223.837669019135,5.12294509658309 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441076,26073.355405685794,5223.837669019135,4.99122619378437 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441058,264.7864506667201,5223.837669019135,0.05068810852164904 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441069,83.1010679797946,5223.837669019135,0.01590804945426228 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441064,61124.58900095629,5223.837669019135,11.701088907005312 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441063,13143.087763041316,5223.837669019135,2.515983190095789 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441074,528531.7723327196,656386.6079991342,0.8052141312630449 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441076,466984.7904652373,656386.6079991342,0.7114477729653089 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441058,812759.73,656386.6079991342,1.2382332608484177 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441069,449377.0912672224,656386.6079991342,0.6846225772903264 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441064,1080040.414568439,656386.6079991342,1.6454333488928579 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441063,776395.1713898901,656386.6079991342,1.1828321326612352 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441074,49.56533644166007,50.79723336807032,0.9757487397495828 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441076,53.64529517100984,50.79723336807032,1.0560672622129403 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441058,33.777251817891596,50.79723336807032,0.6649427454669805 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441069,40.7762953387901,50.79723336807032,0.802726696616137 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441064,60.763082272098906,50.79723336807032,1.1961888127216949 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441063,35.16883361533281,50.79723336807032,0.6923375798934539 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441074,49.904648545205745,124.85055234194422,0.3997150802226768 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441076,93.82619301188166,124.85055234194422,0.751508033019412 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441058,104.49057623851878,124.85055234194422,0.8369252220233439 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441069,136.79376660156066,124.85055234194422,1.0956600834804961 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441064,87.91533492901549,124.85055234194422,0.7041645653935954 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441063,99.80264192376198,124.85055234194422,0.7993768553816221 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441074,265.60660662477835,149.81706398084205,1.7728728595211487 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441076,285.08418442838627,149.81706398084205,1.9028819338285896 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441058,267.8739254447594,149.81706398084205,1.7880067752429984 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441069,208.8976440596651,149.81706398084205,1.3943514744513885 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441064,235.0639325346117,149.81706398084205,1.5690064021323409 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441063,176.5348881368856,149.81706398084205,1.178336321952352 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441074,3362.485060235401,2791.14294318225,1.2046982647193805 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441076,3543.5007902359516,2791.14294318225,1.2695518869398785 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441058,3865.5551087191384,2791.14294318225,1.3849362742819344 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441069,3446.1817747682644,2791.14294318225,1.2346848029356707 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441064,3444.298540625756,2791.14294318225,1.2340100850223126 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441063,3432.5539393589347,2791.14294318225,1.2298022742774315 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441074,989.7138333414376,222.01180748199775,4.457933317000225 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441076,1131.6374738023433,222.01180748199775,5.097194994433367 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441058,354.20858271284345,222.01180748199775,1.5954492994322615 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441069,881.539855022312,222.01180748199775,3.970689059381643 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441064,618.6639627440912,222.01180748199775,2.7866263950589962 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441063,832.945154800237,222.01180748199775,3.751805655056333 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441074,15907.05211978756,4330.453784028004,3.673299130557052 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441076,14401.282340732949,4330.453784028004,3.325582735428131 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441058,17458.772540391532,4330.453784028004,4.031626571050049 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441069,18838.32780035094,4330.453784028004,4.350197170982929 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441064,16065.389462947234,4330.453784028004,3.7098628144240102 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441063,14144.320020260391,4330.453784028004,3.266244307335373 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441074,237.20615442854876,100.4664893584531,2.361047508908408 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441076,242.02953388260457,100.4664893584531,2.4090573426833943 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441058,454.1801203805888,100.4664893584531,4.52071256078358 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441069,150.57678345678082,100.4664893584531,1.498776203073443 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441064,423.1882201067973,100.4664893584531,4.212232584308878 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441063,176.27856488776737,100.4664893584531,1.7546006236848322 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441074,707.4364960603735,219.8603821991507,3.2176624500705806 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441076,279.6999711342125,219.8603821991507,1.2721708583261662 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441058,378.1737181633756,219.8603821991507,1.7200630435583608 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441069,111.15286883989155,219.8603821991507,0.505561155348164 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441064,475.3159053390426,219.8603821991507,2.161898840458209 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441063,69.18054770714012,219.8603821991507,0.31465672448652443 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441074,100.38069222302136,115.26780159034894,0.8708476334073327 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441076,184.8894117363485,115.26780159034894,1.6039987679597492 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441058,38.4014635388468,115.26780159034894,0.3331499604314658 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441069,65.18574285375325,115.26780159034894,0.5655156249567189 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441064,62.97661089521365,115.26780159034894,0.5463504120519855 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441063,117.15322164017478,115.26780159034894,1.0163568665647538 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441074,1347.4502621777328,1760.6737631139824,0.7653037663232911 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441076,717.5327601752726,1760.6737631139824,0.40753305649663446 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441058,807.0594999965609,1760.6737631139824,0.45838105667524137 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441069,877.2134574347716,1760.6737631139824,0.49822600632345687 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441064,1100.5825003044845,1760.6737631139824,0.6250916685201011 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441063,866.0655736167504,1760.6737631139824,0.4918944052900521 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441074,2714.498475174579,518.6000624505415,5.234281041825866 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441076,4324.8803735797355,518.6000624505415,8.339529218610915 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441058,2313.3106548220203,518.6000624505415,4.460683332529754 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441069,2699.687854632363,518.6000624505415,5.205722193467399 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441064,3056.3144868993836,518.6000624505415,5.893393981592245 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441063,4485.089991166299,518.6000624505415,8.648456326775007 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441074,4030.5012807214066,841.89306662726494,4.787426622799174 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441076,3056.810448314098,841.89306662726494,3.630877328114941 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441058,5924.869328348437,841.89306662726494,7.037555674480427 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441069,1146.0793748050278,841.89306662726494,1.3613122856521118 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441064,6346.781370428341,841.89306662726494,7.538702505122636 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441063,2014.7182737049463,841.89306662726494,2.3930809666555093 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441074,611.4384101932039,246.94010350613598,2.4760595849430787 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441076,1204.5583418973513,246.94010350613598,4.877937300562524 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441058,1535.8827552709836,246.94010350613598,6.219657048264013 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441069,619.9696665006511,246.94010350613598,2.5106074618829424 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441064,803.851602012863,246.94010350613598,3.255249311875699 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441063,431.5003529681057,246.94010350613598,1.7473887264220076 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441074,2366.1766542071296,6405.278640912654,0.3694104170728138 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441076,2060.1003307477285,6405.278640912654,0.3216254040205495 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441058,2714.298940263232,6405.278640912654,0.4237596976540721 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441069,2730.9440138903847,6405.278640912654,0.42635834707438536 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441064,2769.542140414893,6405.278640912654,0.4323843341841372 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441063,2067.351642178027,6405.278640912654,0.322757487702902 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441074,68.97586016097357,184.84349394551683,0.3731581712110701 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441076,143.01338183512914,184.84349394551683,0.7736998407814276 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441058,248.94945974362932,184.84349394551683,1.346812129709082 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441069,623.1927580927523,184.84349394551683,3.371461687888459 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441064,242.05139352311232,184.84349394551683,1.3094937146906436 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441063,78.56416008929347,184.84349394551683,0.42503070252746084 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441074,22822.0645981696,66689.05961878091,0.34221602056812434 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441076,17677.749263328173,66689.05961878091,0.26507720103388266 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441058,25726.030124495053,66689.05961878091,0.3857608769947344 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441069,20840.740842467687,66689.05961878091,0.31250614361037615 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441064,25326.91128390638,66689.05961878091,0.3797761046367167 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441063,24677.37395406395,66689.05961878091,0.3700363162283118 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441074,768.4781397887318,426.591426110135,1.8014383148674218 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441076,2114.645790765666,426.591426110135,4.957075227807599 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441058,2321.1534092519623,426.591426110135,5.441162825088519 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441069,1130.5907541957502,426.591426110135,2.6502894455826698 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441064,776.758133005938,426.591426110135,1.82084797176725 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441063,360.5399260479981,426.591426110135,0.8451644922533346 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441074,209935.839056162,6086.038398766024,34.49466225824792 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441076,189812.74,6086.038398766024,31.188225831517183 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441058,137206.27121437347,6086.038398766024,22.544430748611894 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441069,200420.91672552697,6086.038398766024,32.93126063190192 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441064,190540.45803463637,6086.038398766024,31.307797544174125 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441063,133761.87405378997,6086.038398766024,21.978480135930607 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441074,440.0438542027988,118.38689307733607,3.7169980794693274 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441076,527.2379995015372,118.38689307733607,4.453516650336619 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441058,387.3549364940288,118.38689307733607,3.2719410605783 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441069,357.3936034086216,118.38689307733607,3.018861244843673 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441064,398.0089222554954,118.38689307733607,3.361934010680529 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441063,826.293126603326,118.38689307733607,6.9795997270031505 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441074,276.3226450104281,43.003791743375764,6.425541418751578 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441076,308.10001260372417,43.003791743375764,7.164484807346864 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441058,847.6952479515155,43.003791743375764,19.712104760671323 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441069,178.16544561844998,43.003791743375764,4.143017124667717 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441064,554.2642995877729,43.003791743375764,12.88873090297092 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441063,291.06282420670385,43.003791743375764,6.76830605876838 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441074,90.41901089881608,56.77751951238643,1.5925142851492573 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441076,52.92016079616091,56.77751951238643,0.9320618662218237 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441058,8.985332214543776,56.77751951238643,0.15825510328226933 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441069,47.989218184639135,56.77751951238643,0.8452151238162129 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441064,77.75355138239533,56.77751951238643,1.3694425549082472 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441063,35.011973049115525,56.77751951238643,0.6166520367533388 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441074,180.17407879091533,232.93832449773902,0.7734840506791065 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441076,203.615576251968,232.93832449773902,0.8741179738928893 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441058,254.60217264365812,232.93832449773902,1.0930025069624358 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441069,157.08182155362366,232.93832449773902,0.6743494094083619 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441064,254.8795386928784,232.93832449773902,1.0941932343784517 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441063,246.3606348277172,232.93832449773902,1.0576217346755599 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441074,96.63992500046552,55.88566907011774,1.7292434108503716 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441076,91.01302802976826,55.88566907011774,1.6285575451477101 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441058,72.236222541147,55.88566907011774,1.2925714900275205 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441069,115.97674034977416,55.88566907011774,2.0752501004195247 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441064,82.09151073777892,55.88566907011774,1.4689188141378722 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441063,23.65507567057761,55.88566907011774,0.42327623636210626 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441074,1362.7099384356568,226.42114305345407,6.0184747769511295 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441076,1460.633359826227,226.42114305345407,6.450958334228518 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441058,1023.3984855854484,226.42114305345407,4.519889228471221 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441069,689.0108356083042,226.42114305345407,3.0430498950605545 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441064,2219.0317491560895,226.42114305345407,9.800461737940326 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441063,704.2423381015848,226.42114305345407,3.1103205672595933 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441074,568.6772001435268,212.71806341276286,2.6733846247934894 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441076,648.9666223626243,212.71806341276286,3.0508298728883925 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441058,486.6776031696073,212.71806341276286,2.287899745614209 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441069,492.25520406565875,212.71806341276286,2.3141203721400743 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441064,368.2724127473361,212.71806341276286,1.7312700521945432 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441063,355.40370549094223,212.71806341276286,1.6707735101993149 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441074,10274.71275394017,10996.969545575432,0.9343221977071076 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441076,8013.750233007883,10996.969545575432,0.7287235087626637 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441058,9804.40756267362,10996.969545575432,0.8915553982431794 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441069,11451.361800033648,10996.969545575432,1.0413197701944203 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441064,10571.946863822866,10996.969545575432,0.9613509267265753 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441063,8565.66629352545,10996.969545575432,0.7789115226723345 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441074,110.70791822525088,147.8550055811589,0.7487600287193681 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441076,113.6522071313917,147.8550055811589,0.7686733816327037 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441058,79.31055265910135,147.8550055811589,0.5364076268325396 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441069,137.28439532543555,147.8550055811589,0.928506916528294 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441064,30.603405071888908,147.8550055811589,0.20698254314488143 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441063,95.84843889494768,147.8550055811589,0.6482596819648127 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441074,355.4935920463984,92.19915296117537,3.8557142948601175 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441076,259.1417537602078,92.19915296117537,2.8106739100882105 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441058,295.84195635869145,92.19915296117537,3.2087274867185505 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441069,309.8336552781259,92.19915296117537,3.3604826652647817 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441064,123.90834631975189,92.19915296117537,1.3439206580556018 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441063,298.39793827961955,92.19915296117537,3.2364498880512875 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441074,13037.227826868871,1229.7970051816276,10.601121788342146 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441076,15242.291281545627,1229.7970051816276,12.39415221969459 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441058,16385.744008979997,1229.7970051816276,13.323942032660911 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441069,8703.108951173135,1229.7970051816276,7.076866275087229 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441064,12257.737886803116,1229.7970051816276,9.967285523672894 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441063,7778.116906606519,1229.7970051816276,6.324716090406949 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441074,155956.85242447123,50083.06853493704,3.1139636006064317 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441076,182137.48505928295,50083.06853493704,3.636707781437696 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441058,222096.5099830367,50083.06853493704,4.434562747051056 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441069,149739.01431074087,50083.06853493704,2.989813098338526 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441064,164925.94834208136,50083.06853493704,3.2930479933958523 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441063,160472.9726552193,50083.06853493704,3.204136195115047 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441074,161.22693573116217,35.678906774941794,4.518830600616831 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441076,87.09648443514219,35.678906774941794,2.4411197625682934 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441058,8.318560593056533,35.678906774941794,0.23315065804927831 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441069,42.422219288515066,35.678906774941794,1.1889999757029908 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441064,26.431318469282164,35.678906774941794,0.740810771922125 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441063,3.130893824527562,35.678906774941794,0.08775195507745963 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441074,81.11254100891458,67.70693010562654,1.197994664392176 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441076,141.7484633395893,67.70693010562654,2.0935591544093626 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441058,174.00069688236331,67.70693010562654,2.5699097065974286 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441069,243.70904668473125,67.70693010562654,3.59946974858455 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441064,286.2302656465082,67.70693010562654,4.227488459452721 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441063,88.69051809940052,67.70693010562654,1.3099178763686143 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441074,88.21889788616167,64.01321127549492,1.3781357961638927 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441076,74.39250655568566,64.01321127549492,1.1621430181891852 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441058,11.450466718559143,64.01321127549492,0.1788766176606817 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441069,3.914448604970135,64.01321127549492,0.06115063636041387 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441064,21.42458443199856,64.01321127549492,0.33469004296305577 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441063,5.006338209556969,64.01321127549492,0.0782078903683037 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441074,497.36330742895393,1060.427767412219,0.46902139185083636 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441076,534.3415250639861,1060.427767412219,0.5038924304744955 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441058,487.6385186462718,1060.427767412219,0.4598507636557508 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441069,529.6953066103075,1060.427767412219,0.49951097367332475 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441064,978.8184387678544,1060.427767412219,0.9230411243912282 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441063,633.2668607661064,1060.427767412219,0.5971805720548783 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441074,108.11389158647064,57.09593719876665,1.8935478930855707 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441076,35.40803813709556,57.09593719876665,0.6201498718521854 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441058,32.551908376966985,57.09593719876665,0.5701265269303636 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441069,55.12052368557644,57.09593719876665,0.9654018550161765 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441064,9.636337149032515,57.09593719876665,0.16877448066901463 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441063,2.037914080213505,57.09593719876665,0.03569280372995658 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441074,317.20706621544804,50.205845180981015,6.318130191255349 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441076,22.331621952574444,50.205845180981015,0.4448012352361337 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441058,85.4465108692965,50.205845180981015,1.701923562112751 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441069,132.92295909653333,50.205845180981015,2.647559434909926 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441064,58.53588135547505,50.205845180981015,1.1659176564893208 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441063,3.703831889573831,50.205845180981015,0.07377292178275921 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441074,44110.574355060264,1506.8779059558976,29.272825741696995 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441076,49849.39130208173,1506.8779059558976,33.081241091300924 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441058,16650.692770181333,1506.8779059558976,11.049795543733094 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441069,15766.730638358002,1506.8779059558976,10.463177259445102 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441064,9896.368632940525,1506.8779059558976,6.56746548199119 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441063,12656.984642834028,1506.8779059558976,8.399475891714657 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441074,44486.497402638925,16162.128318216166,2.7525148004485684 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441076,57887.23644876333,16162.128318216166,3.581659253597141 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441058,72691.03037503948,16162.128318216166,4.497614976432911 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441069,48441.54715563159,16162.128318216166,2.997225749100979 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441064,46430.82466870809,16162.128318216166,2.872816237721389 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441063,78582.20963141926,16162.128318216166,4.862120141865851 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441074,78.81495601170072,24.995311385825953,3.1531896040468683 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441076,40.72865260453151,24.995311385825953,1.6294516989945336 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441058,246.11451530057235,24.995311385825953,9.846427255958734 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441069,166.0855284909771,24.995311385825953,6.644667310892512 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441064,210.53342445529128,24.995311385825953,8.42291665046742 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441063,331.7729893385326,24.995311385825953,13.273408929271053 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441074,3148.9243887544185,522.7489803443298,6.023779112261973 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441076,940.1242183873431,522.7489803443298,1.7984238204885494 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441058,3210.730793484407,522.7489803443298,6.1420125417930596 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441069,2254.3392425143347,522.7489803443298,4.312469899088895 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441064,1904.845204618659,522.7489803443298,3.6439003732995436 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441063,1461.5884238963242,522.7489803443298,2.795966092432337 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441074,6.022582973692233,2.8430683750443606,2.118339124924585 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441076,4.5692384679732445,2.8430683750443606,1.6071503971134533 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441058,2.3466418968644667,2.8430683750443606,0.8253905947048678 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441069,4.368163618232122,2.8430683750443606,1.5364258055045776 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441064,4.422768179139854,2.8430683750443606,1.5556320129201413 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441063,2.647081082487811,2.8430683750443606,0.9310648684087692 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441074,3054.539697873133,1771.7543971110147,1.7240198206104642 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441076,1559.3483368985037,1771.7543971110147,0.880115403941508 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441058,3449.5329720610043,1771.7543971110147,1.9469588887070013 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441069,2778.9993400510734,1771.7543971110147,1.568501449513799 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441064,2601.324031095299,1771.7543971110147,1.4682193171564653 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441063,2432.228190170808,1771.7543971110147,1.3727795422078521 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441074,603.9837096531772,73.62821549612136,8.2031556188536765 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441076,0.644311395811816,73.62821549612136,0.008750876161676871 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441058,17.779501855201538,73.62821549612136,0.24147674550306247 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441069,3.6934403681738135,73.62821549612136,0.05016338292713857 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441064,507.9432916615456,73.62821549612136,6.898758692424148 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441063,316.22640682058,73.62821549612136,4.294907932913822 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441074,699.3372601364155,1923.334023596175,0.3636067638572846 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441076,486.6219104386845,1923.334023596175,0.25300956800463487 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441058,715.2684037857429,1923.334023596175,0.3718898511701893 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441069,471.52859623748526,1923.334023596175,0.24516209376665601 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441064,536.4689509795899,1923.334023596175,0.27892656418385464 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441063,515.3846349570169,1923.334023596175,0.267964185437416 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441074,29.43525434563615,51.40813337414527,0.5725797147974262 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441076,69.1901724286916,51.40813337414527,1.3458993331877998 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441058,30.299494325441987,51.40813337414527,0.5893910620119993 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441069,29.713762153616617,51.40813337414527,0.5779972973801959 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441064,49.32339854161239,51.40813337414527,0.9594473734854306 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441063,10.668125313672972,51.40813337414527,0.20751823910880024 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441074,36.78685454080493,89.1451395839603,0.41266248179641546 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441076,29.099115097780523,89.1451395839603,0.3264240230436104 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441058,6.272221196774437,89.1451395839603,0.07035965422284206 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441069,10.174867901599638,89.1451395839603,0.11413822390189382 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441064,165.99317454723288,89.1451395839603,1.8620552429658173 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441063,41.31289665822109,89.1451395839603,0.46343409019300513 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441074,17290.077190761316,4771.656231796832,3.6234959835424907 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441076,18043.705609373446,4771.656231796832,3.781434523538349 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441058,2339.882969827342,4771.656231796832,0.49037123718911063 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441069,16318.904063143482,4771.656231796832,3.419966416356523 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441064,19557.100722592026,4771.656231796832,4.098598007180315 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441063,8097.849535742935,4771.656231796832,1.6970731214418562 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441074,561021.8323959385,209884.98459768714,2.672996515073812 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441076,681547.240652282,209884.98459768714,3.2472415402116024 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441058,529714.8212173424,209884.98459768714,2.523833814185008 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441069,656039.0891199096,209884.98459768714,3.125707588741624 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441064,966298.8914534368,209884.98459768714,4.603944838196324 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441063,535883.018500849,209884.98459768714,2.553222278039771 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441074,161.95667626659795,22.903585106474594,7.071236905213349 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441076,7.64507987174886,22.903585106474594,0.3337940255295525 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441058,40.02725002654312,22.903585106474594,1.7476412465761901 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441069,4.214121683639472,22.903585106474594,0.18399397579238305 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441064,15.171234752603532,22.903585106474594,0.6623956329140275 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441063,69.3112871330297,22.903585106474594,3.026219991796662 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441074,18.16093826776989,83.56495705722055,0.21732720158444294 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441076,85.51294738423339,83.56495705722055,1.0233110911034031 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441058,13.752744945781435,83.56495705722055,0.1645755042555019 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441069,11.66578814893539,83.56495705722055,0.13960143772882355 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441064,15.69105190423003,83.56495705722055,0.18777071701820758 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441063,68.7874266742991,83.56495705722055,0.8231611562631135 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441074,1611.4392551754654,1829.6496491832456,0.8807365147173454 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441076,1386.0277985894272,1829.6496491832456,0.7575372690657739 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441058,1191.860652235263,1829.6496491832456,0.6514146862856005 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441069,1508.8582763176164,1829.6496491832456,0.8246706012766815 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441064,2277.707286761172,1829.6496491832456,1.2448871223941365 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441063,1075.3869385457294,1829.6496491832456,0.5877556607767949 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441074,274413.21901673573,96234.19538703516,2.851514660803255 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441076,231309.2217189748,96234.19538703516,2.4036073745792153 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441058,279089.86230903363,96234.19538703516,2.900111142266932 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441069,294734.7319507286,96234.19538703516,3.0626819371779748 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441064,255292.4020963134,96234.19538703516,2.6528241969455575 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441063,202845.06774256376,96234.19538703516,2.107827336496767 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441074,72.27195330238611,77.99112650544876,0.9266689242825197 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441076,113.78019234818188,77.99112650544876,1.4588863816479527 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441058,403.900740107852,77.99112650544876,5.178803771729518 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441069,138.99393386681334,77.99112650544876,1.7821762563860735 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441064,232.05043117005684,77.99112650544876,2.9753440111400993 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441063,18.074866205166163,77.99112650544876,0.23175541904633706 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441074,53.98155124311277,110.33780757772625,0.4892389329476758 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441076,183.7496723221963,110.33780757772625,1.665337352228572 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441058,69.573859016633,110.33780757772625,0.6305532123938792 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441069,123.29,110.33780757772625,1.117386711831751 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441064,542.0470625465862,110.33780757772625,4.912614039070398 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441063,105.66291041403112,110.33780757772625,0.9576310489910546 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441074,53.804570532155566,67.31067174214355,0.7993468069709999 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441076,56.327964600639255,67.31067174214355,0.8368355736579588 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441058,37.780972360776325,67.31067174214355,0.5612924575394107 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441069,63.88949006409722,67.31067174214355,0.9491732649593464 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441064,60.31953889225744,67.31067174214355,0.8961363381327105 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441063,83.99680975462448,67.31067174214355,1.2478973627897052 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441074,4174.2578120099215,2375.529574917848,1.7571904202263102 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441076,4864.455498419076,2375.529574917848,2.0477351870423677 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441058,4233.000707876107,2375.529574917848,1.7819187572196382 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441069,5469.617624272209,2375.529574917848,2.3024834891653 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441064,5436.860844749463,2375.529574917848,2.2886942356579514 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441063,4793.22024021132,2375.529574917848,2.017748080605177 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441074,307.34740663969666,194.62377093849457,1.5791873991426528 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441076,325.8822575244516,194.62377093849457,1.6744216595589323 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441058,643.0523773108856,194.62377093849457,3.3040793229420284 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441069,265.5873337542587,194.62377093849457,1.3646191956592506 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441064,524.6011259504241,194.62377093849457,2.695462755760753 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441063,204.74395487626953,194.62377093849457,1.051998704418142 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441074,4406.835143560694,3728.1507253933823,1.1820431812331564 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441076,3155.805280632212,3728.1507253933823,0.8464800682915581 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441058,3874.3795967573415,3728.1507253933823,1.039222896855526 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441069,4569.824660843049,3728.1507253933823,1.2257617777405865 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441064,4137.053520010008,3728.1507253933823,1.1096797916005607 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441063,3676.4361342116063,3728.1507253933823,0.9861286211339217 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441074,84.58337218572248,68.78582331086372,1.229662859503257 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441076,105.74784124570358,68.78582331086372,1.537349357116763 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441058,131.6156237927606,68.78582331086372,1.9134120587312042 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441069,38.83429297777108,68.78582331086372,0.5645682657931895 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441064,60.6043719227278,68.78582331086372,0.88105904684514 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441063,88.90149128484741,68.78582331086372,1.292439153967453 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441074,629.0550987025307,696.3940975413478,0.9033033176522308 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441076,455.3200965642762,696.3940975413478,0.6538253241545344 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441058,705.8532137297229,696.3940975413478,1.0135829930520246 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441069,401.8176302027944,696.3940975413478,0.5769974668387203 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441064,610.0007556643114,696.3940975413478,0.875941880923385 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441063,656.4170219979949,696.3940975413478,0.9425941780889673 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441074,66.22191686551321,81.2393188807366,0.8151461358597837 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441076,90.00102274629262,81.2393188807366,1.1078505332918736 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441058,23.296200928210386,81.2393188807366,0.28676017043434815 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441069,34.135469897829935,81.2393188807366,0.4201840976527944 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441064,47.42935815207031,81.2393188807366,0.5838226957773857 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441063,69.9599129499764,81.2393188807366,0.8611582902692853 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441074,274.49996494217174,543.8205698619286,0.5047620118743669 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441076,162.17040856185267,543.8205698619286,0.2982057273100691 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441058,470.04797468036054,543.8205698619286,0.8643438676836033 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441069,110.81124960535716,543.8205698619286,0.20376435858888384 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441064,190.26764140128063,543.8205698619286,0.34987209374884065 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441063,525.8502410243923,543.8205698619286,0.9669554080271389 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441074,742776.8869524614,306516.0644612488,2.4232886072643893 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441076,708775.6115960483,306516.0644612488,2.312360407086119 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441058,695497.2697312051,306516.0644612488,2.2690401919183363 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441069,1014707.4313550846,306516.0644612488,3.3104543252524 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441064,1386855.4216696434,306516.0644612488,4.524576628984404 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441063,182258.4449344406,306516.0644612488,0.5946130270685456 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441074,1404875.5615530338,335923.8645439917,4.182124909345507 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441076,1338315.694136411,335923.8645439917,3.983985168642726 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441058,1120206.44251747,335923.8645439917,3.3347033680924176 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441069,1020682.250384719,335923.8645439917,3.0384332824054336 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441064,1481130.3017694035,335923.8645439917,4.409124977708866 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441063,1129303.633124961,335923.8645439917,3.3617844765448943 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441074,59.108844915398386,33.931355493730415,1.7420124853638719 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441076,49.01322923075827,33.931355493730415,1.4444819111283242 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441058,140.12442745554904,33.931355493730415,4.129644260201753 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441069,123.07200423170836,33.931355493730415,3.6270877611844505 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441064,114.75264404995023,33.931355493730415,3.3819056851752762 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441063,8.331008772009621,33.931355493730415,0.2455253747098009 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441074,6.631955277777519,76.3332642617619,0.08688158880557274 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441076,64.97355402193489,76.3332642617619,0.8511827006261344 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441058,55.22309656057231,76.3332642617619,0.7234473344569854 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441069,38.77714892760481,76.3332642617619,0.5079980438754759 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441064,91.92314685472314,76.3332642617619,1.2042344545819559 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441063,34.33758058906667,76.3332642617619,0.44983770733708306 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441074,185.41205346751636,130.67426801703346,1.4188872551660117 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441076,181.5852779924859,130.67426801703346,1.3896024117679862 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441058,75.25746838548864,130.67426801703346,0.5759165100177089 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441069,289.0079805275349,130.67426801703346,2.2116671087062265 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441064,345.6898003121169,130.67426801703346,2.645431312207971 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441063,34.47294968916162,130.67426801703346,0.26380824788448826 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441074,9246.880710792448,5444.214081294075,1.698478526508364 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441076,8649.151130894345,5444.214081294075,1.5886868153499327 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441058,9288.810139535748,5444.214081294075,1.706180176024199 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441069,7574.984480287267,5444.214081294075,1.3913825516734113 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441064,8361.034198653539,5444.214081294075,1.5357651396151826 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441063,8521.630204694218,5444.214081294075,1.565263613342084 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441074,296.8566061321928,100.67607722942154,2.948631038292377 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441076,362.59904512988265,100.67607722942154,3.601640579455522 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441058,184.60743676769823,100.67607722942154,1.8336772930376812 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441069,146.5016593799498,100.67607722942154,1.4551784635599234 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441064,173.78557249428854,100.67607722942154,1.7261853786601602 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441063,157.45739350433016,100.67607722942154,1.5640000865897352 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441074,638.7422138061019,599.1099853739104,1.0661518408968875 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441076,556.367382023829,599.1099853739104,0.9286564998188016 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441058,927.6781541961818,599.1099853739104,1.548427128313024 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441069,576.8596577853592,599.1099853739104,0.9628610303087095 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441064,701.7374584157269,599.1099853739104,1.1712998874117675 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441063,574.3104786817411,599.1099853739104,0.9586060868661842 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441074,65.70614260200124,114.30018844822946,0.574855942882035 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441076,56.7802050987962,114.30018844822946,0.4967638800045718 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441058,72.35388853134356,114.30018844822946,0.6330163538104328 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441069,179.50359556354022,114.30018844822946,1.5704575644233836 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441064,103.29037949133787,114.30018844822946,0.9036763709109866 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441063,77.1817079723751,114.30018844822946,0.6752544245133365 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441074,3627.6062536012814,1759.6959467320276,2.061496055803387 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441076,3864.0921851625862,1759.6959467320276,2.1958862792965355 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441058,3248.3228450429233,1759.6959467320276,1.84595688310555 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441069,4873.136097154889,1759.6959467320276,2.769305746373346 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441064,4265.889434814463,1759.6959467320276,2.424219617449677 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441063,4293.5284315115805,1759.6959467320276,2.4399263062946712 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441074,80.22847831564798,38.77498679262034,2.069078159709833 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441076,35.412669982568005,38.77498679262034,0.9132864486057736 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441058,105.4880396101722,38.77498679262034,2.720517744450881 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441069,133.26236952934707,38.77498679262034,3.4368127639107175 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441064,189.86826397044655,38.77498679262034,4.89666869484485 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441063,13.83146307845494,38.77498679262034,0.3567109681411251 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441074,954.096541855032,2284.874121495706,0.4175707243033892 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441076,972.362931250229,2284.874121495706,0.4255652082109927 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441058,858.4865776817252,2284.874121495706,0.375725984029155 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441069,823.571387656993,2284.874121495706,0.36044497152336485 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441064,1125.1843856220055,2284.874121495706,0.4924491791632908 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441063,878.3180692864115,2284.874121495706,0.38440545193424225 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441074,417.6287919316099,306.4947439651267,1.3625969128499251 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441076,392.6726824394017,306.4947439651267,1.2811726470718219 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441058,483.7154647067096,306.4947439651267,1.578217813620149 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441069,352.7069197999199,306.4947439651267,1.1507764056144834 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441064,650.6912474925225,306.4947439651267,2.1230094815804046 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441063,439.43472967978846,306.4947439651267,1.4337431174016733 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441074,24617.72545236923,53872.22448470133,0.456965081502439 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441076,22700.82273971812,53872.22448470133,0.4213826875881971 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441058,31077.636340272777,53872.22448470133,0.5768767975990712 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441069,23746.47542910724,53872.22448470133,0.44079255416398816 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441064,29468.142810359583,53872.22448470133,0.5470006685676766 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441063,24207.743537214537,53872.22448470133,0.4493548163040691 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441074,44.00379849225652,320.29657233769314,0.13738454386537333 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441076,142.01294702370373,320.29657233769314,0.44337954036541327 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441058,56.508841640921965,320.29657233769314,0.17642661995565756 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441069,116.22165457857768,320.29657233769314,0.36285637941839594 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441064,176.49463329736423,320.29657233769314,0.5510350360892513 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441063,320.9878756409371,320.29657233769314,1.0021583225140327 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441074,14038.900753749476,6299.521117687065,2.228566345199269 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441076,5309.479742269491,6299.521117687065,0.8428386290129497 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441058,19015.06377640662,6299.521117687065,3.0184935364401473 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441069,4268.8753903168035,6299.521117687065,0.6776507786173063 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441064,7946.527734582772,6299.521117687065,1.2614494953071007 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441063,5786.938212262169,6299.521117687065,0.9186314489865388 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441074,1448.2233254237972,1965.7827420843205,0.73671586102554 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441076,1792.1737354053,1965.7827420843205,0.9116845402280097 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441058,1116.2425512403709,1965.7827420843205,0.5678361740305128 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441069,1096.8703792339309,1965.7827420843205,0.5579814878580726 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441064,2602.6752630257524,1965.7827420843205,1.3239892727240725 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441063,1520.821864923717,1965.7827420843205,0.773646971440592 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441074,11462.173085765924,6243.797224888628,1.8357695922724937 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441076,5560.706287225728,6243.797224888628,0.8905968734955059 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441058,16259.27653230544,6243.797224888628,2.6040686375101587 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441069,5067.762335785822,6243.797224888628,0.8116474884201924 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441064,7688.885463210936,6243.797224888628,1.2314438131594005 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441063,6433.48980210264,6243.797224888628,1.0303809637599812 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441074,342.54985470473736,477.14850073021523,0.7179103658096133 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441076,430.1537242545591,477.14850073021523,0.9015091184322352 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441058,338.9925616159869,477.14850073021523,0.7104550493131632 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441069,291.8814756907036,477.14850073021523,0.6117204083089773 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441064,777.2097317677476,477.14850073021523,1.6288634053723876 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441063,503.67640256154783,477.14850073021523,1.0555967414562448 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441074,392.58973217879486,205.1372392304115,1.9137906586421176 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441076,422.84727843161824,205.1372392304115,2.0612897005827078 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441058,461.31589843163187,205.1372392304115,2.2488159641920444 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441069,295.4862935117507,205.1372392304115,1.4404322424357996 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441064,327.33645040854293,205.1372392304115,1.595694919345563 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441063,204.89545465905897,205.1372392304115,0.9988213521237802 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441074,66.51610943055931,44.32085041603382,1.5007859462573845 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441076,45.304346535281006,44.32085041603382,1.0221903711236413 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441058,62.81439919621529,44.32085041603382,1.4172652060279762 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441069,27.68999069683295,44.32085041603382,0.624762170330911 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441064,15.495876840300292,44.32085041603382,0.3496295015741484 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441063,39.29628703599553,44.32085041603382,0.8866320629484004 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441074,87.26663326914698,73.02499011367847,1.1950242394185668 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441076,16.29063324178891,73.02499011367847,0.2230829914037534 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441058,5.88379435240803,73.02499011367847,0.08057234028034362 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441069,2.558745670115763,73.02499011367847,0.03503931552928042 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441064,37.67692888467808,73.02499011367847,0.5159456896334551 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441063,11.820524771575538,73.02499011367847,0.16186958400370136 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441074,61.576429584004934,446.9213615105917,0.13777911482207283 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441076,109.76566632415636,446.9213615105917,0.24560398266296563 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441058,22.938036684329457,446.9213615105917,0.051324547582149625 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441069,765.0206387739024,446.9213615105917,1.711756708580984 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441064,1446.6673123271723,446.9213615105917,3.236961660184344 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441063,202.67230168715383,446.9213615105917,0.45348537604495476 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441074,2027.8790196908244,2631.000022355788,0.7707635889242862 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441076,1665.9535431565494,2631.000022355788,0.6332016453822986 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441058,1511.7157438821832,2631.000022355788,0.5745783850387801 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441069,2141.798691295763,2631.000022355788,0.8140625895464662 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441064,2121.138672266534,2631.000022355788,0.806210054824429 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441063,1858.5358131358337,2631.000022355788,0.7063990107729864 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441074,59.28393377661589,48.89133349009634,1.212565286005642 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441076,50.67298251644202,48.89133349009634,1.0364409988266443 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441058,80.69104702652913,48.89133349009634,1.650416163078765 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441069,128.4569035892375,48.89133349009634,2.6273961951816744 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441064,49.0653530512352,48.89133349009634,1.0035593130462295 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441063,99.89831156867491,48.89133349009634,2.043272384642787 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441074,325.1420253004413,307.70649021557807,1.056662877252436 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441076,198.58241577523813,307.70649021557807,0.6453631044184736 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441058,118.79086774435623,307.70649021557807,0.3860525257726341 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441069,131.61238037180863,307.70649021557807,0.4277205212005813 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441064,790.619168215106,307.70649021557807,2.5693938651121755 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441063,130.47591150291473,307.70649021557807,0.42402716761516396 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441074,415.60902541597,154.19153082843468,2.6954076088550445 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441076,261.7666737629521,154.19153082843468,1.6976721896237854 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441058,134.93805968231035,154.19153082843468,0.8751327583124704 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441069,231.9570724016575,154.19153082843468,1.5043437934327972 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441064,336.9175759580941,154.19153082843468,2.185058894920594 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441063,90.10239615055224,154.19153082843468,0.5843537298478934 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441074,8339.22758819996,6593.957266089812,1.2646772266913833 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441076,8572.622888136759,6593.957266089812,1.3000725576767784 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441058,8579.121058797104,6593.957266089812,1.3010580312548015 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441069,8981.011227380244,6593.957266089812,1.3620062831717357 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441064,8927.78427724955,6593.957266089812,1.3539342032381243 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441063,8668.053315625726,6593.957266089812,1.3145449637962006 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441074,205.9064266062662,127.96554716912783,1.6090770614540997 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441076,196.05794726036143,127.96554716912783,1.5321151012720489 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441058,254.6808370567905,127.96554716912783,1.9902297351972968 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441069,225.02481615094672,127.96554716912783,1.75847969339387 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441064,259.2584416935427,127.96554716912783,2.026001899955848 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441063,111.68386673779774,127.96554716912783,0.8727651247424345 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441074,1448.9983022499341,1681.9358703135756,0.8615062725190508 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441076,913.9876265622116,1681.9358703135756,0.543414075824312 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441058,1347.7282460008134,1681.9358703135756,0.801295857819803 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441069,1205.8348215676217,1681.9358703135756,0.7169326981193457 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441064,1450.050405797424,1681.9358703135756,0.8621318038285731 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441063,1042.587511276801,1681.9358703135756,0.6198735217427902 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441074,43.83564432531571,45.403354316773296,0.9654714940107756 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441076,46.9491131570131,45.403354316773296,1.0340450361762976 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441058,39.496700449914435,45.403354316773296,0.8699071036547453 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441069,34.75121449691234,45.403354316773296,0.7653887035406599 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441064,41.39763474461444,45.403354316773296,0.9117748097593964 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441063,46.23983654957669,45.403354316773296,1.018423357599691 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441074,156.8882971422138,171.72890790902974,0.9135811730970915 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441076,147.4948289879978,171.72890790902974,0.8588817735109019 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441058,147.98534969880103,171.72890790902974,0.861738140075948 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441069,148.82899077567572,171.72890790902974,0.8666507729410075 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441064,139.27789262361264,171.72890790902974,0.8110334731610391 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441063,144.88186371915162,171.72890790902974,0.8436661333448888 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441074,1765.8729050979548,385.5886159476326,4.5796811214410456 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441076,55.55207821400117,385.5886159476326,0.14407084627608868 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441058,661.5055960322237,385.5886159476326,1.715573460089039 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441069,809.9999784755726,385.5886159476326,2.1006843692335044 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441064,1588.1869039021517,385.5886159476326,4.118863571734301 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441063,420.962638918319,385.5886159476326,1.0917403198840563 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441074,158.86204205671612,430.1288265554666,0.3693359576220598 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441076,236.7580462722608,430.1288265554666,0.5504351990733874 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441058,248.70901410839133,430.1288265554666,0.5782198233494109 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441069,349.64159600482986,430.1288265554666,0.8128764556535537 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441064,296.4571063047667,430.1288265554666,0.689228640356048 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441063,924.6953942005256,430.1288265554666,2.149810329164913 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441074,182121.8116955172,54695.927744901994,3.3297142804656437 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441076,160707.87530021588,54695.927744901994,2.9382054921848337 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441058,234012.20177307504,54695.927744901994,4.27842092494512 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441069,272643.9015144901,54695.927744901994,4.984720302873045 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441064,282698.57699827943,54695.927744901994,5.168548896670442 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441063,76291.95679576501,54695.927744901994,1.3948379695026913 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441074,593602.1229263047,97212.60478924697,6.106225876913908 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441076,403132.2025543312,97212.60478924697,4.14691287645574 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441058,564416.6550859112,97212.60478924697,5.806002794694617 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441069,286300.1892852785,97212.60478924697,2.945093281945956 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441064,452500.4051880492,97212.60478924697,4.65475033992816 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441063,353488.6518957999,97212.60478924697,3.6362429816807107 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441074,221441.9960897058,62941.57202670208,3.5182152106998874 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441076,209593.16136777325,62941.57202670208,3.329963879498534 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441058,219201.3089393811,62941.57202670208,3.48261573203777 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441069,251509.3726526399,62941.57202670208,3.995918191333711 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441064,370667.5377886745,62941.57202670208,5.889073403368826 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441063,82129.41316830597,62941.57202670208,1.3048516349967192 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441074,173275.61529554275,14728.399701289269,11.764727927663102 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441076,103928.2624749854,14728.399701289269,7.056317358489932 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441058,167663.34951321955,14728.399701289269,11.383677311428677 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441069,65174.21488032287,14728.399701289269,4.4250710329797585 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441064,100552.84146650472,14728.399701289269,6.827139642177331 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441063,86505.14920779351,14728.399701289269,5.8733569812218756 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441074,25999.4374515582,3575.9352491809864,7.270667850463169 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441076,34311.86458187841,3575.9352491809864,9.595214172218869 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441058,13499.77013099287,3575.9352491809864,3.7751718614269616 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441069,31625.045059761625,3575.9352491809864,8.84385282619557 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441064,26577.40620703768,3575.9352491809864,7.432295149394785 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441063,14555.574638481034,3575.9352491809864,4.070424553077343 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441074,111890.50733208776,12966.336321671553,8.62930781342431 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441076,98669.29398545423,12966.336321671553,7.60965098680506 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441058,240974.02230589933,12966.336321671553,18.584588300639897 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441069,66691.48932137928,12966.336321671553,5.143433554928935 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441064,105518.87372034766,12966.336321671553,8.13790966874633 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441063,112993.59450179612,12966.336321671553,8.714380970740512 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441074,728.8258018007608,103.34580193186551,7.052301962698648 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441076,690.2145333216698,103.34580193186551,6.678689607311954 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441058,428.5823198527602,103.34580193186551,4.147070435771728 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441069,477.8257393731191,103.34580193186551,4.623562161607137 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441064,572.3182954332264,103.34580193186551,5.537895925473084 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441063,719.7129509210838,103.34580193186551,6.964123723144369 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441074,1007.286481759998,211.8154700640626,4.755490623302202 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441076,789.0310143056338,211.8154700640626,3.725086812908401 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441058,1238.6802701976949,211.8154700640626,5.847921635860978 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441069,707.5848475019885,211.8154700640626,3.340572089885516 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441064,1174.8364758728808,211.8154700640626,5.546509306036793 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441063,958.4812173661952,211.8154700640626,4.52507655402274 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441074,133.31753465604038,76.10596635595309,1.7517356527936938 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441076,87.39483883398604,76.10596635595309,1.1483309787465819 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441058,176.22965203394693,76.10596635595309,2.315582607672415 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441069,212.7547683792046,76.10596635595309,2.795507087895517 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441064,170.25288173754657,76.10596635595309,2.2370503902579935 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441063,166.6600127872252,76.10596635595309,2.189841621716546 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441074,4346.335894684474,1382.686999693948,3.1433982496736546 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441076,5993.2901131904155,1382.686999693948,4.334524092955966 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441058,4183.736502044555,1382.686999693948,3.0258015754618417 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441069,4791.933761478794,1382.686999693948,3.465667763231641 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441064,4804.802437735099,1382.686999693948,3.4749747692707187 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441063,4360.894119545945,1382.686999693948,3.1539271870721355 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441074,30.60496976312753,30.899530320120164,0.9904671509909382 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441076,31.069169307095738,30.899530320120164,1.0054900183018354 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441058,23.5117097551532,30.899530320120164,0.7609083216337305 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441069,28.315478766207928,30.899530320120164,0.916372464981138 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441064,35.32387138970042,30.899530320120164,1.143184735293512 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441063,24.402634442457728,30.899530320120164,0.7897412740467451 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441074,30.630611848642975,31.68183515511672,0.9668193682175646 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441076,31.92722716074689,31.68183515511672,1.0077455110926723 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441058,31.125806219546067,31.68183515511672,0.9824495982367091 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441069,30.13260919417105,31.68183515511672,0.9511004980184847 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441064,30.361556407442997,31.68183515511672,0.9583269485113619 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441063,31.25166534186874,31.68183515511672,0.9864221939435694 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441074,275.2624933423895,628.1906149122311,0.4381830718385507 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441076,531.1741803263043,628.1906149122311,0.8455621076104716 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441058,1440.9119205756376,628.1906149122311,2.2937495186504138 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441069,400.4783121042149,628.1906149122311,0.6375108169359845 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441064,556.888838619958,628.1906149122311,0.8864965910032974 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441063,468.6413480286188,628.1906149122311,0.7460177482818585 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441074,37276.87050461152,10551.186365326936,3.5329553676646173 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441076,37650.22502817678,10551.186365326936,3.568340442919488 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441058,51059.31866343188,10551.186365326936,4.839201668470365 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441069,25017.669121672596,10551.186365326936,2.3710764131591002 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441064,38146.89836753526,10551.186365326936,3.6154131911547607 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441063,34472.28526387684,10551.186365326936,3.2671477945986114 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441074,91.40172725571634,102.14043933131707,0.8948632672239921 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441076,78.17184463551976,102.14043933131707,0.7653368748684406 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441058,70.26956390833048,102.14043933131707,0.6879700573873024 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441069,85.77905120796838,102.14043933131707,0.8398147860880391 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441064,87.43090023224853,102.14043933131707,0.8559871173908444 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441063,62.7857147165589,102.14043933131707,0.6146998693915771 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441074,7551.258035728869,2995.2816068385046,2.5210511153571167 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441076,7745.804447464024,2995.2816068385046,2.5860020739885146 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441058,6582.854504774803,2995.2816068385046,2.197741437648313 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441069,10093.2834550944,2995.2816068385046,3.3697277184390617 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441064,7694.226787113356,2995.2816068385046,2.568782437533328 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441063,7453.838483226458,2995.2816068385046,2.488526776984393 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441074,36.30581335799454,35.73806763844074,1.0158863015565822 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441076,37.773858219977626,35.73806763844074,1.0569642041683065 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441058,20.67160656132514,35.73806763844074,0.5784198175026748 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441069,43.66852123441443,35.73806763844074,1.221904935549551 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441064,58.84912971686605,35.73806763844074,1.6466791185309215 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441063,21.311929211126973,35.73806763844074,0.5963369208077535 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441074,247.15940964224728,271.6614200921023,0.9098068086313177 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441076,237.32049415578268,271.6614200921023,0.8735892423566185 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441058,252.34557021832563,271.6614200921023,0.9288973389477684 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441069,238.5603129318652,271.6614200921023,0.8781530805919564 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441064,215.51177430635815,271.6614200921023,0.7933101955857128 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441063,300.2579484990231,271.6614200921023,1.1052653276907174 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441074,163.34449498056867,166.02715311669658,0.9838420518224369 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441076,155.02568707771175,166.02715311669658,0.9337369470447273 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441058,206.97219449009228,166.02715311669658,1.246616535938651 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441069,206.33866443701112,166.02715311669658,1.242800714001164 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441064,207.28350839773557,166.02715311669658,1.2484916142122902 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441063,160.25360984234186,166.02715311669658,0.9652253070297686 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441074,1919.9673842872685,1793.9624976146763,1.0702383058955431 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441076,1354.042745947439,1793.9624976146763,0.7547776209078105 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441058,1757.0239794694396,1793.9624976146763,0.9794095371590256 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441069,1432.3831011760265,1793.9624976146763,0.798446513280283 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441064,1587.7732752297934,1793.9624976146763,0.8850649204434093 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441063,1466.0949232152616,1793.9624976146763,0.8172383342264063 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441074,146.12022809317622,59.13775760336051,2.4708449223457354 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441076,125.74093442770084,59.13775760336051,2.1262377797793874 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441058,176.7373576382671,59.13775760336051,2.9885704971035962 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441069,96.25051260606838,59.13775760336051,1.627564461466813 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441064,184.10708350768303,59.13775760336051,3.1131901338312007 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441063,9.128607867401705,59.13775760336051,0.15436175190523238 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441074,491.1119445512069,238.79765196261823,2.0566029042366227 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441076,437.82701698153033,238.79765196261823,1.833464497590908 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441058,610.8400639347481,238.79765196261823,2.5579818683911095 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441069,545.4088346777827,238.79765196261823,2.2839790517000638 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441064,551.1249823963961,238.79765196261823,2.3079162540621216 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441063,269.251904021527,238.79765196261823,1.1275316227300096 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441074,972.399678968812,386.8144501381946,2.5138659598197775 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441076,1160.3206772023902,386.8144501381946,2.999682862901968 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441058,961.4466845042916,386.8144501381946,2.4855500722912547 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441069,680.9056372073824,386.8144501381946,1.7602900743861036 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441064,503.0918563423538,386.8144501381946,1.3006025399584156 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441063,452.919676458086,386.8144501381946,1.1708964758071327 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441074,17417.406629798952,5555.372966797932,3.135236235963864 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441076,10101.148144043233,5555.372966797932,1.8182664250291452 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441058,16044.93654408169,5555.372966797932,2.888183500905403 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441069,12379.454053877427,5555.372966797932,2.2283749674169644 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441064,15243.54228538777,5555.372966797932,2.743927793235818 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441063,11408.470611889355,5555.372966797932,2.053592203452921 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441074,120.750295708228,84.54153084580483,1.4282955903467642 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441076,63.35781231394189,84.54153084580483,0.7494282594610229 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441058,6.027488462430246,84.54153084580483,0.07129618309637394 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441069,138.60368009998842,84.54153084580483,1.6394744537189356 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441064,41.47603825966525,84.54153084580483,0.49059956502696095 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441063,91.33407218074504,84.54153084580483,1.080345615545206 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441074,65.3695062533449,122.00200397429413,0.5358068238544531 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441076,174.60087331819156,122.00200397429413,1.4311311915415754 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441058,16.934700827879613,122.00200397429413,0.13880674313716815 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441069,60.482124439942865,122.00200397429413,0.49574697521105043 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441064,191.83893729742775,122.00200397429413,1.5724244770425926 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441063,291.05516485244084,122.00200397429413,2.3856588856832737 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441074,125.17383193739136,143.84455848940917,0.8702020657014115 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441076,464.5250758416846,143.84455848940917,3.229354524911599 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441058,95.61833517841312,143.84455848940917,0.6647337666614146 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441069,190.7530708032241,143.84455848940917,1.3261055740059062 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441064,149.06906963746374,143.84455848940917,1.0363205337964816 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441063,227.844734643177,143.84455848940917,1.5839649204384225 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441074,1074.5353203206955,5334.764851653101,0.20142130913000333 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441076,875.5080533448426,5334.764851653101,0.16411371029288124 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441058,543.9822794268255,5334.764851653101,0.10196930784273649 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441069,2782.8618159394227,5334.764851653101,0.5216465754956544 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441064,2308.7045078940464,5334.764851653101,0.43276593666141455 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441063,1068.656481233823,5334.764851653101,0.20031932258507607 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441074,177.29650609042525,159.70733471984832,1.1101337731384167 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441076,198.44654843175888,159.70733471984832,1.2425637731658674 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441058,237.6883021053059,159.70733471984832,1.4882741767762164 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441069,134.22815429412452,159.70733471984832,0.8404633045162373 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441064,304.4504710069467,159.70733471984832,1.9063023720294408 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441063,252.43017284315184,159.70733471984832,1.5805797102929173 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441074,58065.420949520296,82077.5827732141,0.7074455531903147 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441076,61191.7205635204,82077.5827732141,0.745535120504185 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441058,81235.70827789787,82077.5827732141,0.98974294238607885 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441069,32544.88183620421,82077.5827732141,0.3965136488744791 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441064,77029.50112321298,82077.5827732141,0.9384962193154577 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441063,73555.72923788782,82077.5827732141,0.896173190688708 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441074,352020.994884629,170961.68742491837,2.0590636427780162 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441076,187134.348436758,170961.68742491837,1.0945981597130774 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441058,97417.7736078918,170961.68742491837,0.5698222512612656 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441069,78696.45673601351,170961.68742491837,0.46031633122815785 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441064,151291.0757854627,170961.68742491837,0.8849414044997977 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441063,59376.51335081425,170961.68742491837,0.34730888683402106 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441074,459756.40715620946,55195.40432138408,8.32961390189669 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441076,379731.3019598926,55195.40432138408,6.879763027893524 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441058,426764.1519280035,55195.40432138408,7.731878354275674 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441069,285998.81568956847,55195.40432138408,5.18156935719312 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441064,372694.79814113025,55195.40432138408,6.752279518980513 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441063,315466.8491124654,55195.40432138408,5.715454991064277 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441074,2047.7650737513509,546.121028905539,3.749654317203645 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441076,2939.1875002281517,546.121028905539,5.381934305145636 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441058,2288.9730281806155,546.121028905539,4.1913292237947 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441069,1790.807979054899,546.121028905539,3.2791412237756004 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441064,1820.2263348984889,546.121028905539,3.333009055788123 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441063,1462.3721339918932,546.121028905539,2.6777436805950856 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441074,2161.295817346992,1228.731327313693,1.758965340349963 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441076,2001.260337627761,1228.731327313693,1.6287208547071108 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441058,2071.545401893991,1228.731327313693,1.68592218318621 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441069,1949.546768402639,1228.731327313693,1.5866338922641652 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441064,2089.773969168446,1228.731327313693,1.7007574582941598 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441063,1525.2358711317486,1228.731327313693,1.2413095012937343 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441074,46.668800313164986,76.68368758811918,0.6085883684132518 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441076,65.16059834330156,76.68368758811918,0.8497321971954446 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441058,300.9618977335644,76.68368758811918,3.9247186357296835 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441069,70.82183550375342,76.68368758811918,0.9235580308050554 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441064,88.24878328257873,76.68368758811918,1.1508155914016236 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441063,13.55816838703512,76.68368758811918,0.17680642146291 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441074,293.75849539737675,81.06808963980528,3.623602044930121 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441076,293.70083391401846,81.06808963980528,3.6228907726697965 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441058,294.6408131403846,81.06808963980528,3.634485707625616 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441069,277.49184004764953,81.06808963980528,3.422947811902035 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441064,147.1125338506261,81.06808963980528,1.8146786794195322 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441063,72.00937903724243,81.06808963980528,0.8882579983960183 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441074,69.82562757494728,34.254424530644805,2.038441122036064 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441076,114.60823316607986,34.254424530644805,3.3457935649611823 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441058,81.99137284686583,34.254424530644805,2.393599482995677 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441069,231.0004052942592,34.254424530644805,6.743666211283184 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441064,135.31770835838572,34.254424530644805,3.950371673514099 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441063,106.90797855617552,34.254424530644805,3.120997652742149 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441074,138.85515817808644,60.87738129746832,2.280899000888216 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441076,77.86378854844438,60.87738129746832,1.2790265758636117 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441058,166.5817555963381,60.87738129746832,2.7363489040758995 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441069,64.20575410655357,60.87738129746832,1.0546733899873526 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441064,249.19833744024177,60.87738129746832,4.0934470591396 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441063,102.97463101237145,60.87738129746832,1.6915088792863995 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441074,97.4673600428647,81.37032235510941,1.1978244306014418 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441076,156.61355198105846,81.37032235510941,1.9247011373210368 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441058,275.82437171548423,81.37032235510941,3.38974166172963 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441069,123.8534901437986,81.37032235510941,1.5220965895070169 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441064,234.63508565352353,81.37032235510941,2.8835462225349082 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441063,223.67182382242265,81.37032235510941,2.748813293946326 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441074,860.0206125689688,592.3362991324378,1.4519127290165963 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441076,594.9802501605363,592.3362991324378,1.0044635978446212 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441058,894.7184357123878,592.3362991324378,1.5104906402373657 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441069,679.8260848800286,592.3362991324378,1.1477028942439156 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441064,911.9122627504796,592.3362991324378,1.5395177774620719 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441063,539.6331311890432,592.3362991324378,0.9110249228004664 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441074,6047.5637994148865,1509.2244087879828,4.007067314973736 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441076,7642.153592718108,1509.2244087879828,5.06362973472932 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441058,5890.522475014361,1509.2244087879828,3.903012991782236 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441069,4581.815097780909,1509.2244087879828,3.035873970167525 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441064,7408.962383971108,1509.2244087879828,4.909119108351185 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441063,2035.7763142491604,1509.2244087879828,1.3488890733512833 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441074,758301.1417842151,911297.6405793307,0.8321113849281421 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441076,647061.9264560591,911297.6405793307,0.7100445536594482 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441058,695072.3331883529,911297.6405793307,0.7627281167396429 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441069,614096.5884540384,911297.6405793307,0.6738704909448076 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441064,949292.1105855064,911297.6405793307,1.0416927119245276 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441063,724154.0271771225,911297.6405793307,0.7946405158217713 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441074,2876.8032186696064,749.6106308195243,3.83773001661475 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441076,5004.46017870264,749.6106308195243,6.67607951775101 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441058,6440.115149747936,749.6106308195243,8.591280439429164 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441069,3637.785809309864,749.6106308195243,4.8529005056035475 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441064,4462.4362578901155,749.6106308195243,5.953005566385155 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441063,2298.3547162401355,749.6106308195243,3.066064729801685 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441074,21757.328923903005,2138.7943755926544,10.172707190645246 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441076,23902.43784546089,2138.7943755926544,11.17565957636184 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441058,36305.87153598153,2138.7943755926544,16.974923793654202 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441069,19117.380710836096,2138.7943755926544,8.938391146432073 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441064,24802.79684280435,2138.7943755926544,11.596625241700272 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441063,22111.162026324524,2138.7943755926544,10.338142964396742 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441074,1827.0899212998947,613.8984432679271,2.976208754617232 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441076,2643.5047783412665,613.8984432679271,4.30609461113676 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441058,2655.955903167149,613.8984432679271,4.326376670754963 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441069,1968.3477613839957,613.8984432679271,3.2063084423312977 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441064,1729.3871542588638,613.8984432679271,2.817057402936104 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441063,1404.259703096773,613.8984432679271,2.287446268183326 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441074,5640.146361682949,6365.76448478505,0.8860124145597255 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441076,4390.284043346958,6365.76448478505,0.6896711390816092 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441058,5278.2846346976085,6365.76448478505,0.8291674389326451 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441069,5677.895759932559,6365.76448478505,0.8919424797294054 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441064,5774.615134365533,6365.76448478505,0.9071361575137699 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441063,4088.026091973307,6365.76448478505,0.6421893398262197 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441074,51.67631769150619,70.21289390855102,0.7359946986206287 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441076,144.26412969167768,70.21289390855102,2.0546671937432874 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441058,99.35770037244107,70.21289390855102,1.41509194168595 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441069,86.7910981363386,70.21289390855102,1.2361133875122696 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441064,162.4481300663532,70.21289390855102,2.313650969548901 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441063,131.19212920237908,70.21289390855102,1.8684905563535186 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441074,1424.353566700009,2003.7789126851078,0.7108336941181519 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441076,1532.7787627576313,2003.7789126851078,0.7649440529862019 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441058,1826.9269600269029,2003.7789126851078,0.9117407856033282 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441069,700.9619110101157,2003.7789126851078,0.3498199859139207 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441064,1855.15970028526,2003.7789126851078,0.9258305337684711 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441063,1778.7597004572071,2003.7789126851078,0.8877025749680288 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441074,1394.6642980268111,700.7857837159185,1.9901435366334062 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441076,1929.9519676854193,700.7857837159185,2.7539827612538654 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441058,3712.206409281121,700.7857837159185,5.297205644779403 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441069,1527.396346205085,700.7857837159185,2.1795481325349693 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441064,1526.14198109544,700.7857837159185,2.1777581916731648 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441063,972.5218169585028,700.7857837159185,1.3877590549878214 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441074,4833.333728984157,4688.560133729121,1.030878050217069 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441076,2922.3030692888783,4688.560133729121,0.6232836917812075 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441058,3699.950120501397,4688.560133729121,0.7891442180477235 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441069,4385.13385920327,4688.560133729121,0.9352836977939075 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441064,4699.006934182241,4688.560133729121,1.0022281468414933 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441063,2636.4844643737156,4688.560133729121,0.5623228430850359 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441074,799.7384384065389,384.65137963543384,2.079125360643494 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441076,1333.090763636391,384.65137963543384,3.4657116397187298 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441058,1045.1376405774568,384.65137963543384,2.717103579787029 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441069,845.4140050582025,384.65137963543384,2.1978707209095982 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441064,813.2253236842056,384.65137963543384,2.1141879809581523 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441063,560.6516593121685,384.65137963543384,1.4575579056639412 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441074,854.3074083590409,772.5530415852671,1.1058236294119237 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441076,177.17230925367568,772.5530415852671,0.22933352108758873 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441058,1063.4464554172669,772.5530415852671,1.3765351997515807 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441069,125.54180609071484,772.5530415852671,0.16250250705518543 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441064,473.7240644858303,772.5530415852671,0.6131929317290056 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441063,228.48127594779095,772.5530415852671,0.2957483352585744 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441074,136.78407518786707,216.68366112664066,0.6312616026361291 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441076,143.42894409050098,216.68366112664066,0.6619278230058795 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441058,417.0469543907296,216.68366112664066,1.92468113295809 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441069,126.80397663444232,216.68366112664066,0.5852032219463552 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441064,149.3176245540727,216.68366112664066,0.6891042166155946 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441063,101.64815268800147,216.68366112664066,0.4691085251166827 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441074,1682.6632200931886,615.8359185894908,2.7323239345102777 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441076,1456.057993035546,615.8359185894908,2.3643602931938394 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441058,1743.1704161869282,615.8359185894908,2.8305760732168426 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441069,1143.9420237926215,615.8359185894908,1.8575435262248161 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441064,1270.8265305387822,615.8359185894908,2.0635797493746066 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441063,1353.4376419621751,615.8359185894908,2.1977244280620813 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441074,81.67656283150964,101.73138829665541,0.8028649190683943 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441076,73.56357952493134,101.73138829665541,0.7231158520162441 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441058,0.3363461930824716,101.73138829665541,0.0033062184514936924 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441069,119.80465663700276,101.73138829665541,1.177656755136817 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441064,43.708505280273634,101.73138829665541,0.4296462086295015 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441063,223.0985392395788,101.73138829665541,2.19301577394195 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441074,213.18586785437452,93.53234569214308,2.2792742582984595 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441076,196.70575844930983,93.53234569214308,2.103077357823963 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441058,117.12343790295968,93.53234569214308,1.2522238914916715 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441069,327.86666520464615,93.53234569214308,3.5053826863682267 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441064,296.27048641690595,93.53234569214308,3.167572503656276 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441063,320.125783979741,93.53234569214308,3.4226211436353644 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441074,100.31165271696044,42.30806113801961,2.3709820308172107 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441076,117.62367484971604,42.30806113801961,2.780171713990812 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441058,41.328820741428984,42.30806113801961,0.9768545196766144 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441069,96.4313272186432,42.30806113801961,2.2792660458738534 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441064,366.66775600790487,42.30806113801961,8.66661686083278 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441063,44.683007321990914,42.30806113801961,1.05613460225047 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441074,542.304611127225,205.3077634331321,2.6414228184013675 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441076,384.3874551931163,205.3077634331321,1.8722499761598628 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441058,853.2895667949075,205.3077634331321,4.156148567040527 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441069,143.87985673111177,205.3077634331321,0.7008008578203272 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441064,575.5677411913719,205.3077634331321,2.8034387573406687 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441063,330.20745167343455,205.3077634331321,1.6083534599556522 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441074,743.6541717196116,761.179367641068,0.9769762599112902 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441076,632.5997691380271,761.179367641068,0.8310784501404507 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441058,523.0945170336819,761.179367641068,0.6872158380419287 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441069,448.0148890151213,761.179367641068,0.5885799169826966 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441064,1107.9881681457712,761.179367641068,1.4556203376603343 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441063,860.9326186031838,761.179367641068,1.1310509128370834 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441074,812438.2559095537,258075.7105503754,3.1480616838250217 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441076,872701.4097390628,258075.7105503754,3.38157127564593 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441058,875724.8565696947,258075.7105503754,3.393286623921768 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441069,941207.6877325288,258075.7105503754,3.64702158806537 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441064,1035410.7571890976,258075.7105503754,4.012042648186332 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441063,1024530.9800136876,258075.7105503754,3.969885340347452 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441074,234.38933641257017,131.47736122215045,1.7827353259435648 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441076,252.48837720577524,131.47736122215045,1.9203943162439865 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441058,305.5215008452186,131.47736122215045,2.3237574743304656 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441069,158.1970493946973,131.47736122215045,1.2032265321130076 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441064,354.5193957769728,131.47736122215045,2.6964291987725537 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441063,220.7682586635368,131.47736122215045,1.6791351500469818 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441074,2387.4116205102155,3004.2024881525895,0.7946906474930507 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441076,2664.0043601425755,3004.2024881525895,0.8867592549598026 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441058,2408.0453008918685,3004.2024881525895,0.801558919676109 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441069,3316.206238960643,3004.2024881525895,1.1038557660605353 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441064,2958.4034204543173,3004.2024881525895,0.9847549997448953 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441063,2343.5618556057757,3004.2024881525895,0.7800945058956165 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441074,117.20711071551142,96.13121274223809,1.2192409454958744 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441076,117.587507255223,96.13121274223809,1.2231980009501893 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441058,85.05156971250949,96.13121274223809,0.8847445828085301 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441069,198.16676552087816,96.13121274223809,2.061419593782028 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441064,124.40432631399412,96.13121274223809,1.2941096108666212 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441063,84.88165151555575,96.13121274223809,0.8829770174974655 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441074,209.19519540729675,490.807523353751,0.4262265459539802 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441076,213.59665612971816,490.807523353751,0.4351943398711265 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441058,256.20927029853885,490.807523353751,0.5220157762615942 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441069,204.7656343891009,490.807523353751,0.417201498848084 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441064,402.58289347749735,490.807523353751,0.8202459708168217 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441063,475.4879721244824,490.807523353751,0.9687870488932441 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441074,186.54994338723273,78.64120835950264,2.372165271602047 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441076,129.02274321915206,78.64120835950264,1.6406505687111756 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441058,181.81170898587692,78.64120835950264,2.311913979687821 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441069,103.72029191267166,78.64120835950264,1.3189051144601158 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441064,152.35466661215816,78.64120835950264,1.9373388302438046 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441063,352.0992256108097,78.64120835950264,4.477286564586004 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441074,1961.0749162658544,1710.8868039225827,1.1462330013707867 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441076,1629.0666880011904,1710.8868039225827,0.9521767800571016 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441058,2676.1471497658695,1710.8868039225827,1.5641871476419225 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441069,1649.5347265312737,1710.8868039225827,0.964140189023233 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441064,1881.8542454944304,1710.8868039225827,1.0999291368545643 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441063,1654.8942149042848,1710.8868039225827,0.9672727681983855 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441074,207.1761527467286,158.21676846284709,1.3094449770371734 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441076,361.73699157767817,158.21676846284709,2.2863378837283124 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441058,227.9907267762856,158.21676846284709,1.4410022969836036 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441069,256.34294309522403,158.21676846284709,1.6202008521961389 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441064,150.96684766242055,158.21676846284709,0.9541772918833885 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441063,223.49391624700635,158.21676846284709,1.4125804642476176 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441074,889.2285085172812,1068.4447009417866,0.8322644192380436 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441076,935.9074742509802,1068.4447009417866,0.8759531245987924 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441058,1147.7599178284106,1068.4447009417866,1.0742342741900552 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441069,566.8355739284486,1068.4447009417866,0.5305240162909772 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441064,965.7252210080268,1068.4447009417866,0.9038607427757215 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441063,899.5978118111071,1068.4447009417866,0.8419694636682195 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441074,156.8688562380015,101.193417409009,1.5501883448007348 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441076,144.27913386406564,101.193417409009,1.4257758810626038 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441058,175.77107418982266,101.193417409009,1.7369813046176874 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441069,147.1506770907677,101.193417409009,1.4541526599107346 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441064,164.7628894979528,101.193417409009,1.6281977001725843 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441063,141.41911445419785,101.193417409009,1.39751298132963 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441074,9738.503566419196,8195.704907369402,1.188244779001565 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441076,9274.809417108014,8195.704907369402,1.1316670770769583 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441058,11314.70596680398,8195.704907369402,1.3805653198457695 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441069,8610.226291819978,8195.704907369402,1.0505778806259662 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441064,11006.791893616,8195.704907369402,1.3429951441661754 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441063,8138.538701368172,8195.704907369402,0.9930248579411605 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441074,68.08717296493553,54.484574340672744,1.2496596291495379 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441076,73.3614156031188,54.484574340672744,1.346462122369092 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441058,12.100709863291362,54.484574340672744,0.22209423510643417 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441069,88.12798196215958,54.484574340672744,1.6174850043083118 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441064,80.11147173761218,54.484574340672744,1.4703514289513124 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441063,30.295882108876423,54.484574340672744,0.5560451279190878 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441074,104.06547343639627,181.8259570369428,0.5723356287092309 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441076,194.5298723288139,181.8259570369428,1.0698685462675164 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441058,555.9382362893069,181.8259570369428,3.0575295483051037 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441069,99.40964909601448,181.8259570369428,0.5467296898419005 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441064,87.26725049807797,181.8259570369428,0.4799493533277391 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441063,189.2051552852384,181.8259570369428,1.0405838548497028 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441074,624.1746015930245,598.5025834222519,1.0428937466300972 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441076,625.2242176559146,598.5025834222519,1.0446474835260824 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441058,610.7656370622286,598.5025834222519,1.0204895584073443 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441069,643.452986763331,598.5025834222519,1.0751047774665425 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441064,694.4483130944025,598.5025834222519,1.160309633291022 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441063,613.1183294954741,598.5025834222519,1.0244205229485377 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441074,16713.884419355607,15066.853658787537,1.109314844218153 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441076,14160.754304427115,15066.853658787537,0.9398614087001534 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441058,15840.385646472609,15066.853658787537,1.0513399814721052 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441069,20925.01382721893,15066.853658787537,1.3888111148550712 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441064,16360.272335401613,15066.853658787537,1.0858453069171283 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441063,16584.79575704511,15066.853658787537,1.1007471189827516 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441074,61.862289088690886,62.8704966822211,0.9839637405979755 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441076,62.11741203037472,62.8704966822211,0.9880216525781108 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441058,1927.8146120305144,62.8704966822211,30.663263593647947 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441069,61.47947320163996,62.8704966822211,0.9778747814318683 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441064,64.98411649616622,62.8704966822211,1.033618627583434 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441063,66.04913951854198,62.8704966822211,1.0505585768216104 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441074,97.39724654990462,100.49015468400951,0.9692217795481506 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441076,99.44262377358692,100.49015468400951,0.9895757856705809 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441058,99.47581805505943,100.49015468400951,0.9899061093881321 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441069,97.02839449555536,100.49015468400951,0.9655512502758143 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441064,97.43294240069996,100.49015468400951,0.9695769969414125 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441063,98.82435598273511,100.49015468400951,0.9834232646321176 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441074,148.71998564113542,109.95671552102958,1.3525320844336446 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441076,146.03095520707896,109.95671552102958,1.3280767301488745 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441058,139.04175260683363,109.95671552102958,1.264513512867174 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441069,133.7732724233062,109.95671552102958,1.216599384488905 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441064,135.3982531683753,109.95671552102958,1.231377751934396 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441063,130.84127805189414,109.95671552102958,1.1899343976573247 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441074,260.0395728858153,243.54938966397899,1.0677077583507293 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441076,269.3461905237324,243.54938966397899,1.1059202032710689 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441058,254.851761193368,243.54938966397899,1.0464068973647715 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441069,262.2142076298664,243.54938966397899,1.0766366854445373 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441064,270.5408097680722,243.54938966397899,1.1108252422284155 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441063,271.2876900365743,243.54938966397899,1.1138918903096633 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441074,427.2412665646776,49.66723175069083,8.602075281933445 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441076,447.66025425541864,49.66723175069083,9.013191161981602 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441058,153.65522208123667,49.66723175069083,3.0936941050494413 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441069,118.66421972932032,49.66723175069083,2.38918529474254 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441064,142.76885882489816,49.66723175069083,2.8745080769055016 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441063,138.1303153276619,49.66723175069083,2.781115646247802 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441074,431.665092033392,318.9289567276793,1.3534835358395305 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441076,341.37330547959743,318.9289567276793,1.0703741327918446 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441058,583.2861559099965,318.9289567276793,1.828890552600532 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441069,380.6933792679385,318.9289567276793,1.1936620091633678 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441064,424.26045589011886,318.9289567276793,1.3302663396989003 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441063,399.2004881400849,318.9289567276793,1.25169094783998 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441074,48.81791931717409,52.85511393128503,0.9236177104951556 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441076,51.576258513961406,52.85511393128503,0.9758045093046962 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441058,49.33927949461364,52.85511393128503,0.933481660048218 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441069,48.1769156463482,52.85511393128503,0.9114901485025879 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441064,57.27750951327575,52.85511393128503,1.0836701551289836 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441063,47.262808308889895,52.85511393128503,0.8941955620478751 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441074,147.4407129873891,145.91831693350866,1.0104332073304694 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441076,125.19798983510432,145.91831693350866,0.8580005064899009 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441058,114.78232989764234,145.91831693350866,0.786620434704889 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441069,114.8506269166243,145.91831693350866,0.7870884843673112 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441064,126.5501980724215,145.91831693350866,0.8672673913178923 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441063,120.2125167295296,145.91831693350866,0.823834315360884 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441074,2694.337274622378,261.347965154705,10.309386847636118 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441076,4658.6327749002685,261.347965154705,17.82540289587711 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441058,3405.416116049583,261.347965154705,13.030199466193457 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441069,1748.91554757303,261.347965154705,6.691904207242475 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441064,1560.9078385966109,261.347965154705,5.972527230784564 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441063,903.3274463484752,261.347965154705,3.4564166046357023 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441074,7954.734408148114,7540.877985370558,1.0548817291011001 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441076,6694.406190728753,7540.877985370558,0.8877489071850817 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441058,7245.990838763877,7540.877985370558,0.9608948524059443 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441069,7120.946712548385,7540.877985370558,0.9443126816748862 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441064,9032.12557853783,7540.877985370558,1.1977551680401566 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441063,6297.659387715307,7540.877985370558,0.8351360942230974 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441074,8685.838619632601,5107.556668860965,1.7005858540125856 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441076,5909.294409639001,5107.556668860965,1.156970894844096 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441058,4867.178675479698,5107.556668860965,0.9529367936636376 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441069,4520.082826457895,5107.556668860965,0.8849794763933412 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441064,6357.1980074467765,5107.556668860965,1.244665193086246 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441063,5910.661378525561,5107.556668860965,1.1572385314020797 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441074,117529.51097378916,180330.65339424144,0.6517444969094881 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441076,83763.22710679987,180330.65339424144,0.46449799593236935 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441058,101138.24141594378,180330.65339424144,0.5608488602036722 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441069,66947.54333782311,180330.65339424144,0.3712488258524824 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441064,131379.4343844196,180330.65339424144,0.7285474316848175 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441063,85508.41774230498,180330.65339424144,0.4741757218356286 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441074,368.5797784356559,98.01831453553807,3.7603154082191605 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441076,519.772881178774,98.01831453553807,5.302813904133418 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441058,470.8499108604241,98.01831453553807,4.803693198475782 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441069,618.0696223196344,98.01831453553807,6.305654461090979 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441064,405.81676858258777,98.01831453553807,4.140213698894533 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441063,481.33305130050735,98.01831453553807,4.910644031998658 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441074,2112.9604556196605,1812.4793707702274,1.1657845544039165 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441076,1716.65010320149,1812.4793707702274,0.9471280781926836 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441058,2061.875614359507,1812.4793707702274,1.1375994936059861 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441069,2367.6190013263436,1812.4793707702274,1.3062874201543078 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441064,2329.06341672033,1812.4793707702274,1.2850151313615097 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441063,1855.873780910362,1812.4793707702274,1.023942016025095 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441074,5829.2635259118,434.5650550234931,13.414018128072133 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441076,6821.343518813874,434.5650550234931,15.696944427446207 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441058,42905.49367776955,434.5650550234931,98.73203834912596 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441069,1978.712336437315,434.5650550234931,4.5533167325898845 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441064,15701.919377886255,434.5650550234931,36.13249430982754 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441063,1015.0941160276664,434.5650550234931,2.3358852818314837 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441074,2771608.0533065917,9833.502392298877,281.8536003486592 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441076,2433675.2215221,9833.502392298877,247.48814048472053 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441058,2791846.8565997286,9833.502392298877,283.9117483498217 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441069,2155436.884112279,9833.502392298877,219.1932028002874 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441064,2687265.426467721,9833.502392298877,273.27653152067745 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441063,1510579.1665813357,9833.502392298877,153.61557930410922 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441074,49.10502790357176,42.4088060383901,1.157896967415682 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441076,48.66880364529633,42.4088060383901,1.1476107957682053 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441058,52.058690562832254,42.4088060383901,1.2275443575493898 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441069,51.597915465865746,42.4088060383901,1.2166792769208667 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441064,98.43898671414068,42.4088060383901,2.321192127527238 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441063,41.86954281904422,42.4088060383901,0.9872841687913186 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441074,1545.5097591690865,385.8715169071063,4.005244469861061 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441076,1540.8521643147506,385.8715169071063,3.9931741442468045 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441058,1801.2903010919017,385.8715169071063,4.668109000451411 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441069,1418.5557262401978,385.8715169071063,3.676238499307782 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441064,1641.2019145072766,385.8715169071063,4.253234153331859 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441063,1233.690857117176,385.8715169071063,3.1971545010775477 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441074,1690.8562438479769,1002.6445024002205,1.6863965640865264 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441076,1549.816064418431,1002.6445024002205,1.5457283820021375 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441058,658.6808909431337,1002.6445024002205,0.6569436020108066 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441069,796.0939090636957,1002.6445024002205,0.793994189523739 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441064,903.0311057107092,1002.6445024002205,0.9006493363788982 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441063,1040.2090277560044,1002.6445024002205,1.0374654478889163 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441074,21519.94750106329,6245.085755978491,3.445901039943607 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441076,16714.734909219947,6245.085755978491,2.676462031481112 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441058,24064.962790635935,6245.085755978491,3.853423912970014 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441069,24199.1644000191,6245.085755978491,3.8749130669427507 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441064,21523.0591535429,6245.085755978491,3.446399296108726 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441063,13098.100929454116,6245.085755978491,2.097345247327494 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441074,255.6626146810504,289.8012081128336,0.8821999616423566 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441076,196.6389216467589,289.8012081128336,0.6785303723447483 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441058,346.78548674268376,289.8012081128336,1.196632301849009 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441069,236.26847093688977,289.8012081128336,0.8152777294320287 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441064,416.9961833664612,289.8012081128336,1.4389042270800487 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441063,270.78873245645536,289.8012081128336,0.9343947674332133 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441074,39499.570475299704,19122.271903916942,2.065631671475644 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441076,43564.51909464849,19122.271903916942,2.2782083276268486 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441058,61802.12882395503,19122.271903916942,3.2319448826211747 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441069,53837.38297964751,19122.271903916942,2.8154281693180843 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441064,54445.3135032259,19122.271903916942,2.847219921189046 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441063,42755.84060020562,19122.271903916942,2.2359184523177738 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441074,72.14494352842921,111.01681566749893,0.6498559978923105 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441076,54.257545423443155,111.01681566749893,0.4887326761915717 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441058,123.04224254150682,111.01681566749893,1.10832076926098 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441069,41.41478354784106,111.01681566749893,0.3730496438654885 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441064,228.84036714880145,111.01681566749893,2.0613126558609833 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441063,57.05144106489445,111.01681566749893,0.5138990946719859 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441074,2072.015802453315,1048.3386659324408,1.9764756083000796 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441076,2056.51510631905,1048.3386659324408,1.961689645864479 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441058,2437.340704398408,1048.3386659324408,2.324955459150717 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441069,2604.9641209620654,1048.3386659324408,2.4848497967449195 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441064,2401.0591220203687,1048.3386659324408,2.2903468125777424 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441063,1915.6445749966217,1048.3386659324408,1.8273146238412936 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441074,51072.20347381242,5453.602601951663,9.36485607798694 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441076,68070.03285839477,5453.602601951663,12.481663558330188 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441058,61951.11104687701,5453.602601951663,11.35966728208373 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441069,55929.09528697436,5453.602601951663,10.255440186815079 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441064,81238.27874308219,5453.602601951663,14.896259348638589 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441063,29673.016081089685,5453.602601951663,5.440993458245509 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441074,167273.72149043484,64173.361133824874,2.6065912480664384 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441076,237726.10290404403,64173.361133824874,3.704435901499664 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441058,117481.7920202899,64173.361133824874,1.830694075307938 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441069,240765.28774727636,64173.361133824874,3.751794880202595 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441064,125343.46618240472,64173.361133824874,1.9532008915820671 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441063,219655.05571487657,64173.361133824874,3.4228385709268934 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441074,40.420444889078425,44.60879663763593,0.906109286413168 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441076,57.26679564715605,44.60879663763593,1.2837556707109357 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441058,68.75104776226564,44.60879663763593,1.5411993361027176 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441069,45.53173208825692,44.60879663763593,1.0206895392879152 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441064,28.348819389013084,44.60879663763593,0.6354984112056389 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441063,181.2350350253088,44.60879663763593,4.062764492337883 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441074,137.9255585963331,136.29080299882398,1.01199461417454 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441076,136.4021827382759,136.29080299882398,1.0008172212431157 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441058,138.4502234270877,136.29080299882398,1.0158442123808042 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441069,133.2494494055328,136.29080299882398,0.9776848215259439 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441064,137.78042182246557,136.29080299882398,1.0109297090549423 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441063,138.1224482380437,136.29080299882398,1.0134392431397996 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441074,72.19232924392632,82.77341642135346,0.872168050626729 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441076,33.81480533286485,82.77341642135346,0.4085225280630253 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441058,19.21738735102616,82.77341642135346,0.23216858964961798 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441069,172.21307641007803,82.77341642135346,2.0805360447300734 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441064,88.73245361262966,82.77341642135346,1.0719921618426627 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441063,109.12989719794037,82.77341642135346,1.3184172155275156 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441074,4416.7089993614145,2141.365658987758,2.0625664658548932 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441076,4385.542223608452,2141.365658987758,2.048011840108399 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441058,6313.180191486032,2141.365658987758,2.948202781243035 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441069,2782.761499122551,2141.365658987758,1.2995265369287685 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441064,4280.2564163735515,2141.365658987758,1.9988442414813292 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441063,4131.576871409588,2141.365658987758,1.9294121272882563 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441074,253.2909480145279,285.0677067828484,0.8885290826977937 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441076,383.80140314600567,285.0677067828484,1.3463517403546803 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441058,516.4839375620741,285.0677067828484,1.8117939186830025 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441069,326.58978534428354,285.0677067828484,1.1456569003554822 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441064,0.10439721519973603,285.0677067828484,3.6621901645022555e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441063,273.1355326185514,285.0677067828484,0.9581426661793495 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441074,669593.0069611162,724296.655045942,0.9244734216239671 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441076,360370.521297409,724296.655045942,0.4975454722686118 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441058,642419.5354648089,724296.655045942,0.8869563748351983 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441069,362699.2839499864,724296.655045942,0.5007606778564792 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441064,624477.0012346982,724296.655045942,0.8621840193298804 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441063,451335.10024349985,724296.655045942,0.6231356959875394 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441074,44.97754785990825,126.94877083842833,0.3542968361399306 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441076,30.78311911658644,126.94877083842833,0.24248457793864803 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441058,13.505592946879624,126.94877083842833,0.10638616551922833 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441069,91.2122554281465,126.94877083842833,0.71849656224112 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441064,113.6724527943935,126.94877083842833,0.8954198771965108 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441063,74.78694831453677,126.94877083842833,0.5891112440129134 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441074,43360.51561487056,94593.87687362579,0.45838607157203987 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441076,24102.254952170853,94593.87687362579,0.25479719986919075 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441058,52601.79699710869,94593.87687362579,0.5560803588522216 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441069,19914.171939438376,94593.87687362579,0.21052284352446018 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441064,34924.57453796257,94593.87687362579,0.36920544640136294 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441063,19645.438267275615,94593.87687362579,0.20768192314943654 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441074,145.9409204617782,34.2642969985689,4.259270822567107 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441076,10.126504238898567,34.2642969985689,0.29554098948306207 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441058,23.431490184222337,34.2642969985689,0.6838456421621896 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441069,188.67887141031431,34.2642969985689,5.506573545582878 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441064,123.1559707577784,34.2642969985689,3.5942943981288216 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441063,6.56410044513605,34.2642969985689,0.1915725994731545 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441074,18.661190279579227,74.66086218948179,0.24994608597231296 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441076,94.4882968007512,74.66086218948179,1.2655666440195852 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441058,140.82799637264804,74.66086218948179,1.8862358703445012 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441069,19.79134864315682,74.66086218948179,0.26508331223028686 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441064,11.105041711880284,74.66086218948179,0.14873980002664317 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441063,106.43861864142988,74.66086218948179,1.425628040181204 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441074,379.06968936902473,347.6986105145094,1.0902249186676176 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441076,396.51892485235607,347.6986105145094,1.1404098632019393 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441058,62.162328933565185,347.6986105145094,0.1787822184321647 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441069,720.9442591803165,347.6986105145094,2.0734746627646694 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441064,795.5074997214607,347.6986105145094,2.2879225733582973 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441063,64.35626802280483,347.6986105145094,0.1850921058544732 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441074,6327.533533132412,2521.321340016667,2.509610113041198 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441076,7351.373823998273,2521.321340016667,2.9156830219624754 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441058,5758.781460911187,2521.321340016667,2.2840331256122712 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441069,9438.743549953417,2521.321340016667,3.743570246341953 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441064,7235.031453084818,2521.321340016667,2.8695396093530037 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441063,6558.405706785728,2521.321340016667,2.6011780421223003 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441074,154.13637758473396,79.44971561377609,1.9400494563634116 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441076,182.11733431841137,79.44971561377609,2.2922339357855845 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441058,563.1511790964577,79.44971561377609,7.0881459391757815 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441069,198.00616471519317,79.44971561377609,2.4922199303739245 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441064,281.0767608840307,79.44971561377609,3.5377944239651087 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441063,160.35861528890015,79.44971561377609,2.0183661332211864 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441074,57.166595707692686,42.37178439720435,1.3491665862310127 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441076,235.9743624361615,42.37178439720435,5.569139128625673 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441058,87.13,42.37178439720435,2.056321234508801 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441069,134.49346799022968,42.37178439720435,3.174128017112808 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441064,781.6200450758272,42.37178439720435,18.4467106164025 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441063,185.81736146922003,42.37178439720435,4.385403260984215 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441074,7137.694385006356,1321.2949146990686,5.402044846764586 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441076,7691.825571835203,1321.2949146990686,5.821429785482111 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441058,1410.9505483960545,1321.2949146990686,1.0678543697546927 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441069,4198.660331497347,1321.2949146990686,3.1776859842479697 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441064,2435.260978669896,1321.2949146990686,1.8430866202376466 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441063,3086.0746302928555,1321.2949146990686,2.3356440685278232 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441074,66724.7207092465,23354.026662177774,2.8570970511611287 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441076,81989.44467161459,23354.026662177774,3.5107198367807735 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441058,82254.5344072455,23354.026662177774,3.522070758806577 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441069,73991.90412448332,23354.026662177774,3.1682718014668714 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441064,101192.48603579692,23354.026662177774,4.332978098362789 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441063,68247.45493576908,23354.026662177774,2.922299264404667 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441074,29641.558743211088,13473.54115415771,2.1999827962127236 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441076,27927.37261126087,13473.54115415771,2.072756693413368 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441058,38949.63282100759,13473.54115415771,2.8908237541537756 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441069,38731.79224444733,13473.54115415771,2.874655727198736 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441064,53627.789366456935,13473.54115415771,3.9802297519912417 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441063,12584.319665006562,13473.54115415771,0.9340023918747783 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441074,154330.70832474082,49612.48263442616,3.1107233528694764 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441076,120969.5804696823,49612.48263442616,2.43828919752025 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441058,147554.1789116138,49612.48263442616,2.9741341508523056 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441069,103928.2460848533,49612.48263442616,2.094800351973061 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441064,147341.86915049772,49612.48263442616,2.969854789090055 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441063,109230.14403151735,49612.48263442616,2.201666561143272 diff --git a/runs/GC-MS analysis/individual_values_cv.csv b/runs/GC-MS analysis/individual_values_cv.csv new file mode 100644 index 0000000000000000000000000000000000000000..7d5e2d515ddc0fe684ed90beaf5375d9edbd7340 --- /dev/null +++ b/runs/GC-MS analysis/individual_values_cv.csv @@ -0,0 +1,3649 @@ +genotype,tissue,alias,met,cv,jack_rep +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_1,0.8939367547320193,1 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_1,1.2055740826631427,2 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_1,1.1613955947142218,3 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_1,0.6556610650635764,4 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_10,0.15155861839377882,5 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_10,0.05973748468501778,6 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_10,0.18940222430132753,7 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_10,0.17874423098435638,8 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_100,0.5817897061610094,9 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_100,0.7065821177949169,10 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_100,0.8587211846288855,11 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_100,0.4618314259629445,12 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_101,0.08065152027427178,13 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_101,0.06007771777338856,14 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_101,0.03216376678361679,15 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_101,0.08148117855768183,16 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_102,0.17513478276974112,17 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_102,0.3265784525216312,18 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_102,0.3692013517277152,19 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_102,0.2647577806926047,20 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_103,0.7410095721724579,21 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_103,0.9771404178193415,22 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_103,0.7188967462700926,23 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_103,0.5127547336983145,24 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_104,0.7535198403090319,25 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_104,0.9894560010558255,26 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_104,0.7317039427613096,27 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_104,0.5127547336983144,28 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_105,0.02804055708506263,29 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_105,0.06459073004723073,30 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_105,0.06932635251981605,31 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_105,0.0575465898476604,32 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_106,0.2640199897461953,33 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_106,0.29041308469335747,34 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_106,0.21834500076454438,35 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_106,0.1175780464033934,36 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_107,0.43787041081329303,37 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_107,0.5065205457910112,38 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_107,0.3342939419705188,39 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_107,0.28375041691676484,40 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_108,0.6866182238547792,41 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_108,0.7630224714491147,42 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_108,0.6385042028386222,43 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_108,0.20594097385400087,44 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_109,0.13005622773638656,45 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_109,0.13227563020257718,46 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_109,0.09630922657595588,47 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_109,0.080864704109131,48 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_11,0.7074314471481791,49 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_11,0.7733661292388219,50 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_11,0.48775100072217903,51 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_11,0.43196803380017995,52 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_110,0.4559968978889927,53 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_110,0.5579636075634289,54 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_110,0.3821542074962182,55 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_110,0.3210249135782463,56 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_111,0.2555874687273671,57 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_111,0.5173669106605786,58 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_111,0.5356491300483331,59 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_111,0.36245512471272706,60 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_112,0.06590175610916821,61 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_112,0.0388013756874348,62 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_112,0.04421121637030195,63 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_112,0.06574615702665226,64 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_12,0.6289272699661839,65 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_12,0.7078390134740361,66 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_12,0.41951470558498066,67 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_12,0.4321196059376848,68 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_120,0.031201089796849782,69 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_120,0.08018243204188352,70 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_120,0.07585360849107993,71 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_120,0.06556744606019546,72 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_121,0.18663188774475586,73 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_121,0.29046940108762476,74 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_121,0.17093617653287363,75 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_121,0.304594015818588,76 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_122,0.05628226114165241,77 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_122,0.05134432965832155,78 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_122,0.05783779388456501,79 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_122,0.011262160747471526,80 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_123,0.34430332235469263,81 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_123,0.1000502004705755,82 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_123,0.3422272544130112,83 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_123,0.3934541387582169,84 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_13,0.8175191051360339,85 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_13,1.0707252818589705,86 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_13,0.704284311605449,87 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_13,0.6674692464795922,88 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_14,0.5806450155329645,89 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_14,0.6603963516759909,90 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_14,0.48013088918939195,91 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_14,0.28342625367180907,92 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_15,0.1884126295879448,93 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_15,0.29615669471831635,94 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_15,0.40685580167000707,95 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_15,0.42489667071298076,96 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_16,0.27917401115171897,97 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_16,0.5408185309256619,98 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_16,0.5860643092998015,99 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_16,0.4392110125903182,100 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_17,1.0518452827981595,101 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_17,1.2653646017132423,102 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_17,1.003982041941377,103 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_17,0.5841559531429785,104 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_18,0.4172527461805813,105 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_18,0.32187027092579906,106 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_18,0.3124251666182083,107 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_18,0.3102153219574327,108 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_19,0.09823375569920262,109 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_19,0.10416401705387966,110 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_19,0.057947462033232415,111 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_19,0.08822744168663214,112 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_2,1.691046684981659,113 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_2,1.6869790977135002,114 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_2,0.20204465463971893,115 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_2,1.69513329946275,116 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_20,0.2206407022119121,117 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_20,0.4654122246205525,118 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_20,0.5139714939733094,119 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_20,0.48994185363077364,120 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_21,0.5448398449876611,121 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_21,0.5056542663052633,122 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_21,0.3901185956422196,123 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_21,0.23111898573245512,124 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_22,0.6247626792621688,125 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_22,0.2197684302530969,126 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_22,0.547606819950989,127 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_22,0.6447917054523181,128 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_23,0.2820475115421963,129 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_23,0.2873170036223449,130 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_23,0.33633660167917323,131 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_23,0.11055581860410824,132 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_24,0.11104141109848183,133 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_24,0.19534117072787163,134 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_24,0.19582874507733478,135 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_24,0.11576610701630961,136 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_25,0.13513194945850482,137 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_25,0.1304158132524112,138 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_25,0.04559047627480431,139 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_25,0.10554521361713877,140 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_26,0.16791477154098153,141 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_26,0.16991840402817704,142 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_26,0.030856184202430362,143 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_26,0.15313110103592495,144 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_27,0.05636162031821513,145 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_27,0.19389339347834794,146 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_27,0.15749559024837292,147 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_27,0.1910133529617447,148 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_28,0.2373426289120273,149 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_28,0.2704113631399141,150 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_28,0.23202369475832318,151 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_28,0.07647831199608247,152 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_29,0.8127392956557679,153 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_29,0.9150589278981508,154 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_29,0.7273000923580626,155 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_29,0.3186244022841951,156 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_3,0.21388602194576573,157 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_3,0.20645403281705924,158 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_3,0.1891290560634233,159 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_3,0.10950693194911827,160 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_30,0.20882313481882117,161 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_30,0.198053219508774,162 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_30,0.12663333153069314,163 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_30,0.19814141726416695,164 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_31,0.38131890913411925,165 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_31,0.36397942042908443,166 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_31,0.26866674394992407,167 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_31,0.16519360002066405,168 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_32,0.25039237298593975,169 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_32,0.20264296191766465,170 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_32,0.2629502179013478,171 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_32,0.2418963906818857,172 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_33,0.7439701014094474,173 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_33,0.7308668672394075,174 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_33,0.9819715419988251,175 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_33,0.5622602703013923,176 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_34,0.19569180190581908,177 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_34,0.22212327234035534,178 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_34,0.16442850883359916,179 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_34,0.11743591478885615,180 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_35,0.9226885411812694,181 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_35,0.6283047553454121,182 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_35,0.5737049050035524,183 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_35,0.694232809586748,184 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_36,0.11365808207243092,185 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_36,0.11396240130720951,186 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_36,0.07388373168226138,187 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_36,0.09044173609266551,188 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_37,0.12132909230345437,189 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_37,0.11773779992686902,190 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_37,0.07448142245413705,191 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_37,0.10254224280152027,192 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_38,0.6472488837937458,193 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_38,0.5006607649311114,194 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_38,0.5245567920829228,195 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_38,0.4069977356136437,196 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_39,1.0626962431132823,197 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_39,0.9702685613617908,198 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_39,0.6614555178795305,199 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_39,0.6449752505258819,200 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_4,0.40163041247323816,201 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_4,0.4223767836680156,202 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_4,0.2818053213382693,203 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_4,0.48157686511212716,204 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_40,0.6145587996139553,205 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_40,0.6057372893272266,206 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_40,0.5907245721671364,207 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_40,0.03755295413284503,208 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_41,0.1616526740835048,209 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_41,0.16161474732179712,210 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_41,0.06919025618115811,211 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_41,0.11666676842207659,212 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_42,0.04274427160527863,213 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_42,0.0430662844669021,214 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_42,0.05499097371797315,215 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_42,0.0530009910646976,216 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_43,0.2094138032973207,217 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_43,0.29199932694429215,218 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_43,0.3033150483617933,219 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_43,0.324344658622421,220 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_44,0.7300662747840466,221 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_44,0.9667081818751543,222 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_44,0.6831813609808236,223 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_44,0.5430761204038334,224 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_45,0.7763949943066389,225 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_45,0.9630395643424048,226 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_45,0.6770579084142446,227 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_45,0.5030624749903932,228 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_46,0.8596613708410407,229 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_46,0.8855121921629067,230 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_46,0.5812097021334841,231 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_46,0.4995577704338645,232 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_47,0.7719089763383109,233 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_47,0.827709697412435,234 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_47,0.5937401265025706,235 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_47,0.37176957827478113,236 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_48,0.4552273936918019,237 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_48,0.35351126186512294,238 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_48,0.389178465930745,239 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_48,0.18033109258379681,240 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_49,0.049907462616215224,241 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_49,0.04480332678283623,242 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_49,0.05267709011868062,243 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_49,0.04371296496264288,244 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_5,0.30039642009959167,245 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_5,0.25063675291626675,246 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_5,0.30118916109361876,247 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_5,0.09223629008996259,248 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_50,0.20187183150583118,249 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_50,0.169633507891392,250 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_50,0.049990299187511716,251 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_50,0.19466693065809307,252 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_51,0.08070845730746734,253 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_51,0.0549186015655718,254 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_51,0.058905246882015865,255 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_51,0.07643234884740584,256 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_52,0.050314888086997474,257 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_52,0.0592383655532411,258 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_52,0.02408175370900123,259 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_52,0.06239288127097749,260 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_53,0.13741721789135777,261 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_53,0.048677489670427884,262 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_53,0.11261957697615207,263 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_53,0.14379891598386385,264 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_54,0.11781830723309669,265 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_54,0.038572215773697016,266 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_54,0.09655957049631808,267 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_54,0.12149445293472187,268 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_55,0.17971926559376755,269 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_55,0.19856632230590487,270 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_55,0.31634464796905754,271 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_55,0.3015881129822266,272 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_56,0.10410241387795621,273 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_56,0.393065263105786,274 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_56,0.37103291420869167,275 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_56,0.32467925817524856,276 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_57,0.39892977718737394,277 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_57,0.4170277122835824,278 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_57,0.35676782464852697,279 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_57,0.09180732674500666,280 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_58,0.3683207424902346,281 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_58,0.31056080304772515,282 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_58,0.09234714058457813,283 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_58,0.3662567175817884,284 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_59,0.6145810824230251,285 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_59,0.7531755175292799,286 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_59,0.4929284407019936,287 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_59,0.4364677406297466,288 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_6,0.5735544828650831,289 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_6,0.43521851776061543,290 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_6,0.6822921562687023,291 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_6,0.41338193943671236,292 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_60,0.5118881507035277,293 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_60,0.522699724219832,294 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_60,0.13404742738757452,295 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_60,0.5106224281339237,296 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_61,0.22361749809198353,297 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_61,0.13128307867421032,298 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_61,0.1335824883957741,299 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_61,0.21644055578295157,300 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_62,0.9024960053598869,301 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_62,1.175658958654835,302 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_62,0.891893989201268,303 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_62,0.6160069781930632,304 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_63,0.35600127750980515,305 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_63,0.4065815484913974,306 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_63,0.258448861464586,307 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_63,0.26604045351500943,308 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_64,0.42010196009902667,309 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_64,0.5782672878744041,310 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_64,0.4325913007942809,311 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_64,0.3604539503067122,312 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_65,0.16351776770406098,313 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_65,0.3100091894091073,314 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_65,0.29745220923289095,315 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_65,0.23766131516342345,316 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_66,0.16544179591084257,317 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_66,0.2594480903247794,318 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_66,0.24872742010601984,319 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_66,0.2244116468325469,320 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_67,0.3878604283445053,321 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_67,0.42321532149988733,322 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_67,0.3185464630210209,323 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_67,0.16053285912069093,324 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_68,0.059898127343777675,325 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_68,0.11943832488375464,326 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_68,0.11123404899224137,327 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_68,0.08638708794572358,328 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_69,0.20959701773599868,329 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_69,0.18343718886404412,330 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_69,0.2082585739835811,331 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_69,0.1299483689400012,332 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_7,0.45725895193828886,333 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_7,0.520634217820607,334 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_7,0.30152316903729204,335 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_7,0.3570420716095867,336 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_70,0.6004067856652859,337 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_70,0.5934271079467376,338 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_70,0.6872695450898277,339 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_70,0.33478713959174616,340 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_71,0.4635831430221098,341 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_71,0.5511348423065533,342 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_71,0.4449431362789007,343 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_71,0.19604124913796697,344 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_72,0.27427514546422443,345 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_72,0.37620841194327287,346 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_72,0.30841972297727593,347 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_72,0.22678842930898974,348 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_73,0.4362145587979628,349 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_73,0.46063818965782694,350 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_73,0.38744117395276345,351 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_73,0.11141647946215627,352 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_74,0.23108624661592927,353 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_74,0.23538033775542358,354 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_74,0.12462677623337627,355 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_74,0.18196110241966937,356 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_75,0.10696551471089444,357 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_75,0.1111744380992235,358 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_75,0.07235958856588505,359 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_75,0.06723604281970394,360 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_76,0.33799078688068585,361 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_76,0.21886488518808203,362 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_76,0.4539782756701479,363 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_76,0.48607328143062695,364 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_77,0.05133443362415227,365 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_77,0.06462963580454553,366 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_77,0.07647753546179314,367 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_77,0.07861198972948535,368 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_78,0.9844071150595989,369 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_78,0.03241212590576127,370 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_78,1.0012472735376667,371 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_78,0.9956428225996076,372 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_79,0.12873353952769892,373 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_79,0.1677757679862551,374 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_79,0.15391024642692722,375 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_79,0.0679799159971214,376 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_8,0.3099763307650566,377 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_8,0.3179793993876274,378 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_8,0.2604771491243071,379 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_8,0.08787923217537205,380 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_80,0.04201765623979536,381 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_80,0.08226314133461109,382 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_80,0.09162556742109765,383 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_80,0.08055428005142588,384 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_81,0.7283279589963687,385 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_81,0.8958941482438082,386 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_81,0.6194765687835165,387 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_81,0.4727327183684557,388 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_82,0.13605543645632018,389 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_82,0.15626636726891863,390 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_82,0.14813660887042993,391 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_82,0.046483799613439826,392 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_83,0.32391652178678504,393 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_83,0.31332437793883783,394 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_83,0.22354036519780207,395 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_83,0.14594532948378985,396 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_84,1.246707365738483,397 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_84,1.5103627325212212,398 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_84,1.257655922492615,399 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_84,0.8668559819089281,400 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_85,0.20425737065860153,401 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_85,0.21019263222005238,402 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_85,0.2244662048335527,403 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_85,0.035127550316112956,404 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_86,0.2909389991857008,405 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_86,0.2242829460014148,406 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_86,0.257896033731616,407 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_86,0.11749485660710184,408 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_87,0.1514025445276283,409 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_87,0.17873217692309665,410 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_87,0.158099921226677,411 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_87,0.055790752355451334,412 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_88,0.11224904637553022,413 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_88,0.1115730031330517,414 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_88,0.06583594296256756,415 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_88,0.08580753327067314,416 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_89,0.8454835391254552,417 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_89,1.0825724937508492,418 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_89,0.6330178306930353,419 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_89,0.7629692497078213,420 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_9,0.6892891156180422,421 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_9,0.3350477647226701,422 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_9,0.48724825555890594,423 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_9,0.6987631114891991,424 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_90,0.10872717574517936,425 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_90,0.19255562931655998,426 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_90,0.19103197298192023,427 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_90,0.16262394484832035,428 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_91,0.3817998636914496,429 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_91,0.3806670308735426,430 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_91,0.34474562357077915,431 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_91,0.07893996612836514,432 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_92,0.35374643244195836,433 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_92,0.256059492858683,434 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_92,0.14920301700114533,435 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_92,0.3551358588477701,436 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_93,0.8599375218840436,437 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_93,1.097019202874769,438 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_93,0.63286991518408,439 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_93,0.753441278606687,440 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_94,0.03846028077951686,441 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_94,0.07370458634442843,442 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_94,0.09840751975898238,443 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_94,0.09824465056139464,444 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_97,0.2476693005375127,445 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_97,0.28824518253196707,446 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_97,0.07903851865965611,447 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_97,0.28534863703924945,448 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_98,0.48993191444031625,449 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_98,0.5934632663745883,450 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_98,0.4426097075589611,451 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_98,0.2692649224282004,452 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_99,0.6552550008084664,453 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_99,0.8073812687762335,454 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_99,0.5795838615436821,455 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_99,0.39654337545541896,456 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_1,0.1758664311038279,457 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_1,0.1017360041673783,458 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_1,0.17147211603522478,459 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_1,0.12347721824817988,460 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_10,0.007742557270940676,461 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_10,0.004006065404260934,462 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_10,0.007582551782975866,463 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_10,0.005259790109186748,464 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_100,0.3229172674415845,465 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_100,0.3004103301982804,466 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_100,0.24646644094858344,467 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_100,0.11744796383760366,468 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_101,0.22965868850595275,469 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_101,0.2464070686681748,470 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_101,0.39073877258563655,471 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_101,0.36053265837370746,472 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_102,0.07159628607478809,473 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_102,0.035257144586831705,474 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_102,0.06341119451476632,475 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_102,0.05794863014176235,476 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_103,0.04182588141344099,477 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_103,0.041637664547530685,478 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_103,0.024532152242514316,479 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_103,0.024795816896526608,480 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_104,0.041831755194249386,481 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_104,0.04164405338308923,482 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_104,0.024532152242514316,483 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_104,0.024802759807233177,484 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_105,0.10562783325481427,485 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_105,0.11465892888569817,486 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_105,0.11546595637411985,487 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_105,0.12010371860408561,488 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_106,0.05269165501024461,489 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_106,0.051631257719876894,490 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_106,0.04465589156282499,491 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_106,0.012920165338592578,492 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_107,0.4934753957782315,493 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_107,0.5930129721739923,494 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_107,0.3833275554264618,495 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_107,0.3601898442815191,496 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_108,0.5287075421145098,497 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_108,0.5830806213839467,498 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_108,0.39364796101797217,499 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_108,0.6621275645076481,500 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_109,0.3837041292006477,501 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_109,0.3489219703017534,502 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_109,0.28537339655242777,503 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_109,0.22358839173678563,504 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_11,0.5743865497874281,505 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_11,0.7560313730741113,506 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_11,0.4559113875473923,507 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_11,0.5895582109144071,508 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_110,0.7435474793576734,509 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_110,0.5881408823354507,510 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_110,0.5360933175903488,511 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_110,0.4425515243324335,512 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_111,0.4160396978878393,513 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_111,0.4157441921629888,514 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_111,0.36805225286019533,515 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_111,0.10091949433971555,516 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_112,0.38639518357503544,517 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_112,0.43791047328428223,518 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_112,0.17841039796034336,519 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_112,0.427911508375716,520 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_12,0.6055256239349156,521 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_12,0.8488890261144378,522 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_12,0.5918183383039568,523 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_12,0.536720718355773,524 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_120,0.15751017310056603,525 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_120,0.1511934227270142,526 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_120,0.142132346409656,527 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_120,0.09854322360886238,528 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_121,0.8994344988507367,529 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_121,1.134578603716888,530 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_121,0.935281063653902,531 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_121,0.4844125850896445,532 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_122,0.2537602021630423,533 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_122,0.21638143505023713,534 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_122,0.21749701615748593,535 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_122,0.20330938439412183,536 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_123,0.08615549863443431,537 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_123,0.10639099436259335,538 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_123,0.16196577700817757,539 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_123,0.1635005435819099,540 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_13,0.4827281033713623,541 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_13,0.5518132046239408,542 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_13,0.36312220757746944,543 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_13,0.29746209703748455,544 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_14,0.25406534179683027,545 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_14,0.25737578167819136,546 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_14,0.2585304004041276,547 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_14,0.007205801660387445,548 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_15,0.13189801315435554,549 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_15,0.15118740218088103,550 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_15,0.08012551993099817,551 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_15,0.17067586600599086,552 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_16,0.4923610189878977,553 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_16,0.4258350899339677,554 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_16,0.5377237750753345,555 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_16,0.2599885404460584,556 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_17,0.3494879311345775,557 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_17,0.314284826481388,558 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_17,0.2939498117076737,559 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_17,0.4264860403864137,560 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_18,0.6642054093811324,561 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_18,0.6202159769799145,562 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_18,0.2855652135041934,563 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_18,0.7255854458939902,564 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_19,0.2602660375170124,565 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_19,0.09483533515430702,566 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_19,0.1969607326258815,567 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_19,0.2551242700749034,568 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_2,0.2133073390893557,569 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_2,0.23736305410488812,570 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_2,0.2282256875477838,571 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_2,0.056843496923577715,572 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_20,0.3316655013477071,573 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_20,0.4111417018930862,574 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_20,0.39898365179617507,575 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_20,0.17515942919765828,576 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_21,0.39614116287238516,577 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_21,0.4760974187543351,578 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_21,0.49755545818985236,579 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_21,0.1535629904559267,580 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_22,0.3600309723239824,581 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_22,0.513500212147417,582 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_22,0.26122372255586385,583 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_22,0.43658587185027126,584 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_23,0.40231249304843403,585 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_23,0.4126639660790626,586 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_23,0.19903801025103343,587 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_23,0.28695213732253627,588 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_24,0.38445997934979287,589 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_24,0.4666485055756658,590 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_24,0.3088252154188784,591 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_24,0.3486423839463111,592 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_25,0.27146760487079363,593 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_25,0.2741329453791212,594 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_25,0.22016353686121967,595 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_25,0.0836216769243511,596 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_26,0.12326283289155816,597 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_26,0.01615597853123216,598 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_26,0.12862087448141502,599 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_26,0.11904808772131571,600 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_27,0.11346118026380847,601 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_27,0.06948544249062996,602 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_27,0.1141051896592504,603 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_27,0.06323980087253077,604 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_28,0.2602842122837483,605 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_28,0.23541547438657914,606 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_28,0.22434708739176248,607 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_28,0.21132555788896473,608 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_29,0.4413407437879572,609 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_29,0.5638500050016015,610 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_29,0.4189877974759012,611 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_29,0.2965609698843086,612 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_3,0.3708881341099874,613 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_3,0.4251335524953781,614 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_3,0.10932364428150461,615 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_3,0.44273413555380126,616 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_30,0.08485798206457285,617 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_30,0.0688396764453676,618 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_30,0.057886310875553355,619 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_30,0.08425745415891407,620 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_31,0.1464434754798651,621 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_31,0.14609826640902138,622 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_31,0.139552386669635,623 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_31,0.012024886280352884,624 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_32,0.3378433853301113,625 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_32,0.3968572074465108,626 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_32,0.3367633861354123,627 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_32,0.12243216663569702,628 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_33,0.4611701557576193,629 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_33,0.15160620396575478,630 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_33,0.4260426916042957,631 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_33,0.36183065857866653,632 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_34,0.32053081431565134,633 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_34,0.3425368101047693,634 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_34,0.3358444632063878,635 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_34,0.05269751736769258,636 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_35,0.8580616707460401,637 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_35,0.3065611825052953,638 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_35,0.6886637308644623,639 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_35,0.7245081970730637,640 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_36,0.7097278304081786,641 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_36,0.22035801794609172,642 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_36,0.5734504372005141,643 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_36,0.6335669864569928,644 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_37,0.32885301140816936,645 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_37,0.21919268711061635,646 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_37,0.24894142900031094,647 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_37,0.2651973680185051,648 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_38,0.47747372286551665,649 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_38,0.4424366630122098,650 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_38,0.4703217142704021,651 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_38,0.17933274735106888,652 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_39,0.1031425118297718,653 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_39,0.07842039085988269,654 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_39,0.09515621985002534,655 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_39,0.10500492516875631,656 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_4,0.013610212982817825,657 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_4,0.09765685088633143,658 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_4,0.10051676912879669,659 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_4,0.0931714318433553,660 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_40,0.07578862828201793,661 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_40,0.07606823005932249,662 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_40,0.049577018244372266,663 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_40,0.05657543253365163,664 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_41,0.15352431548772358,665 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_41,0.1338601154359789,666 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_41,0.15176266043955833,667 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_41,0.034819411406279595,668 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_42,0.04504323957713649,669 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_42,0.06128153623192214,670 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_42,0.06076141245776074,671 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_42,0.024986947464251192,672 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_43,0.05917045398571084,673 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_43,0.06033453153253072,674 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_43,0.017187839297452063,675 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_43,0.04945991710385414,676 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_44,0.43551888257544213,677 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_44,0.4790525183128831,678 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_44,0.34969137656609967,679 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_44,0.5329054028112774,680 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_45,0.5737654550250539,681 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_45,0.7352246039914251,682 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_45,0.4712673485952861,683 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_45,0.7647513231507577,684 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_46,0.961753407614578,685 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_46,1.1909849763354514,686 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_46,0.8700756448938013,687 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_46,0.6318923132911003,688 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_47,0.6462258400438204,689 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_47,0.74222025336532,690 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_47,0.6191409398891606,691 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_47,0.21614660242780145,692 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_48,0.22241799535767046,693 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_48,0.24661837387233032,694 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_48,0.1686126842859297,695 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_48,0.17374968011976524,696 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_49,0.036955219991931944,697 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_49,0.03735887072132842,698 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_49,0.021533835911846648,699 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_49,0.023175491579563785,700 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_5,0.4248544202973477,701 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_5,0.5179234745123369,702 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_5,0.3307509621783188,703 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_5,0.397176633598687,704 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_50,0.326081024543145,705 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_50,0.4321359119499668,706 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_50,0.36437056764923154,707 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_50,0.19548133199638373,708 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_51,0.09815143274842072,709 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_51,0.052693272767953055,710 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_51,0.09919771955396003,711 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_51,0.06197529887484918,712 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_52,0.08690148547855901,713 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_52,0.08221466790081891,714 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_52,0.0715496764345958,715 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_52,0.0468060761012064,716 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_53,0.10744885606116256,717 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_53,0.2666135778052455,718 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_53,0.26636120129937035,719 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_53,0.20903767713003435,720 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_54,0.339254377979767,721 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_54,0.4643339983589222,722 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_54,0.40091362661136143,723 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_54,0.21137814507021813,724 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_55,0.30550046347472953,725 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_55,0.3320908581058612,726 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_55,0.09522272724835376,727 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_55,0.27233496652352773,728 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_56,0.2755565886922943,729 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_56,0.293739591276042,730 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_56,0.17367446725453986,731 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_56,0.18054669446641264,732 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_57,0.37301807341617743,733 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_57,0.140448416258941,734 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_57,0.3807942605717597,735 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_57,0.4460296203579793,736 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_58,0.5209177552649226,737 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_58,0.6496300683573465,738 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_58,0.3857609527220086,739 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_58,0.5228053365103661,740 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_59,0.10569996035578122,741 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_59,0.07643644305829915,742 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_59,0.14489654887131234,743 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_59,0.14510211109613172,744 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_6,0.471917390358837,745 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_6,0.5132528264953209,746 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_6,0.33785384524571455,747 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_6,0.2598527768799562,748 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_60,0.5921875608630609,749 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_60,0.48103973510867365,750 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_60,0.36455452327987514,751 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_60,0.5144860714601659,752 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_61,0.19364707219272223,753 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_61,0.08170322901295639,754 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_61,0.20989511648784284,755 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_61,0.16025059878159162,756 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_62,0.1716315150148774,757 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_62,0.17375504643005632,758 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_62,0.13473300238003016,759 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_62,0.07086387728934701,760 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_63,0.895130752447736,761 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_63,1.128915763302277,762 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_63,0.8388462652194661,763 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_63,0.5741566094672366,764 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_64,0.22002551534408057,765 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_64,0.21908912517536097,766 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_64,0.22507142609239522,767 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_64,0.16927066913002778,768 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_65,0.13486949079818855,769 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_65,0.1138996543417675,770 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_65,0.059573541932994474,771 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_65,0.11319048075165931,772 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_66,0.2593375042416545,773 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_66,0.2568275288886486,774 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_66,0.30000459911523997,775 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_66,0.2292411255795111,776 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_67,0.8256669970564133,777 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_67,0.2483886289658019,778 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_67,0.8469619975709941,779 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_67,0.7029591483432812,780 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_68,0.20086086366205752,781 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_68,0.24789926301058327,782 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_68,0.20041169865244854,783 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_68,0.18451907197781872,784 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_69,0.3470760619163573,785 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_69,0.40321053260023554,786 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_69,0.3212727046667102,787 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_69,0.14853579570934553,788 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_7,0.49655961704440765,789 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_7,0.41319033225470136,790 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_7,0.48902312010066046,791 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_7,0.1316517216446414,792 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_70,0.395222659227681,793 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_70,0.4852488579283514,794 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_70,0.39163016355944164,795 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_70,0.19318351873176817,796 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_71,0.36965081351996965,797 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_71,0.24842520529117473,798 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_71,0.1794675612411691,799 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_71,0.34609054636939907,800 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_72,0.41874456727078946,801 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_72,0.4210423214489316,802 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_72,0.4058972788272596,803 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_72,0.17886207916868502,804 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_73,0.017670537391824438,805 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_73,0.01849044046155078,806 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_73,0.02891555775613709,807 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_73,0.028980961087720646,808 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_74,0.08190258782631951,809 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_74,0.08338830413826348,810 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_74,0.0835264637409529,811 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_74,0.08991732721612113,812 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_75,0.061863839273396434,813 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_75,0.03958349691823032,814 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_75,0.03796052612586279,815 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_75,0.06250076178769633,816 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_76,0.10226584059767237,817 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_76,0.2112954476233843,818 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_76,0.15844602963054955,819 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_76,0.18777519027420006,820 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_77,0.12520566720057322,821 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_77,0.11886661264037944,822 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_77,0.04630718041646203,823 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_77,0.09616687540749924,824 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_78,0.03317956601430996,825 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_78,0.03097400424533092,826 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_78,0.026616200327723643,827 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_78,0.017353210045565087,828 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_79,0.034881984949085974,829 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_79,0.02941551283898497,830 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_79,0.04449877340332306,831 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_79,0.04705277070738494,832 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_8,0.2496860838449485,833 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_8,0.15607726129076546,834 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_8,0.17379522176221776,835 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_8,0.2695837498377997,836 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_80,0.13333147804784712,837 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_80,0.12809131658830405,838 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_80,0.07608632692699595,839 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_80,0.08608433319909782,840 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_81,0.12332252507165768,841 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_81,0.09678008655295546,842 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_81,0.11401671343514595,843 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_81,0.04663882023994859,844 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_82,0.4190960561791408,845 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_82,0.4708604407328037,846 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_82,0.4399233050391969,847 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_82,0.28967545942447354,848 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_83,0.1672832863324039,849 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_83,0.050190640796422784,850 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_83,0.17553158514205885,851 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_83,0.19411499911118318,852 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_84,1.2034125028477332,853 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_84,1.6853194573817265,854 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_84,1.188278511590102,855 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_84,1.5711767823419376,856 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_85,0.572664890412262,857 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_85,0.8124359034046132,858 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_85,0.5816314809683875,859 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_85,0.5072758078693547,860 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_86,0.4272972920749277,861 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_86,0.4151304710543904,862 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_86,0.16461039959187815,863 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_86,0.4168326611120535,864 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_87,0.3924554806153593,865 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_87,0.4136235276100624,866 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_87,0.21388720274341258,867 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_87,0.28412210025282886,868 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_88,0.3168458007231412,869 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_88,0.32509259210982094,870 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_88,0.15288905586424545,871 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_88,0.25144438545813874,872 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_89,0.31476234209547066,873 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_89,0.3329924819728035,874 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_89,0.19241301797090143,875 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_89,0.28093145758244803,876 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_9,0.02071259165830203,877 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_9,0.01688602417025527,878 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_9,0.026522628490959516,879 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_9,0.024810558278664768,880 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_90,0.2787563868652815,881 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_90,0.28371054417182956,882 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_90,0.18846723230186666,883 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_90,0.2764000933710149,884 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_91,0.2937058186594378,885 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_91,0.2874455727441744,886 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_91,0.2654128530623332,887 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_91,0.06207434524344747,888 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_92,0.7117369367669423,889 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_92,0.6209050952082966,890 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_92,0.5964951572407529,891 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_92,0.3319032443490176,892 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_93,0.41168608307690513,893 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_93,0.3540443938202077,894 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_93,0.1548375740445481,895 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_93,0.32573126885973125,896 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_94,0.4573675973825296,897 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_94,0.4695929042354297,898 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_94,0.3411223795868888,899 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_94,0.19210998418447092,900 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_97,0.3079613431834071,901 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_97,0.28338107212990665,902 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_97,0.13480493205295604,903 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_97,0.29853039336902,904 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_98,0.5400680604414317,905 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_98,0.6817846301456607,906 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_98,0.4102936463916261,907 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_98,0.5128189861294897,908 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_99,0.2998988065977432,909 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_99,0.32323465385228456,910 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_99,0.2155501656300603,911 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_99,0.29398494686007454,912 +MoneyMaker,fruit,967514 MM WT,m_1,0.5676429678228355,913 +MoneyMaker,fruit,967514 MM WT,m_1,0.24840968846190623,914 +MoneyMaker,fruit,967514 MM WT,m_1,0.5748470463704872,915 +MoneyMaker,fruit,967514 MM WT,m_1,0.4352590016227044,916 +MoneyMaker,fruit,967514 MM WT,m_10,0.09515425202858242,917 +MoneyMaker,fruit,967514 MM WT,m_10,0.09268471962424735,918 +MoneyMaker,fruit,967514 MM WT,m_10,0.06486704704316569,919 +MoneyMaker,fruit,967514 MM WT,m_10,0.06939101436731175,920 +MoneyMaker,fruit,967514 MM WT,m_100,0.3064158156988269,921 +MoneyMaker,fruit,967514 MM WT,m_100,0.32546576230855573,922 +MoneyMaker,fruit,967514 MM WT,m_100,0.0629496282236778,923 +MoneyMaker,fruit,967514 MM WT,m_100,0.3326852030492372,924 +MoneyMaker,fruit,967514 MM WT,m_101,0.16947699405198594,925 +MoneyMaker,fruit,967514 MM WT,m_101,0.18410301096210396,926 +MoneyMaker,fruit,967514 MM WT,m_101,0.13274522012783688,927 +MoneyMaker,fruit,967514 MM WT,m_101,0.1402376879861443,928 +MoneyMaker,fruit,967514 MM WT,m_102,0.11717782753279228,929 +MoneyMaker,fruit,967514 MM WT,m_102,0.11656878563298183,930 +MoneyMaker,fruit,967514 MM WT,m_102,0.10827915247736736,931 +MoneyMaker,fruit,967514 MM WT,m_102,0.015139315577638373,932 +MoneyMaker,fruit,967514 MM WT,m_103,1.152172304026806,933 +MoneyMaker,fruit,967514 MM WT,m_103,0.8784830149851316,934 +MoneyMaker,fruit,967514 MM WT,m_103,0.8670744919871984,935 +MoneyMaker,fruit,967514 MM WT,m_103,0.6097496457502017,936 +MoneyMaker,fruit,967514 MM WT,m_104,1.1723856404704778,937 +MoneyMaker,fruit,967514 MM WT,m_104,0.8784830149851315,938 +MoneyMaker,fruit,967514 MM WT,m_104,0.8848322403237798,939 +MoneyMaker,fruit,967514 MM WT,m_104,0.6384689453249738,940 +MoneyMaker,fruit,967514 MM WT,m_105,0.0692021672606118,941 +MoneyMaker,fruit,967514 MM WT,m_105,0.09459340832926444,942 +MoneyMaker,fruit,967514 MM WT,m_105,0.09340505383274482,943 +MoneyMaker,fruit,967514 MM WT,m_105,0.04115125414412133,944 +MoneyMaker,fruit,967514 MM WT,m_106,0.2691642431946965,945 +MoneyMaker,fruit,967514 MM WT,m_106,0.24069784414376746,946 +MoneyMaker,fruit,967514 MM WT,m_106,0.20337331241735487,947 +MoneyMaker,fruit,967514 MM WT,m_106,0.11470445716637366,948 +MoneyMaker,fruit,967514 MM WT,m_107,0.5733270462230367,949 +MoneyMaker,fruit,967514 MM WT,m_107,0.5120071677162301,950 +MoneyMaker,fruit,967514 MM WT,m_107,0.3204401724260165,951 +MoneyMaker,fruit,967514 MM WT,m_107,0.5626993720458983,952 +MoneyMaker,fruit,967514 MM WT,m_108,0.5811270929875566,953 +MoneyMaker,fruit,967514 MM WT,m_108,0.6012021538851487,954 +MoneyMaker,fruit,967514 MM WT,m_108,0.47716848904726866,955 +MoneyMaker,fruit,967514 MM WT,m_108,0.19252211978753908,956 +MoneyMaker,fruit,967514 MM WT,m_109,0.5796459988362292,957 +MoneyMaker,fruit,967514 MM WT,m_109,0.5682280210329234,958 +MoneyMaker,fruit,967514 MM WT,m_109,0.5273160032387982,959 +MoneyMaker,fruit,967514 MM WT,m_109,0.16749922637992762,960 +MoneyMaker,fruit,967514 MM WT,m_11,1.0155197885690392,961 +MoneyMaker,fruit,967514 MM WT,m_11,0.807038666239123,962 +MoneyMaker,fruit,967514 MM WT,m_11,0.7063458024751554,963 +MoneyMaker,fruit,967514 MM WT,m_11,0.5545304210407498,964 +MoneyMaker,fruit,967514 MM WT,m_110,0.703704503334757,965 +MoneyMaker,fruit,967514 MM WT,m_110,0.5893367757180983,966 +MoneyMaker,fruit,967514 MM WT,m_110,0.5492010444098717,967 +MoneyMaker,fruit,967514 MM WT,m_110,0.27167329423117026,968 +MoneyMaker,fruit,967514 MM WT,m_111,0.33786393352931726,969 +MoneyMaker,fruit,967514 MM WT,m_111,0.26557561871020297,970 +MoneyMaker,fruit,967514 MM WT,m_111,0.3870601852301198,971 +MoneyMaker,fruit,967514 MM WT,m_111,0.21171437897067036,972 +MoneyMaker,fruit,967514 MM WT,m_112,0.5381104391958039,973 +MoneyMaker,fruit,967514 MM WT,m_112,0.3279506810654164,974 +MoneyMaker,fruit,967514 MM WT,m_112,0.4499091291782706,975 +MoneyMaker,fruit,967514 MM WT,m_112,0.4030844637545829,976 +MoneyMaker,fruit,967514 MM WT,m_12,0.8021059335860972,977 +MoneyMaker,fruit,967514 MM WT,m_12,0.6323966468409069,978 +MoneyMaker,fruit,967514 MM WT,m_12,0.5732032234395297,979 +MoneyMaker,fruit,967514 MM WT,m_12,0.41568171039849927,980 +MoneyMaker,fruit,967514 MM WT,m_120,0.22071027797762693,981 +MoneyMaker,fruit,967514 MM WT,m_120,0.20472483072044917,982 +MoneyMaker,fruit,967514 MM WT,m_120,0.15379126981608626,983 +MoneyMaker,fruit,967514 MM WT,m_120,0.10914573292013588,984 +MoneyMaker,fruit,967514 MM WT,m_121,0.08559883380704396,985 +MoneyMaker,fruit,967514 MM WT,m_121,0.13929044086942088,986 +MoneyMaker,fruit,967514 MM WT,m_121,0.07573870080843449,987 +MoneyMaker,fruit,967514 MM WT,m_121,0.13947161627204202,988 +MoneyMaker,fruit,967514 MM WT,m_122,0.360823335272139,989 +MoneyMaker,fruit,967514 MM WT,m_122,0.32242033907443424,990 +MoneyMaker,fruit,967514 MM WT,m_122,0.2766330022410208,991 +MoneyMaker,fruit,967514 MM WT,m_122,0.13878760296555867,992 +MoneyMaker,fruit,967514 MM WT,m_123,0.7338830149356576,993 +MoneyMaker,fruit,967514 MM WT,m_123,0.70355676668315,994 +MoneyMaker,fruit,967514 MM WT,m_123,0.7367628224602684,995 +MoneyMaker,fruit,967514 MM WT,m_123,0.058909560936124615,996 +MoneyMaker,fruit,967514 MM WT,m_13,1.11952484423435,997 +MoneyMaker,fruit,967514 MM WT,m_13,1.0017931257687964,998 +MoneyMaker,fruit,967514 MM WT,m_13,0.8065498221335027,999 +MoneyMaker,fruit,967514 MM WT,m_13,0.5659426831331165,1000 +MoneyMaker,fruit,967514 MM WT,m_14,1.1831421568904488,1001 +MoneyMaker,fruit,967514 MM WT,m_14,1.0677124841544843,1002 +MoneyMaker,fruit,967514 MM WT,m_14,1.060079842439209,1003 +MoneyMaker,fruit,967514 MM WT,m_14,0.2910174736454507,1004 +MoneyMaker,fruit,967514 MM WT,m_15,0.30644194260962654,1005 +MoneyMaker,fruit,967514 MM WT,m_15,0.2785987252230329,1006 +MoneyMaker,fruit,967514 MM WT,m_15,0.31393320280920606,1007 +MoneyMaker,fruit,967514 MM WT,m_15,0.0971698433067801,1008 +MoneyMaker,fruit,967514 MM WT,m_16,0.7986643809033941,1009 +MoneyMaker,fruit,967514 MM WT,m_16,0.5806809315044548,1010 +MoneyMaker,fruit,967514 MM WT,m_16,0.7460158920841156,1011 +MoneyMaker,fruit,967514 MM WT,m_16,0.39359329572885926,1012 +MoneyMaker,fruit,967514 MM WT,m_17,1.1783633837054834,1013 +MoneyMaker,fruit,967514 MM WT,m_17,1.0769389066508788,1014 +MoneyMaker,fruit,967514 MM WT,m_17,0.8027310427898191,1015 +MoneyMaker,fruit,967514 MM WT,m_17,0.7007465639678551,1016 +MoneyMaker,fruit,967514 MM WT,m_18,0.5727239024304167,1017 +MoneyMaker,fruit,967514 MM WT,m_18,0.5886071936874835,1018 +MoneyMaker,fruit,967514 MM WT,m_18,0.22825332738259405,1019 +MoneyMaker,fruit,967514 MM WT,m_18,0.6207094551819347,1020 +MoneyMaker,fruit,967514 MM WT,m_19,0.1360868042826611,1021 +MoneyMaker,fruit,967514 MM WT,m_19,0.20839189899031677,1022 +MoneyMaker,fruit,967514 MM WT,m_19,0.10563476797571872,1023 +MoneyMaker,fruit,967514 MM WT,m_19,0.20748530190988304,1024 +MoneyMaker,fruit,967514 MM WT,m_2,0.3378496562718353,1025 +MoneyMaker,fruit,967514 MM WT,m_2,0.6560068435350723,1026 +MoneyMaker,fruit,967514 MM WT,m_2,0.7819881333337452,1027 +MoneyMaker,fruit,967514 MM WT,m_2,0.8642469097445388,1028 +MoneyMaker,fruit,967514 MM WT,m_20,0.09558162182265749,1029 +MoneyMaker,fruit,967514 MM WT,m_20,0.0868905055333267,1030 +MoneyMaker,fruit,967514 MM WT,m_20,0.09658777087504358,1031 +MoneyMaker,fruit,967514 MM WT,m_20,0.07705438186656538,1032 +MoneyMaker,fruit,967514 MM WT,m_21,0.6372411954649235,1033 +MoneyMaker,fruit,967514 MM WT,m_21,0.5054243083182317,1034 +MoneyMaker,fruit,967514 MM WT,m_21,0.41947935056860586,1035 +MoneyMaker,fruit,967514 MM WT,m_21,0.631425763200237,1036 +MoneyMaker,fruit,967514 MM WT,m_22,0.37821850788562705,1037 +MoneyMaker,fruit,967514 MM WT,m_22,0.5259993989478895,1038 +MoneyMaker,fruit,967514 MM WT,m_22,0.3911969345974167,1039 +MoneyMaker,fruit,967514 MM WT,m_22,0.6221329775841757,1040 +MoneyMaker,fruit,967514 MM WT,m_23,0.06383617208266486,1041 +MoneyMaker,fruit,967514 MM WT,m_23,0.009997901093241324,1042 +MoneyMaker,fruit,967514 MM WT,m_23,0.06055150207259833,1043 +MoneyMaker,fruit,967514 MM WT,m_23,0.05898193241396735,1044 +MoneyMaker,fruit,967514 MM WT,m_24,0.4281367457597265,1045 +MoneyMaker,fruit,967514 MM WT,m_24,0.3800778733325176,1046 +MoneyMaker,fruit,967514 MM WT,m_24,0.4917405910575231,1047 +MoneyMaker,fruit,967514 MM WT,m_24,0.18652718964187992,1048 +MoneyMaker,fruit,967514 MM WT,m_25,0.03867340095698865,1049 +MoneyMaker,fruit,967514 MM WT,m_25,0.048770684119550316,1050 +MoneyMaker,fruit,967514 MM WT,m_25,0.061707255184308786,1051 +MoneyMaker,fruit,967514 MM WT,m_25,0.06600981343971973,1052 +MoneyMaker,fruit,967514 MM WT,m_26,0.39618591980639367,1053 +MoneyMaker,fruit,967514 MM WT,m_26,0.36682823730023684,1054 +MoneyMaker,fruit,967514 MM WT,m_26,0.41191308252568803,1055 +MoneyMaker,fruit,967514 MM WT,m_26,0.06903113716539239,1056 +MoneyMaker,fruit,967514 MM WT,m_27,0.3856168225234132,1057 +MoneyMaker,fruit,967514 MM WT,m_27,0.3369301562220749,1058 +MoneyMaker,fruit,967514 MM WT,m_27,0.2983729443802954,1059 +MoneyMaker,fruit,967514 MM WT,m_27,0.15094669455693183,1060 +MoneyMaker,fruit,967514 MM WT,m_28,0.04156107662539585,1061 +MoneyMaker,fruit,967514 MM WT,m_28,0.2792542830271217,1062 +MoneyMaker,fruit,967514 MM WT,m_28,0.2594056409535332,1063 +MoneyMaker,fruit,967514 MM WT,m_28,0.25654418589058847,1064 +MoneyMaker,fruit,967514 MM WT,m_29,0.6605419053149029,1065 +MoneyMaker,fruit,967514 MM WT,m_29,0.5589111354811086,1066 +MoneyMaker,fruit,967514 MM WT,m_29,0.5835241499889537,1067 +MoneyMaker,fruit,967514 MM WT,m_29,0.17476416762133626,1068 +MoneyMaker,fruit,967514 MM WT,m_3,0.4447598832223161,1069 +MoneyMaker,fruit,967514 MM WT,m_3,0.4343369964899337,1070 +MoneyMaker,fruit,967514 MM WT,m_3,0.3365300120537214,1071 +MoneyMaker,fruit,967514 MM WT,m_3,0.5284881404365559,1072 +MoneyMaker,fruit,967514 MM WT,m_30,0.5905329095802782,1073 +MoneyMaker,fruit,967514 MM WT,m_30,0.5470094554046666,1074 +MoneyMaker,fruit,967514 MM WT,m_30,0.5393457871626189,1075 +MoneyMaker,fruit,967514 MM WT,m_30,0.08889407666159406,1076 +MoneyMaker,fruit,967514 MM WT,m_31,0.3343432470488718,1077 +MoneyMaker,fruit,967514 MM WT,m_31,0.2921505184441623,1078 +MoneyMaker,fruit,967514 MM WT,m_31,0.3285798688961044,1079 +MoneyMaker,fruit,967514 MM WT,m_31,0.0661961124564064,1080 +MoneyMaker,fruit,967514 MM WT,m_32,0.3012408269021858,1081 +MoneyMaker,fruit,967514 MM WT,m_32,0.32381436812047,1082 +MoneyMaker,fruit,967514 MM WT,m_32,0.07566481913023997,1083 +MoneyMaker,fruit,967514 MM WT,m_32,0.2762101094240509,1084 +MoneyMaker,fruit,967514 MM WT,m_33,0.8328874105450769,1085 +MoneyMaker,fruit,967514 MM WT,m_33,0.8384046700241439,1086 +MoneyMaker,fruit,967514 MM WT,m_33,0.8760084427847694,1087 +MoneyMaker,fruit,967514 MM WT,m_33,0.08127500315436552,1088 +MoneyMaker,fruit,967514 MM WT,m_34,0.2706429064031319,1089 +MoneyMaker,fruit,967514 MM WT,m_34,0.27204249185456186,1090 +MoneyMaker,fruit,967514 MM WT,m_34,0.07070853295064576,1091 +MoneyMaker,fruit,967514 MM WT,m_34,0.233938058292364,1092 +MoneyMaker,fruit,967514 MM WT,m_35,0.06997759779663042,1093 +MoneyMaker,fruit,967514 MM WT,m_35,0.5592731575151488,1094 +MoneyMaker,fruit,967514 MM WT,m_35,0.5604008274511887,1095 +MoneyMaker,fruit,967514 MM WT,m_35,0.5379892572938788,1096 +MoneyMaker,fruit,967514 MM WT,m_36,0.1907119531447035,1097 +MoneyMaker,fruit,967514 MM WT,m_36,0.10716197180190036,1098 +MoneyMaker,fruit,967514 MM WT,m_36,0.11423453159010816,1099 +MoneyMaker,fruit,967514 MM WT,m_36,0.1873276320158471,1100 +MoneyMaker,fruit,967514 MM WT,m_37,0.17278824718845168,1101 +MoneyMaker,fruit,967514 MM WT,m_37,0.1384335289535164,1102 +MoneyMaker,fruit,967514 MM WT,m_37,0.082135104180151,1103 +MoneyMaker,fruit,967514 MM WT,m_37,0.1696621145379726,1104 +MoneyMaker,fruit,967514 MM WT,m_38,0.42124715380922995,1105 +MoneyMaker,fruit,967514 MM WT,m_38,0.38665737617807033,1106 +MoneyMaker,fruit,967514 MM WT,m_38,0.3556517356488328,1107 +MoneyMaker,fruit,967514 MM WT,m_38,0.10442881083399257,1108 +MoneyMaker,fruit,967514 MM WT,m_39,1.621617882329694,1109 +MoneyMaker,fruit,967514 MM WT,m_39,1.6679416780858527,1110 +MoneyMaker,fruit,967514 MM WT,m_39,1.663410396384897,1111 +MoneyMaker,fruit,967514 MM WT,m_39,0.6485707154250595,1112 +MoneyMaker,fruit,967514 MM WT,m_4,0.45556290684119766,1113 +MoneyMaker,fruit,967514 MM WT,m_4,0.39854235209108335,1114 +MoneyMaker,fruit,967514 MM WT,m_4,0.49627309062794167,1115 +MoneyMaker,fruit,967514 MM WT,m_4,0.15083848697929558,1116 +MoneyMaker,fruit,967514 MM WT,m_40,0.42488649737054923,1117 +MoneyMaker,fruit,967514 MM WT,m_40,0.4827817467168935,1118 +MoneyMaker,fruit,967514 MM WT,m_40,0.3770261885364252,1119 +MoneyMaker,fruit,967514 MM WT,m_40,0.17388565669916659,1120 +MoneyMaker,fruit,967514 MM WT,m_41,0.19743063092019794,1121 +MoneyMaker,fruit,967514 MM WT,m_41,0.2122014635222759,1122 +MoneyMaker,fruit,967514 MM WT,m_41,0.15600550750180747,1123 +MoneyMaker,fruit,967514 MM WT,m_41,0.09012831422721691,1124 +MoneyMaker,fruit,967514 MM WT,m_42,0.029056007229083646,1125 +MoneyMaker,fruit,967514 MM WT,m_42,0.025812381434460602,1126 +MoneyMaker,fruit,967514 MM WT,m_42,0.03080018138642316,1127 +MoneyMaker,fruit,967514 MM WT,m_42,0.020864743744789783,1128 +MoneyMaker,fruit,967514 MM WT,m_43,1.180932906026671,1129 +MoneyMaker,fruit,967514 MM WT,m_43,1.2089943314245217,1130 +MoneyMaker,fruit,967514 MM WT,m_43,1.2683373244146172,1131 +MoneyMaker,fruit,967514 MM WT,m_43,0.21682579945194488,1132 +MoneyMaker,fruit,967514 MM WT,m_44,0.7136502359654586,1133 +MoneyMaker,fruit,967514 MM WT,m_44,0.6730122727430321,1134 +MoneyMaker,fruit,967514 MM WT,m_44,0.5969057180284029,1135 +MoneyMaker,fruit,967514 MM WT,m_44,0.18402140869578434,1136 +MoneyMaker,fruit,967514 MM WT,m_45,0.73017343906719,1137 +MoneyMaker,fruit,967514 MM WT,m_45,0.6662805707982206,1138 +MoneyMaker,fruit,967514 MM WT,m_45,0.5918317491440076,1139 +MoneyMaker,fruit,967514 MM WT,m_45,0.2195408389481121,1140 +MoneyMaker,fruit,967514 MM WT,m_46,1.0341994686099099,1141 +MoneyMaker,fruit,967514 MM WT,m_46,0.7824106582787479,1142 +MoneyMaker,fruit,967514 MM WT,m_46,0.6913975289484847,1143 +MoneyMaker,fruit,967514 MM WT,m_46,0.632991251526723,1144 +MoneyMaker,fruit,967514 MM WT,m_47,0.8743845880921042,1145 +MoneyMaker,fruit,967514 MM WT,m_47,0.7734928044061902,1146 +MoneyMaker,fruit,967514 MM WT,m_47,0.6157409728934818,1147 +MoneyMaker,fruit,967514 MM WT,m_47,0.41484339747621457,1148 +MoneyMaker,fruit,967514 MM WT,m_48,0.6095415384655128,1149 +MoneyMaker,fruit,967514 MM WT,m_48,0.5609011519299008,1150 +MoneyMaker,fruit,967514 MM WT,m_48,0.6254447035576428,1151 +MoneyMaker,fruit,967514 MM WT,m_48,0.10248777492142817,1152 +MoneyMaker,fruit,967514 MM WT,m_49,0.04294362622064152,1153 +MoneyMaker,fruit,967514 MM WT,m_49,0.04007288291307037,1154 +MoneyMaker,fruit,967514 MM WT,m_49,0.045017185014561686,1155 +MoneyMaker,fruit,967514 MM WT,m_49,0.03420470704978969,1156 +MoneyMaker,fruit,967514 MM WT,m_5,0.39128703617947524,1157 +MoneyMaker,fruit,967514 MM WT,m_5,0.1346755069676224,1158 +MoneyMaker,fruit,967514 MM WT,m_5,0.31900758506062704,1159 +MoneyMaker,fruit,967514 MM WT,m_5,0.38953164143500474,1160 +MoneyMaker,fruit,967514 MM WT,m_50,0.14987804318188766,1161 +MoneyMaker,fruit,967514 MM WT,m_50,0.13810325060483458,1162 +MoneyMaker,fruit,967514 MM WT,m_50,0.07817133397124144,1163 +MoneyMaker,fruit,967514 MM WT,m_50,0.10775062874035289,1164 +MoneyMaker,fruit,967514 MM WT,m_51,0.09637194531530682,1165 +MoneyMaker,fruit,967514 MM WT,m_51,0.13720801142879313,1166 +MoneyMaker,fruit,967514 MM WT,m_51,0.06906423751062205,1167 +MoneyMaker,fruit,967514 MM WT,m_51,0.1372883045411406,1168 +MoneyMaker,fruit,967514 MM WT,m_52,0.009084390512966086,1169 +MoneyMaker,fruit,967514 MM WT,m_52,0.030108777469885124,1170 +MoneyMaker,fruit,967514 MM WT,m_52,0.028323682285557365,1171 +MoneyMaker,fruit,967514 MM WT,m_52,0.025025456070120605,1172 +MoneyMaker,fruit,967514 MM WT,m_53,0.28663507147696254,1173 +MoneyMaker,fruit,967514 MM WT,m_53,0.3471217868652805,1174 +MoneyMaker,fruit,967514 MM WT,m_53,0.27327487776395343,1175 +MoneyMaker,fruit,967514 MM WT,m_53,0.15869627847426093,1176 +MoneyMaker,fruit,967514 MM WT,m_54,0.32263432069063763,1177 +MoneyMaker,fruit,967514 MM WT,m_54,0.23099690374231308,1178 +MoneyMaker,fruit,967514 MM WT,m_54,0.28244368719855206,1179 +MoneyMaker,fruit,967514 MM WT,m_54,0.16647461836534436,1180 +MoneyMaker,fruit,967514 MM WT,m_55,0.27727917632179444,1181 +MoneyMaker,fruit,967514 MM WT,m_55,0.4359430857264279,1182 +MoneyMaker,fruit,967514 MM WT,m_55,0.3864754783137918,1183 +MoneyMaker,fruit,967514 MM WT,m_55,0.4935314587387512,1184 +MoneyMaker,fruit,967514 MM WT,m_56,0.24375624868456208,1185 +MoneyMaker,fruit,967514 MM WT,m_56,0.27702477773432216,1186 +MoneyMaker,fruit,967514 MM WT,m_56,0.2182067378396891,1187 +MoneyMaker,fruit,967514 MM WT,m_56,0.19873927165517885,1188 +MoneyMaker,fruit,967514 MM WT,m_57,0.5426675477820571,1189 +MoneyMaker,fruit,967514 MM WT,m_57,0.44644790459780276,1190 +MoneyMaker,fruit,967514 MM WT,m_57,0.47837051099628,1191 +MoneyMaker,fruit,967514 MM WT,m_57,0.16149308025922315,1192 +MoneyMaker,fruit,967514 MM WT,m_58,0.3421317153353382,1193 +MoneyMaker,fruit,967514 MM WT,m_58,0.7323994291422252,1194 +MoneyMaker,fruit,967514 MM WT,m_58,0.7905137333436685,1195 +MoneyMaker,fruit,967514 MM WT,m_58,0.5723795511290064,1196 +MoneyMaker,fruit,967514 MM WT,m_59,0.7588996662003972,1197 +MoneyMaker,fruit,967514 MM WT,m_59,0.6439987677430121,1198 +MoneyMaker,fruit,967514 MM WT,m_59,0.56708076087726,1199 +MoneyMaker,fruit,967514 MM WT,m_59,0.3198215891575243,1200 +MoneyMaker,fruit,967514 MM WT,m_6,0.6264531381953615,1201 +MoneyMaker,fruit,967514 MM WT,m_6,0.42729848898490336,1202 +MoneyMaker,fruit,967514 MM WT,m_6,0.6521404791414449,1203 +MoneyMaker,fruit,967514 MM WT,m_6,0.33656159193457197,1204 +MoneyMaker,fruit,967514 MM WT,m_60,0.48085052533887535,1205 +MoneyMaker,fruit,967514 MM WT,m_60,0.6095713133418283,1206 +MoneyMaker,fruit,967514 MM WT,m_60,0.4126012944645198,1207 +MoneyMaker,fruit,967514 MM WT,m_60,0.5985757819199606,1208 +MoneyMaker,fruit,967514 MM WT,m_61,0.2777382551043101,1209 +MoneyMaker,fruit,967514 MM WT,m_61,0.07251745775234907,1210 +MoneyMaker,fruit,967514 MM WT,m_61,0.2802903820550285,1211 +MoneyMaker,fruit,967514 MM WT,m_61,0.2423569134233254,1212 +MoneyMaker,fruit,967514 MM WT,m_62,0.660472563904613,1213 +MoneyMaker,fruit,967514 MM WT,m_62,0.7790213624281123,1214 +MoneyMaker,fruit,967514 MM WT,m_62,0.5244421844874338,1215 +MoneyMaker,fruit,967514 MM WT,m_62,0.408768376150901,1216 +MoneyMaker,fruit,967514 MM WT,m_63,0.8379283478641185,1217 +MoneyMaker,fruit,967514 MM WT,m_63,0.7856039784923791,1218 +MoneyMaker,fruit,967514 MM WT,m_63,0.5943362288506874,1219 +MoneyMaker,fruit,967514 MM WT,m_63,0.3886417038500033,1220 +MoneyMaker,fruit,967514 MM WT,m_64,0.5735583024369242,1221 +MoneyMaker,fruit,967514 MM WT,m_64,0.47743254566086246,1222 +MoneyMaker,fruit,967514 MM WT,m_64,0.35916801990019,1223 +MoneyMaker,fruit,967514 MM WT,m_64,0.37798295293753015,1224 +MoneyMaker,fruit,967514 MM WT,m_65,0.11890728295698394,1225 +MoneyMaker,fruit,967514 MM WT,m_65,0.1832238063344048,1226 +MoneyMaker,fruit,967514 MM WT,m_65,0.17650862399500689,1227 +MoneyMaker,fruit,967514 MM WT,m_65,0.09543419194105154,1228 +MoneyMaker,fruit,967514 MM WT,m_66,0.44043079119526757,1229 +MoneyMaker,fruit,967514 MM WT,m_66,0.3547041044911819,1230 +MoneyMaker,fruit,967514 MM WT,m_66,0.35763326044561344,1231 +MoneyMaker,fruit,967514 MM WT,m_66,0.18252738427056167,1232 +MoneyMaker,fruit,967514 MM WT,m_67,0.48325926428362215,1233 +MoneyMaker,fruit,967514 MM WT,m_67,0.4657533568013959,1234 +MoneyMaker,fruit,967514 MM WT,m_67,0.39679941113425493,1235 +MoneyMaker,fruit,967514 MM WT,m_67,0.1319134682413013,1236 +MoneyMaker,fruit,967514 MM WT,m_68,0.14393469097764452,1237 +MoneyMaker,fruit,967514 MM WT,m_68,0.13947390377206667,1238 +MoneyMaker,fruit,967514 MM WT,m_68,0.1859757388769843,1239 +MoneyMaker,fruit,967514 MM WT,m_68,0.1682631002582881,1240 +MoneyMaker,fruit,967514 MM WT,m_69,0.2709473920319044,1241 +MoneyMaker,fruit,967514 MM WT,m_69,0.1384763421290897,1242 +MoneyMaker,fruit,967514 MM WT,m_69,0.17800966760651163,1243 +MoneyMaker,fruit,967514 MM WT,m_69,0.2671671191950284,1244 +MoneyMaker,fruit,967514 MM WT,m_7,0.5564819929064554,1245 +MoneyMaker,fruit,967514 MM WT,m_7,0.6007014241930703,1246 +MoneyMaker,fruit,967514 MM WT,m_7,0.33879409864435067,1247 +MoneyMaker,fruit,967514 MM WT,m_7,0.3765568957932127,1248 +MoneyMaker,fruit,967514 MM WT,m_70,0.25512191549469077,1249 +MoneyMaker,fruit,967514 MM WT,m_70,0.33376016090020943,1250 +MoneyMaker,fruit,967514 MM WT,m_70,0.18996319010332785,1251 +MoneyMaker,fruit,967514 MM WT,m_70,0.3539853080196328,1252 +MoneyMaker,fruit,967514 MM WT,m_71,0.7605327745648437,1253 +MoneyMaker,fruit,967514 MM WT,m_71,0.7734400269730463,1254 +MoneyMaker,fruit,967514 MM WT,m_71,0.6988419933816289,1255 +MoneyMaker,fruit,967514 MM WT,m_71,0.12723610726678541,1256 +MoneyMaker,fruit,967514 MM WT,m_72,0.4053000567204417,1257 +MoneyMaker,fruit,967514 MM WT,m_72,0.5169998370156702,1258 +MoneyMaker,fruit,967514 MM WT,m_72,0.38685017672315714,1259 +MoneyMaker,fruit,967514 MM WT,m_72,0.27571264792787353,1260 +MoneyMaker,fruit,967514 MM WT,m_73,0.4917387743038118,1261 +MoneyMaker,fruit,967514 MM WT,m_73,0.5484968090898132,1262 +MoneyMaker,fruit,967514 MM WT,m_73,0.46738676505589033,1263 +MoneyMaker,fruit,967514 MM WT,m_73,0.13573200423684123,1264 +MoneyMaker,fruit,967514 MM WT,m_74,0.2538772308127304,1265 +MoneyMaker,fruit,967514 MM WT,m_74,0.22932800729317285,1266 +MoneyMaker,fruit,967514 MM WT,m_74,0.1906453206782367,1267 +MoneyMaker,fruit,967514 MM WT,m_74,0.2236048151215709,1268 +MoneyMaker,fruit,967514 MM WT,m_75,0.20906431864120356,1269 +MoneyMaker,fruit,967514 MM WT,m_75,0.21167583710825158,1270 +MoneyMaker,fruit,967514 MM WT,m_75,0.18341699627313957,1271 +MoneyMaker,fruit,967514 MM WT,m_75,0.04501218481844449,1272 +MoneyMaker,fruit,967514 MM WT,m_76,0.17816344543231127,1273 +MoneyMaker,fruit,967514 MM WT,m_76,0.41608249344098763,1274 +MoneyMaker,fruit,967514 MM WT,m_76,0.4858514994425715,1275 +MoneyMaker,fruit,967514 MM WT,m_76,0.3849691582000756,1276 +MoneyMaker,fruit,967514 MM WT,m_77,0.008958256948488542,1277 +MoneyMaker,fruit,967514 MM WT,m_77,0.011307597123280168,1278 +MoneyMaker,fruit,967514 MM WT,m_77,0.012362622094865954,1279 +MoneyMaker,fruit,967514 MM WT,m_77,0.013547846172860324,1280 +MoneyMaker,fruit,967514 MM WT,m_78,0.8103224244905424,1281 +MoneyMaker,fruit,967514 MM WT,m_78,0.8013649171739416,1282 +MoneyMaker,fruit,967514 MM WT,m_78,0.7991242617594839,1283 +MoneyMaker,fruit,967514 MM WT,m_78,0.01991330751819246,1284 +MoneyMaker,fruit,967514 MM WT,m_79,0.11507151318226207,1285 +MoneyMaker,fruit,967514 MM WT,m_79,0.10797641190828804,1286 +MoneyMaker,fruit,967514 MM WT,m_79,0.08424887731428814,1287 +MoneyMaker,fruit,967514 MM WT,m_79,0.082708732713898,1288 +MoneyMaker,fruit,967514 MM WT,m_8,0.9231389194229004,1289 +MoneyMaker,fruit,967514 MM WT,m_8,0.8297152224902409,1290 +MoneyMaker,fruit,967514 MM WT,m_8,0.7430884756328497,1291 +MoneyMaker,fruit,967514 MM WT,m_8,0.3058706924259271,1292 +MoneyMaker,fruit,967514 MM WT,m_80,0.0688579341435444,1293 +MoneyMaker,fruit,967514 MM WT,m_80,0.04332225163979401,1294 +MoneyMaker,fruit,967514 MM WT,m_80,0.06757333145470677,1295 +MoneyMaker,fruit,967514 MM WT,m_80,0.05359548133090689,1296 +MoneyMaker,fruit,967514 MM WT,m_81,0.9158693789586997,1297 +MoneyMaker,fruit,967514 MM WT,m_81,0.8902615277435609,1298 +MoneyMaker,fruit,967514 MM WT,m_81,0.7658757570371953,1299 +MoneyMaker,fruit,967514 MM WT,m_81,0.26694879820394785,1300 +MoneyMaker,fruit,967514 MM WT,m_82,0.21815686682339094,1301 +MoneyMaker,fruit,967514 MM WT,m_82,0.3837258118214751,1302 +MoneyMaker,fruit,967514 MM WT,m_82,0.32750580928448547,1303 +MoneyMaker,fruit,967514 MM WT,m_82,0.45102625462384244,1304 +MoneyMaker,fruit,967514 MM WT,m_83,0.5944057123482074,1305 +MoneyMaker,fruit,967514 MM WT,m_83,0.5094051296379358,1306 +MoneyMaker,fruit,967514 MM WT,m_83,0.33075329140826487,1307 +MoneyMaker,fruit,967514 MM WT,m_83,0.5303176269930329,1308 +MoneyMaker,fruit,967514 MM WT,m_84,1.492444436441994,1309 +MoneyMaker,fruit,967514 MM WT,m_84,1.271965478525364,1310 +MoneyMaker,fruit,967514 MM WT,m_84,1.2475384938903933,1311 +MoneyMaker,fruit,967514 MM WT,m_84,0.7869896144005067,1312 +MoneyMaker,fruit,967514 MM WT,m_85,0.10864775368162857,1313 +MoneyMaker,fruit,967514 MM WT,m_85,0.08509556579630426,1314 +MoneyMaker,fruit,967514 MM WT,m_85,0.09774519732611817,1315 +MoneyMaker,fruit,967514 MM WT,m_85,0.07366964688391157,1316 +MoneyMaker,fruit,967514 MM WT,m_86,0.29859366331959925,1317 +MoneyMaker,fruit,967514 MM WT,m_86,0.31866691646491674,1318 +MoneyMaker,fruit,967514 MM WT,m_86,0.34919280537547354,1319 +MoneyMaker,fruit,967514 MM WT,m_86,0.08405765671790202,1320 +MoneyMaker,fruit,967514 MM WT,m_87,0.11534497705051817,1321 +MoneyMaker,fruit,967514 MM WT,m_87,0.08405513915600425,1322 +MoneyMaker,fruit,967514 MM WT,m_87,0.10315649768432049,1323 +MoneyMaker,fruit,967514 MM WT,m_87,0.11397808344969233,1324 +MoneyMaker,fruit,967514 MM WT,m_88,0.25194622548430834,1325 +MoneyMaker,fruit,967514 MM WT,m_88,0.1948429612709634,1326 +MoneyMaker,fruit,967514 MM WT,m_88,0.19208268083548538,1327 +MoneyMaker,fruit,967514 MM WT,m_88,0.2850107382974779,1328 +MoneyMaker,fruit,967514 MM WT,m_89,1.0509525874237893,1329 +MoneyMaker,fruit,967514 MM WT,m_89,0.7869465081635783,1330 +MoneyMaker,fruit,967514 MM WT,m_89,0.6435447862830679,1331 +MoneyMaker,fruit,967514 MM WT,m_89,0.7268420336421597,1332 +MoneyMaker,fruit,967514 MM WT,m_9,0.12311534530204028,1333 +MoneyMaker,fruit,967514 MM WT,m_9,0.028936720475754286,1334 +MoneyMaker,fruit,967514 MM WT,m_9,0.1059011431165057,1335 +MoneyMaker,fruit,967514 MM WT,m_9,0.12362360447370815,1336 +MoneyMaker,fruit,967514 MM WT,m_90,0.3791876305486519,1337 +MoneyMaker,fruit,967514 MM WT,m_90,0.2774592018036989,1338 +MoneyMaker,fruit,967514 MM WT,m_90,0.4391284415399239,1339 +MoneyMaker,fruit,967514 MM WT,m_90,0.29763599144286845,1340 +MoneyMaker,fruit,967514 MM WT,m_91,0.028700321703321867,1341 +MoneyMaker,fruit,967514 MM WT,m_91,0.12031751584297166,1342 +MoneyMaker,fruit,967514 MM WT,m_91,0.12137789967523713,1343 +MoneyMaker,fruit,967514 MM WT,m_91,0.10357257734882763,1344 +MoneyMaker,fruit,967514 MM WT,m_92,0.4533505303341319,1345 +MoneyMaker,fruit,967514 MM WT,m_92,0.40164849381813345,1346 +MoneyMaker,fruit,967514 MM WT,m_92,0.25919949943494375,1347 +MoneyMaker,fruit,967514 MM WT,m_92,0.29202177653928757,1348 +MoneyMaker,fruit,967514 MM WT,m_93,0.4021068221644323,1349 +MoneyMaker,fruit,967514 MM WT,m_93,0.8993202084729158,1350 +MoneyMaker,fruit,967514 MM WT,m_93,0.743731100792987,1351 +MoneyMaker,fruit,967514 MM WT,m_93,0.979064759189718,1352 +MoneyMaker,fruit,967514 MM WT,m_94,0.5299097661711591,1353 +MoneyMaker,fruit,967514 MM WT,m_94,0.39220269068274244,1354 +MoneyMaker,fruit,967514 MM WT,m_94,0.4522925238752067,1355 +MoneyMaker,fruit,967514 MM WT,m_94,0.23315808890630838,1356 +MoneyMaker,fruit,967514 MM WT,m_97,0.7242107881611096,1357 +MoneyMaker,fruit,967514 MM WT,m_97,0.672788617321203,1358 +MoneyMaker,fruit,967514 MM WT,m_97,0.6899244572209023,1359 +MoneyMaker,fruit,967514 MM WT,m_97,0.08502068761595395,1360 +MoneyMaker,fruit,967514 MM WT,m_98,0.3621780084221458,1361 +MoneyMaker,fruit,967514 MM WT,m_98,0.34658822734773365,1362 +MoneyMaker,fruit,967514 MM WT,m_98,0.22722805826695822,1363 +MoneyMaker,fruit,967514 MM WT,m_98,0.35229191804526255,1364 +MoneyMaker,fruit,967514 MM WT,m_99,0.5992352213871257,1365 +MoneyMaker,fruit,967514 MM WT,m_99,0.4966774861738471,1366 +MoneyMaker,fruit,967514 MM WT,m_99,0.5350315677697723,1367 +MoneyMaker,fruit,967514 MM WT,m_99,0.1677954966033985,1368 +MoneyMaker,leaf,967514 MM WT,m_1,0.5845525108364357,1369 +MoneyMaker,leaf,967514 MM WT,m_1,0.6678110981584366,1370 +MoneyMaker,leaf,967514 MM WT,m_1,0.43262434152772244,1371 +MoneyMaker,leaf,967514 MM WT,m_1,0.3626070216934184,1372 +MoneyMaker,leaf,967514 MM WT,m_10,0.04461358530495659,1373 +MoneyMaker,leaf,967514 MM WT,m_10,0.02246404358517511,1374 +MoneyMaker,leaf,967514 MM WT,m_10,0.028890927574765385,1375 +MoneyMaker,leaf,967514 MM WT,m_10,0.044374127892947694,1376 +MoneyMaker,leaf,967514 MM WT,m_100,0.43343395753422065,1377 +MoneyMaker,leaf,967514 MM WT,m_100,0.5133672685955163,1378 +MoneyMaker,leaf,967514 MM WT,m_100,0.33466994648350434,1379 +MoneyMaker,leaf,967514 MM WT,m_100,0.3135760104984041,1380 +MoneyMaker,leaf,967514 MM WT,m_101,0.10034173866997931,1381 +MoneyMaker,leaf,967514 MM WT,m_101,0.18565868194905283,1382 +MoneyMaker,leaf,967514 MM WT,m_101,0.1175489745388765,1383 +MoneyMaker,leaf,967514 MM WT,m_101,0.18730070062117588,1384 +MoneyMaker,leaf,967514 MM WT,m_102,0.0451355026613271,1385 +MoneyMaker,leaf,967514 MM WT,m_102,0.03569784684740816,1386 +MoneyMaker,leaf,967514 MM WT,m_102,0.04012595798594048,1387 +MoneyMaker,leaf,967514 MM WT,m_102,0.04056104936368879,1388 +MoneyMaker,leaf,967514 MM WT,m_103,0.13044806334281847,1389 +MoneyMaker,leaf,967514 MM WT,m_103,0.13062587436614734,1390 +MoneyMaker,leaf,967514 MM WT,m_103,0.06011310761174787,1391 +MoneyMaker,leaf,967514 MM WT,m_103,0.09098460426354371,1392 +MoneyMaker,leaf,967514 MM WT,m_104,0.1304431589678661,1393 +MoneyMaker,leaf,967514 MM WT,m_104,0.13062125943906064,1394 +MoneyMaker,leaf,967514 MM WT,m_104,0.06010723894982982,1395 +MoneyMaker,leaf,967514 MM WT,m_104,0.09098460426354371,1396 +MoneyMaker,leaf,967514 MM WT,m_105,0.16254794370068296,1397 +MoneyMaker,leaf,967514 MM WT,m_105,0.1654227762461767,1398 +MoneyMaker,leaf,967514 MM WT,m_105,0.11481930762176412,1399 +MoneyMaker,leaf,967514 MM WT,m_105,0.09238493954904528,1400 +MoneyMaker,leaf,967514 MM WT,m_106,0.09638659254360984,1401 +MoneyMaker,leaf,967514 MM WT,m_106,0.09715763943774725,1402 +MoneyMaker,leaf,967514 MM WT,m_106,0.05476690910418839,1403 +MoneyMaker,leaf,967514 MM WT,m_106,0.060682552612203115,1404 +MoneyMaker,leaf,967514 MM WT,m_107,0.5976696666658065,1405 +MoneyMaker,leaf,967514 MM WT,m_107,0.80018043943768,1406 +MoneyMaker,leaf,967514 MM WT,m_107,0.5058646515570963,1407 +MoneyMaker,leaf,967514 MM WT,m_107,0.5641580844336841,1408 +MoneyMaker,leaf,967514 MM WT,m_108,0.33734117894680643,1409 +MoneyMaker,leaf,967514 MM WT,m_108,0.18894762973433613,1410 +MoneyMaker,leaf,967514 MM WT,m_108,0.20993295237302304,1411 +MoneyMaker,leaf,967514 MM WT,m_108,0.3443089410834524,1412 +MoneyMaker,leaf,967514 MM WT,m_109,0.34315564964822054,1413 +MoneyMaker,leaf,967514 MM WT,m_109,0.3035212306647909,1414 +MoneyMaker,leaf,967514 MM WT,m_109,0.31932074312940617,1415 +MoneyMaker,leaf,967514 MM WT,m_109,0.25036886444663436,1416 +MoneyMaker,leaf,967514 MM WT,m_11,1.2464015871917287,1417 +MoneyMaker,leaf,967514 MM WT,m_11,1.3796132801427752,1418 +MoneyMaker,leaf,967514 MM WT,m_11,1.2267117637915477,1419 +MoneyMaker,leaf,967514 MM WT,m_11,0.4464079156146978,1420 +MoneyMaker,leaf,967514 MM WT,m_110,0.28703384359456324,1421 +MoneyMaker,leaf,967514 MM WT,m_110,0.2603106067962446,1422 +MoneyMaker,leaf,967514 MM WT,m_110,0.26615762450226466,1423 +MoneyMaker,leaf,967514 MM WT,m_110,0.21438914603076223,1424 +MoneyMaker,leaf,967514 MM WT,m_111,0.4958385479881655,1425 +MoneyMaker,leaf,967514 MM WT,m_111,0.47338661618062045,1426 +MoneyMaker,leaf,967514 MM WT,m_111,0.41346116572581587,1427 +MoneyMaker,leaf,967514 MM WT,m_111,0.20712025323439204,1428 +MoneyMaker,leaf,967514 MM WT,m_112,0.856030801808019,1429 +MoneyMaker,leaf,967514 MM WT,m_112,1.3191489493002262,1430 +MoneyMaker,leaf,967514 MM WT,m_112,0.6931680502565883,1431 +MoneyMaker,leaf,967514 MM WT,m_112,1.385064980094715,1432 +MoneyMaker,leaf,967514 MM WT,m_12,1.4088501102133926,1433 +MoneyMaker,leaf,967514 MM WT,m_12,1.523653476238361,1434 +MoneyMaker,leaf,967514 MM WT,m_12,1.3749645284543157,1435 +MoneyMaker,leaf,967514 MM WT,m_12,0.5871098615562068,1436 +MoneyMaker,leaf,967514 MM WT,m_120,0.11692395136389139,1437 +MoneyMaker,leaf,967514 MM WT,m_120,0.13712114839455627,1438 +MoneyMaker,leaf,967514 MM WT,m_120,0.14574157722640166,1439 +MoneyMaker,leaf,967514 MM WT,m_120,0.12831314781907976,1440 +MoneyMaker,leaf,967514 MM WT,m_121,1.0202258023408493,1441 +MoneyMaker,leaf,967514 MM WT,m_121,1.124749905072131,1442 +MoneyMaker,leaf,967514 MM WT,m_121,1.0061619661456631,1443 +MoneyMaker,leaf,967514 MM WT,m_121,0.25972626172464114,1444 +MoneyMaker,leaf,967514 MM WT,m_122,0.11940441830990546,1445 +MoneyMaker,leaf,967514 MM WT,m_122,0.06054798831540475,1446 +MoneyMaker,leaf,967514 MM WT,m_122,0.12441461987568883,1447 +MoneyMaker,leaf,967514 MM WT,m_122,0.10140419728158735,1448 +MoneyMaker,leaf,967514 MM WT,m_123,0.5118902949449636,1449 +MoneyMaker,leaf,967514 MM WT,m_123,0.5953193710440149,1450 +MoneyMaker,leaf,967514 MM WT,m_123,0.32306125264402835,1451 +MoneyMaker,leaf,967514 MM WT,m_123,0.5053105070288526,1452 +MoneyMaker,leaf,967514 MM WT,m_13,0.5969027774817215,1453 +MoneyMaker,leaf,967514 MM WT,m_13,0.7513269409826757,1454 +MoneyMaker,leaf,967514 MM WT,m_13,0.5013070220436253,1455 +MoneyMaker,leaf,967514 MM WT,m_13,0.4396147233165281,1456 +MoneyMaker,leaf,967514 MM WT,m_14,0.25643621163124586,1457 +MoneyMaker,leaf,967514 MM WT,m_14,0.34074520326647967,1458 +MoneyMaker,leaf,967514 MM WT,m_14,0.15932336420130006,1459 +MoneyMaker,leaf,967514 MM WT,m_14,0.3486822865907767,1460 +MoneyMaker,leaf,967514 MM WT,m_15,0.3178026951318177,1461 +MoneyMaker,leaf,967514 MM WT,m_15,0.24433302628706363,1462 +MoneyMaker,leaf,967514 MM WT,m_15,0.265326740279039,1463 +MoneyMaker,leaf,967514 MM WT,m_15,0.26355856939122146,1464 +MoneyMaker,leaf,967514 MM WT,m_16,0.29910641447276953,1465 +MoneyMaker,leaf,967514 MM WT,m_16,0.2976629444875804,1466 +MoneyMaker,leaf,967514 MM WT,m_16,0.32479731180677446,1467 +MoneyMaker,leaf,967514 MM WT,m_16,0.408854770906315,1468 +MoneyMaker,leaf,967514 MM WT,m_17,0.5771843403628396,1469 +MoneyMaker,leaf,967514 MM WT,m_17,0.7070152246055521,1470 +MoneyMaker,leaf,967514 MM WT,m_17,0.53949386826457435,1471 +MoneyMaker,leaf,967514 MM WT,m_17,0.3032989686334842,1472 +MoneyMaker,leaf,967514 MM WT,m_18,0.38426891668077934,1473 +MoneyMaker,leaf,967514 MM WT,m_18,0.21313444884994207,1474 +MoneyMaker,leaf,967514 MM WT,m_18,0.2524267954471318,1475 +MoneyMaker,leaf,967514 MM WT,m_18,0.40150468438295017,1476 +MoneyMaker,leaf,967514 MM WT,m_19,0.15031470507686487,1477 +MoneyMaker,leaf,967514 MM WT,m_19,0.14123622137563863,1478 +MoneyMaker,leaf,967514 MM WT,m_19,0.13235412138015962,1479 +MoneyMaker,leaf,967514 MM WT,m_19,0.043935827714074456,1480 +MoneyMaker,leaf,967514 MM WT,m_2,0.6072175835332656,1481 +MoneyMaker,leaf,967514 MM WT,m_2,0.6544986071852783,1482 +MoneyMaker,leaf,967514 MM WT,m_2,0.6759262442390028,1483 +MoneyMaker,leaf,967514 MM WT,m_2,0.197521521026295,1484 +MoneyMaker,leaf,967514 MM WT,m_20,0.577539474918243,1485 +MoneyMaker,leaf,967514 MM WT,m_20,0.514143317648343,1486 +MoneyMaker,leaf,967514 MM WT,m_20,0.2700236197822639,1487 +MoneyMaker,leaf,967514 MM WT,m_20,0.4021784683563029,1488 +MoneyMaker,leaf,967514 MM WT,m_21,0.5219587765226876,1489 +MoneyMaker,leaf,967514 MM WT,m_21,0.5596595624782907,1490 +MoneyMaker,leaf,967514 MM WT,m_21,0.4641466279907566,1491 +MoneyMaker,leaf,967514 MM WT,m_21,0.14668227381284352,1492 +MoneyMaker,leaf,967514 MM WT,m_22,0.45416322243947665,1493 +MoneyMaker,leaf,967514 MM WT,m_22,0.3252144484399605,1494 +MoneyMaker,leaf,967514 MM WT,m_22,0.2551802021243923,1495 +MoneyMaker,leaf,967514 MM WT,m_22,0.37217925322065254,1496 +MoneyMaker,leaf,967514 MM WT,m_23,0.3188505934161162,1497 +MoneyMaker,leaf,967514 MM WT,m_23,0.34448170005367584,1498 +MoneyMaker,leaf,967514 MM WT,m_23,0.2332665493043626,1499 +MoneyMaker,leaf,967514 MM WT,m_23,0.3254968769963905,1500 +MoneyMaker,leaf,967514 MM WT,m_24,0.2513337928825963,1501 +MoneyMaker,leaf,967514 MM WT,m_24,0.23249984706399907,1502 +MoneyMaker,leaf,967514 MM WT,m_24,0.1735875350123582,1503 +MoneyMaker,leaf,967514 MM WT,m_24,0.2098331961080873,1504 +MoneyMaker,leaf,967514 MM WT,m_25,0.360658974647973,1505 +MoneyMaker,leaf,967514 MM WT,m_25,0.3961393851873974,1506 +MoneyMaker,leaf,967514 MM WT,m_25,0.26610649722938,1507 +MoneyMaker,leaf,967514 MM WT,m_25,0.20069872794269777,1508 +MoneyMaker,leaf,967514 MM WT,m_26,0.10947494259580383,1509 +MoneyMaker,leaf,967514 MM WT,m_26,0.13168502196080356,1510 +MoneyMaker,leaf,967514 MM WT,m_26,0.11650143324493849,1511 +MoneyMaker,leaf,967514 MM WT,m_26,0.04740334689528718,1512 +MoneyMaker,leaf,967514 MM WT,m_27,0.261037016773495,1513 +MoneyMaker,leaf,967514 MM WT,m_27,0.2585082736087178,1514 +MoneyMaker,leaf,967514 MM WT,m_27,0.27478852013093774,1515 +MoneyMaker,leaf,967514 MM WT,m_27,0.050431358506855824,1516 +MoneyMaker,leaf,967514 MM WT,m_28,0.43195078135212883,1517 +MoneyMaker,leaf,967514 MM WT,m_28,0.4207706668982897,1518 +MoneyMaker,leaf,967514 MM WT,m_28,0.4119972091995812,1519 +MoneyMaker,leaf,967514 MM WT,m_28,0.21342312751441667,1520 +MoneyMaker,leaf,967514 MM WT,m_29,0.6142276599089211,1521 +MoneyMaker,leaf,967514 MM WT,m_29,0.8798097367899339,1522 +MoneyMaker,leaf,967514 MM WT,m_29,0.5406887940683801,1523 +MoneyMaker,leaf,967514 MM WT,m_29,0.7193233168632456,1524 +MoneyMaker,leaf,967514 MM WT,m_3,0.2999519077303168,1525 +MoneyMaker,leaf,967514 MM WT,m_3,0.5068800253908629,1526 +MoneyMaker,leaf,967514 MM WT,m_3,0.6536998860998432,1527 +MoneyMaker,leaf,967514 MM WT,m_3,0.5105772052427722,1528 +MoneyMaker,leaf,967514 MM WT,m_30,0.20494336045433048,1529 +MoneyMaker,leaf,967514 MM WT,m_30,0.22021923700860863,1530 +MoneyMaker,leaf,967514 MM WT,m_30,0.17604827350408062,1531 +MoneyMaker,leaf,967514 MM WT,m_30,0.20999559305278387,1532 +MoneyMaker,leaf,967514 MM WT,m_31,0.21285200290471512,1533 +MoneyMaker,leaf,967514 MM WT,m_31,0.20935762826503324,1534 +MoneyMaker,leaf,967514 MM WT,m_31,0.20052089873412593,1535 +MoneyMaker,leaf,967514 MM WT,m_31,0.019635243545494882,1536 +MoneyMaker,leaf,967514 MM WT,m_32,0.37211750510895225,1537 +MoneyMaker,leaf,967514 MM WT,m_32,0.4202502730840152,1538 +MoneyMaker,leaf,967514 MM WT,m_32,0.28368817585309114,1539 +MoneyMaker,leaf,967514 MM WT,m_32,0.22246995744629536,1540 +MoneyMaker,leaf,967514 MM WT,m_33,0.4298364063957781,1541 +MoneyMaker,leaf,967514 MM WT,m_33,0.312071243671659,1542 +MoneyMaker,leaf,967514 MM WT,m_33,0.4335129245503218,1543 +MoneyMaker,leaf,967514 MM WT,m_33,0.19679912741952998,1544 +MoneyMaker,leaf,967514 MM WT,m_34,0.3776094639571001,1545 +MoneyMaker,leaf,967514 MM WT,m_34,0.386816422378722,1546 +MoneyMaker,leaf,967514 MM WT,m_34,0.35689300298983917,1547 +MoneyMaker,leaf,967514 MM WT,m_34,0.105350577427139,1548 +MoneyMaker,leaf,967514 MM WT,m_35,0.4681969480394825,1549 +MoneyMaker,leaf,967514 MM WT,m_35,0.13189314787735934,1550 +MoneyMaker,leaf,967514 MM WT,m_35,0.43762099637020996,1551 +MoneyMaker,leaf,967514 MM WT,m_35,0.3816145115911795,1552 +MoneyMaker,leaf,967514 MM WT,m_36,0.32313907284128457,1553 +MoneyMaker,leaf,967514 MM WT,m_36,0.114224716457396,1554 +MoneyMaker,leaf,967514 MM WT,m_36,0.38899073605397627,1555 +MoneyMaker,leaf,967514 MM WT,m_36,0.3448225917405901,1556 +MoneyMaker,leaf,967514 MM WT,m_37,0.1337566346982064,1557 +MoneyMaker,leaf,967514 MM WT,m_37,0.12023848753985779,1558 +MoneyMaker,leaf,967514 MM WT,m_37,0.13696951660591358,1559 +MoneyMaker,leaf,967514 MM WT,m_37,0.16152358684172222,1560 +MoneyMaker,leaf,967514 MM WT,m_38,0.12404409336743506,1561 +MoneyMaker,leaf,967514 MM WT,m_38,0.3226671350608774,1562 +MoneyMaker,leaf,967514 MM WT,m_38,0.38804190507126674,1563 +MoneyMaker,leaf,967514 MM WT,m_38,0.3343957028501383,1564 +MoneyMaker,leaf,967514 MM WT,m_39,0.14853624508924682,1565 +MoneyMaker,leaf,967514 MM WT,m_39,0.07187358650427096,1566 +MoneyMaker,leaf,967514 MM WT,m_39,0.10296002779654198,1567 +MoneyMaker,leaf,967514 MM WT,m_39,0.1483768094616156,1568 +MoneyMaker,leaf,967514 MM WT,m_4,0.36121805924095995,1569 +MoneyMaker,leaf,967514 MM WT,m_4,0.28206834554528587,1570 +MoneyMaker,leaf,967514 MM WT,m_4,0.1199011049187081,1571 +MoneyMaker,leaf,967514 MM WT,m_4,0.3533574601263222,1572 +MoneyMaker,leaf,967514 MM WT,m_40,0.07828366058883279,1573 +MoneyMaker,leaf,967514 MM WT,m_40,0.0780196283860143,1574 +MoneyMaker,leaf,967514 MM WT,m_40,0.060433743579420676,1575 +MoneyMaker,leaf,967514 MM WT,m_40,0.06861080861128191,1576 +MoneyMaker,leaf,967514 MM WT,m_41,0.23692410386510632,1577 +MoneyMaker,leaf,967514 MM WT,m_41,0.21822974131224948,1578 +MoneyMaker,leaf,967514 MM WT,m_41,0.2301518821326937,1579 +MoneyMaker,leaf,967514 MM WT,m_41,0.040085639008889826,1580 +MoneyMaker,leaf,967514 MM WT,m_42,0.05430491538251634,1581 +MoneyMaker,leaf,967514 MM WT,m_42,0.05258313447049563,1582 +MoneyMaker,leaf,967514 MM WT,m_42,0.04865583624665402,1583 +MoneyMaker,leaf,967514 MM WT,m_42,0.042306193445914984,1584 +MoneyMaker,leaf,967514 MM WT,m_43,0.2188056060636022,1585 +MoneyMaker,leaf,967514 MM WT,m_43,0.1917304262160019,1586 +MoneyMaker,leaf,967514 MM WT,m_43,0.06305557552533336,1587 +MoneyMaker,leaf,967514 MM WT,m_43,0.18885829901023038,1588 +MoneyMaker,leaf,967514 MM WT,m_44,0.6379454246063186,1589 +MoneyMaker,leaf,967514 MM WT,m_44,0.9009685831762962,1590 +MoneyMaker,leaf,967514 MM WT,m_44,0.5259484730682565,1591 +MoneyMaker,leaf,967514 MM WT,m_44,0.7988793025164722,1592 +MoneyMaker,leaf,967514 MM WT,m_45,0.7403059541887449,1593 +MoneyMaker,leaf,967514 MM WT,m_45,1.1548491525579474,1594 +MoneyMaker,leaf,967514 MM WT,m_45,0.6477116337698002,1595 +MoneyMaker,leaf,967514 MM WT,m_45,1.0386144450178123,1596 +MoneyMaker,leaf,967514 MM WT,m_46,1.11424489159404,1597 +MoneyMaker,leaf,967514 MM WT,m_46,1.3820009897787757,1598 +MoneyMaker,leaf,967514 MM WT,m_46,1.0944309653140778,1599 +MoneyMaker,leaf,967514 MM WT,m_46,0.7426271728937903,1600 +MoneyMaker,leaf,967514 MM WT,m_47,0.9805635768073129,1601 +MoneyMaker,leaf,967514 MM WT,m_47,1.1915914349212744,1602 +MoneyMaker,leaf,967514 MM WT,m_47,0.9421714249845622,1603 +MoneyMaker,leaf,967514 MM WT,m_47,0.5314512919943413,1604 +MoneyMaker,leaf,967514 MM WT,m_48,0.4331252939738997,1605 +MoneyMaker,leaf,967514 MM WT,m_48,0.467730777012304,1606 +MoneyMaker,leaf,967514 MM WT,m_48,0.2843951137935198,1607 +MoneyMaker,leaf,967514 MM WT,m_48,0.26838059321208746,1608 +MoneyMaker,leaf,967514 MM WT,m_49,0.029701790386106805,1609 +MoneyMaker,leaf,967514 MM WT,m_49,0.009680996502460317,1610 +MoneyMaker,leaf,967514 MM WT,m_49,0.03287090980663965,1611 +MoneyMaker,leaf,967514 MM WT,m_49,0.028558448111204303,1612 +MoneyMaker,leaf,967514 MM WT,m_5,0.6136211523033741,1613 +MoneyMaker,leaf,967514 MM WT,m_5,0.6963052344008293,1614 +MoneyMaker,leaf,967514 MM WT,m_5,0.510202265643014,1615 +MoneyMaker,leaf,967514 MM WT,m_5,0.2929497385037275,1616 +MoneyMaker,leaf,967514 MM WT,m_50,0.48434243681706224,1617 +MoneyMaker,leaf,967514 MM WT,m_50,0.540933333184201,1618 +MoneyMaker,leaf,967514 MM WT,m_50,0.34201825672608116,1619 +MoneyMaker,leaf,967514 MM WT,m_50,0.30214905684446036,1620 +MoneyMaker,leaf,967514 MM WT,m_51,0.04450524677567084,1621 +MoneyMaker,leaf,967514 MM WT,m_51,0.056179436052224065,1622 +MoneyMaker,leaf,967514 MM WT,m_51,0.055310869949852175,1623 +MoneyMaker,leaf,967514 MM WT,m_51,0.01875702526411371,1624 +MoneyMaker,leaf,967514 MM WT,m_52,0.0631095914250185,1625 +MoneyMaker,leaf,967514 MM WT,m_52,0.04704358272777028,1626 +MoneyMaker,leaf,967514 MM WT,m_52,0.0614119117703274,1627 +MoneyMaker,leaf,967514 MM WT,m_52,0.055053647396378635,1628 +MoneyMaker,leaf,967514 MM WT,m_53,0.3772523440294036,1629 +MoneyMaker,leaf,967514 MM WT,m_53,0.4051824486132805,1630 +MoneyMaker,leaf,967514 MM WT,m_53,0.22676902137473637,1631 +MoneyMaker,leaf,967514 MM WT,m_53,0.2661317224357186,1632 +MoneyMaker,leaf,967514 MM WT,m_54,0.5427439390638938,1633 +MoneyMaker,leaf,967514 MM WT,m_54,0.637498955272328,1634 +MoneyMaker,leaf,967514 MM WT,m_54,0.42979450325364815,1635 +MoneyMaker,leaf,967514 MM WT,m_54,0.3358514363679901,1636 +MoneyMaker,leaf,967514 MM WT,m_55,0.2330963428114406,1637 +MoneyMaker,leaf,967514 MM WT,m_55,0.24728202675628513,1638 +MoneyMaker,leaf,967514 MM WT,m_55,0.2576094095256072,1639 +MoneyMaker,leaf,967514 MM WT,m_55,0.1181518083971016,1640 +MoneyMaker,leaf,967514 MM WT,m_56,0.3452176144678073,1641 +MoneyMaker,leaf,967514 MM WT,m_56,0.41065810870102226,1642 +MoneyMaker,leaf,967514 MM WT,m_56,0.5067076103242925,1643 +MoneyMaker,leaf,967514 MM WT,m_56,0.3381519872910188,1644 +MoneyMaker,leaf,967514 MM WT,m_57,0.26323702084489825,1645 +MoneyMaker,leaf,967514 MM WT,m_57,0.0656152356772018,1646 +MoneyMaker,leaf,967514 MM WT,m_57,0.23596581372428632,1647 +MoneyMaker,leaf,967514 MM WT,m_57,0.2281642184193586,1648 +MoneyMaker,leaf,967514 MM WT,m_58,0.6999998723147347,1649 +MoneyMaker,leaf,967514 MM WT,m_58,1.0675392408419677,1650 +MoneyMaker,leaf,967514 MM WT,m_58,0.6129152965672308,1651 +MoneyMaker,leaf,967514 MM WT,m_58,0.9574610227096374,1652 +MoneyMaker,leaf,967514 MM WT,m_59,0.3981088119694455,1653 +MoneyMaker,leaf,967514 MM WT,m_59,0.40713586877525443,1654 +MoneyMaker,leaf,967514 MM WT,m_59,0.31039724428068205,1655 +MoneyMaker,leaf,967514 MM WT,m_59,0.14600312179872,1656 +MoneyMaker,leaf,967514 MM WT,m_6,0.5483860038666403,1657 +MoneyMaker,leaf,967514 MM WT,m_6,0.5776740671790029,1658 +MoneyMaker,leaf,967514 MM WT,m_6,0.41211640856114135,1659 +MoneyMaker,leaf,967514 MM WT,m_6,0.24756503851300285,1660 +MoneyMaker,leaf,967514 MM WT,m_60,0.32515676375910724,1661 +MoneyMaker,leaf,967514 MM WT,m_60,0.2880363954169892,1662 +MoneyMaker,leaf,967514 MM WT,m_60,0.22612920433359315,1663 +MoneyMaker,leaf,967514 MM WT,m_60,0.17389395399513571,1664 +MoneyMaker,leaf,967514 MM WT,m_61,0.14641280948996546,1665 +MoneyMaker,leaf,967514 MM WT,m_61,0.06281969726332282,1666 +MoneyMaker,leaf,967514 MM WT,m_61,0.15613687121957198,1667 +MoneyMaker,leaf,967514 MM WT,m_61,0.1174561613895436,1668 +MoneyMaker,leaf,967514 MM WT,m_62,0.09852699385502879,1669 +MoneyMaker,leaf,967514 MM WT,m_62,0.07768986334631807,1670 +MoneyMaker,leaf,967514 MM WT,m_62,0.0385915623887009,1671 +MoneyMaker,leaf,967514 MM WT,m_62,0.0954096535265551,1672 +MoneyMaker,leaf,967514 MM WT,m_63,1.0507313136264427,1673 +MoneyMaker,leaf,967514 MM WT,m_63,1.336367587229807,1674 +MoneyMaker,leaf,967514 MM WT,m_63,1.0097101021361299,1675 +MoneyMaker,leaf,967514 MM WT,m_63,0.7597944383628213,1676 +MoneyMaker,leaf,967514 MM WT,m_64,0.10104418423336242,1677 +MoneyMaker,leaf,967514 MM WT,m_64,0.06081521255519465,1678 +MoneyMaker,leaf,967514 MM WT,m_64,0.13956467519929658,1679 +MoneyMaker,leaf,967514 MM WT,m_64,0.1389631447380295,1680 +MoneyMaker,leaf,967514 MM WT,m_65,0.04482782141492812,1681 +MoneyMaker,leaf,967514 MM WT,m_65,0.060604828802222975,1682 +MoneyMaker,leaf,967514 MM WT,m_65,0.0359800776460077,1683 +MoneyMaker,leaf,967514 MM WT,m_65,0.05679247141589826,1684 +MoneyMaker,leaf,967514 MM WT,m_66,0.1140586864498691,1685 +MoneyMaker,leaf,967514 MM WT,m_66,0.1283870230313765,1686 +MoneyMaker,leaf,967514 MM WT,m_66,0.18463636394524702,1687 +MoneyMaker,leaf,967514 MM WT,m_66,0.1965474859856246,1688 +MoneyMaker,leaf,967514 MM WT,m_67,0.36537025804452966,1689 +MoneyMaker,leaf,967514 MM WT,m_67,0.4433286272711797,1690 +MoneyMaker,leaf,967514 MM WT,m_67,0.4136705950575813,1691 +MoneyMaker,leaf,967514 MM WT,m_67,0.3222600785638092,1692 +MoneyMaker,leaf,967514 MM WT,m_68,0.38992251094568176,1693 +MoneyMaker,leaf,967514 MM WT,m_68,0.5386658722988348,1694 +MoneyMaker,leaf,967514 MM WT,m_68,0.40246973059171043,1695 +MoneyMaker,leaf,967514 MM WT,m_68,0.4677392917241772,1696 +MoneyMaker,leaf,967514 MM WT,m_69,0.42118583176052454,1697 +MoneyMaker,leaf,967514 MM WT,m_69,0.4983300057760185,1698 +MoneyMaker,leaf,967514 MM WT,m_69,0.3629060778289089,1699 +MoneyMaker,leaf,967514 MM WT,m_69,0.23661161216821847,1700 +MoneyMaker,leaf,967514 MM WT,m_7,0.8232320101060044,1701 +MoneyMaker,leaf,967514 MM WT,m_7,0.9395809289784216,1702 +MoneyMaker,leaf,967514 MM WT,m_7,0.7480884265830124,1703 +MoneyMaker,leaf,967514 MM WT,m_7,0.33273916435732726,1704 +MoneyMaker,leaf,967514 MM WT,m_70,0.5062019229618495,1705 +MoneyMaker,leaf,967514 MM WT,m_70,0.5882512739534006,1706 +MoneyMaker,leaf,967514 MM WT,m_70,0.37794276458739706,1707 +MoneyMaker,leaf,967514 MM WT,m_70,0.33728005335111844,1708 +MoneyMaker,leaf,967514 MM WT,m_71,0.176917733463252,1709 +MoneyMaker,leaf,967514 MM WT,m_71,0.11686866275200375,1710 +MoneyMaker,leaf,967514 MM WT,m_71,0.11886921171571732,1711 +MoneyMaker,leaf,967514 MM WT,m_71,0.16622169081954444,1712 +MoneyMaker,leaf,967514 MM WT,m_72,0.31931698436783346,1713 +MoneyMaker,leaf,967514 MM WT,m_72,0.27217704619233607,1714 +MoneyMaker,leaf,967514 MM WT,m_72,0.19306737038380445,1715 +MoneyMaker,leaf,967514 MM WT,m_72,0.22837794658896735,1716 +MoneyMaker,leaf,967514 MM WT,m_73,0.07589575750836465,1717 +MoneyMaker,leaf,967514 MM WT,m_73,0.06807914307554266,1718 +MoneyMaker,leaf,967514 MM WT,m_73,0.07365226679566547,1719 +MoneyMaker,leaf,967514 MM WT,m_73,0.012795913977661754,1720 +MoneyMaker,leaf,967514 MM WT,m_74,0.10812670660700753,1721 +MoneyMaker,leaf,967514 MM WT,m_74,0.07955674744280906,1722 +MoneyMaker,leaf,967514 MM WT,m_74,0.10059380352679675,1723 +MoneyMaker,leaf,967514 MM WT,m_74,0.05206205480421772,1724 +MoneyMaker,leaf,967514 MM WT,m_75,0.09031385899469097,1725 +MoneyMaker,leaf,967514 MM WT,m_75,0.11132392511202707,1726 +MoneyMaker,leaf,967514 MM WT,m_75,0.10096353329428094,1727 +MoneyMaker,leaf,967514 MM WT,m_75,0.04075297684404574,1728 +MoneyMaker,leaf,967514 MM WT,m_76,0.14686891287110526,1729 +MoneyMaker,leaf,967514 MM WT,m_76,0.13785970985607562,1730 +MoneyMaker,leaf,967514 MM WT,m_76,0.13038688935457224,1731 +MoneyMaker,leaf,967514 MM WT,m_76,0.1697591817892621,1732 +MoneyMaker,leaf,967514 MM WT,m_77,0.07449667713037797,1733 +MoneyMaker,leaf,967514 MM WT,m_77,0.09963622841647818,1734 +MoneyMaker,leaf,967514 MM WT,m_77,0.09813478938650191,1735 +MoneyMaker,leaf,967514 MM WT,m_77,0.037911372075943715,1736 +MoneyMaker,leaf,967514 MM WT,m_78,0.013179535832910049,1737 +MoneyMaker,leaf,967514 MM WT,m_78,0.011140844194139255,1738 +MoneyMaker,leaf,967514 MM WT,m_78,0.021092021796122136,1739 +MoneyMaker,leaf,967514 MM WT,m_78,0.021087397237916222,1740 +MoneyMaker,leaf,967514 MM WT,m_79,0.04580549304247966,1741 +MoneyMaker,leaf,967514 MM WT,m_79,0.053301587972066015,1742 +MoneyMaker,leaf,967514 MM WT,m_79,0.0519609224188138,1743 +MoneyMaker,leaf,967514 MM WT,m_79,0.04725107450004175,1744 +MoneyMaker,leaf,967514 MM WT,m_8,0.23299656600613466,1745 +MoneyMaker,leaf,967514 MM WT,m_8,0.3033079501045838,1746 +MoneyMaker,leaf,967514 MM WT,m_8,0.2498657580793966,1747 +MoneyMaker,leaf,967514 MM WT,m_8,0.2379964794002023,1748 +MoneyMaker,leaf,967514 MM WT,m_80,0.07542207094718753,1749 +MoneyMaker,leaf,967514 MM WT,m_80,0.0739428976990706,1750 +MoneyMaker,leaf,967514 MM WT,m_80,0.0462389901705325,1751 +MoneyMaker,leaf,967514 MM WT,m_80,0.04723174413998162,1752 +MoneyMaker,leaf,967514 MM WT,m_81,0.11200470691636852,1753 +MoneyMaker,leaf,967514 MM WT,m_81,0.1146937891209294,1754 +MoneyMaker,leaf,967514 MM WT,m_81,0.05140916420200649,1755 +MoneyMaker,leaf,967514 MM WT,m_81,0.08803381579450699,1756 +MoneyMaker,leaf,967514 MM WT,m_82,0.46761004083872704,1757 +MoneyMaker,leaf,967514 MM WT,m_82,0.39565735099439764,1758 +MoneyMaker,leaf,967514 MM WT,m_82,0.16462514904832473,1759 +MoneyMaker,leaf,967514 MM WT,m_82,0.3801707246851227,1760 +MoneyMaker,leaf,967514 MM WT,m_83,0.18218576714584894,1761 +MoneyMaker,leaf,967514 MM WT,m_83,0.13404544683233235,1762 +MoneyMaker,leaf,967514 MM WT,m_83,0.13386614559633594,1763 +MoneyMaker,leaf,967514 MM WT,m_83,0.16511346925173878,1764 +MoneyMaker,leaf,967514 MM WT,m_84,1.31593045100987,1765 +MoneyMaker,leaf,967514 MM WT,m_84,1.700658812573071,1766 +MoneyMaker,leaf,967514 MM WT,m_84,1.310200570039031,1767 +MoneyMaker,leaf,967514 MM WT,m_84,1.5812396454756024,1768 +MoneyMaker,leaf,967514 MM WT,m_85,0.5938733715259563,1769 +MoneyMaker,leaf,967514 MM WT,m_85,0.7636102141648775,1770 +MoneyMaker,leaf,967514 MM WT,m_85,0.5977441080074842,1771 +MoneyMaker,leaf,967514 MM WT,m_85,0.33981766115000905,1772 +MoneyMaker,leaf,967514 MM WT,m_86,0.5528591289298396,1773 +MoneyMaker,leaf,967514 MM WT,m_86,0.6355689441922519,1774 +MoneyMaker,leaf,967514 MM WT,m_86,0.32058793928205476,1775 +MoneyMaker,leaf,967514 MM WT,m_86,0.5429615322879847,1776 +MoneyMaker,leaf,967514 MM WT,m_87,0.33223219363965933,1777 +MoneyMaker,leaf,967514 MM WT,m_87,0.3324907640237174,1778 +MoneyMaker,leaf,967514 MM WT,m_87,0.21437901563304665,1779 +MoneyMaker,leaf,967514 MM WT,m_87,0.3440989507503847,1780 +MoneyMaker,leaf,967514 MM WT,m_88,0.2810472237527136,1781 +MoneyMaker,leaf,967514 MM WT,m_88,0.2999968898431727,1782 +MoneyMaker,leaf,967514 MM WT,m_88,0.22594439750202852,1783 +MoneyMaker,leaf,967514 MM WT,m_88,0.3008298393860789,1784 +MoneyMaker,leaf,967514 MM WT,m_89,0.7069639442340983,1785 +MoneyMaker,leaf,967514 MM WT,m_89,0.8557711912615112,1786 +MoneyMaker,leaf,967514 MM WT,m_89,0.687524777249389,1787 +MoneyMaker,leaf,967514 MM WT,m_89,0.31839114502060434,1788 +MoneyMaker,leaf,967514 MM WT,m_9,0.0193569705086725,1789 +MoneyMaker,leaf,967514 MM WT,m_9,0.03006516645504425,1790 +MoneyMaker,leaf,967514 MM WT,m_9,0.03231948614439334,1791 +MoneyMaker,leaf,967514 MM WT,m_9,0.02662702964050468,1792 +MoneyMaker,leaf,967514 MM WT,m_90,0.31504522116609135,1793 +MoneyMaker,leaf,967514 MM WT,m_90,0.3159926657572546,1794 +MoneyMaker,leaf,967514 MM WT,m_90,0.21950883994792691,1795 +MoneyMaker,leaf,967514 MM WT,m_90,0.14284521452971094,1796 +MoneyMaker,leaf,967514 MM WT,m_91,0.5266528461996673,1797 +MoneyMaker,leaf,967514 MM WT,m_91,0.515334431765097,1798 +MoneyMaker,leaf,967514 MM WT,m_91,0.5402992174392302,1799 +MoneyMaker,leaf,967514 MM WT,m_91,0.24876509175095382,1800 +MoneyMaker,leaf,967514 MM WT,m_92,0.8212389061256814,1801 +MoneyMaker,leaf,967514 MM WT,m_92,0.696797562232777,1802 +MoneyMaker,leaf,967514 MM WT,m_92,0.7128308072237004,1803 +MoneyMaker,leaf,967514 MM WT,m_92,0.3691785060825271,1804 +MoneyMaker,leaf,967514 MM WT,m_93,0.07677216501527948,1805 +MoneyMaker,leaf,967514 MM WT,m_93,0.23978586612732714,1806 +MoneyMaker,leaf,967514 MM WT,m_93,0.19691842928973982,1807 +MoneyMaker,leaf,967514 MM WT,m_93,0.2409114521008087,1808 +MoneyMaker,leaf,967514 MM WT,m_94,0.41357258580893963,1809 +MoneyMaker,leaf,967514 MM WT,m_94,0.4608561005666815,1810 +MoneyMaker,leaf,967514 MM WT,m_94,0.33975994652132013,1811 +MoneyMaker,leaf,967514 MM WT,m_94,0.18966801844765963,1812 +MoneyMaker,leaf,967514 MM WT,m_97,0.5720389066797728,1813 +MoneyMaker,leaf,967514 MM WT,m_97,0.5499045049944968,1814 +MoneyMaker,leaf,967514 MM WT,m_97,0.2081034531977071,1815 +MoneyMaker,leaf,967514 MM WT,m_97,0.5243128303175736,1816 +MoneyMaker,leaf,967514 MM WT,m_98,0.5905848564876701,1817 +MoneyMaker,leaf,967514 MM WT,m_98,0.8714881144425976,1818 +MoneyMaker,leaf,967514 MM WT,m_98,0.5787271948878826,1819 +MoneyMaker,leaf,967514 MM WT,m_98,0.6497889622136032,1820 +MoneyMaker,leaf,967514 MM WT,m_99,0.39326634618187145,1821 +MoneyMaker,leaf,967514 MM WT,m_99,0.4363252896632666,1822 +MoneyMaker,leaf,967514 MM WT,m_99,0.25270724403497363,1823 +MoneyMaker,leaf,967514 MM WT,m_99,0.3682596415025115,1824 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_1,0.19071985852590112,1825 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_1,0.1325927313800493,1826 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_1,0.14351379089575794,1827 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_1,0.17727310683007919,1828 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_10,0.020444319560241002,1829 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_10,0.012046620108960055,1830 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_10,0.020887315369793293,1831 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_10,0.02369751076273323,1832 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_100,0.26865559056721106,1833 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_100,0.2798976738755255,1834 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_100,0.10843699784772856,1835 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_100,0.25227451471270496,1836 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_101,0.2759733780537263,1837 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_101,0.2522768288435736,1838 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_101,0.3032674650086753,1839 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_101,0.08496002725338088,1840 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_102,0.11596281559318068,1841 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_102,0.06103180045391317,1842 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_102,0.107781974537307,1843 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_102,0.10039686721115072,1844 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_103,1.3645934373839386,1845 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_103,1.3712894577278276,1846 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_103,1.353089470017565,1847 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_103,0.05812929756168571,1848 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_104,1.3618598141436908,1849 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_104,1.3685454711518623,1850 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_104,1.353089470017565,1851 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_104,0.04875266593114077,1852 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_105,0.032149822693957185,1853 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_105,0.06767495676123399,1854 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_105,0.08781703407380735,1855 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_105,0.08802459451796206,1856 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_106,0.23885865968119516,1857 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_106,0.23143048892935272,1858 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_106,0.19644790010323898,1859 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_106,0.06496950787108087,1860 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_107,0.49511444160356355,1861 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_107,0.5175694939061035,1862 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_107,0.4226433226753197,1863 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_107,0.144576997336669,1864 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_108,0.7200438474200807,1865 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_108,0.9103366649868473,1866 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_108,0.7077608511507505,1867 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_108,0.40003276742751287,1868 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_109,0.3033796770612322,1869 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_109,0.3912209244265311,1870 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_109,0.3961229369125679,1871 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_109,0.16069867943041716,1872 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_11,0.8283300513155308,1873 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_11,0.7975666798237967,1874 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_11,0.6175306529058056,1875 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_11,0.34662481196369177,1876 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_110,0.4991021182531661,1877 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_110,0.5089329342671384,1878 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_110,0.4024798749916485,1879 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_110,0.16514886582231963,1880 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_111,0.06434081849100069,1881 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_111,0.03586238862858176,1882 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_111,0.05616793955700793,1883 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_111,0.07132685282753194,1884 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_112,0.3827899654783091,1885 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_112,0.05399468684564197,1886 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_112,0.37552093368634026,1887 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_112,0.3622536188207378,1888 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_12,0.7353321485923412,1889 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_12,0.6829739687944769,1890 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_12,0.535020050194341,1891 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_12,0.3096554603688901,1892 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_120,0.08482056023851181,1893 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_120,0.19679828548441505,1894 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_120,0.2015592790205039,1895 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_120,0.16622785101077106,1896 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_121,0.10425810171436675,1897 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_121,0.2954312532978984,1898 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_121,0.2416168145469983,1899 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_121,0.2945468286926177,1900 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_122,0.2211998342165004,1901 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_122,0.1376776766853463,1902 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_122,0.21892831411753724,1903 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_122,0.11741646692509171,1904 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_123,0.20861299739531908,1905 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_123,0.15008515226207472,1906 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_123,0.20551902187629287,1907 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_123,0.10764970526585965,1908 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_13,1.01186798632513,1909 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_13,1.1414739234630322,1910 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_13,0.9028505903041062,1911 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_13,0.456917214672528,1912 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_14,0.33964238314489004,1913 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_14,0.1416515484563859,1914 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_14,0.28115352716731334,1915 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_14,0.3718661168077795,1916 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_15,0.11234481755742519,1917 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_15,0.04554809683903852,1918 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_15,0.13869478688851536,1919 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_15,0.13987903557676076,1920 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_16,0.5003630640772236,1921 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_16,0.5950401691364493,1922 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_16,0.7050232306149747,1923 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_16,0.392926478803712,1924 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_17,1.0748481897923357,1925 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_17,1.1549227471349457,1926 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_17,1.08665300485786,1927 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_17,0.1825908824173355,1928 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_18,0.5487409734418328,1929 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_18,0.5439693036417017,1930 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_18,0.02285034419934193,1931 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_18,0.5437056024395727,1932 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_19,0.2720433247170692,1933 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_19,0.2806802300534042,1934 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_19,0.2264878542475979,1935 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_19,0.08230135425272189,1936 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_2,0.4428415928479218,1937 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_2,0.3387751501352727,1938 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_2,0.4305529978087322,1939 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_2,0.15698375330887127,1940 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_20,0.12100417659603173,1941 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_20,0.10172402344091554,1942 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_20,0.10044206523512497,1943 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_20,0.06785901366469338,1944 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_21,0.6672542697956965,1945 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_21,0.6437083781299001,1946 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_21,0.722798386865265,1947 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_21,0.13262282675867762,1948 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_22,0.5295056783978878,1949 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_22,0.11721102908473009,1950 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_22,0.5315541105810375,1951 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_22,0.4607604950909954,1952 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_23,0.17846199500043192,1953 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_23,0.1632446340252908,1954 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_23,0.1882948988068684,1955 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_23,0.040260129771253726,1956 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_24,0.4096489751605985,1957 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_24,0.2965363995273334,1958 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_24,0.39473390348126786,1959 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_24,0.1669686141504649,1960 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_25,0.13870856128101494,1961 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_25,0.10044979739048963,1962 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_25,0.08480764703387564,1963 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_25,0.12702568215927473,1964 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_26,0.26958370085763406,1965 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_26,0.3121262807111333,1966 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_26,0.32022670948909865,1967 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_26,0.07789143447623213,1968 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_27,0.34286862193227235,1969 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_27,0.30417024672667337,1970 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_27,0.22264366928500615,1971 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_27,0.26022344629558647,1972 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_28,0.0227260613152529,1973 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_28,0.08998556532028147,1974 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_28,0.10387381441323648,1975 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_28,0.1031492004178609,1976 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_29,1.0541671577763385,1977 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_29,1.0878441071988298,1978 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_29,1.1438107136756466,1979 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_29,0.18854501674425128,1980 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_3,0.41896556681920527,1981 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_3,0.14725875196489346,1982 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_3,0.4019090844615947,1983 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_3,0.4069419537976707,1984 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_30,0.465828230069975,1985 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_30,0.4309777308130439,1986 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_30,0.5247312227971958,1987 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_30,0.15495050375053765,1988 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_31,0.32292291671898826,1989 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_31,0.24332900048601816,1990 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_31,0.2963403557360924,1991 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_31,0.12509259644473908,1992 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_32,0.20859732631823144,1993 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_32,0.19480103431070314,1994 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_32,0.24029770539581827,1995 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_32,0.20643982547010434,1996 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_33,0.5842129989259646,1997 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_33,0.452131846315472,1998 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_33,0.6007228882749178,1999 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_33,0.7633358310463317,2000 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_34,0.2606289990620755,2001 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_34,0.3236480778396023,2002 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_34,0.25660275279567274,2003 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_34,0.1642458967130135,2004 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_35,0.38739565472943555,2005 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_35,0.416329741659843,2006 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_35,0.29173606624979326,2007 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_35,0.22351977652542804,2008 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_36,0.23566155703542221,2009 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_36,0.23649440515732956,2010 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_36,0.11573054303700506,2011 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_36,0.1899593596389985,2012 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_37,0.28951916037643843,2013 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_37,0.30453935815277455,2014 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_37,0.17807363376628668,2015 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_37,0.18577550013646638,2016 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_38,0.29196592098457697,2017 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_38,0.39413548394949116,2018 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_38,0.3355172110216499,2019 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_38,0.2628406430547016,2020 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_39,1.653843060156297,2021 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_39,1.6037565126383146,2022 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_39,1.6603520166655126,2023 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_39,0.6899998217904958,2024 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_4,0.3636429113925916,2025 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_4,0.3512384684706127,2026 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_4,0.22437038996817943,2027 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_4,0.20225049600446973,2028 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_40,0.6121579121050033,2029 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_40,0.6933553564150773,2030 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_40,0.5736293544503307,2031 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_40,0.20073798854991312,2032 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_41,0.2339040255187333,2033 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_41,0.1834114668200079,2034 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_41,0.2015227583991069,2035 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_41,0.10619829679579375,2036 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_42,0.031038974315164607,2037 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_42,0.03706121611250856,2038 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_42,0.04041886117301099,2039 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_42,0.04252789863019577,2040 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_43,0.22470122346848023,2041 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_43,0.6575482275738571,2042 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_43,0.6338554150242114,2043 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_43,0.5609886039495328,2044 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_44,1.128581471993718,2045 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_44,1.2138533588321614,2046 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_44,1.1988588915091383,2047 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_44,0.20806275371656688,2048 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_45,1.0904530459868678,2049 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_45,1.1545220165698777,2050 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_45,1.1577736733451245,2051 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_45,0.16381106173346843,2052 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_46,1.1563306800515505,2053 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_46,1.1622884400053308,2054 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_46,1.0686766987167617,2055 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_46,0.22396804121502578,2056 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_47,0.8577899664250055,2057 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_47,0.877407904991258,2058 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_47,0.6886543363969468,2059 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_47,0.32887466413056116,2060 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_48,0.4413729940433088,2061 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_48,0.48906795597539915,2062 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_48,0.311404699772534,2063 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_48,0.27003088237503176,2064 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_49,0.031861730951385184,2065 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_49,0.04476088896892032,2066 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_49,0.04623292305454102,2067 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_49,0.02352242583409257,2068 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_5,0.34041588943395945,2069 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_5,0.2666107600878574,2070 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_5,0.20487550550883896,2071 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_5,0.26646886579918455,2072 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_50,0.0891655087987805,2073 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_50,0.08878919446192307,2074 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_50,0.11875026676483172,2075 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_50,0.11126392377296676,2076 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_51,0.11677308923251564,2077 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_51,0.13941086767467997,2078 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_51,0.15458221016139034,2079 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_51,0.11012964156550427,2080 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_52,0.09259789616333249,2081 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_52,0.07815719447832264,2082 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_52,0.10116767791479833,2083 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_52,0.04461725846437168,2084 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_53,0.24055311067422294,2085 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_53,0.06568747902265673,2086 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_53,0.2674766930189236,2087 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_53,0.25833106250760607,2088 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_54,0.25663048645215175,2089 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_54,0.15219593726045266,2090 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_54,0.19280533414157977,2091 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_54,0.2690979507818494,2092 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_55,0.5696340454016009,2093 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_55,0.5186808886520718,2094 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_55,0.33774388230228636,2095 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_55,0.34127663320192264,2096 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_56,0.16156471474975287,2097 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_56,0.1987908681459614,2098 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_56,0.12882002442605237,2099 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_56,0.1629392973976203,2100 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_57,0.39061920381530985,2101 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_57,0.34950509508514366,2102 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_57,0.356855561324549,2103 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_57,0.0725287325713698,2104 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_58,0.2908407302701574,2105 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_58,0.3254617067203367,2106 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_58,0.07026890835685963,2107 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_58,0.28959090659939846,2108 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_59,0.6029686666579781,2109 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_59,0.6376920869438322,2110 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_59,0.49245285865348587,2111 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_59,0.22269398418790565,2112 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_6,0.28852940774256636,2113 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_6,0.2663622591794311,2114 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_6,0.20475278472599695,2115 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_6,0.17810439540430917,2116 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_60,0.2883986047566286,2117 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_60,0.26115524492059744,2118 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_60,0.04427782830738276,2119 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_60,0.2723467333775961,2120 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_61,0.32030358844502455,2121 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_61,0.16792311674310126,2122 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_61,0.31578463592541084,2123 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_61,0.20562465831960508,2124 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_62,0.9827242754180063,2125 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_62,1.227389563618359,2126 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_62,0.9994609463683629,2127 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_62,0.5560668952205102,2128 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_63,0.8411318499639735,2129 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_63,0.8785606899908793,2130 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_63,0.8408242635926492,2131 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_63,0.07531866523924259,2132 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_64,0.4913709749525674,2133 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_64,0.513172536521781,2134 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_64,0.4719561977476456,2135 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_64,0.06405316098484824,2136 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_65,0.24177285438873852,2137 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_65,0.24121435741722433,2138 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_65,0.10468792838304694,2139 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_65,0.1852359250176421,2140 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_66,0.250539141313677,2141 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_66,0.21872229640667015,2142 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_66,0.27829886314986646,2143 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_66,0.10122885043301934,2144 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_67,0.41501276321246755,2145 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_67,0.4442662069281565,2146 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_67,0.34103075041552094,2147 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_67,0.15547524352691366,2148 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_68,0.05545386093448353,2149 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_68,0.058785232689366446,2150 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_68,0.06416234145000346,2151 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_68,0.03789830154175271,2152 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_69,0.660829256634,2153 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_69,0.7502358965268155,2154 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_69,0.7007926729294219,2155 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_69,0.25954264704490426,2156 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_7,0.8533387074138413,2157 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_7,0.7846785149546928,2158 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_7,0.7315772398114834,2159 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_7,0.20464761190174174,2160 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_70,0.3202672932555644,2161 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_70,0.10868654103730488,2162 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_70,0.3212437329224513,2163 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_70,0.26810272176175637,2164 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_71,0.7738870671921223,2165 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_71,0.7954087096242978,2166 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_71,0.7559937643539276,2167 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_71,0.06541249256657396,2168 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_72,0.5415804257295527,2169 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_72,0.43396314480683956,2170 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_72,0.587974108665727,2171 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_72,0.23288805244188632,2172 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_73,0.4125813249690123,2173 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_73,0.445752978639374,2174 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_73,0.30632926503816194,2175 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_73,0.20757129451601478,2176 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_74,0.14365589170219828,2177 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_74,0.14509046953111632,2178 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_74,0.05521641158203081,2179 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_74,0.1115302329271437,2180 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_75,0.12174933158151949,2181 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_75,0.10275767200912014,2182 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_75,0.10231196130639787,2183 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_75,0.05564237233095555,2184 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_76,0.2493646975932394,2185 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_76,0.08698819791623301,2186 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_76,0.2745809642779588,2187 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_76,0.22268709432894734,2188 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_77,0.07146906677690179,2189 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_77,0.042077579788118415,2190 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_77,0.07198668722161074,2191 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_77,0.04586601776990374,2192 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_78,0.020803886906110056,2193 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_78,0.01396630867814838,2194 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_78,0.010742743029547409,2195 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_78,0.02054112528996101,2196 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_79,0.16320722420257883,2197 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_79,0.19953787281513224,2198 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_79,0.1710321207260875,2199 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_79,0.0816896227018958,2200 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_8,0.5953547614483671,2201 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_8,0.5817753098425708,2202 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_8,0.6551783762447332,2203 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_8,0.12739378713992533,2204 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_80,0.15629217811151758,2205 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_80,0.15429802775569532,2206 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_80,0.1533559569885241,2207 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_80,0.004890407100231908,2208 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_81,0.7205275199394818,2209 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_81,0.763836643422769,2210 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_81,0.6228546036990241,2211 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_81,0.22503653527362133,2212 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_82,0.23943040741084626,2213 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_82,0.21088485105385496,2214 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_82,0.13890961928363882,2215 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_82,0.17262758062719732,2216 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_83,0.42524075873083717,2217 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_83,0.40562925338284817,2218 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_83,0.23575241062488664,2219 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_83,0.2659734953035835,2220 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_84,1.3783274714518632,2221 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_84,1.4885609795167285,2222 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_84,1.4043829094213003,2223 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_84,0.421614227986993,2224 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_85,0.3546327889175921,2225 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_85,0.43044532019486026,2226 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_85,0.3301295703753689,2227 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_85,0.19907402568919455,2228 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_86,0.17464034752960608,2229 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_86,0.17128550252092972,2230 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_86,0.09999490423336607,2231 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_86,0.1057038725977032,2232 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_87,0.20982317682308693,2233 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_87,0.17583974308128872,2234 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_87,0.22321436161224328,2235 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_87,0.07415357643009085,2236 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_88,0.29707475198232347,2237 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_88,0.21883696159732674,2238 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_88,0.31079233790733474,2239 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_88,0.13518277136754278,2240 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_89,1.3105727714302366,2241 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_89,1.3658189001759347,2242 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_89,1.2468821681599809,2243 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_89,0.33341256571473843,2244 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_9,0.18290970008460386,2245 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_9,0.3049674259792325,2246 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_9,0.27855526796392266,2247 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_9,0.1957430765502069,2248 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_90,0.32827496254659216,2249 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_90,0.30813370361582165,2250 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_90,0.2817275375665115,2251 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_90,0.07283672288744568,2252 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_91,0.18518671880836893,2253 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_91,0.16301850112646568,2254 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_91,0.19217982089337132,2255 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_91,0.0664968213785996,2256 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_92,0.7201716617907361,2257 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_92,0.440283321622943,2258 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_92,0.4379119513804982,2259 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_92,0.6159009249422778,2260 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_93,0.6986494542424889,2261 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_93,0.2355020947121791,2262 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_93,0.7430746864686508,2263 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_93,0.7003012948233026,2264 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_94,0.5917611845268377,2265 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_94,0.4444567313350845,2266 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_94,0.6506386349379828,2267 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_94,0.3109064277473272,2268 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_97,0.542872174221208,2269 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_97,0.4941823420733944,2270 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_97,0.3901730220878568,2271 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_97,0.23131339933710446,2272 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_98,0.407390058894694,2273 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_98,0.4492300389136672,2274 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_98,0.41706276750713267,2275 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_98,0.07059623052576018,2276 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_99,0.9891761557318576,2277 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_99,1.0411542587125442,2278 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_99,1.0838656017772412,2279 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_99,0.1857093562553398,2280 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_1,0.5063318881398421,2281 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_1,0.6174037892775083,2282 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_1,0.6186274079972269,2283 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_1,0.18696980891927173,2284 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_10,0.021812333188449815,2285 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_10,0.022971156583666094,2286 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_10,0.023656037268574875,2287 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_10,0.0031322064847325378,2288 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_100,0.37737167580255493,2289 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_100,0.46579952393040447,2290 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_100,0.3228011847842178,2291 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_100,0.30073550585748565,2292 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_101,0.47349751233596676,2293 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_101,0.2098433727549469,2294 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_101,0.38781413612310645,2295 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_101,0.44981236087913407,2296 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_102,0.017378758490133317,2297 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_102,0.07422421053212373,2298 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_102,0.06448318629805977,2299 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_102,0.07524049773105435,2300 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_103,0.16921624984126865,2301 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_103,0.1907149965965253,2302 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_103,0.14692906867776578,2303 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_103,0.08640707318304722,2304 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_104,0.16921624984126865,2305 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_104,0.1907149965965253,2306 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_104,0.14692906867776578,2307 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_104,0.08640707318304722,2308 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_105,0.33553158198342276,2309 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_105,0.3394486478780069,2310 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_105,0.1383093609159921,2311 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_105,0.2659986999070735,2312 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_106,0.09719946146826737,2313 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_106,0.06657389111230988,2314 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_106,0.09729516580538171,2315 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_106,0.044892377274691746,2316 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_107,0.5696776385989547,2317 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_107,0.6918236496352584,2318 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_107,0.4328323036492351,2319 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_107,0.4333372828559022,2320 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_108,0.42377026165694026,2321 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_108,0.4236203817326298,2322 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_108,0.2735528794795075,2323 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_108,0.22046887961822614,2324 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_109,0.45941929309820817,2325 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_109,0.42012388332430994,2326 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_109,0.2647673346750546,2327 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_109,0.2826622799542828,2328 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_11,1.140028768902079,2329 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_11,1.3239662604552338,2330 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_11,0.9997177613342005,2331 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_11,0.704383118670577,2332 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_110,0.883377283061728,2333 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_110,0.6934026256695679,2334 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_110,0.45729574250426913,2335 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_110,0.633092801333004,2336 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_111,0.44629957321408786,2337 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_111,0.4334642338486616,2338 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_111,0.3789722605036938,2339 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_111,0.18031913070607075,2340 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_112,0.8771862762720911,2341 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_112,0.8369203950648703,2342 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_112,0.2073919785618276,2343 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_112,0.8360694542895494,2344 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_12,1.3741422617966967,2345 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_12,1.4474013272788548,2346 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_12,1.404766657235133,2347 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_12,0.2593708117153923,2348 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_120,0.21474420032170982,2349 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_120,0.3013838761095632,2350 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_120,0.33710604581302384,2351 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_120,0.2407212869003852,2352 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_121,1.1856021231231557,2353 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_121,1.363571300479785,2354 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_121,1.1675294841204604,2355 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_121,0.5381587004077708,2356 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_122,0.20685992282633067,2357 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_122,0.15502220492200444,2358 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_122,0.08141235319379789,2359 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_122,0.19414131727449097,2360 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_123,0.19111068078217291,2361 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_123,0.2033045485832708,2362 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_123,0.15033582177910876,2363 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_123,0.1777402385984353,2364 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_13,0.6201956781394872,2365 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_13,0.7140232008638976,2366 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_13,0.5133775275820038,2367 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_13,0.3191691460633105,2368 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_14,0.6052835901666843,2369 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_14,0.38855398246158795,2370 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_14,0.3647710344760189,2371 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_14,0.6349428772135401,2372 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_15,0.09237829658817891,2373 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_15,0.13829152991613267,2374 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_15,0.14189664921590434,2375 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_15,0.0723178736541878,2376 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_16,0.11068145514231578,2377 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_16,0.21762649858634683,2378 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_16,0.2548909262672737,2379 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_16,0.2831717915337317,2380 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_17,0.4338031587097116,2381 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_17,0.5903659356029908,2382 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_17,0.4663015973371819,2383 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_17,0.3069501625849357,2384 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_18,0.554454913221197,2385 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_18,0.6717513933353503,2386 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_18,0.4221783805516647,2387 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_18,0.5126756375741388,2388 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_19,0.18461594948162452,2389 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_19,0.28260272640767137,2390 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_19,0.24017436376409887,2391 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_19,0.20671271586969034,2392 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_2,0.2417746808650346,2393 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_2,0.31271038783166627,2394 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_2,0.3157313144947211,2395 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_2,0.1313643080152855,2396 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_20,0.24622383497922093,2397 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_20,0.43219452000096026,2398 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_20,0.5588007627490907,2399 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_20,0.5273195352771208,2400 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_21,0.2509751240183084,2401 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_21,0.3719400650429536,2402 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_21,0.4158816853125213,2403 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_21,0.276263391167526,2404 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_22,0.12626537814896377,2405 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_22,0.14928610423600316,2406 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_22,0.12406663491383975,2407 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_22,0.13402613804338867,2408 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_23,0.37966644629809804,2409 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_23,0.41201359980314894,2410 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_23,0.22932275363830082,2411 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_23,0.28436128341421874,2412 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_24,0.3952473194304509,2413 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_24,0.5686949832431789,2414 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_24,0.43087456565881127,2415 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_24,0.40087040632759247,2416 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_25,0.2601638751559244,2417 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_25,0.3227928236495378,2418 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_25,0.28192179924804645,2419 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_25,0.11474160269437407,2420 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_26,0.08921712086073749,2421 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_26,0.09760156537824156,2422 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_26,0.08051082528643881,2423 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_26,0.07726205070873841,2424 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_27,0.14834818819003323,2425 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_27,0.16494105890844946,2426 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_27,0.09462088507257929,2427 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_27,0.12111277212619098,2428 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_28,0.11782480463417641,2429 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_28,0.2637170527498527,2430 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_28,0.31103600375842233,2431 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_28,0.309372274322273,2432 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_29,0.4643965237282054,2433 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_29,0.6649272680327358,2434 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_29,0.4683404354480565,2435 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_29,0.5784134625958118,2436 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_3,0.3251570204446356,2437 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_3,0.3561245314996431,2438 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_3,0.5799228593188536,2439 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_3,0.5616871331393518,2440 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_30,0.05782058119056364,2441 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_30,0.04788243287809522,2442 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_30,0.06570541229142741,2443 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_30,0.07255045079438639,2444 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_31,0.1582581218906627,2445 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_31,0.16018655440902776,2446 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_31,0.11601785021026009,2447 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_31,0.06549766000398073,2448 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_32,0.3824158007127837,2449 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_32,0.4813920339328371,2450 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_32,0.4302314868633928,2451 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_32,0.15906562134208047,2452 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_33,0.31781856947060677,2453 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_33,0.32377194467650494,2454 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_33,0.3229103822890793,2455 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_33,0.1915832016128387,2456 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_34,0.3545319797930377,2457 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_34,0.36927790271942595,2458 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_34,0.358703069265708,2459 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_34,0.16102361489563163,2460 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_35,0.43967277484773126,2461 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_35,0.31778850420235755,2462 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_35,0.2890325739165419,2463 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_35,0.368957269288697,2464 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_36,0.3401603959889327,2465 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_36,0.1230342259295566,2466 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_36,0.2832493497284438,2467 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_36,0.2846290735807337,2468 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_37,0.048031133089163194,2469 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_37,0.09012583202806788,2470 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_37,0.07995332400838895,2471 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_37,0.0809215255356459,2472 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_38,0.48318579577014165,2473 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_38,0.47709923734177506,2474 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_38,0.1991014725937638,2475 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_38,0.5800288009486911,2476 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_39,0.10288748144430131,2477 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_39,0.2059847704424619,2478 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_39,0.14187109598142145,2479 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_39,0.2037373781500774,2480 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_4,0.3485862235357236,2481 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_4,0.4187962754624361,2482 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_4,0.3541907609723445,2483 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_4,0.13969452334586394,2484 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_40,0.11880427278561058,2485 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_40,0.12777407454508904,2486 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_40,0.10139011092685227,2487 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_40,0.04505267834051941,2488 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_41,0.18728146488015818,2489 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_41,0.17645971806516483,2490 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_41,0.13370758771900024,2491 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_41,0.12316588968407928,2492 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_42,0.04619819331357036,2493 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_42,0.03526028934641224,2494 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_42,0.020007414581458428,2495 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_42,0.04341614919125533,2496 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_43,0.2534496652913345,2497 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_43,0.11958768118851655,2498 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_43,0.1904073123680219,2499 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_43,0.2504193225224318,2500 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_44,0.44755226983791035,2501 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_44,0.4880060705185843,2502 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_44,0.4348418604449731,2503 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_44,0.6210619228791207,2504 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_45,0.5964261809932518,2505 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_45,0.6972024137206857,2506 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_45,0.5676856296332179,2507 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_45,0.8813618827861582,2508 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_46,1.1342257651173022,2509 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_46,1.4408851975146713,2510 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_46,1.1120142794952501,2511 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_46,0.8789322827621627,2512 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_47,1.0110812397420945,2513 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_47,1.1812141602835893,2514 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_47,0.9628768167424429,2515 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_47,0.4586848682067658,2516 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_48,0.25347713481955614,2517 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_48,0.2731705176786416,2518 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_48,0.2738005591190006,2519 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_48,0.03426578148781492,2520 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_49,0.009156326505584044,2521 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_49,0.015432657403638523,2522 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_49,0.00934234955866849,2523 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_49,0.015414861532721912,2524 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_5,0.5801509906324311,2525 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_5,0.6239712715925425,2526 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_5,0.4761204313417645,2527 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_5,0.22526790812818892,2528 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_50,0.4431053898454379,2529 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_50,0.5931055042761461,2530 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_50,0.4166826510712177,2531 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_50,0.40438143416898137,2532 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_51,0.005921264735088326,2533 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_51,0.01693511884178597,2534 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_51,0.015017037906674186,2535 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_51,0.01806769269089137,2536 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_52,0.029180675951556382,2537 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_52,0.043417061220069976,2538 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_52,0.04230178811168364,2539 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_52,0.04826450711902774,2540 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_53,0.32145188605707437,2541 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_53,0.32525948314170733,2542 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_53,0.26352580676207227,2543 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_53,0.09576768739737207,2544 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_54,0.5494619754110879,2545 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_54,0.7067938000824371,2546 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_54,0.5554360415537688,2547 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_54,0.31439024780123914,2548 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_55,0.3049722536362932,2549 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_55,0.23112274591398332,2550 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_55,0.26884815967136494,2551 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_55,0.13100794290547774,2552 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_56,0.18475190186686957,2553 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_56,0.10926302984841514,2554 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_56,0.2523136823472591,2555 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_56,0.23205933668892334,2556 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_57,0.19824903045826936,2557 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_57,0.21727344957606884,2558 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_57,0.17588561391368795,2559 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_57,0.07069734641945447,2560 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_58,0.5097296377408386,2561 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_58,0.6323094017538987,2562 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_58,0.4372948713608273,2563 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_58,0.6694694214418002,2564 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_59,0.28963917037692283,2565 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_59,0.32521146887063573,2566 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_59,0.3562864880991066,2567 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_59,0.1068314947661393,2568 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_6,0.2423488524847642,2569 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_6,0.2586922392193008,2570 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_6,0.2921777021997897,2571 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_6,0.09083656965554218,2572 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_60,0.5043221044551742,2573 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_60,0.643644930278839,2574 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_60,0.4219656486871372,2575 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_60,0.625695308909033,2576 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_61,0.17060302423984713,2577 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_61,0.09429504036155263,2578 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_61,0.11098721346710107,2579 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_61,0.16753650485014512,2580 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_62,0.1488545230427294,2581 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_62,0.1551908162604852,2582 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_62,0.13481081000964176,2583 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_62,0.11698966463647216,2584 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_63,0.9421144361441753,2585 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_63,1.2418478838201474,2586 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_63,0.9478157392801662,2587 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_63,0.6797512958341203,2588 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_64,0.2466896490721545,2589 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_64,0.1880563658909379,2590 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_64,0.10893906363291211,2591 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_64,0.21818126975370578,2592 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_65,0.053155204810198156,2593 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_65,0.1771530866599722,2594 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_65,0.17335498572549832,2595 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_65,0.14820974499772072,2596 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_66,0.21052797006355528,2597 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_66,0.18193166607178915,2598 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_66,0.13050245424978293,2599 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_66,0.15879391940929577,2600 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_67,0.5276801714182388,2601 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_67,0.3580837523130687,2602 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_67,0.3036292086636461,2603 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_67,0.46552562785921336,2604 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_68,0.16844056060870713,2605 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_68,0.29878828276047614,2606 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_68,0.3197089035658266,2607 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_68,0.31962167568454836,2608 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_69,0.559772636893323,2609 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_69,0.645087464713039,2610 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_69,0.529461785440197,2611 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_69,0.19923577102605097,2612 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_7,0.6078378762043807,2613 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_7,0.7382650584444057,2614 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_7,0.660253006207897,2615 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_7,0.21394112360354384,2616 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_70,0.28968386672966234,2617 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_70,0.404825947993683,2618 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_70,0.3625848927263044,2619 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_70,0.18352818898590825,2620 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_71,0.2816964513772487,2621 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_71,0.24610635949355306,2622 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_71,0.14987478635414725,2623 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_71,0.32626104658405886,2624 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_72,0.19612821327493785,2625 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_72,0.1887446593662042,2626 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_72,0.18310399177355655,2627 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_72,0.02900856434053464,2628 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_73,0.05592575740799798,2629 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_73,0.13657853297477437,2630 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_73,0.13612393717912785,2631 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_73,0.10072455320704896,2632 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_74,0.10962285992040974,2633 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_74,0.11357992166735804,2634 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_74,0.1245909318126813,2635 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_74,0.029369533978832837,2636 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_75,0.09905501303578106,2637 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_75,0.10788441556120905,2638 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_75,0.08199067309698074,2639 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_75,0.049541503684336914,2640 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_76,0.12256222645934098,2641 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_76,0.23942449131610175,2642 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_76,0.2366704583793858,2643 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_76,0.2540203603570015,2644 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_77,0.048619760524348576,2645 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_77,0.05844207631097292,2646 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_77,0.053949248340521616,2647 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_77,0.025584617708315216,2648 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_78,0.004942039778289038,2649 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_78,0.016341557504316075,2650 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_78,0.015515853346295494,2651 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_78,0.017773440097825798,2652 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_79,0.05690812769457948,2653 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_79,0.07061997866381585,2654 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_79,0.06267563554418935,2655 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_79,0.040819991743529495,2656 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_8,0.21048066807581106,2657 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_8,0.24745583346034708,2658 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_8,0.18580493863860356,2659 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_8,0.15324780659438264,2660 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_80,0.11643220778907092,2661 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_80,0.09942616634342817,2662 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_80,0.038350320131647415,2663 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_80,0.10257609424506409,2664 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_81,0.08501369368801515,2665 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_81,0.117765278835775,2666 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_81,0.11619029384212987,2667 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_81,0.048604944418427574,2668 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_82,0.6229949677592117,2669 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_82,0.529654332922427,2670 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_82,0.18847984244491547,2671 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_82,0.6503734250546308,2672 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_83,0.15476917424300943,2673 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_83,0.08311290881910494,2674 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_83,0.15446522501605414,2675 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_83,0.09600023442486709,2676 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_84,1.2566304036796898,2677 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_84,1.6930309728658985,2678 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_84,1.2392949301723297,2679 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_84,1.577576529429249,2680 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_85,0.7431205901310703,2681 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_85,0.9252273386615869,2682 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_85,0.711343491849599,2683 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_85,0.405922001225881,2684 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_86,0.5337639771667095,2685 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_86,0.647271082057555,2686 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_86,0.3686823319006823,2687 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_86,0.5747422473773444,2688 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_87,0.3558165911555025,2689 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_87,0.3772545089484237,2690 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_87,0.24747102302481577,2691 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_87,0.1895507274069618,2692 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_88,0.27637339806488415,2693 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_88,0.28203849159007993,2694 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_88,0.14486725919459054,2695 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_88,0.18688948927036497,2696 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_89,0.5873909228561702,2697 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_89,0.6874064775849447,2698 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_89,0.5233055623480831,2699 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_89,0.27333959415429165,2700 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_9,0.02068463197240279,2701 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_9,0.035427477930383734,2702 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_9,0.03630674300610408,2703 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_9,0.026429412791243907,2704 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_90,0.3720728355070302,2705 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_90,0.4057153568524596,2706 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_90,0.2658183093272312,2707 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_90,0.21204537107070265,2708 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_91,0.36576801794061514,2709 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_91,0.36681330235389287,2710 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_91,0.3154127097129312,2711 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_91,0.10912216508164181,2712 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_92,0.8841477121452656,2713 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_92,0.6693703149115201,2714 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_92,0.882011243010681,2715 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_92,0.4921901918395386,2716 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_93,0.47695412566530215,2717 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_93,0.08720296578160791,2718 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_93,0.464080206569164,2719 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_93,0.45993569076565716,2720 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_94,0.5129918181188822,2721 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_94,0.5891828780928605,2722 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_94,0.41142472653550866,2723 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_94,0.28189047938479284,2724 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_97,0.2723431998408122,2725 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_97,0.3862649194987629,2726 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_97,0.4254691739671981,2727 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_97,0.23543144349520553,2728 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_98,0.6451327757837203,2729 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_98,0.8742088142790179,2730 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_98,0.5066327106605606,2731 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_98,0.7019861058536627,2732 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_99,0.35026075341090607,2733 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_99,0.40988887799555224,2734 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_99,0.27206897261540536,2735 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_99,0.33338234208488743,2736 +log2-1,fruit,1017361 Sl10g086080 #2,m_1,0.1221204908982829,2737 +log2-1,fruit,1017361 Sl10g086080 #2,m_1,0.11830926107647476,2738 +log2-1,fruit,1017361 Sl10g086080 #2,m_1,0.20575711528418653,2739 +log2-1,fruit,1017361 Sl10g086080 #2,m_1,0.20753432284793566,2740 +log2-1,fruit,1017361 Sl10g086080 #2,m_10,0.004483398844682142,2741 +log2-1,fruit,1017361 Sl10g086080 #2,m_10,0.03163230609029181,2742 +log2-1,fruit,1017361 Sl10g086080 #2,m_10,0.0330490881982947,2743 +log2-1,fruit,1017361 Sl10g086080 #2,m_10,0.030543759372459484,2744 +log2-1,fruit,1017361 Sl10g086080 #2,m_100,0.33161828545416455,2745 +log2-1,fruit,1017361 Sl10g086080 #2,m_100,0.4028810119225904,2746 +log2-1,fruit,1017361 Sl10g086080 #2,m_100,0.15705676089272053,2747 +log2-1,fruit,1017361 Sl10g086080 #2,m_100,0.4096131068047028,2748 +log2-1,fruit,1017361 Sl10g086080 #2,m_101,0.06210848228122584,2749 +log2-1,fruit,1017361 Sl10g086080 #2,m_101,0.09901293417618229,2750 +log2-1,fruit,1017361 Sl10g086080 #2,m_101,0.09346234938764575,2751 +log2-1,fruit,1017361 Sl10g086080 #2,m_101,0.08634717503955826,2752 +log2-1,fruit,1017361 Sl10g086080 #2,m_102,0.1840429021989083,2753 +log2-1,fruit,1017361 Sl10g086080 #2,m_102,0.11054979152852693,2754 +log2-1,fruit,1017361 Sl10g086080 #2,m_102,0.10226935579119562,2755 +log2-1,fruit,1017361 Sl10g086080 #2,m_102,0.18188044752828772,2756 +log2-1,fruit,1017361 Sl10g086080 #2,m_103,0.6479228659410577,2757 +log2-1,fruit,1017361 Sl10g086080 #2,m_103,0.8516994414696494,2758 +log2-1,fruit,1017361 Sl10g086080 #2,m_103,0.7241886066579819,2759 +log2-1,fruit,1017361 Sl10g086080 #2,m_103,0.34641307621037726,2760 +log2-1,fruit,1017361 Sl10g086080 #2,m_104,0.7101953963261698,2761 +log2-1,fruit,1017361 Sl10g086080 #2,m_104,0.9102251529131453,2762 +log2-1,fruit,1017361 Sl10g086080 #2,m_104,0.7825935995029559,2763 +log2-1,fruit,1017361 Sl10g086080 #2,m_104,0.3464130762103773,2764 +log2-1,fruit,1017361 Sl10g086080 #2,m_105,0.06954439633863801,2765 +log2-1,fruit,1017361 Sl10g086080 #2,m_105,0.07458831081463158,2766 +log2-1,fruit,1017361 Sl10g086080 #2,m_105,0.12097436234936546,2767 +log2-1,fruit,1017361 Sl10g086080 #2,m_105,0.11927483430751695,2768 +log2-1,fruit,1017361 Sl10g086080 #2,m_106,0.23845241815488252,2769 +log2-1,fruit,1017361 Sl10g086080 #2,m_106,0.24999284025755322,2770 +log2-1,fruit,1017361 Sl10g086080 #2,m_106,0.21848565268971537,2771 +log2-1,fruit,1017361 Sl10g086080 #2,m_106,0.04930352527787968,2772 +log2-1,fruit,1017361 Sl10g086080 #2,m_107,0.7315377409621502,2773 +log2-1,fruit,1017361 Sl10g086080 #2,m_107,0.6856655180868777,2774 +log2-1,fruit,1017361 Sl10g086080 #2,m_107,0.46647911010022763,2775 +log2-1,fruit,1017361 Sl10g086080 #2,m_107,0.3985009453933873,2776 +log2-1,fruit,1017361 Sl10g086080 #2,m_108,0.8580072623279369,2777 +log2-1,fruit,1017361 Sl10g086080 #2,m_108,0.9830450566535069,2778 +log2-1,fruit,1017361 Sl10g086080 #2,m_108,1.0637702341548774,2779 +log2-1,fruit,1017361 Sl10g086080 #2,m_108,0.3766846045936917,2780 +log2-1,fruit,1017361 Sl10g086080 #2,m_109,0.22596432669833033,2781 +log2-1,fruit,1017361 Sl10g086080 #2,m_109,0.21054247590029698,2782 +log2-1,fruit,1017361 Sl10g086080 #2,m_109,0.21380007684699281,2783 +log2-1,fruit,1017361 Sl10g086080 #2,m_109,0.043103514230994816,2784 +log2-1,fruit,1017361 Sl10g086080 #2,m_11,1.0809451934543404,2785 +log2-1,fruit,1017361 Sl10g086080 #2,m_11,0.9928032050025581,2786 +log2-1,fruit,1017361 Sl10g086080 #2,m_11,0.7300069846816215,2787 +log2-1,fruit,1017361 Sl10g086080 #2,m_11,0.6141513863252179,2788 +log2-1,fruit,1017361 Sl10g086080 #2,m_110,0.6794281703663781,2789 +log2-1,fruit,1017361 Sl10g086080 #2,m_110,0.7595818971093176,2790 +log2-1,fruit,1017361 Sl10g086080 #2,m_110,0.5336400487825762,2791 +log2-1,fruit,1017361 Sl10g086080 #2,m_110,0.3508717271164444,2792 +log2-1,fruit,1017361 Sl10g086080 #2,m_111,0.4360635873730692,2793 +log2-1,fruit,1017361 Sl10g086080 #2,m_111,0.10295829536736766,2794 +log2-1,fruit,1017361 Sl10g086080 #2,m_111,0.5029630832965019,2795 +log2-1,fruit,1017361 Sl10g086080 #2,m_111,0.47384837295542526,2796 +log2-1,fruit,1017361 Sl10g086080 #2,m_112,0.39901303358119306,2797 +log2-1,fruit,1017361 Sl10g086080 #2,m_112,0.2597798235790153,2798 +log2-1,fruit,1017361 Sl10g086080 #2,m_112,0.40022522742001265,2799 +log2-1,fruit,1017361 Sl10g086080 #2,m_112,0.2050700240321461,2800 +log2-1,fruit,1017361 Sl10g086080 #2,m_12,0.9985355658695485,2801 +log2-1,fruit,1017361 Sl10g086080 #2,m_12,0.9277004235577128,2802 +log2-1,fruit,1017361 Sl10g086080 #2,m_12,0.6346010381228804,2803 +log2-1,fruit,1017361 Sl10g086080 #2,m_12,0.6016404488910613,2804 +log2-1,fruit,1017361 Sl10g086080 #2,m_120,0.10494405444400769,2805 +log2-1,fruit,1017361 Sl10g086080 #2,m_120,0.07257763632210872,2806 +log2-1,fruit,1017361 Sl10g086080 #2,m_120,0.11370969590560152,2807 +log2-1,fruit,1017361 Sl10g086080 #2,m_120,0.08338674105340205,2808 +log2-1,fruit,1017361 Sl10g086080 #2,m_121,0.1899740748487112,2809 +log2-1,fruit,1017361 Sl10g086080 #2,m_121,0.23523341130451175,2810 +log2-1,fruit,1017361 Sl10g086080 #2,m_121,0.21548855760659666,2811 +log2-1,fruit,1017361 Sl10g086080 #2,m_121,0.07548269674373649,2812 +log2-1,fruit,1017361 Sl10g086080 #2,m_122,0.4310080175314297,2813 +log2-1,fruit,1017361 Sl10g086080 #2,m_122,0.4446119763574714,2814 +log2-1,fruit,1017361 Sl10g086080 #2,m_122,0.32429442820017373,2815 +log2-1,fruit,1017361 Sl10g086080 #2,m_122,0.17894592067847379,2816 +log2-1,fruit,1017361 Sl10g086080 #2,m_123,0.4588786457426656,2817 +log2-1,fruit,1017361 Sl10g086080 #2,m_123,0.3944624287044667,2818 +log2-1,fruit,1017361 Sl10g086080 #2,m_123,0.4266320019914089,2819 +log2-1,fruit,1017361 Sl10g086080 #2,m_123,0.23428780052373288,2820 +log2-1,fruit,1017361 Sl10g086080 #2,m_13,1.1367783919542191,2821 +log2-1,fruit,1017361 Sl10g086080 #2,m_13,1.139941264186714,2822 +log2-1,fruit,1017361 Sl10g086080 #2,m_13,0.9093350552858314,2823 +log2-1,fruit,1017361 Sl10g086080 #2,m_13,0.5085256657207144,2824 +log2-1,fruit,1017361 Sl10g086080 #2,m_14,0.21318429009043469,2825 +log2-1,fruit,1017361 Sl10g086080 #2,m_14,0.13493176152642986,2826 +log2-1,fruit,1017361 Sl10g086080 #2,m_14,0.11743231699436193,2827 +log2-1,fruit,1017361 Sl10g086080 #2,m_14,0.21623109756256415,2828 +log2-1,fruit,1017361 Sl10g086080 #2,m_15,0.36788606814100977,2829 +log2-1,fruit,1017361 Sl10g086080 #2,m_15,0.32713064396516883,2830 +log2-1,fruit,1017361 Sl10g086080 #2,m_15,0.37486188114169267,2831 +log2-1,fruit,1017361 Sl10g086080 #2,m_15,0.16909131794385737,2832 +log2-1,fruit,1017361 Sl10g086080 #2,m_16,0.21465362647486366,2833 +log2-1,fruit,1017361 Sl10g086080 #2,m_16,0.1928783395582804,2834 +log2-1,fruit,1017361 Sl10g086080 #2,m_16,0.12546188353758592,2835 +log2-1,fruit,1017361 Sl10g086080 #2,m_16,0.1519697194149082,2836 +log2-1,fruit,1017361 Sl10g086080 #2,m_17,1.4176463270969386,2837 +log2-1,fruit,1017361 Sl10g086080 #2,m_17,1.4377063529096816,2838 +log2-1,fruit,1017361 Sl10g086080 #2,m_17,1.2724139783508417,2839 +log2-1,fruit,1017361 Sl10g086080 #2,m_17,0.577876173600865,2840 +log2-1,fruit,1017361 Sl10g086080 #2,m_18,0.6196186605631634,2841 +log2-1,fruit,1017361 Sl10g086080 #2,m_18,0.8637066403394881,2842 +log2-1,fruit,1017361 Sl10g086080 #2,m_18,0.5182935358478301,2843 +log2-1,fruit,1017361 Sl10g086080 #2,m_18,0.7059495617160049,2844 +log2-1,fruit,1017361 Sl10g086080 #2,m_19,0.22067407998943392,2845 +log2-1,fruit,1017361 Sl10g086080 #2,m_19,0.20037657768132702,2846 +log2-1,fruit,1017361 Sl10g086080 #2,m_19,0.1274317333510499,2847 +log2-1,fruit,1017361 Sl10g086080 #2,m_19,0.21559380003130948,2848 +log2-1,fruit,1017361 Sl10g086080 #2,m_2,1.7315455940195952,2849 +log2-1,fruit,1017361 Sl10g086080 #2,m_2,0.969624489040842,2850 +log2-1,fruit,1017361 Sl10g086080 #2,m_2,1.731506609767317,2851 +log2-1,fruit,1017361 Sl10g086080 #2,m_2,1.731869026770359,2852 +log2-1,fruit,1017361 Sl10g086080 #2,m_20,0.24541117869607304,2853 +log2-1,fruit,1017361 Sl10g086080 #2,m_20,0.22003115171410137,2854 +log2-1,fruit,1017361 Sl10g086080 #2,m_20,0.068558357545116,2855 +log2-1,fruit,1017361 Sl10g086080 #2,m_20,0.26304989537895807,2856 +log2-1,fruit,1017361 Sl10g086080 #2,m_21,0.45322459601040793,2857 +log2-1,fruit,1017361 Sl10g086080 #2,m_21,0.3162606846422986,2858 +log2-1,fruit,1017361 Sl10g086080 #2,m_21,0.4084887013881326,2859 +log2-1,fruit,1017361 Sl10g086080 #2,m_21,0.2117330368392173,2860 +log2-1,fruit,1017361 Sl10g086080 #2,m_22,0.4302674812630842,2861 +log2-1,fruit,1017361 Sl10g086080 #2,m_22,0.5766651289769467,2862 +log2-1,fruit,1017361 Sl10g086080 #2,m_22,0.2962532894380174,2863 +log2-1,fruit,1017361 Sl10g086080 #2,m_22,0.5167253519411927,2864 +log2-1,fruit,1017361 Sl10g086080 #2,m_23,0.15587596016091726,2865 +log2-1,fruit,1017361 Sl10g086080 #2,m_23,0.1644801435100664,2866 +log2-1,fruit,1017361 Sl10g086080 #2,m_23,0.11782871410015758,2867 +log2-1,fruit,1017361 Sl10g086080 #2,m_23,0.10970833299591279,2868 +log2-1,fruit,1017361 Sl10g086080 #2,m_24,0.4304077251054924,2869 +log2-1,fruit,1017361 Sl10g086080 #2,m_24,0.34807139436472256,2870 +log2-1,fruit,1017361 Sl10g086080 #2,m_24,0.3514450953297307,2871 +log2-1,fruit,1017361 Sl10g086080 #2,m_24,0.174350115086366,2872 +log2-1,fruit,1017361 Sl10g086080 #2,m_25,0.15295324772903793,2873 +log2-1,fruit,1017361 Sl10g086080 #2,m_25,0.16390487392520425,2874 +log2-1,fruit,1017361 Sl10g086080 #2,m_25,0.01756973673276741,2875 +log2-1,fruit,1017361 Sl10g086080 #2,m_25,0.1606410181717025,2876 +log2-1,fruit,1017361 Sl10g086080 #2,m_26,0.30069076361253344,2877 +log2-1,fruit,1017361 Sl10g086080 #2,m_26,0.33575500774346356,2878 +log2-1,fruit,1017361 Sl10g086080 #2,m_26,0.2342603768465827,2879 +log2-1,fruit,1017361 Sl10g086080 #2,m_26,0.16900808429269482,2880 +log2-1,fruit,1017361 Sl10g086080 #2,m_27,0.10876102491683969,2881 +log2-1,fruit,1017361 Sl10g086080 #2,m_27,0.13672806756226896,2882 +log2-1,fruit,1017361 Sl10g086080 #2,m_27,0.11500403376264647,2883 +log2-1,fruit,1017361 Sl10g086080 #2,m_27,0.11946179817712572,2884 +log2-1,fruit,1017361 Sl10g086080 #2,m_28,0.3302778237660741,2885 +log2-1,fruit,1017361 Sl10g086080 #2,m_28,0.32536924961283725,2886 +log2-1,fruit,1017361 Sl10g086080 #2,m_28,0.23999698115423998,2887 +log2-1,fruit,1017361 Sl10g086080 #2,m_28,0.1485340678883194,2888 +log2-1,fruit,1017361 Sl10g086080 #2,m_29,0.5869450878147965,2889 +log2-1,fruit,1017361 Sl10g086080 #2,m_29,0.6404144216420751,2890 +log2-1,fruit,1017361 Sl10g086080 #2,m_29,0.6232137714672203,2891 +log2-1,fruit,1017361 Sl10g086080 #2,m_29,0.08447589315165373,2892 +log2-1,fruit,1017361 Sl10g086080 #2,m_3,0.10585636232063143,2893 +log2-1,fruit,1017361 Sl10g086080 #2,m_3,0.4732023538229311,2894 +log2-1,fruit,1017361 Sl10g086080 #2,m_3,0.4927158587831592,2895 +log2-1,fruit,1017361 Sl10g086080 #2,m_3,0.4824941351398702,2896 +log2-1,fruit,1017361 Sl10g086080 #2,m_30,0.20309533235871055,2897 +log2-1,fruit,1017361 Sl10g086080 #2,m_30,0.19624039134001844,2898 +log2-1,fruit,1017361 Sl10g086080 #2,m_30,0.13463562185982772,2899 +log2-1,fruit,1017361 Sl10g086080 #2,m_30,0.10006738719792627,2900 +log2-1,fruit,1017361 Sl10g086080 #2,m_31,0.6707170435774497,2901 +log2-1,fruit,1017361 Sl10g086080 #2,m_31,0.7642935006922436,2902 +log2-1,fruit,1017361 Sl10g086080 #2,m_31,0.6632478271462786,2903 +log2-1,fruit,1017361 Sl10g086080 #2,m_31,0.18896818919564498,2904 +log2-1,fruit,1017361 Sl10g086080 #2,m_32,0.2874225527814093,2905 +log2-1,fruit,1017361 Sl10g086080 #2,m_32,0.28908517377737786,2906 +log2-1,fruit,1017361 Sl10g086080 #2,m_32,0.14395043212336986,2907 +log2-1,fruit,1017361 Sl10g086080 #2,m_32,0.1891274577931707,2908 +log2-1,fruit,1017361 Sl10g086080 #2,m_33,0.6920413860953103,2909 +log2-1,fruit,1017361 Sl10g086080 #2,m_33,0.5131936686904435,2910 +log2-1,fruit,1017361 Sl10g086080 #2,m_33,0.2793636775040323,2911 +log2-1,fruit,1017361 Sl10g086080 #2,m_33,0.617009894395279,2912 +log2-1,fruit,1017361 Sl10g086080 #2,m_34,0.15834041919711156,2913 +log2-1,fruit,1017361 Sl10g086080 #2,m_34,0.1569175714463449,2914 +log2-1,fruit,1017361 Sl10g086080 #2,m_34,0.08941364746893858,2915 +log2-1,fruit,1017361 Sl10g086080 #2,m_34,0.12821049640120188,2916 +log2-1,fruit,1017361 Sl10g086080 #2,m_35,0.45717604289581043,2917 +log2-1,fruit,1017361 Sl10g086080 #2,m_35,0.5396145523934801,2918 +log2-1,fruit,1017361 Sl10g086080 #2,m_35,0.20725073449677148,2919 +log2-1,fruit,1017361 Sl10g086080 #2,m_35,0.42219408360273425,2920 +log2-1,fruit,1017361 Sl10g086080 #2,m_36,0.2378176137955561,2921 +log2-1,fruit,1017361 Sl10g086080 #2,m_36,0.09068246491890432,2922 +log2-1,fruit,1017361 Sl10g086080 #2,m_36,0.18037586709194142,2923 +log2-1,fruit,1017361 Sl10g086080 #2,m_36,0.24077475846329888,2924 +log2-1,fruit,1017361 Sl10g086080 #2,m_37,0.18417333701788524,2925 +log2-1,fruit,1017361 Sl10g086080 #2,m_37,0.11773286423253701,2926 +log2-1,fruit,1017361 Sl10g086080 #2,m_37,0.10613744650088777,2927 +log2-1,fruit,1017361 Sl10g086080 #2,m_37,0.18829493027055572,2928 +log2-1,fruit,1017361 Sl10g086080 #2,m_38,0.33673837621853125,2929 +log2-1,fruit,1017361 Sl10g086080 #2,m_38,0.6308465904218782,2930 +log2-1,fruit,1017361 Sl10g086080 #2,m_38,0.5751855483035815,2931 +log2-1,fruit,1017361 Sl10g086080 #2,m_38,0.5425719657785635,2932 +log2-1,fruit,1017361 Sl10g086080 #2,m_39,0.5409304438305377,2933 +log2-1,fruit,1017361 Sl10g086080 #2,m_39,0.6080437011016023,2934 +log2-1,fruit,1017361 Sl10g086080 #2,m_39,0.7354581658254397,2935 +log2-1,fruit,1017361 Sl10g086080 #2,m_39,0.8779316079752085,2936 +log2-1,fruit,1017361 Sl10g086080 #2,m_4,0.614138423167871,2937 +log2-1,fruit,1017361 Sl10g086080 #2,m_4,0.514482160914075,2938 +log2-1,fruit,1017361 Sl10g086080 #2,m_4,0.3163553581062143,2939 +log2-1,fruit,1017361 Sl10g086080 #2,m_4,0.7115581662386153,2940 +log2-1,fruit,1017361 Sl10g086080 #2,m_40,0.3909310493799333,2941 +log2-1,fruit,1017361 Sl10g086080 #2,m_40,0.46721317177257243,2942 +log2-1,fruit,1017361 Sl10g086080 #2,m_40,0.4001641061518155,2943 +log2-1,fruit,1017361 Sl10g086080 #2,m_40,0.1443120706257823,2944 +log2-1,fruit,1017361 Sl10g086080 #2,m_41,0.2094244430132244,2945 +log2-1,fruit,1017361 Sl10g086080 #2,m_41,0.20264445135103543,2946 +log2-1,fruit,1017361 Sl10g086080 #2,m_41,0.22132327161551346,2947 +log2-1,fruit,1017361 Sl10g086080 #2,m_41,0.03138740334586713,2948 +log2-1,fruit,1017361 Sl10g086080 #2,m_42,0.05430136152667251,2949 +log2-1,fruit,1017361 Sl10g086080 #2,m_42,0.1482709385466978,2950 +log2-1,fruit,1017361 Sl10g086080 #2,m_42,0.1604570389919262,2951 +log2-1,fruit,1017361 Sl10g086080 #2,m_42,0.12854210981585412,2952 +log2-1,fruit,1017361 Sl10g086080 #2,m_43,1.186941867245409,2953 +log2-1,fruit,1017361 Sl10g086080 #2,m_43,1.3053190700684951,2954 +log2-1,fruit,1017361 Sl10g086080 #2,m_43,1.1880937546883301,2955 +log2-1,fruit,1017361 Sl10g086080 #2,m_43,0.33409071875039936,2956 +log2-1,fruit,1017361 Sl10g086080 #2,m_44,0.9022809250910774,2957 +log2-1,fruit,1017361 Sl10g086080 #2,m_44,0.7454021951544556,2958 +log2-1,fruit,1017361 Sl10g086080 #2,m_44,0.7998331115821932,2959 +log2-1,fruit,1017361 Sl10g086080 #2,m_44,0.27330777414517937,2960 +log2-1,fruit,1017361 Sl10g086080 #2,m_45,0.8343280288552325,2961 +log2-1,fruit,1017361 Sl10g086080 #2,m_45,0.7382050994303526,2962 +log2-1,fruit,1017361 Sl10g086080 #2,m_45,0.8007384449329151,2963 +log2-1,fruit,1017361 Sl10g086080 #2,m_45,0.16030392295038215,2964 +log2-1,fruit,1017361 Sl10g086080 #2,m_46,1.0047485474635205,2965 +log2-1,fruit,1017361 Sl10g086080 #2,m_46,0.9694093237136132,2966 +log2-1,fruit,1017361 Sl10g086080 #2,m_46,0.697527972157196,2967 +log2-1,fruit,1017361 Sl10g086080 #2,m_46,0.5430640873083283,2968 +log2-1,fruit,1017361 Sl10g086080 #2,m_47,1.0892574478232653,2969 +log2-1,fruit,1017361 Sl10g086080 #2,m_47,0.9996909998936805,2970 +log2-1,fruit,1017361 Sl10g086080 #2,m_47,0.8275818034322383,2971 +log2-1,fruit,1017361 Sl10g086080 #2,m_47,0.4774059481135475,2972 +log2-1,fruit,1017361 Sl10g086080 #2,m_48,0.4619731262678378,2973 +log2-1,fruit,1017361 Sl10g086080 #2,m_48,0.5953488132306538,2974 +log2-1,fruit,1017361 Sl10g086080 #2,m_48,0.507129373797352,2975 +log2-1,fruit,1017361 Sl10g086080 #2,m_48,0.22826988029604312,2976 +log2-1,fruit,1017361 Sl10g086080 #2,m_49,0.041016383731144246,2977 +log2-1,fruit,1017361 Sl10g086080 #2,m_49,0.027672278909923135,2978 +log2-1,fruit,1017361 Sl10g086080 #2,m_49,0.059773294279390744,2979 +log2-1,fruit,1017361 Sl10g086080 #2,m_49,0.05883873645221724,2980 +log2-1,fruit,1017361 Sl10g086080 #2,m_5,0.11717263771259753,2981 +log2-1,fruit,1017361 Sl10g086080 #2,m_5,0.20580573546983513,2982 +log2-1,fruit,1017361 Sl10g086080 #2,m_5,0.2187825195399976,2983 +log2-1,fruit,1017361 Sl10g086080 #2,m_5,0.1445225948995598,2984 +log2-1,fruit,1017361 Sl10g086080 #2,m_50,0.3018676318563404,2985 +log2-1,fruit,1017361 Sl10g086080 #2,m_50,0.29242771071490115,2986 +log2-1,fruit,1017361 Sl10g086080 #2,m_50,0.2701488100265257,2987 +log2-1,fruit,1017361 Sl10g086080 #2,m_50,0.10419284552075482,2988 +log2-1,fruit,1017361 Sl10g086080 #2,m_51,0.039114929330242895,2989 +log2-1,fruit,1017361 Sl10g086080 #2,m_51,0.09604138983993236,2990 +log2-1,fruit,1017361 Sl10g086080 #2,m_51,0.10723972189141481,2991 +log2-1,fruit,1017361 Sl10g086080 #2,m_51,0.09601836601629257,2992 +log2-1,fruit,1017361 Sl10g086080 #2,m_52,0.1039120877747171,2993 +log2-1,fruit,1017361 Sl10g086080 #2,m_52,0.09044279332404476,2994 +log2-1,fruit,1017361 Sl10g086080 #2,m_52,0.043802956987630856,2995 +log2-1,fruit,1017361 Sl10g086080 #2,m_52,0.09471333634214134,2996 +log2-1,fruit,1017361 Sl10g086080 #2,m_53,0.12434365064799555,2997 +log2-1,fruit,1017361 Sl10g086080 #2,m_53,0.23526754901015456,2998 +log2-1,fruit,1017361 Sl10g086080 #2,m_53,0.23412989562967085,2999 +log2-1,fruit,1017361 Sl10g086080 #2,m_53,0.1487045357525441,3000 +log2-1,fruit,1017361 Sl10g086080 #2,m_54,0.3678291199038819,3001 +log2-1,fruit,1017361 Sl10g086080 #2,m_54,0.33015807163127875,3002 +log2-1,fruit,1017361 Sl10g086080 #2,m_54,0.26809636652442176,3003 +log2-1,fruit,1017361 Sl10g086080 #2,m_54,0.16103772488919577,3004 +log2-1,fruit,1017361 Sl10g086080 #2,m_55,0.04648818117961267,3005 +log2-1,fruit,1017361 Sl10g086080 #2,m_55,0.287638869699626,3006 +log2-1,fruit,1017361 Sl10g086080 #2,m_55,0.3125733017551312,3007 +log2-1,fruit,1017361 Sl10g086080 #2,m_55,0.3168225272715113,3008 +log2-1,fruit,1017361 Sl10g086080 #2,m_56,0.19253988154533522,3009 +log2-1,fruit,1017361 Sl10g086080 #2,m_56,0.25943861407295765,3010 +log2-1,fruit,1017361 Sl10g086080 #2,m_56,0.2008430349773478,3011 +log2-1,fruit,1017361 Sl10g086080 #2,m_56,0.28986101650626706,3012 +log2-1,fruit,1017361 Sl10g086080 #2,m_57,0.29825604697681124,3013 +log2-1,fruit,1017361 Sl10g086080 #2,m_57,0.40102219482816637,3014 +log2-1,fruit,1017361 Sl10g086080 #2,m_57,0.3769781012317228,3015 +log2-1,fruit,1017361 Sl10g086080 #2,m_57,0.15348600027694584,3016 +log2-1,fruit,1017361 Sl10g086080 #2,m_58,0.1492273785552059,3017 +log2-1,fruit,1017361 Sl10g086080 #2,m_58,0.07335132762870988,3018 +log2-1,fruit,1017361 Sl10g086080 #2,m_58,0.13912252864996583,3019 +log2-1,fruit,1017361 Sl10g086080 #2,m_58,0.10655549169784266,3020 +log2-1,fruit,1017361 Sl10g086080 #2,m_59,0.7657062866713614,3021 +log2-1,fruit,1017361 Sl10g086080 #2,m_59,0.7827524290991275,3022 +log2-1,fruit,1017361 Sl10g086080 #2,m_59,0.5459577533553005,3023 +log2-1,fruit,1017361 Sl10g086080 #2,m_59,0.3826214652214768,3024 +log2-1,fruit,1017361 Sl10g086080 #2,m_6,0.1463385511484477,3025 +log2-1,fruit,1017361 Sl10g086080 #2,m_6,1.0943546800779493,3026 +log2-1,fruit,1017361 Sl10g086080 #2,m_6,1.0326350847874854,3027 +log2-1,fruit,1017361 Sl10g086080 #2,m_6,1.0296929237451675,3028 +log2-1,fruit,1017361 Sl10g086080 #2,m_60,0.664262637506967,3029 +log2-1,fruit,1017361 Sl10g086080 #2,m_60,0.44203772924086937,3030 +log2-1,fruit,1017361 Sl10g086080 #2,m_60,0.48711210663884436,3031 +log2-1,fruit,1017361 Sl10g086080 #2,m_60,0.5457175884610262,3032 +log2-1,fruit,1017361 Sl10g086080 #2,m_61,0.3388903585339971,3033 +log2-1,fruit,1017361 Sl10g086080 #2,m_61,0.2805309576991512,3034 +log2-1,fruit,1017361 Sl10g086080 #2,m_61,0.25099480689451625,3035 +log2-1,fruit,1017361 Sl10g086080 #2,m_61,0.2673164805956664,3036 +log2-1,fruit,1017361 Sl10g086080 #2,m_62,1.1083643622345496,3037 +log2-1,fruit,1017361 Sl10g086080 #2,m_62,1.1346085140705169,3038 +log2-1,fruit,1017361 Sl10g086080 #2,m_62,0.9391665254112823,3039 +log2-1,fruit,1017361 Sl10g086080 #2,m_62,0.41282949303283467,3040 +log2-1,fruit,1017361 Sl10g086080 #2,m_63,0.9996962242256173,3041 +log2-1,fruit,1017361 Sl10g086080 #2,m_63,0.7914969063984697,3042 +log2-1,fruit,1017361 Sl10g086080 #2,m_63,0.7557920137482196,3043 +log2-1,fruit,1017361 Sl10g086080 #2,m_63,0.47172381423159704,3044 +log2-1,fruit,1017361 Sl10g086080 #2,m_64,0.7205194521600824,3045 +log2-1,fruit,1017361 Sl10g086080 #2,m_64,0.7491407177118024,3046 +log2-1,fruit,1017361 Sl10g086080 #2,m_64,0.5869499328121226,3047 +log2-1,fruit,1017361 Sl10g086080 #2,m_64,0.26072312344553,3048 +log2-1,fruit,1017361 Sl10g086080 #2,m_65,0.2548932317276018,3049 +log2-1,fruit,1017361 Sl10g086080 #2,m_65,0.2815744491392362,3050 +log2-1,fruit,1017361 Sl10g086080 #2,m_65,0.3053948012702582,3051 +log2-1,fruit,1017361 Sl10g086080 #2,m_65,0.3817507424103798,3052 +log2-1,fruit,1017361 Sl10g086080 #2,m_66,0.5681378912550288,3053 +log2-1,fruit,1017361 Sl10g086080 #2,m_66,0.6087421382943065,3054 +log2-1,fruit,1017361 Sl10g086080 #2,m_66,0.4574955600762935,3055 +log2-1,fruit,1017361 Sl10g086080 #2,m_66,0.22918610317471164,3056 +log2-1,fruit,1017361 Sl10g086080 #2,m_67,0.47730492203103186,3057 +log2-1,fruit,1017361 Sl10g086080 #2,m_67,0.5377582372454246,3058 +log2-1,fruit,1017361 Sl10g086080 #2,m_67,0.3259764505155564,3059 +log2-1,fruit,1017361 Sl10g086080 #2,m_67,0.32704616417957505,3060 +log2-1,fruit,1017361 Sl10g086080 #2,m_68,0.03676982723108331,3061 +log2-1,fruit,1017361 Sl10g086080 #2,m_68,0.10575833675059651,3062 +log2-1,fruit,1017361 Sl10g086080 #2,m_68,0.08169871280267861,3063 +log2-1,fruit,1017361 Sl10g086080 #2,m_68,0.10350319015177194,3064 +log2-1,fruit,1017361 Sl10g086080 #2,m_69,0.27687453806734147,3065 +log2-1,fruit,1017361 Sl10g086080 #2,m_69,0.7014834638352727,3066 +log2-1,fruit,1017361 Sl10g086080 #2,m_69,0.5612918447992093,3067 +log2-1,fruit,1017361 Sl10g086080 #2,m_69,0.7368006010309244,3068 +log2-1,fruit,1017361 Sl10g086080 #2,m_7,0.5742378421905275,3069 +log2-1,fruit,1017361 Sl10g086080 #2,m_7,0.6733880907882693,3070 +log2-1,fruit,1017361 Sl10g086080 #2,m_7,0.5207435146361332,3071 +log2-1,fruit,1017361 Sl10g086080 #2,m_7,0.25783676651257015,3072 +log2-1,fruit,1017361 Sl10g086080 #2,m_70,0.5582968632112574,3073 +log2-1,fruit,1017361 Sl10g086080 #2,m_70,0.44873207540621113,3074 +log2-1,fruit,1017361 Sl10g086080 #2,m_70,0.24322956089716014,3075 +log2-1,fruit,1017361 Sl10g086080 #2,m_70,0.4361720150950258,3076 +log2-1,fruit,1017361 Sl10g086080 #2,m_71,0.41649947958538447,3077 +log2-1,fruit,1017361 Sl10g086080 #2,m_71,0.38543408419480946,3078 +log2-1,fruit,1017361 Sl10g086080 #2,m_71,0.32509274859816983,3079 +log2-1,fruit,1017361 Sl10g086080 #2,m_71,0.1396609676685699,3080 +log2-1,fruit,1017361 Sl10g086080 #2,m_72,0.15375000447953302,3081 +log2-1,fruit,1017361 Sl10g086080 #2,m_72,0.3618538266380014,3082 +log2-1,fruit,1017361 Sl10g086080 #2,m_72,0.3645665979574715,3083 +log2-1,fruit,1017361 Sl10g086080 #2,m_72,0.2712715472983891,3084 +log2-1,fruit,1017361 Sl10g086080 #2,m_73,0.5907454362787666,3085 +log2-1,fruit,1017361 Sl10g086080 #2,m_73,0.4681101784716534,3086 +log2-1,fruit,1017361 Sl10g086080 #2,m_73,0.44382584505917705,3087 +log2-1,fruit,1017361 Sl10g086080 #2,m_73,0.2891367924528222,3088 +log2-1,fruit,1017361 Sl10g086080 #2,m_74,0.34720151765854135,3089 +log2-1,fruit,1017361 Sl10g086080 #2,m_74,0.341866266695882,3090 +log2-1,fruit,1017361 Sl10g086080 #2,m_74,0.17014170303813078,3091 +log2-1,fruit,1017361 Sl10g086080 #2,m_74,0.23601866465935525,3092 +log2-1,fruit,1017361 Sl10g086080 #2,m_75,0.11997541076185195,3093 +log2-1,fruit,1017361 Sl10g086080 #2,m_75,0.14878241135065876,3094 +log2-1,fruit,1017361 Sl10g086080 #2,m_75,0.12638004105580006,3095 +log2-1,fruit,1017361 Sl10g086080 #2,m_75,0.0842308935687827,3096 +log2-1,fruit,1017361 Sl10g086080 #2,m_76,0.35622534541819495,3097 +log2-1,fruit,1017361 Sl10g086080 #2,m_76,0.4015572806759506,3098 +log2-1,fruit,1017361 Sl10g086080 #2,m_76,0.5371729037460189,3099 +log2-1,fruit,1017361 Sl10g086080 #2,m_76,0.6150400092646482,3100 +log2-1,fruit,1017361 Sl10g086080 #2,m_77,0.025804033740689566,3101 +log2-1,fruit,1017361 Sl10g086080 #2,m_77,0.05621343351429824,3102 +log2-1,fruit,1017361 Sl10g086080 #2,m_77,0.05746871359821528,3103 +log2-1,fruit,1017361 Sl10g086080 #2,m_77,0.040346390114987904,3104 +log2-1,fruit,1017361 Sl10g086080 #2,m_78,1.074269105560592,3105 +log2-1,fruit,1017361 Sl10g086080 #2,m_78,0.7051226040638574,3106 +log2-1,fruit,1017361 Sl10g086080 #2,m_78,0.6967787503933828,3107 +log2-1,fruit,1017361 Sl10g086080 #2,m_78,0.8027070766176994,3108 +log2-1,fruit,1017361 Sl10g086080 #2,m_79,0.13737612388157774,3109 +log2-1,fruit,1017361 Sl10g086080 #2,m_79,0.13559891429225618,3110 +log2-1,fruit,1017361 Sl10g086080 #2,m_79,0.07662791346555549,3111 +log2-1,fruit,1017361 Sl10g086080 #2,m_79,0.09135887991019223,3112 +log2-1,fruit,1017361 Sl10g086080 #2,m_8,0.8381663890478873,3113 +log2-1,fruit,1017361 Sl10g086080 #2,m_8,0.835848071577532,3114 +log2-1,fruit,1017361 Sl10g086080 #2,m_8,0.7941038123835606,3115 +log2-1,fruit,1017361 Sl10g086080 #2,m_8,0.08287218481182847,3116 +log2-1,fruit,1017361 Sl10g086080 #2,m_80,0.033284651241237764,3117 +log2-1,fruit,1017361 Sl10g086080 #2,m_80,0.046326858445984866,3118 +log2-1,fruit,1017361 Sl10g086080 #2,m_80,0.0377787568759669,3119 +log2-1,fruit,1017361 Sl10g086080 #2,m_80,0.045548598888633184,3120 +log2-1,fruit,1017361 Sl10g086080 #2,m_81,1.1907560396221608,3121 +log2-1,fruit,1017361 Sl10g086080 #2,m_81,1.2335044292672055,3122 +log2-1,fruit,1017361 Sl10g086080 #2,m_81,1.0558679352681761,3123 +log2-1,fruit,1017361 Sl10g086080 #2,m_81,0.4077030820824246,3124 +log2-1,fruit,1017361 Sl10g086080 #2,m_82,0.05462222220275542,3125 +log2-1,fruit,1017361 Sl10g086080 #2,m_82,0.07123841600583376,3126 +log2-1,fruit,1017361 Sl10g086080 #2,m_82,0.10565601947643166,3127 +log2-1,fruit,1017361 Sl10g086080 #2,m_82,0.10823656606647031,3128 +log2-1,fruit,1017361 Sl10g086080 #2,m_83,0.5260153504082021,3129 +log2-1,fruit,1017361 Sl10g086080 #2,m_83,0.568589872199131,3130 +log2-1,fruit,1017361 Sl10g086080 #2,m_83,0.2533185251946946,3131 +log2-1,fruit,1017361 Sl10g086080 #2,m_83,0.4683070048242506,3132 +log2-1,fruit,1017361 Sl10g086080 #2,m_84,1.5728378746280112,3133 +log2-1,fruit,1017361 Sl10g086080 #2,m_84,1.5879216092938093,3134 +log2-1,fruit,1017361 Sl10g086080 #2,m_84,1.5483723655279877,3135 +log2-1,fruit,1017361 Sl10g086080 #2,m_84,0.26201124900118317,3136 +log2-1,fruit,1017361 Sl10g086080 #2,m_85,0.13725302448379204,3137 +log2-1,fruit,1017361 Sl10g086080 #2,m_85,0.15259372584547404,3138 +log2-1,fruit,1017361 Sl10g086080 #2,m_85,0.11302454859232547,3139 +log2-1,fruit,1017361 Sl10g086080 #2,m_85,0.09367486459434288,3140 +log2-1,fruit,1017361 Sl10g086080 #2,m_86,0.03660181452708512,3141 +log2-1,fruit,1017361 Sl10g086080 #2,m_86,0.09387228961023031,3142 +log2-1,fruit,1017361 Sl10g086080 #2,m_86,0.0695277898512013,3143 +log2-1,fruit,1017361 Sl10g086080 #2,m_86,0.09240971876451129,3144 +log2-1,fruit,1017361 Sl10g086080 #2,m_87,0.12994411740216488,3145 +log2-1,fruit,1017361 Sl10g086080 #2,m_87,0.12082274015266517,3146 +log2-1,fruit,1017361 Sl10g086080 #2,m_87,0.06630329803876002,3147 +log2-1,fruit,1017361 Sl10g086080 #2,m_87,0.09335424148739396,3148 +log2-1,fruit,1017361 Sl10g086080 #2,m_88,0.11318922614628209,3149 +log2-1,fruit,1017361 Sl10g086080 #2,m_88,0.05412426207208138,3150 +log2-1,fruit,1017361 Sl10g086080 #2,m_88,0.10251369246443695,3151 +log2-1,fruit,1017361 Sl10g086080 #2,m_88,0.08695376420941446,3152 +log2-1,fruit,1017361 Sl10g086080 #2,m_89,1.254425668700925,3153 +log2-1,fruit,1017361 Sl10g086080 #2,m_89,1.1071595988540972,3154 +log2-1,fruit,1017361 Sl10g086080 #2,m_89,0.9273420931108738,3155 +log2-1,fruit,1017361 Sl10g086080 #2,m_89,0.6588007633218559,3156 +log2-1,fruit,1017361 Sl10g086080 #2,m_9,0.3042769286589414,3157 +log2-1,fruit,1017361 Sl10g086080 #2,m_9,0.3012898297404143,3158 +log2-1,fruit,1017361 Sl10g086080 #2,m_9,0.08108061003910337,3159 +log2-1,fruit,1017361 Sl10g086080 #2,m_9,0.2635786155153257,3160 +log2-1,fruit,1017361 Sl10g086080 #2,m_90,0.10892601532366905,3161 +log2-1,fruit,1017361 Sl10g086080 #2,m_90,0.17579091099056754,3162 +log2-1,fruit,1017361 Sl10g086080 #2,m_90,0.24472036957659496,3163 +log2-1,fruit,1017361 Sl10g086080 #2,m_90,0.24367684789752062,3164 +log2-1,fruit,1017361 Sl10g086080 #2,m_91,0.2665991676555393,3165 +log2-1,fruit,1017361 Sl10g086080 #2,m_91,0.27784315824846384,3166 +log2-1,fruit,1017361 Sl10g086080 #2,m_91,0.2856215234811797,3167 +log2-1,fruit,1017361 Sl10g086080 #2,m_91,0.044342909817208565,3168 +log2-1,fruit,1017361 Sl10g086080 #2,m_92,0.40835897981427566,3169 +log2-1,fruit,1017361 Sl10g086080 #2,m_92,0.40841608166423704,3170 +log2-1,fruit,1017361 Sl10g086080 #2,m_92,0.30935428549352806,3171 +log2-1,fruit,1017361 Sl10g086080 #2,m_92,0.1680875625029743,3172 +log2-1,fruit,1017361 Sl10g086080 #2,m_93,0.27204469559092,3173 +log2-1,fruit,1017361 Sl10g086080 #2,m_93,0.6521680791479416,3174 +log2-1,fruit,1017361 Sl10g086080 #2,m_93,0.6291963247520312,3175 +log2-1,fruit,1017361 Sl10g086080 #2,m_93,0.6799498403601784,3176 +log2-1,fruit,1017361 Sl10g086080 #2,m_94,0.21114645492634854,3177 +log2-1,fruit,1017361 Sl10g086080 #2,m_94,0.051637300383802896,3178 +log2-1,fruit,1017361 Sl10g086080 #2,m_94,0.18432285614468252,3179 +log2-1,fruit,1017361 Sl10g086080 #2,m_94,0.20651514095611256,3180 +log2-1,fruit,1017361 Sl10g086080 #2,m_97,0.7092224741451372,3181 +log2-1,fruit,1017361 Sl10g086080 #2,m_97,0.6267255988114775,3182 +log2-1,fruit,1017361 Sl10g086080 #2,m_97,0.38029311416673317,3183 +log2-1,fruit,1017361 Sl10g086080 #2,m_97,0.4897838888860935,3184 +log2-1,fruit,1017361 Sl10g086080 #2,m_98,0.8928752930735336,3185 +log2-1,fruit,1017361 Sl10g086080 #2,m_98,0.7223561513735451,3186 +log2-1,fruit,1017361 Sl10g086080 #2,m_98,0.5897931132586837,3187 +log2-1,fruit,1017361 Sl10g086080 #2,m_98,0.5109605199205783,3188 +log2-1,fruit,1017361 Sl10g086080 #2,m_99,0.6900245335267546,3189 +log2-1,fruit,1017361 Sl10g086080 #2,m_99,0.5581836981773056,3190 +log2-1,fruit,1017361 Sl10g086080 #2,m_99,0.6965740631879102,3191 +log2-1,fruit,1017361 Sl10g086080 #2,m_99,0.2303597749612081,3192 +log2-1,leaf,1017361 Sl10g086080 #2,m_1,0.2731842630390539,3193 +log2-1,leaf,1017361 Sl10g086080 #2,m_1,0.28497019352782177,3194 +log2-1,leaf,1017361 Sl10g086080 #2,m_1,0.2069773947800937,3195 +log2-1,leaf,1017361 Sl10g086080 #2,m_1,0.2675000035340007,3196 +log2-1,leaf,1017361 Sl10g086080 #2,m_10,0.013642508349820403,3197 +log2-1,leaf,1017361 Sl10g086080 #2,m_10,0.04149669839173314,3198 +log2-1,leaf,1017361 Sl10g086080 #2,m_10,0.04742601126548813,3199 +log2-1,leaf,1017361 Sl10g086080 #2,m_10,0.04362917803486219,3200 +log2-1,leaf,1017361 Sl10g086080 #2,m_100,0.21486704438530801,3201 +log2-1,leaf,1017361 Sl10g086080 #2,m_100,0.22505871400817665,3202 +log2-1,leaf,1017361 Sl10g086080 #2,m_100,0.14756778550113078,3203 +log2-1,leaf,1017361 Sl10g086080 #2,m_100,0.18656581788507595,3204 +log2-1,leaf,1017361 Sl10g086080 #2,m_101,0.6163237809989398,3205 +log2-1,leaf,1017361 Sl10g086080 #2,m_101,0.6252212391149032,3206 +log2-1,leaf,1017361 Sl10g086080 #2,m_101,0.9630762736537006,3207 +log2-1,leaf,1017361 Sl10g086080 #2,m_101,0.7822098529719639,3208 +log2-1,leaf,1017361 Sl10g086080 #2,m_102,0.08291140982071732,3209 +log2-1,leaf,1017361 Sl10g086080 #2,m_102,0.047984213725915076,3210 +log2-1,leaf,1017361 Sl10g086080 #2,m_102,0.08250731989844423,3211 +log2-1,leaf,1017361 Sl10g086080 #2,m_102,0.04812369354392996,3212 +log2-1,leaf,1017361 Sl10g086080 #2,m_103,0.08148710854354801,3213 +log2-1,leaf,1017361 Sl10g086080 #2,m_103,0.08771004532515891,3214 +log2-1,leaf,1017361 Sl10g086080 #2,m_103,0.07797672029848013,3215 +log2-1,leaf,1017361 Sl10g086080 #2,m_103,0.05640938611868214,3216 +log2-1,leaf,1017361 Sl10g086080 #2,m_104,0.08148710854354801,3217 +log2-1,leaf,1017361 Sl10g086080 #2,m_104,0.08771004532515891,3218 +log2-1,leaf,1017361 Sl10g086080 #2,m_104,0.07797672029848013,3219 +log2-1,leaf,1017361 Sl10g086080 #2,m_104,0.05640938611868214,3220 +log2-1,leaf,1017361 Sl10g086080 #2,m_105,0.07269113354894914,3221 +log2-1,leaf,1017361 Sl10g086080 #2,m_105,0.20793167741659224,3222 +log2-1,leaf,1017361 Sl10g086080 #2,m_105,0.17066120879666985,3223 +log2-1,leaf,1017361 Sl10g086080 #2,m_105,0.21813630192442496,3224 +log2-1,leaf,1017361 Sl10g086080 #2,m_106,0.03284763791623128,3225 +log2-1,leaf,1017361 Sl10g086080 #2,m_106,0.0450314421405272,3226 +log2-1,leaf,1017361 Sl10g086080 #2,m_106,0.02053318158495597,3227 +log2-1,leaf,1017361 Sl10g086080 #2,m_106,0.04396385167663306,3228 +log2-1,leaf,1017361 Sl10g086080 #2,m_107,0.5782645232829627,3229 +log2-1,leaf,1017361 Sl10g086080 #2,m_107,0.674879801001874,3230 +log2-1,leaf,1017361 Sl10g086080 #2,m_107,0.4235879131851236,3231 +log2-1,leaf,1017361 Sl10g086080 #2,m_107,0.3959948543857581,3232 +log2-1,leaf,1017361 Sl10g086080 #2,m_108,0.06910227519976064,3233 +log2-1,leaf,1017361 Sl10g086080 #2,m_108,0.06446525503204352,3234 +log2-1,leaf,1017361 Sl10g086080 #2,m_108,0.05684608975519834,3235 +log2-1,leaf,1017361 Sl10g086080 #2,m_108,0.03135123339446702,3236 +log2-1,leaf,1017361 Sl10g086080 #2,m_109,0.3338802531562125,3237 +log2-1,leaf,1017361 Sl10g086080 #2,m_109,0.34226797816017895,3238 +log2-1,leaf,1017361 Sl10g086080 #2,m_109,0.2664342468989864,3239 +log2-1,leaf,1017361 Sl10g086080 #2,m_109,0.1557831173766273,3240 +log2-1,leaf,1017361 Sl10g086080 #2,m_11,0.7873100632977871,3241 +log2-1,leaf,1017361 Sl10g086080 #2,m_11,0.7277225317322563,3242 +log2-1,leaf,1017361 Sl10g086080 #2,m_11,0.6285971829414267,3243 +log2-1,leaf,1017361 Sl10g086080 #2,m_11,0.25334357890507847,3244 +log2-1,leaf,1017361 Sl10g086080 #2,m_110,0.6012685873491029,3245 +log2-1,leaf,1017361 Sl10g086080 #2,m_110,0.528222127634922,3246 +log2-1,leaf,1017361 Sl10g086080 #2,m_110,0.3350395434273459,3247 +log2-1,leaf,1017361 Sl10g086080 #2,m_110,0.38430009983581803,3248 +log2-1,leaf,1017361 Sl10g086080 #2,m_111,0.4707350937181734,3249 +log2-1,leaf,1017361 Sl10g086080 #2,m_111,0.45397365614681884,3250 +log2-1,leaf,1017361 Sl10g086080 #2,m_111,0.37893393404094955,3251 +log2-1,leaf,1017361 Sl10g086080 #2,m_111,0.19392279415643277,3252 +log2-1,leaf,1017361 Sl10g086080 #2,m_112,0.9436734426161071,3253 +log2-1,leaf,1017361 Sl10g086080 #2,m_112,0.8140367373011558,3254 +log2-1,leaf,1017361 Sl10g086080 #2,m_112,0.3591917456361236,3255 +log2-1,leaf,1017361 Sl10g086080 #2,m_112,0.8969068585554462,3256 +log2-1,leaf,1017361 Sl10g086080 #2,m_12,0.902975039989797,3257 +log2-1,leaf,1017361 Sl10g086080 #2,m_12,0.8673553276518322,3258 +log2-1,leaf,1017361 Sl10g086080 #2,m_12,0.622350715713055,3259 +log2-1,leaf,1017361 Sl10g086080 #2,m_12,0.46630976101968485,3260 +log2-1,leaf,1017361 Sl10g086080 #2,m_120,0.2895865458161498,3261 +log2-1,leaf,1017361 Sl10g086080 #2,m_120,0.08202109675889778,3262 +log2-1,leaf,1017361 Sl10g086080 #2,m_120,0.24986558061756634,3263 +log2-1,leaf,1017361 Sl10g086080 #2,m_120,0.2921860866267567,3264 +log2-1,leaf,1017361 Sl10g086080 #2,m_121,1.1573132698629456,3265 +log2-1,leaf,1017361 Sl10g086080 #2,m_121,1.053407764505888,3266 +log2-1,leaf,1017361 Sl10g086080 #2,m_121,1.1355142501996147,3267 +log2-1,leaf,1017361 Sl10g086080 #2,m_121,0.23058645186957638,3268 +log2-1,leaf,1017361 Sl10g086080 #2,m_122,0.1904562857001335,3269 +log2-1,leaf,1017361 Sl10g086080 #2,m_122,0.13415824196513737,3270 +log2-1,leaf,1017361 Sl10g086080 #2,m_122,0.12923971352654154,3271 +log2-1,leaf,1017361 Sl10g086080 #2,m_122,0.17351478830439068,3272 +log2-1,leaf,1017361 Sl10g086080 #2,m_123,0.05305791026862185,3273 +log2-1,leaf,1017361 Sl10g086080 #2,m_123,0.20450371029277584,3274 +log2-1,leaf,1017361 Sl10g086080 #2,m_123,0.22407609609108145,3275 +log2-1,leaf,1017361 Sl10g086080 #2,m_123,0.21214110608700162,3276 +log2-1,leaf,1017361 Sl10g086080 #2,m_13,0.43715316494659234,3277 +log2-1,leaf,1017361 Sl10g086080 #2,m_13,0.48411013867595465,3278 +log2-1,leaf,1017361 Sl10g086080 #2,m_13,0.3081808833583409,3279 +log2-1,leaf,1017361 Sl10g086080 #2,m_13,0.2675142850104327,3280 +log2-1,leaf,1017361 Sl10g086080 #2,m_14,0.25927787134798125,3281 +log2-1,leaf,1017361 Sl10g086080 #2,m_14,0.43911228703832855,3282 +log2-1,leaf,1017361 Sl10g086080 #2,m_14,0.40424896141092587,3283 +log2-1,leaf,1017361 Sl10g086080 #2,m_14,0.2684094346318686,3284 +log2-1,leaf,1017361 Sl10g086080 #2,m_15,0.24084870707412312,3285 +log2-1,leaf,1017361 Sl10g086080 #2,m_15,0.2171600840467896,3286 +log2-1,leaf,1017361 Sl10g086080 #2,m_15,0.08523554634538347,3287 +log2-1,leaf,1017361 Sl10g086080 #2,m_15,0.19185528612372582,3288 +log2-1,leaf,1017361 Sl10g086080 #2,m_16,0.5921286795716214,3289 +log2-1,leaf,1017361 Sl10g086080 #2,m_16,0.07944732427552781,3290 +log2-1,leaf,1017361 Sl10g086080 #2,m_16,0.5901198553507051,3291 +log2-1,leaf,1017361 Sl10g086080 #2,m_16,0.633795136495808,3292 +log2-1,leaf,1017361 Sl10g086080 #2,m_17,0.43812854448309946,3293 +log2-1,leaf,1017361 Sl10g086080 #2,m_17,0.5307549238364575,3294 +log2-1,leaf,1017361 Sl10g086080 #2,m_17,0.335191634116226,3295 +log2-1,leaf,1017361 Sl10g086080 #2,m_17,0.38068640197333814,3296 +log2-1,leaf,1017361 Sl10g086080 #2,m_18,0.6362951298289609,3297 +log2-1,leaf,1017361 Sl10g086080 #2,m_18,0.18410788253344249,3298 +log2-1,leaf,1017361 Sl10g086080 #2,m_18,0.5206884564225378,3299 +log2-1,leaf,1017361 Sl10g086080 #2,m_18,0.620504647658916,3300 +log2-1,leaf,1017361 Sl10g086080 #2,m_19,0.3415613849806153,3301 +log2-1,leaf,1017361 Sl10g086080 #2,m_19,0.10164383361559302,3302 +log2-1,leaf,1017361 Sl10g086080 #2,m_19,0.3499630065413783,3303 +log2-1,leaf,1017361 Sl10g086080 #2,m_19,0.283350673494732,3304 +log2-1,leaf,1017361 Sl10g086080 #2,m_2,0.3503788484822424,3305 +log2-1,leaf,1017361 Sl10g086080 #2,m_2,0.515063576581056,3306 +log2-1,leaf,1017361 Sl10g086080 #2,m_2,0.530287242947785,3307 +log2-1,leaf,1017361 Sl10g086080 #2,m_2,0.276611412894653,3308 +log2-1,leaf,1017361 Sl10g086080 #2,m_20,0.4324806713374223,3309 +log2-1,leaf,1017361 Sl10g086080 #2,m_20,0.31706124905146327,3310 +log2-1,leaf,1017361 Sl10g086080 #2,m_20,0.5115135603735974,3311 +log2-1,leaf,1017361 Sl10g086080 #2,m_20,0.331010247551775,3312 +log2-1,leaf,1017361 Sl10g086080 #2,m_21,0.36463052130587625,3313 +log2-1,leaf,1017361 Sl10g086080 #2,m_21,0.3986095352562531,3314 +log2-1,leaf,1017361 Sl10g086080 #2,m_21,0.44322583291110484,3315 +log2-1,leaf,1017361 Sl10g086080 #2,m_21,0.12812659020769268,3316 +log2-1,leaf,1017361 Sl10g086080 #2,m_22,0.3077854956354116,3317 +log2-1,leaf,1017361 Sl10g086080 #2,m_22,0.6945780899470838,3318 +log2-1,leaf,1017361 Sl10g086080 #2,m_22,0.5861773664461429,3319 +log2-1,leaf,1017361 Sl10g086080 #2,m_22,0.5099625772994586,3320 +log2-1,leaf,1017361 Sl10g086080 #2,m_23,0.39105074031124215,3321 +log2-1,leaf,1017361 Sl10g086080 #2,m_23,0.5826954562121487,3322 +log2-1,leaf,1017361 Sl10g086080 #2,m_23,0.4458243956349882,3323 +log2-1,leaf,1017361 Sl10g086080 #2,m_23,0.4718681990434149,3324 +log2-1,leaf,1017361 Sl10g086080 #2,m_24,0.3632979108562353,3325 +log2-1,leaf,1017361 Sl10g086080 #2,m_24,0.35380458343989396,3326 +log2-1,leaf,1017361 Sl10g086080 #2,m_24,0.31946745214394334,3327 +log2-1,leaf,1017361 Sl10g086080 #2,m_24,0.06771492192845562,3328 +log2-1,leaf,1017361 Sl10g086080 #2,m_25,0.20013117775585912,3329 +log2-1,leaf,1017361 Sl10g086080 #2,m_25,0.2520262401418808,3330 +log2-1,leaf,1017361 Sl10g086080 #2,m_25,0.24975236448960778,3331 +log2-1,leaf,1017361 Sl10g086080 #2,m_25,0.08011491520387935,3332 +log2-1,leaf,1017361 Sl10g086080 #2,m_26,0.09734058836102562,3333 +log2-1,leaf,1017361 Sl10g086080 #2,m_26,0.06591201997852192,3334 +log2-1,leaf,1017361 Sl10g086080 #2,m_26,0.09549261368463259,3335 +log2-1,leaf,1017361 Sl10g086080 #2,m_26,0.060940653154218545,3336 +log2-1,leaf,1017361 Sl10g086080 #2,m_27,0.3067452633586794,3337 +log2-1,leaf,1017361 Sl10g086080 #2,m_27,0.3047930509181335,3338 +log2-1,leaf,1017361 Sl10g086080 #2,m_27,0.22224663189622976,3339 +log2-1,leaf,1017361 Sl10g086080 #2,m_27,0.13474577252468295,3340 +log2-1,leaf,1017361 Sl10g086080 #2,m_28,0.5095176916387384,3341 +log2-1,leaf,1017361 Sl10g086080 #2,m_28,0.5220018242508471,3342 +log2-1,leaf,1017361 Sl10g086080 #2,m_28,0.12078418868646734,3343 +log2-1,leaf,1017361 Sl10g086080 #2,m_28,0.4447991818676019,3344 +log2-1,leaf,1017361 Sl10g086080 #2,m_29,0.46361594129968997,3345 +log2-1,leaf,1017361 Sl10g086080 #2,m_29,0.5264674670687866,3346 +log2-1,leaf,1017361 Sl10g086080 #2,m_29,0.4058025766593546,3347 +log2-1,leaf,1017361 Sl10g086080 #2,m_29,0.1951662898768635,3348 +log2-1,leaf,1017361 Sl10g086080 #2,m_3,0.5921825920084643,3349 +log2-1,leaf,1017361 Sl10g086080 #2,m_3,0.4873602866824119,3350 +log2-1,leaf,1017361 Sl10g086080 #2,m_3,0.44051055244804654,3351 +log2-1,leaf,1017361 Sl10g086080 #2,m_3,0.3569512586981267,3352 +log2-1,leaf,1017361 Sl10g086080 #2,m_30,0.04551715928472984,3353 +log2-1,leaf,1017361 Sl10g086080 #2,m_30,0.11979724546907243,3354 +log2-1,leaf,1017361 Sl10g086080 #2,m_30,0.11344457872547141,3355 +log2-1,leaf,1017361 Sl10g086080 #2,m_30,0.10010086278766617,3356 +log2-1,leaf,1017361 Sl10g086080 #2,m_31,0.12224212718379503,3357 +log2-1,leaf,1017361 Sl10g086080 #2,m_31,0.10133046307486725,3358 +log2-1,leaf,1017361 Sl10g086080 #2,m_31,0.07863245565862839,3359 +log2-1,leaf,1017361 Sl10g086080 #2,m_31,0.12104839609378364,3360 +log2-1,leaf,1017361 Sl10g086080 #2,m_32,0.3235311345541651,3361 +log2-1,leaf,1017361 Sl10g086080 #2,m_32,0.32461573408457683,3362 +log2-1,leaf,1017361 Sl10g086080 #2,m_32,0.27029470942068373,3363 +log2-1,leaf,1017361 Sl10g086080 #2,m_32,0.08671783634858862,3364 +log2-1,leaf,1017361 Sl10g086080 #2,m_33,0.3678912642372795,3365 +log2-1,leaf,1017361 Sl10g086080 #2,m_33,0.22345863818501688,3366 +log2-1,leaf,1017361 Sl10g086080 #2,m_33,0.37482786455012346,3367 +log2-1,leaf,1017361 Sl10g086080 #2,m_33,0.21339871684826084,3368 +log2-1,leaf,1017361 Sl10g086080 #2,m_34,0.4371671453278523,3369 +log2-1,leaf,1017361 Sl10g086080 #2,m_34,0.4382667840239261,3370 +log2-1,leaf,1017361 Sl10g086080 #2,m_34,0.411228562629877,3371 +log2-1,leaf,1017361 Sl10g086080 #2,m_34,0.06575288789738475,3372 +log2-1,leaf,1017361 Sl10g086080 #2,m_35,0.759498158188481,3373 +log2-1,leaf,1017361 Sl10g086080 #2,m_35,0.18378666936204152,3374 +log2-1,leaf,1017361 Sl10g086080 #2,m_35,0.7108847196008374,3375 +log2-1,leaf,1017361 Sl10g086080 #2,m_35,0.6446914139215847,3376 +log2-1,leaf,1017361 Sl10g086080 #2,m_36,0.6406312225075288,3377 +log2-1,leaf,1017361 Sl10g086080 #2,m_36,0.11306876109395687,3378 +log2-1,leaf,1017361 Sl10g086080 #2,m_36,0.600988662167601,3379 +log2-1,leaf,1017361 Sl10g086080 #2,m_36,0.5693784857135931,3380 +log2-1,leaf,1017361 Sl10g086080 #2,m_37,0.3516099855673404,3381 +log2-1,leaf,1017361 Sl10g086080 #2,m_37,0.2597518154230487,3382 +log2-1,leaf,1017361 Sl10g086080 #2,m_37,0.19400180271798226,3383 +log2-1,leaf,1017361 Sl10g086080 #2,m_37,0.370695078177988,3384 +log2-1,leaf,1017361 Sl10g086080 #2,m_38,0.5628078313087251,3385 +log2-1,leaf,1017361 Sl10g086080 #2,m_38,0.5561539038294672,3386 +log2-1,leaf,1017361 Sl10g086080 #2,m_38,0.5507479337251878,3387 +log2-1,leaf,1017361 Sl10g086080 #2,m_38,0.19032885847965317,3388 +log2-1,leaf,1017361 Sl10g086080 #2,m_39,0.23611257298078797,3389 +log2-1,leaf,1017361 Sl10g086080 #2,m_39,0.2330583887303376,3390 +log2-1,leaf,1017361 Sl10g086080 #2,m_39,0.1740262760740208,3391 +log2-1,leaf,1017361 Sl10g086080 #2,m_39,0.11518723717724677,3392 +log2-1,leaf,1017361 Sl10g086080 #2,m_4,0.27577270626919786,3393 +log2-1,leaf,1017361 Sl10g086080 #2,m_4,0.1755503658754934,3394 +log2-1,leaf,1017361 Sl10g086080 #2,m_4,0.20351066128668094,3395 +log2-1,leaf,1017361 Sl10g086080 #2,m_4,0.29563698284968776,3396 +log2-1,leaf,1017361 Sl10g086080 #2,m_40,0.07938369441536572,3397 +log2-1,leaf,1017361 Sl10g086080 #2,m_40,0.09763650265218439,3398 +log2-1,leaf,1017361 Sl10g086080 #2,m_40,0.08473319625380353,3399 +log2-1,leaf,1017361 Sl10g086080 #2,m_40,0.05325761977669857,3400 +log2-1,leaf,1017361 Sl10g086080 #2,m_41,0.3055229349855507,3401 +log2-1,leaf,1017361 Sl10g086080 #2,m_41,0.3096742136669962,3402 +log2-1,leaf,1017361 Sl10g086080 #2,m_41,0.2721344077576261,3403 +log2-1,leaf,1017361 Sl10g086080 #2,m_41,0.07859616738663618,3404 +log2-1,leaf,1017361 Sl10g086080 #2,m_42,0.08554939546404565,3405 +log2-1,leaf,1017361 Sl10g086080 #2,m_42,0.08120922018104232,3406 +log2-1,leaf,1017361 Sl10g086080 #2,m_42,0.06964018124022964,3407 +log2-1,leaf,1017361 Sl10g086080 #2,m_42,0.03366631273255601,3408 +log2-1,leaf,1017361 Sl10g086080 #2,m_43,0.25581513665224076,3409 +log2-1,leaf,1017361 Sl10g086080 #2,m_43,0.07194953326273397,3410 +log2-1,leaf,1017361 Sl10g086080 #2,m_43,0.21576385362490583,3411 +log2-1,leaf,1017361 Sl10g086080 #2,m_43,0.255287369448041,3412 +log2-1,leaf,1017361 Sl10g086080 #2,m_44,0.28890369325541404,3413 +log2-1,leaf,1017361 Sl10g086080 #2,m_44,0.3943856041284241,3414 +log2-1,leaf,1017361 Sl10g086080 #2,m_44,0.31501304924661483,3415 +log2-1,leaf,1017361 Sl10g086080 #2,m_44,0.2958979876489266,3416 +log2-1,leaf,1017361 Sl10g086080 #2,m_45,0.4742041216815502,3417 +log2-1,leaf,1017361 Sl10g086080 #2,m_45,0.6829815997376388,3418 +log2-1,leaf,1017361 Sl10g086080 #2,m_45,0.49741147618478415,3419 +log2-1,leaf,1017361 Sl10g086080 #2,m_45,0.46190303491820345,3420 +log2-1,leaf,1017361 Sl10g086080 #2,m_46,0.9372504255810301,3421 +log2-1,leaf,1017361 Sl10g086080 #2,m_46,1.0936565015081432,3422 +log2-1,leaf,1017361 Sl10g086080 #2,m_46,0.8213598761885346,3423 +log2-1,leaf,1017361 Sl10g086080 #2,m_46,0.4973075464306204,3424 +log2-1,leaf,1017361 Sl10g086080 #2,m_47,0.5994860272972964,3425 +log2-1,leaf,1017361 Sl10g086080 #2,m_47,0.6708632515462359,3426 +log2-1,leaf,1017361 Sl10g086080 #2,m_47,0.5245135158742222,3427 +log2-1,leaf,1017361 Sl10g086080 #2,m_47,0.23162249435598492,3428 +log2-1,leaf,1017361 Sl10g086080 #2,m_48,0.10771657609856088,3429 +log2-1,leaf,1017361 Sl10g086080 #2,m_48,0.2897775149652908,3430 +log2-1,leaf,1017361 Sl10g086080 #2,m_48,0.2885138958859403,3431 +log2-1,leaf,1017361 Sl10g086080 #2,m_48,0.23871306707200957,3432 +log2-1,leaf,1017361 Sl10g086080 #2,m_49,0.023354257141663507,3433 +log2-1,leaf,1017361 Sl10g086080 #2,m_49,0.019470465970014846,3434 +log2-1,leaf,1017361 Sl10g086080 #2,m_49,0.0261451273204733,3435 +log2-1,leaf,1017361 Sl10g086080 #2,m_49,0.023140461046448894,3436 +log2-1,leaf,1017361 Sl10g086080 #2,m_5,0.5536956127152526,3437 +log2-1,leaf,1017361 Sl10g086080 #2,m_5,0.5887306667665152,3438 +log2-1,leaf,1017361 Sl10g086080 #2,m_5,0.35279872615133395,3439 +log2-1,leaf,1017361 Sl10g086080 #2,m_5,0.34026880959451844,3440 +log2-1,leaf,1017361 Sl10g086080 #2,m_50,0.25317133518159896,3441 +log2-1,leaf,1017361 Sl10g086080 #2,m_50,0.3910034658837741,3442 +log2-1,leaf,1017361 Sl10g086080 #2,m_50,0.3386956256955516,3443 +log2-1,leaf,1017361 Sl10g086080 #2,m_50,0.2780390215619627,3444 +log2-1,leaf,1017361 Sl10g086080 #2,m_51,0.03374724951771267,3445 +log2-1,leaf,1017361 Sl10g086080 #2,m_51,0.036741046164595094,3446 +log2-1,leaf,1017361 Sl10g086080 #2,m_51,0.03648383867097015,3447 +log2-1,leaf,1017361 Sl10g086080 #2,m_51,0.005289010292165732,3448 +log2-1,leaf,1017361 Sl10g086080 #2,m_52,0.06922399661891465,3449 +log2-1,leaf,1017361 Sl10g086080 #2,m_52,0.14392867788822464,3450 +log2-1,leaf,1017361 Sl10g086080 #2,m_52,0.15066099052958512,3451 +log2-1,leaf,1017361 Sl10g086080 #2,m_52,0.10580050943501942,3452 +log2-1,leaf,1017361 Sl10g086080 #2,m_53,0.2411357538148116,3453 +log2-1,leaf,1017361 Sl10g086080 #2,m_53,0.13697830622919382,3454 +log2-1,leaf,1017361 Sl10g086080 #2,m_53,0.23978594385986265,3455 +log2-1,leaf,1017361 Sl10g086080 #2,m_53,0.14260922146336666,3456 +log2-1,leaf,1017361 Sl10g086080 #2,m_54,0.33151214764792425,3457 +log2-1,leaf,1017361 Sl10g086080 #2,m_54,0.39140741274020235,3458 +log2-1,leaf,1017361 Sl10g086080 #2,m_54,0.38031781488397065,3459 +log2-1,leaf,1017361 Sl10g086080 #2,m_54,0.09192477570874816,3460 +log2-1,leaf,1017361 Sl10g086080 #2,m_55,0.17644869865402174,3461 +log2-1,leaf,1017361 Sl10g086080 #2,m_55,0.17438373036060614,3462 +log2-1,leaf,1017361 Sl10g086080 #2,m_55,0.10723854854312968,3463 +log2-1,leaf,1017361 Sl10g086080 #2,m_55,0.09830728632442963,3464 +log2-1,leaf,1017361 Sl10g086080 #2,m_56,0.33161714138332093,3465 +log2-1,leaf,1017361 Sl10g086080 #2,m_56,0.3389935069190017,3466 +log2-1,leaf,1017361 Sl10g086080 #2,m_56,0.3234245352990526,3467 +log2-1,leaf,1017361 Sl10g086080 #2,m_56,0.03922157214436406,3468 +log2-1,leaf,1017361 Sl10g086080 #2,m_57,0.2761426463760561,3469 +log2-1,leaf,1017361 Sl10g086080 #2,m_57,0.22363038215170386,3470 +log2-1,leaf,1017361 Sl10g086080 #2,m_57,0.09183488938391265,3471 +log2-1,leaf,1017361 Sl10g086080 #2,m_57,0.2756347050639941,3472 +log2-1,leaf,1017361 Sl10g086080 #2,m_58,0.437470529278952,3473 +log2-1,leaf,1017361 Sl10g086080 #2,m_58,0.559540885887702,3474 +log2-1,leaf,1017361 Sl10g086080 #2,m_58,0.3729542462343495,3475 +log2-1,leaf,1017361 Sl10g086080 #2,m_58,0.41387346328303065,3476 +log2-1,leaf,1017361 Sl10g086080 #2,m_59,0.18881191714688667,3477 +log2-1,leaf,1017361 Sl10g086080 #2,m_59,0.23238994685575634,3478 +log2-1,leaf,1017361 Sl10g086080 #2,m_59,0.265247909936537,3479 +log2-1,leaf,1017361 Sl10g086080 #2,m_59,0.18977207752656156,3480 +log2-1,leaf,1017361 Sl10g086080 #2,m_6,0.5540603091157226,3481 +log2-1,leaf,1017361 Sl10g086080 #2,m_6,0.5368542371478169,3482 +log2-1,leaf,1017361 Sl10g086080 #2,m_6,0.24408319300960854,3483 +log2-1,leaf,1017361 Sl10g086080 #2,m_6,0.4142339911177778,3484 +log2-1,leaf,1017361 Sl10g086080 #2,m_60,0.4037536175710471,3485 +log2-1,leaf,1017361 Sl10g086080 #2,m_60,0.49934891332855813,3486 +log2-1,leaf,1017361 Sl10g086080 #2,m_60,0.33963306497294404,3487 +log2-1,leaf,1017361 Sl10g086080 #2,m_60,0.3254489355625932,3488 +log2-1,leaf,1017361 Sl10g086080 #2,m_61,0.11573878636538466,3489 +log2-1,leaf,1017361 Sl10g086080 #2,m_61,0.11590987344908364,3490 +log2-1,leaf,1017361 Sl10g086080 #2,m_61,0.12544518592200038,3491 +log2-1,leaf,1017361 Sl10g086080 #2,m_61,0.026919756925981662,3492 +log2-1,leaf,1017361 Sl10g086080 #2,m_62,0.20651347710853335,3493 +log2-1,leaf,1017361 Sl10g086080 #2,m_62,0.2045622027361516,3494 +log2-1,leaf,1017361 Sl10g086080 #2,m_62,0.20602475891736058,3495 +log2-1,leaf,1017361 Sl10g086080 #2,m_62,0.004057585652384389,3496 +log2-1,leaf,1017361 Sl10g086080 #2,m_63,0.9250261881940177,3497 +log2-1,leaf,1017361 Sl10g086080 #2,m_63,1.0802387841342675,3498 +log2-1,leaf,1017361 Sl10g086080 #2,m_63,0.8613769087741201,3499 +log2-1,leaf,1017361 Sl10g086080 #2,m_63,0.4177716859393261,3500 +log2-1,leaf,1017361 Sl10g086080 #2,m_64,0.1563063115778417,3501 +log2-1,leaf,1017361 Sl10g086080 #2,m_64,0.11437164164877636,3502 +log2-1,leaf,1017361 Sl10g086080 #2,m_64,0.08100642182125332,3503 +log2-1,leaf,1017361 Sl10g086080 #2,m_64,0.14241290498547426,3504 +log2-1,leaf,1017361 Sl10g086080 #2,m_65,0.15144135717848456,3505 +log2-1,leaf,1017361 Sl10g086080 #2,m_65,0.15269807564283275,3506 +log2-1,leaf,1017361 Sl10g086080 #2,m_65,0.16884597656706668,3507 +log2-1,leaf,1017361 Sl10g086080 #2,m_65,0.14400781147916508,3508 +log2-1,leaf,1017361 Sl10g086080 #2,m_66,0.0947275916358495,3509 +log2-1,leaf,1017361 Sl10g086080 #2,m_66,0.1020072300073953,3510 +log2-1,leaf,1017361 Sl10g086080 #2,m_66,0.1356286792579752,3511 +log2-1,leaf,1017361 Sl10g086080 #2,m_66,0.12355032865251195,3512 +log2-1,leaf,1017361 Sl10g086080 #2,m_67,0.9212021502126155,3513 +log2-1,leaf,1017361 Sl10g086080 #2,m_67,0.2571524357254779,3514 +log2-1,leaf,1017361 Sl10g086080 #2,m_67,0.8618597296661433,3515 +log2-1,leaf,1017361 Sl10g086080 #2,m_67,0.7702958194015684,3516 +log2-1,leaf,1017361 Sl10g086080 #2,m_68,0.164119155548308,3517 +log2-1,leaf,1017361 Sl10g086080 #2,m_68,0.2905675154658236,3518 +log2-1,leaf,1017361 Sl10g086080 #2,m_68,0.2881935364138897,3519 +log2-1,leaf,1017361 Sl10g086080 #2,m_68,0.17344916187258724,3520 +log2-1,leaf,1017361 Sl10g086080 #2,m_69,0.1974925196794524,3521 +log2-1,leaf,1017361 Sl10g086080 #2,m_69,0.2463599812461037,3522 +log2-1,leaf,1017361 Sl10g086080 #2,m_69,0.19836659570208282,3523 +log2-1,leaf,1017361 Sl10g086080 #2,m_69,0.15211942985395097,3524 +log2-1,leaf,1017361 Sl10g086080 #2,m_7,0.3405042829001611,3525 +log2-1,leaf,1017361 Sl10g086080 #2,m_7,0.4567448657663674,3526 +log2-1,leaf,1017361 Sl10g086080 #2,m_7,0.36068505045154303,3527 +log2-1,leaf,1017361 Sl10g086080 #2,m_7,0.25693667817579535,3528 +log2-1,leaf,1017361 Sl10g086080 #2,m_70,0.41466514843773905,3529 +log2-1,leaf,1017361 Sl10g086080 #2,m_70,0.5035357278498721,3530 +log2-1,leaf,1017361 Sl10g086080 #2,m_70,0.4508052371084457,3531 +log2-1,leaf,1017361 Sl10g086080 #2,m_70,0.14487330657309197,3532 +log2-1,leaf,1017361 Sl10g086080 #2,m_71,0.30789261814312424,3533 +log2-1,leaf,1017361 Sl10g086080 #2,m_71,0.2606621958823424,3534 +log2-1,leaf,1017361 Sl10g086080 #2,m_71,0.07247988839810668,3535 +log2-1,leaf,1017361 Sl10g086080 #2,m_71,0.2934886758681096,3536 +log2-1,leaf,1017361 Sl10g086080 #2,m_72,0.42691260222176536,3537 +log2-1,leaf,1017361 Sl10g086080 #2,m_72,0.4469793437034981,3538 +log2-1,leaf,1017361 Sl10g086080 #2,m_72,0.24649682990660962,3539 +log2-1,leaf,1017361 Sl10g086080 #2,m_72,0.2740239230476944,3540 +log2-1,leaf,1017361 Sl10g086080 #2,m_73,0.05042908390136495,3541 +log2-1,leaf,1017361 Sl10g086080 #2,m_73,0.04726210661997799,3542 +log2-1,leaf,1017361 Sl10g086080 #2,m_73,0.03456340271505233,3543 +log2-1,leaf,1017361 Sl10g086080 #2,m_73,0.043817047121130444,3544 +log2-1,leaf,1017361 Sl10g086080 #2,m_74,0.049381867094971735,3545 +log2-1,leaf,1017361 Sl10g086080 #2,m_74,0.03759278370489146,3546 +log2-1,leaf,1017361 Sl10g086080 #2,m_74,0.07147431011179485,3547 +log2-1,leaf,1017361 Sl10g086080 #2,m_74,0.07198053781723662,3548 +log2-1,leaf,1017361 Sl10g086080 #2,m_75,0.09692526640963511,3549 +log2-1,leaf,1017361 Sl10g086080 #2,m_75,0.09801112517431658,3550 +log2-1,leaf,1017361 Sl10g086080 #2,m_75,0.03689571382844283,3551 +log2-1,leaf,1017361 Sl10g086080 #2,m_75,0.07491321886209677,3552 +log2-1,leaf,1017361 Sl10g086080 #2,m_76,0.15029142994828534,3553 +log2-1,leaf,1017361 Sl10g086080 #2,m_76,0.14753533353616805,3554 +log2-1,leaf,1017361 Sl10g086080 #2,m_76,0.043278037853626654,3555 +log2-1,leaf,1017361 Sl10g086080 #2,m_76,0.12556900571540447,3556 +log2-1,leaf,1017361 Sl10g086080 #2,m_77,0.04403867270827416,3557 +log2-1,leaf,1017361 Sl10g086080 #2,m_77,0.08042847549973041,3558 +log2-1,leaf,1017361 Sl10g086080 #2,m_77,0.05076829822045368,3559 +log2-1,leaf,1017361 Sl10g086080 #2,m_77,0.08147126021381611,3560 +log2-1,leaf,1017361 Sl10g086080 #2,m_78,0.018030572247100505,3561 +log2-1,leaf,1017361 Sl10g086080 #2,m_78,0.01327934611786723,3562 +log2-1,leaf,1017361 Sl10g086080 #2,m_78,0.017714692538070165,3563 +log2-1,leaf,1017361 Sl10g086080 #2,m_78,0.011812333340720437,3564 +log2-1,leaf,1017361 Sl10g086080 #2,m_79,0.038697402325627676,3565 +log2-1,leaf,1017361 Sl10g086080 #2,m_79,0.04252824395246832,3566 +log2-1,leaf,1017361 Sl10g086080 #2,m_79,0.04201449415952085,3567 +log2-1,leaf,1017361 Sl10g086080 #2,m_79,0.040198131127421835,3568 +log2-1,leaf,1017361 Sl10g086080 #2,m_8,0.13224241833817474,3569 +log2-1,leaf,1017361 Sl10g086080 #2,m_8,0.10495898486739362,3570 +log2-1,leaf,1017361 Sl10g086080 #2,m_8,0.044960240419691634,3571 +log2-1,leaf,1017361 Sl10g086080 #2,m_8,0.13257175055866707,3572 +log2-1,leaf,1017361 Sl10g086080 #2,m_80,0.07424868428091434,3573 +log2-1,leaf,1017361 Sl10g086080 #2,m_80,0.06280672575057336,3574 +log2-1,leaf,1017361 Sl10g086080 #2,m_80,0.0681952913310195,3575 +log2-1,leaf,1017361 Sl10g086080 #2,m_80,0.0327761916016795,3576 +log2-1,leaf,1017361 Sl10g086080 #2,m_81,0.05531761875529748,3577 +log2-1,leaf,1017361 Sl10g086080 #2,m_81,0.028579316654359786,3578 +log2-1,leaf,1017361 Sl10g086080 #2,m_81,0.0547949006445135,3579 +log2-1,leaf,1017361 Sl10g086080 #2,m_81,0.037730412701386655,3580 +log2-1,leaf,1017361 Sl10g086080 #2,m_82,0.5828050419613914,3581 +log2-1,leaf,1017361 Sl10g086080 #2,m_82,0.4891851907314972,3582 +log2-1,leaf,1017361 Sl10g086080 #2,m_82,0.5548910173465867,3583 +log2-1,leaf,1017361 Sl10g086080 #2,m_82,0.35865957971772877,3584 +log2-1,leaf,1017361 Sl10g086080 #2,m_83,0.17876108662722776,3585 +log2-1,leaf,1017361 Sl10g086080 #2,m_83,0.15092816547912005,3586 +log2-1,leaf,1017361 Sl10g086080 #2,m_83,0.201292869796738,3587 +log2-1,leaf,1017361 Sl10g086080 #2,m_83,0.15125156752491842,3588 +log2-1,leaf,1017361 Sl10g086080 #2,m_84,1.4534037025537712,3589 +log2-1,leaf,1017361 Sl10g086080 #2,m_84,1.7025474619451282,3590 +log2-1,leaf,1017361 Sl10g086080 #2,m_84,1.446634246579884,3591 +log2-1,leaf,1017361 Sl10g086080 #2,m_84,1.5053238484727558,3592 +log2-1,leaf,1017361 Sl10g086080 #2,m_85,0.6746945542090375,3593 +log2-1,leaf,1017361 Sl10g086080 #2,m_85,0.8258642366136923,3594 +log2-1,leaf,1017361 Sl10g086080 #2,m_85,0.6702865135898307,3595 +log2-1,leaf,1017361 Sl10g086080 #2,m_85,0.3057835317331851,3596 +log2-1,leaf,1017361 Sl10g086080 #2,m_86,0.38583864426308867,3597 +log2-1,leaf,1017361 Sl10g086080 #2,m_86,0.33249869961035444,3598 +log2-1,leaf,1017361 Sl10g086080 #2,m_86,0.139613925886036,3599 +log2-1,leaf,1017361 Sl10g086080 #2,m_86,0.38826716222081964,3600 +log2-1,leaf,1017361 Sl10g086080 #2,m_87,0.4635292468498841,3601 +log2-1,leaf,1017361 Sl10g086080 #2,m_87,0.5497088818876211,3602 +log2-1,leaf,1017361 Sl10g086080 #2,m_87,0.3742650968433752,3603 +log2-1,leaf,1017361 Sl10g086080 #2,m_87,0.29841732983817343,3604 +log2-1,leaf,1017361 Sl10g086080 #2,m_88,0.3576929105636973,3605 +log2-1,leaf,1017361 Sl10g086080 #2,m_88,0.45554092834239746,3606 +log2-1,leaf,1017361 Sl10g086080 #2,m_88,0.32807968391550085,3607 +log2-1,leaf,1017361 Sl10g086080 #2,m_88,0.3034800395276317,3608 +log2-1,leaf,1017361 Sl10g086080 #2,m_89,0.34184974358506726,3609 +log2-1,leaf,1017361 Sl10g086080 #2,m_89,0.38333041050179617,3610 +log2-1,leaf,1017361 Sl10g086080 #2,m_89,0.26229017457191406,3611 +log2-1,leaf,1017361 Sl10g086080 #2,m_89,0.3566740280953709,3612 +log2-1,leaf,1017361 Sl10g086080 #2,m_9,0.02078711983450248,3613 +log2-1,leaf,1017361 Sl10g086080 #2,m_9,0.005246359939971535,3614 +log2-1,leaf,1017361 Sl10g086080 #2,m_9,0.017976028212042937,3615 +log2-1,leaf,1017361 Sl10g086080 #2,m_9,0.021208598152677095,3616 +log2-1,leaf,1017361 Sl10g086080 #2,m_90,0.30540495318569627,3617 +log2-1,leaf,1017361 Sl10g086080 #2,m_90,0.32773451446616114,3618 +log2-1,leaf,1017361 Sl10g086080 #2,m_90,0.19820378472968903,3619 +log2-1,leaf,1017361 Sl10g086080 #2,m_90,0.19935396940850972,3620 +log2-1,leaf,1017361 Sl10g086080 #2,m_91,0.3010577097494302,3621 +log2-1,leaf,1017361 Sl10g086080 #2,m_91,0.3013535623301197,3622 +log2-1,leaf,1017361 Sl10g086080 #2,m_91,0.24243696547128446,3623 +log2-1,leaf,1017361 Sl10g086080 #2,m_91,0.11328539333635834,3624 +log2-1,leaf,1017361 Sl10g086080 #2,m_92,0.7178208812080172,3625 +log2-1,leaf,1017361 Sl10g086080 #2,m_92,0.675877755816355,3626 +log2-1,leaf,1017361 Sl10g086080 #2,m_92,0.557440129722985,3627 +log2-1,leaf,1017361 Sl10g086080 #2,m_92,0.311720685102446,3628 +log2-1,leaf,1017361 Sl10g086080 #2,m_93,0.6129522482472688,3629 +log2-1,leaf,1017361 Sl10g086080 #2,m_93,0.6309784203991502,3630 +log2-1,leaf,1017361 Sl10g086080 #2,m_93,0.03432709443835719,3631 +log2-1,leaf,1017361 Sl10g086080 #2,m_93,0.6329472298869362,3632 +log2-1,leaf,1017361 Sl10g086080 #2,m_94,0.49243006873242184,3633 +log2-1,leaf,1017361 Sl10g086080 #2,m_94,0.5387349046428764,3634 +log2-1,leaf,1017361 Sl10g086080 #2,m_94,0.4511767086860029,3635 +log2-1,leaf,1017361 Sl10g086080 #2,m_94,0.13821437408385315,3636 +log2-1,leaf,1017361 Sl10g086080 #2,m_97,0.5052502120962022,3637 +log2-1,leaf,1017361 Sl10g086080 #2,m_97,0.45473898220274733,3638 +log2-1,leaf,1017361 Sl10g086080 #2,m_97,0.3830863407761215,3639 +log2-1,leaf,1017361 Sl10g086080 #2,m_97,0.1902174967094692,3640 +log2-1,leaf,1017361 Sl10g086080 #2,m_98,0.6558626169652044,3641 +log2-1,leaf,1017361 Sl10g086080 #2,m_98,0.7423968732053102,3642 +log2-1,leaf,1017361 Sl10g086080 #2,m_98,0.4128363534650454,3643 +log2-1,leaf,1017361 Sl10g086080 #2,m_98,0.49183576014220914,3644 +log2-1,leaf,1017361 Sl10g086080 #2,m_99,0.22691567707321095,3645 +log2-1,leaf,1017361 Sl10g086080 #2,m_99,0.23289277999445102,3646 +log2-1,leaf,1017361 Sl10g086080 #2,m_99,0.17604221202340656,3647 +log2-1,leaf,1017361 Sl10g086080 #2,m_99,0.2309097683441205,3648 diff --git a/runs/GC-MS analysis/individual_values_levene.csv b/runs/GC-MS analysis/individual_values_levene.csv new file mode 100644 index 0000000000000000000000000000000000000000..9b3f7325d51d6f9df7282a1cf95162fb67027f0f --- /dev/null +++ b/runs/GC-MS analysis/individual_values_levene.csv @@ -0,0 +1,21422 @@ +alias,genotype,treatment,met,tissue,LIMS_ID,mean_tec_rep,lev_t +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441047,0.8984193869514334,0.7788768230937008 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441049,2.6686525136476997,0.30606391026527635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441040,5.363868601746801,0.002877807636015084 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441031,6.149580976552973,0.056489586523947644 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441052,7.930976693654221,0.16697073557182662 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,fruit,2441051,5.435190890899264,0.0028588636020626668 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441047,561.2372097637419,0.1254172153678188 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441049,411.7769166143721,0.009067244174145728 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441040,50.85642316685404,0.9173834293422971 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441031,429.15190418603805,0.008881802405866779 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441052,1109.5123279793495,0.42140289065088776 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_1,leaf,2441051,3.5896570579341542,2.0686762817322477 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441047,58.757065675687485,0.06965875288047019 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441049,56.27446322945427,0.050910015061716996 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441040,54.02679914715144,0.03320789210327635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441031,46.07257031218677,0.03595890464261897 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441052,41.42493027186762,0.08213956006928602 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,fruit,2441051,45.15309999185951,0.04471377392274345 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441047,361.9277555470954,0.028290487449575075 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441049,332.36815197503,0.00871199980477444 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441040,319.746739784776,0.025525277147113723 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441031,334.87425345515504,0.005449643716513464 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441052,343.3313876938607,0.005382106721696367 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_10,leaf,2441051,343.8059976999855,0.005982046541230801 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441047,26.762213195107364,0.005361473650047799 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441049,7.784388268256805,0.5416590102775907 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441040,27.427081118746223,0.005296091262824598 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441031,44.07330676320195,0.21129213654886092 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441052,13.186314252711728,0.3127600782159061 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,fruit,2441051,54.064320929818834,0.3000272527059602 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441047,2642.8562916682044,0.02815442054085482 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441049,2091.5388020388095,0.07345320199064842 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441040,2522.6652583504856,0.007940498248644623 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441031,2431.256277900707,0.008088387883510073 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441052,2547.294971059456,0.012160110231091092 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_100,leaf,2441051,2067.40651199408,0.07849324807739366 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441047,31.21609615411012,0.008939235147111813 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441049,31.562164753711674,0.0041510424374262556 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441040,32.16840786196339,0.004111741586870998 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441031,17.69766115242467,0.255401949301707 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441052,41.45980651805519,0.11430944607981042 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,fruit,2441051,47.895004496374256,0.17697239342126614 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441047,56.42672460361151,0.00525688977080252 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441049,57.801052913720255,0.005194018349534701 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441040,65.97,0.06260475275593413 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441031,85.05020416755912,0.1729336291724275 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441052,54.74115383858218,0.01842778405881651 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_101,leaf,2441051,35.10375693542298,0.21138813255074274 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441047,106.31508747468868,0.023402156541907804 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441049,95.16064343728394,0.024735374416444467 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441040,115.00459880433002,0.05752246295726726 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441031,77.98953499626307,0.11115641339542726 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441052,704.9853387423063,0.8449873409486206 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,fruit,2441051,92.26903298258536,0.03813677526269865 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441047,531.439639540324,0.042738579263890575 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441049,635.0190377072514,0.03459422139542356 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441040,623.2723897840858,0.026485364467351946 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441031,533.8498069404758,0.04077343412561296 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441052,549.5237282817147,0.02820607424917254 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_102,leaf,2441051,669.4948272142848,0.05755470169905941 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441047,1275.4659231194821,0.16530073902842402 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441049,1929.8762761799428,0.01455986840841339 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441040,1060.0278427705427,0.245652326369993 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441031,8564.72656347271,0.6617439032886367 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441052,8211.317456699559,0.6434432436621735 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,fruit,2441051,1802.6218181227364,0.015064975728787289 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441047,823404.2366900011,0.0032911725460067487 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441049,835931.4957534902,0.003266418837379881 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441040,816670.2327323036,0.006857543767700314 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441031,731001.3333471356,0.054986100691349016 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441052,884687.0868413978,0.027885418421458752 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_103,leaf,2441051,920741.268237305,0.04523333915236982 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441047,1250.3816479998952,0.16530073902842402 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441049,1891.9218733370485,0.01455986840841339 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441040,1039.1805354764008,0.245652326369993 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441031,8396.286189215798,0.6617439032886367 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441052,8049.827492566019,0.6434432436621735 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,fruit,2441051,1767.1700974591463,0.015064975728787289 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441047,823404.2366900011,0.0032911725460067487 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441049,835931.4957534902,0.003266418837379881 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441040,816670.2327323036,0.006857543767700314 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441031,731001.3333471356,0.054986100691349016 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441052,884687.0868413978,0.027885418421458752 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_104,leaf,2441051,920741.268237305,0.04523333915236982 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441047,45.10124457734376,0.018099478811753222 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441049,50.33768859644375,0.02960526446396261 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441040,44.91822529544189,0.01986541619932658 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441031,37.82111432943024,0.09455368490910776 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441052,49.32470303245661,0.020776473897099912 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,fruit,2441051,48.939920497905625,0.017375254218966907 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441047,136.37904391584206,0.12245449110979001 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441049,79.47488847189146,0.11206322325528717 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441040,78.17092280229939,0.11924791158813663 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441031,114.2552328787714,0.04558294945162933 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441052,91.4868565620276,0.0509344446595299 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_105,leaf,2441051,190.39749198789156,0.2673680729478307 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441047,161.97980522227311,0.011888899321938151 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441049,162.69980905425822,0.009962728475310545 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441040,164.79050563094376,0.004417585421152559 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441031,168.16006794056244,0.004373102428093301 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441052,212.8839396218426,0.10679312693322052 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,fruit,2441051,169.17252523929267,0.006980060351581052 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441047,3374.7465632987523,0.010672658875950702 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441049,3607.7666466437904,0.03966993437820099 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441040,3210.9012302928977,0.010941558319673472 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441031,3030.608828322463,0.03603862085031784 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441052,3039.226412732291,0.03480545002360591 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_106,leaf,2441051,3463.007443099325,0.02188492011603893 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441047,247.9423270068847,0.06920945685827462 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441049,267.29159649876107,0.03657482472801066 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441040,490.4506967924385,0.2270352261619295 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441031,314.2625081885932,0.03373244265090536 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441052,634.2769300648495,0.338718785797008 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,fruit,2441051,210.1124924424006,0.14110825514477243 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441047,6502.732352155632,0.047618254613061684 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441049,6150.5075676103,0.07180317654371038 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441040,7468.948829298733,0.012545350306737646 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441031,7903.307443018072,0.03709474282623937 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441052,7515.970423920868,0.015270928704119946 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_107,leaf,2441051,7043.614549927703,0.012918551832981962 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441047,76.43800885184137,0.14951037275345325 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441049,107.3111120990466,0.002175042641386682 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441040,56.9511364450186,0.27731734353034354 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441031,113.43801338303882,0.021938873929634006 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441052,108.3886836842738,0.0021642038083959925 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,fruit,2441051,136.78121064248862,0.1032067050644363 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441047,300.60114177408656,0.20241855596320635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441049,201.971618820689,0.02971827652674719 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441040,164.47263657765075,0.0594784154397594 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441031,363.87874404935553,0.2853846171736172 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441052,161.07998822964245,0.06853048067181611 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_108,leaf,2441051,175.25476947647675,0.03190222395219555 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441047,117.3925647421935,0.11602758728482376 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441049,80.27929146933519,0.049009472890999106 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441040,99.45998924318155,0.044035404208338846 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441031,125.68088979799896,0.1456562430513313 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441052,20.63804229213843,0.638944505629347 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,fruit,2441051,73.56363422098758,0.08694982742688007 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441047,1754.438718227202,0.004509413017757868 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441049,2330.5686869259916,0.11881429094091756 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441040,1392.6123162116191,0.10481738437805 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441031,1127.4416057974995,0.1965535586390783 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441052,1791.0622783486187,0.004463071166736388 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_109,leaf,2441051,2087.316667620792,0.07094072492916403 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441047,913.3478825404268,0.002853642262645284 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441049,844.6572409819917,0.03680935904441096 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441040,1507.0381726920325,0.21463438443699312 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441031,954.6939875426206,0.016374318952647293 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441052,925.3901714244884,0.0028350140159929538 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,fruit,2441051,643.6685417361452,0.15482758432371835 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441047,1180.8506348386325,0.011234448521086016 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441049,590.3562119369975,0.2898463814910426 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441040,1474.6327091781266,0.10772334397181638 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441031,2092.145508858342,0.25963136756449146 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441052,979.3696658382662,0.07001387046789365 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_11,leaf,2441051,1120.5409172265672,0.011532799205846267 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441047,411.7970803645733,0.05241216368365276 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441049,208.28619272557833,0.24361061791081262 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441040,380.54458273945096,0.018134444434023234 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441031,349.41883368783004,0.018924789701446176 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441052,455.67640691882224,0.09638544368536506 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,fruit,2441051,331.7559216007086,0.041452416022875305 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441047,5918.11767794259,0.0021358247091507465 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441049,5976.470684512265,0.0021253722812981657 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441040,3394.989775360917,0.24348095062412112 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441031,4980.096224146757,0.0770816871167268 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441052,9314.624233425207,0.19484591817944885 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_110,leaf,2441051,9117.041228528313,0.18553449745956518 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441047,336.8960859267592,0.020981799497604925 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441049,281.3959062215058,0.057196390879874937 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441040,305.11741583442836,0.022047168362880676 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441031,463.90910821584896,0.1599187335151271 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441052,892.3579164168522,0.4440249149140234 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,fruit,2441051,262.81812706468776,0.08685884982593217 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441047,42451.68356895704,0.01647507576235796 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441049,68367.9810080481,0.22343291221516637 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441040,41659.4115034865,0.008293288032644064 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441031,39302.82264072202,0.016996101062467517 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441052,39900.01198082331,0.010446816522360791 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_111,leaf,2441051,40083.45031178557,0.00845474485397002 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441047,1840.7953073678823,0.06634715533731139 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441049,938.6353295306152,0.22616144650003145 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441040,2232.8174709022137,0.15019487847111312 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441031,844.3313800672795,0.27214541282267346 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441052,3117.879060578298,0.2952009221262726 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,fruit,2441051,1319.2138333228368,0.0783431465154818 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441047,236253.9708764467,0.021931831584519834 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441049,8453.37579169468,1.4682807724958322 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441040,462227.9899657921,0.26954529210548284 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441031,326442.7595077817,0.11849609210537793 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441052,172973.59356719433,0.15733114022088124 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_112,leaf,2441051,260728.3546800699,0.020877315745774894 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441047,140.94518371337298,0.02712352126630302 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441049,123.8784342051382,0.028931011430634257 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441040,276.86826249427503,0.32034645650250004 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441031,185.6085516492829,0.14667126307472644 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441052,117.78078674757164,0.05085226779097907 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,fruit,2441051,103.27385424855682,0.107936333287177 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441047,145.76252249765022,0.2386390632091413 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441049,9.22183691255827,0.9601893746924023 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441040,129.51504408243,0.18731340552223208 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441031,38.76662382921906,0.3365488320708623 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441052,20.475311055824804,0.6137763040046826 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_12,leaf,2441051,201.3699207477553,0.37898778696193713 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441047,103.01053344001588,0.1526171491024324 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441049,72.87945403128256,0.0023406234374538926 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441040,72.09600173424725,0.00235330657796462 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441031,16.90570428257465,0.6322312191146391 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441052,52.05454811636149,0.14380580633346263 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,fruit,2441051,98.37023605022875,0.13259922645925504 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441047,81.45403063212026,0.4247488634117407 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441049,78.12879487260612,0.4428503175871288 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441040,217.21764876835277,0.0012336654384146328 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441031,262.7670232889716,0.08390941825216558 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441052,215.98533442309477,0.001237179798027288 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_120,leaf,2441051,245.64572073382848,0.05464775991124515 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441047,48.558624319656495,0.006302867219607711 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441049,89.0171331346139,0.26951009605381726 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441040,54.27547939422667,0.054640160768489654 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441031,46.50972441057856,0.012419741185292432 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441052,47.15935086675983,0.006395688788516152 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,fruit,2441051,10.018737772423822,0.6791504976745284 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441047,106.2884434738194,0.07849423470368544 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441049,99.78987663556504,0.10589379610540806 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441040,148.40060888500292,0.06645540101047853 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441031,160.76943835042812,0.10122321271543777 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441052,94.68974035361217,0.12867735615304543 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_121,leaf,2441051,499.3239690825838,0.5934021321846106 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441047,160.748390493784,0.08140481044238523 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441049,179.34785271074873,0.03385526231349889 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441040,450.686523376942,0.366323128152072 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441031,170.2486998785873,0.05646763958815226 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441052,431.0787557335269,0.3470051769866207 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,fruit,2441051,208.42860519377157,0.03140587858250887 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441047,13097.206115571786,0.0028979649541165386 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441049,13272.580945921374,0.00287875549227401 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441040,8740.092577800659,0.17856059433281501 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441031,12841.494995882254,0.011461040305992931 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441052,19372.591661791703,0.1671110972677221 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_122,leaf,2441051,19659.575724027385,0.17349751385419054 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441047,155.57780807767932,0.024870186964953245 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441049,155.6142434337625,0.02497188412648743 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441040,126.42769731623238,0.06523523348165039 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441031,138.2598521563462,0.026381373345589765 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441052,108.1366405827656,0.1331045880149926 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,fruit,2441051,181.21511066182669,0.09111694709789475 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441047,122.83371112944876,0.12639183838591528 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441049,319.87101064210725,0.2892654708973956 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441040,81.61382429162511,0.3039456829416549 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441031,210.91,0.10838776007717899 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441052,163.8107045582721,0.0013671333637619298 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_123,leaf,2441051,164.84366238498987,0.0013628432103431898 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441047,1931.1119403174928,0.0020827502406635112 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441049,1912.634178361868,0.0020927866571729403 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441040,1644.9115674966115,0.06758214421680142 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441031,3267.1393270716385,0.23044295643143098 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441052,5489.299973591914,0.45579226539031215 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,fruit,2441051,1435.2645678808456,0.12679273528128432 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441047,95748.27844441512,0.02011820227745531 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441049,66211.47654090011,0.14007949889158233 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441040,110801.18632814533,0.08353163851767409 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441031,89517.3511622333,0.00910554896879745 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441052,83293.98653316568,0.040399123462893094 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_13,leaf,2441051,93310.67369278889,0.00891855318612933 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441047,28.22757581547385,0.061262105479733764 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441049,2.387299752328559,1.134028735026899 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441040,68.60563277261834,0.32442408631807496 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441031,42.72778071148495,0.11877464805735749 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441052,26.36143259738068,0.09096667995797625 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,fruit,2441051,36.78025634054536,0.053679063721328024 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441047,112.41695615495397,0.04795786022363657 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441049,88.91094101089021,0.05391875503415533 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441040,34.12496534494852,0.4698017427585093 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441031,113.8058844200518,0.05329075640015413 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441052,147.02404355370876,0.16451440106865212 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_14,leaf,2441051,48.1211221420373,0.3205382156175107 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441047,91.09026467772472,0.025847492939153893 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441049,70.66887595671531,0.08439628747265826 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441040,80.56394820540694,0.027483729471847074 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441031,78.12312176712298,0.04084488186414137 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441052,178.15460326843032,0.3171725773487448 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,fruit,2441051,210.03091505829732,0.3886587534491117 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441047,478.49806424644976,0.08894174516966746 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441049,638.0272774852609,0.03601731608827441 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441040,520.8073893094843,0.052144792904620374 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441031,536.4697609655027,0.03927668311565524 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441052,719.8181307149943,0.08840085106823858 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_15,leaf,2441051,678.9873118855077,0.06303972841583017 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441047,43.257369617313,0.5178189622644558 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441049,49.967655844673054,0.5804478304887095 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441040,13.822745255120916,0.022353159130509948 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441031,7.052413307262949,0.26990338894053745 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441052,12.43582894288978,0.0235664055656426 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,fruit,2441051,8.716668357430283,0.1778906224542368 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441047,46.640525835524734,0.2842313684129216 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441049,206.6396507250525,0.3622188525720591 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441040,119.30160840339492,0.1236514922691847 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441031,60.1820041429228,0.17352816027858542 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441052,22.33940674523453,0.6039231708986159 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_16,leaf,2441051,145.72456725785523,0.21053796779427758 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441047,1247.5408447229047,0.05915667413204462 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441049,1444.9481305976676,0.0046408099299033445 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441040,1633.274656115423,0.057847775530726064 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441031,1004.1619649549076,0.15340768013985562 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441052,2257.9551919177848,0.19850387175661321 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,fruit,2441051,1414.2315134371918,0.0046909371081444995 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441047,30552.60836153076,0.09345295344710358 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441049,18286.357453017907,0.12946813475063124 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441040,26243.402854687523,0.027424807565209264 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441031,29718.713508288147,0.0814346656986773 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441052,23031.449915447556,0.029274060369410826 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_17,leaf,2441051,22186.32062090397,0.04551005483462145 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441047,89.5476554538334,0.14751667906052557 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441049,67.1588895201648,0.022565965887581863 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441040,59.888817814661785,0.027191800189173332 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441031,61.529390029708736,0.015454930789096322 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441052,65.98744828998223,0.014923794151748604 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,fruit,2441051,36.5548675549551,0.24159232581537537 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441047,946.3346709135908,0.08205029942932951 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441049,641.4951523530179,0.08680107337403609 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441040,1396.9112873314768,0.2511743743306001 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441031,925.3441178894922,0.07230881641690523 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441052,482.98533689858215,0.210060506152292 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_18,leaf,2441051,584.0904000737077,0.12751438385256586 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441047,3.8487729084518834,0.0019561380123002126 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441049,3.764800387546144,0.011536470376745656 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441040,3.883522195604795,0.001947366718553556 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441031,4.796875565578252,0.09368002778434181 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441052,5.333448699987434,0.13972969725145634 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,fruit,2441051,3.68470281846916,0.02087595836508127 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441047,1717.1816851387334,0.009595384994454115 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441049,1793.905619058297,0.009387957419853876 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441040,2482.7592226154447,0.15052297103066437 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441031,1998.1067435726857,0.05620705275176263 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441052,1588.522438739414,0.04341827894184025 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_19,leaf,2441051,1561.3221678153654,0.05091910688102841 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441047,108.26372065542002,0.08254018176392575 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441049,66.79009778143134,0.12723068719301756 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441040,70.7856348672707,0.101997634922528 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441031,137.21450515971625,0.18545725727563434 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441052,431.2746999110776,0.6828112151831986 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,fruit,2441051,3.895121155577528,1.361421795763044 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441047,1216.370402938453,0.04225433815951263 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441049,1278.8590096608962,0.06401116139671847 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441040,895.5726611476911,0.09071067852310266 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441031,739.3943798962835,0.17393536087088313 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441052,1127.8723452918491,0.009448442096993581 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_2,leaf,2441051,1079.3267107302008,0.009658581134023514 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441047,11.93068042587922,0.146616599017513 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441049,4.1434861513478225,0.6059159202540184 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441040,56.273910890252616,0.5270252866318363 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441031,11.297603447585596,0.1702954852260885 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441052,21.51282617504033,0.10941565620295135 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,fruit,2441051,24.233887189319336,0.16114126997637257 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441047,116.86391419292352,0.1100510884802266 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441049,19.297377496200415,0.672131047203931 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441040,18.79625594533771,0.6835579897189092 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441031,70.37860452425475,0.11018868848286334 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441052,114.49245805798924,0.10114753959008427 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_20,leaf,2441051,111.03060690438085,0.08781337389598054 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441047,6971.66721146443,0.02938922036346492 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441049,10206.560052959108,0.13615352669891667 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441040,5317.875699921996,0.14698768658743155 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441031,12344.484264337165,0.21874708191951164 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441052,7947.887595187455,0.02752584787427681 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,fruit,2441051,5596.616673569787,0.12480030650025453 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441047,385548.5035199615,0.06693076715149449 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441049,326321.4068875624,0.0055026899175354416 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441040,126736.73923396514,0.4162457255090741 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441031,270824.5984955934,0.08646014666216661 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441052,334643.26946128736,0.005433840017431635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_21,leaf,2441051,349023.3600227574,0.023706240495370956 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441047,51.499725338624906,0.09481849800488895 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441049,3.5325128660477843,1.0689026625353502 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441040,201.74537856878095,0.6878171801795703 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441031,34.317553044908685,0.08147010119055587 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441052,10.046847995591236,0.6149565832135293 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,fruit,2441051,48.47979189539148,0.0685743320699519 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441047,33.83258400548092,0.16824561790451975 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441049,71.10046416576027,0.15429164920947702 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441040,60.74984121761041,0.08596436041468447 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441031,12.744240884727878,0.5922668150685135 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441052,99.92465515472416,0.3020918714236007 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_22,leaf,2441051,38.93079067749701,0.10728756248575944 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441047,2086.0788997568125,0.061366389979789826 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441049,1905.325064960857,0.022004740409546475 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441040,1878.8719485682495,0.015932842157935223 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441031,1228.8482828984368,0.1684660733589367 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441052,1743.510792647577,0.016539700242233835 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,fruit,2441051,1461.0449899964,0.09330075094256296 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441047,157207.86568320397,0.011840500077070715 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441049,148751.5107805155,0.012172386214271746 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441040,109779.29599996236,0.14411333012597183 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441031,105555.80775837718,0.16115163800399745 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441052,179359.18280305216,0.06908984501364479 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_23,leaf,2441051,190326.9095440164,0.094866424242662 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441047,179.9684649820797,0.011764297918921418 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441049,178.519387309002,0.015275322690727844 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441040,208.9010847855011,0.05297998486595601 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441031,183.33022600073275,0.0037266365155201875 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441052,325.84712628673384,0.24605318488275918 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,fruit,2441051,186.49003945490372,0.003694930502027738 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441047,77.01475305409593,0.12717798356867815 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441049,93.54307605783252,0.04274026368237238 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441040,86.18303623763815,0.07833012050735699 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441031,295.37220190515137,0.45661770976777794 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441052,286.48633505178344,0.4433520008622196 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_24,leaf,2441051,112.8912465089998,0.038908357636077806 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441047,72.16404310250799,0.005581017452447545 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441049,74.03073833921187,0.005510206112204985 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441040,82.05818140298805,0.05022001308804014 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441031,52.15612533264268,0.1465965544119383 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441052,77.48240642692554,0.02530122576286553 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,fruit,2441051,47.241616295223295,0.18957712681386174 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441047,4370.428478700006,0.0818778763474941 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441049,3505.672926441139,0.013874746447351427 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441040,3089.2934693783386,0.06878697479036289 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441031,3374.400611252305,0.03044950006403635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441052,3733.286405491339,0.013445167723673102 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_25,leaf,2441051,4359.234760364944,0.08076411682754037 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441047,224.5408405528131,0.009504903803904341 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441049,302.48858687160356,0.11990874516331607 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441040,223.66159243331765,0.011208835189603583 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441031,234.47771663039055,0.009301328376368989 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441052,240.4863665128197,0.020290212817051234 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,fruit,2441051,179.53903789692794,0.10664135428517918 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441047,4063.6616122403134,0.017769805622477097 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441049,3866.78529818605,0.0037976720429555577 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441040,4179.323709065255,0.02995827993242406 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441031,3934.7077603073058,0.0037647511081004836 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441052,3479.1776872150026,0.0496711213125236 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_26,leaf,2441051,3519.392282037775,0.04468005344503112 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441047,139.94053237125718,0.02670135935459106 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441049,95.5391230581628,0.13906091176707536 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441040,89.90374236673311,0.16546439218348352 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441031,174.48224158166627,0.122509069611199 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441052,176.37843408555426,0.12720332015481306 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,fruit,2441051,123.25114871595304,0.028451186750747315 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441047,854.4712196301876,0.03901126127179744 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441049,545.7340031810965,0.1557051637709228 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441040,808.1970607469865,0.014831088577398788 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441031,498.30958897455736,0.1951869337059713 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441052,926.1375997268972,0.07398933814227959 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_27,leaf,2441051,753.92934537139,0.015355530300150466 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441047,106.91689889398442,0.16108308695218576 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441049,74.07482091932505,0.0017073435390859704 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441040,73.49354301076909,0.0017140821253402994 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441031,50.43264236795856,0.1652515434980979 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441052,82.11354921975905,0.046451557503195184 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,fruit,2441051,50.30058238974907,0.16639025324975876 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441047,379.855782663944,0.049642079509463866 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441049,194.40073740572143,0.24127875471250215 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441040,245.2169594130641,0.14042615962242744 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441031,297.79611422577085,0.056057636094165364 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441052,1073.3486640619465,0.5007641574022914 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_28,leaf,2441051,454.74899229918685,0.12779508267940365 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441047,153314.93666140694,0.11666655826822137 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441049,194090.41979820095,0.01424692682406814 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441040,207035.77329819647,0.01379436662523048 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441031,384518.08677718334,0.28266574656071963 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441052,553406.160320231,0.44079296305074767 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,fruit,2441051,178171.15890373787,0.05141362134397642 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441047,386967.9685814575,0.12467026045669272 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441049,255619.07836715563,0.30475201340717994 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441040,511995.69705446984,0.003078967008014466 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441031,566207.5676284567,0.04063039154140746 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441052,519281.1645314484,0.0030572919909088725 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_29,leaf,2441051,558178.1061802929,0.03442751976816183 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441047,3.4440812550281183,1.2667915798931118 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441049,32.91567161186787,0.28646224808663034 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441040,68.82094368166918,0.03385565447137728 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441031,67.24943366219915,0.023823662343812835 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441052,187.70292092153497,0.46960606195069676 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,fruit,2441051,60.07007812245794,0.025206772199146243 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441047,14.628367774239711,0.4810806128290954 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441049,12.146773185167795,0.5618155612529765 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441040,85.4948399816089,0.2856634204883439 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441031,51.51405258994692,0.06564923369549303 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441052,37.0599925065029,0.0773711561335968 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_3,leaf,2441051,155.66156378878912,0.5459049057899883 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441047,158.32167138481063,0.010192323879119058 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441049,158.10352930274988,0.009593522536415655 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441040,151.1951302199622,0.009810238760368684 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441031,82.56170163550973,0.2725694067544764 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441052,306.342772315293,0.2968595961376832 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,fruit,2441051,118.12568768742248,0.1170036923045581 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441047,6369.284907478775,0.0521520778497897 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441049,5623.951932976865,0.10620115361894822 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441040,7041.181424917935,0.008597219193312355 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441031,7779.542702324462,0.03471131520776494 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441052,8347.92104522492,0.06533557904778009 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_30,leaf,2441051,7322.731027942781,0.008430328509658747 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441047,53.84815461460597,0.17706557650172994 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441049,53.870471541957414,0.1768856239923775 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441040,89.25927321041576,0.04241694525060491 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441031,116.93652000012683,0.15971376415960692 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441052,72.6480142072241,0.047012653445295705 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,fruit,2441051,165.84640242115995,0.3114696540953126 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441047,547.9892774870758,0.009865982603731283 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441049,612.8865675273912,0.03874205981347911 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441040,573.1718689728596,0.009646823937460969 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441031,503.31160261400134,0.04680110121960457 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441052,524.7312714643148,0.028701096490304945 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_31,leaf,2441051,641.9766500642106,0.05888118889777694 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441047,106.58354607337417,0.0297393219731501 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441049,121.692048651065,0.027832715135725383 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441040,176.67190301414922,0.1897379997957973 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441031,61.1516062179374,0.2710216184829841 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441052,427.5130616713522,0.5735199008749268 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,fruit,2441051,95.80924337055582,0.07602207680610751 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441047,2239.3636041035124,0.008391950215671962 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441049,2404.057749984581,0.03921223080640601 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441040,1944.773260589133,0.05286369061916041 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441031,2426.850043086996,0.04331027655496156 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441052,2049.5813676377775,0.030067500890770482 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_32,leaf,2441051,2153.6511400988297,0.008557309897098797 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441047,102.07545010421846,0.004302773781996727 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441049,100.06281107164084,0.004345830465084521 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441040,38.80555451884504,0.4157246361050124 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441031,11.181984467733578,0.9560996451804982 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441052,2361.5936196001976,1.3685866369464872 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,fruit,2441051,189.60996010148952,0.27324261698958363 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441047,1512.179968585845,0.032158931352250786 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441049,1844.7141256984255,0.054166661197790233 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441040,2525.314869477523,0.19055312379811706 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441031,1744.6299184497127,0.029940903725608425 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441052,1380.385682116225,0.07176196616641661 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_33,leaf,2441051,1404.9093328620345,0.0641141145973454 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441047,370.5333576968093,0.037304449194750955 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441049,334.4821502293352,0.007149916319373784 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441040,334.2292753925819,0.007478375344421639 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441031,345.58666158461773,0.00703410916189684 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441052,356.0663435343437,0.02000806204196337 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,fruit,2441051,306.06951581247966,0.04570278624884061 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441047,47434.52014773318,0.02515400841451143 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441049,55477.58492175835,0.042869026898271656 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441040,60342.67421502512,0.07937603296908069 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441031,45880.776421972274,0.039617761305083654 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441052,52349.939443512085,0.017667663651459442 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_34,leaf,2441051,48176.08685951599,0.018416998803186146 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441047,176.09221230326972,0.08900961852245048 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441049,110.827592571982,0.11208263167917787 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441040,97.54733324219929,0.16751513003900853 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441031,1634.9322791742647,1.056769237228461 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441052,104.70441678501363,0.13676552908059625 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,fruit,2441051,569.9688931257498,0.5991206229215611 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441047,8260.169335673732,0.03979605916841189 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441049,9845.517543996062,0.0364535406646147 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441040,18918.997279306914,0.3201131050178283 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441031,7694.543265554052,0.0706021637506109 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441052,14809.489445253632,0.21375507681474293 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_35,leaf,2441051,6896.488320848176,0.11815700466239099 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441047,2902.176036731441,0.13059631292208618 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441049,3111.6390789210154,0.16086177823897918 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441040,1938.077457540238,0.044756308744839046 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441031,2099.0576622965095,0.010103069834775269 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441052,2197.8639849488104,0.009873373662797391 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,fruit,2441051,2068.991036657349,0.016368829688399256 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441047,8444.455150874746,0.017289324868901 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441049,10205.251236109658,0.0995413921831605 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441040,14755.01684189866,0.25965740095561207 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441031,7785.312569274273,0.018006255037167573 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441052,5949.203705279853,0.13482346884534113 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_36,leaf,2441051,7542.235420853991,0.03178222439356171 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441047,699.5538759496154,0.07360701320521601 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441049,703.332383887655,0.07594646033273156 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441040,441.0211683878922,0.12675471849624032 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441031,543.2716707864882,0.036197094892100434 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441052,637.712698561217,0.033410911054276404 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,fruit,2441051,501.5257472277467,0.07092092032953623 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441047,468.64457359237616,0.059923057285433234 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441049,390.2180137120997,0.01961322149184097 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441040,442.4086283631951,0.03490305305498698 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441031,321.5326193975491,0.10369549688262714 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441052,426.27134902491946,0.018765607958171948 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_37,leaf,2441051,333.6402550081298,0.08764209097273623 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441047,36.94076832732715,0.011941203896575159 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441049,158.73861383562036,0.6212354556238684 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441040,94.03313885824296,0.39383380530639256 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441031,0.8944077157792588,1.6279115908590733 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441052,39.00037364630978,0.01162163989867393 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,fruit,2441051,7.72241334942434,0.6916940840119643 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441047,200.2859654087234,0.5086398555845255 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441049,103.11556974068124,0.2203135831494034 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441040,36.00705819756504,0.23662302190975426 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441031,48.46941439188409,0.10754288995761208 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441052,75.70744113886242,0.08612790500747991 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_38,leaf,2441051,19.45354438842519,0.5040119222920401 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441047,115.8163052322663,0.028436588856776357 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441049,101.13542236041832,0.030429824616132528 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441040,70.80981785316048,0.18523963987853898 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441031,35.62910883706468,0.4835281572942953 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441052,2502.081296943866,1.362968299450499 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,fruit,2441051,1140.6469350419356,1.0218181207384358 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441047,2277.815874759086,0.09864906086843428 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441049,3266.5869673169987,0.05792654881278114 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441040,2904.350893683012,0.006881408944904521 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441031,2228.5826636944976,0.1081389284307237 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441052,3189.393109009315,0.047540375339498286 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_39,leaf,2441051,2813.0371862689008,0.006992202963551186 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441047,34.67828089235202,0.2787934532699181 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441049,74.26166733944008,0.051913682563757835 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441040,57.527892948358584,0.05897254572934396 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441031,163.28625899962233,0.3940986258537944 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441052,122.49128188938876,0.26925416631049015 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,fruit,2441051,46.50698966147079,0.15133278422236196 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441047,203.36008804970012,0.05059872144819799 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441049,108.30338241835987,0.22302497953040534 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441040,127.8572855184518,0.15094151991871874 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441031,158.6302638443978,0.0572809532197085 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441052,310.6648250508013,0.2346250833514123 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_4,leaf,2441051,319.7775814523473,0.24718101372884105 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441047,147.0156796052796,0.01303077541870623 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441049,217.85628590575553,0.18383721490958127 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441040,125.92017245595451,0.054237570627456044 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441031,146.12989968160056,0.010406205710011829 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441052,139.21024433411165,0.010661684717244047 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,fruit,2441051,131.79976809282363,0.034418234338246645 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441047,7338.214493651714,0.013943118203030291 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441049,7413.15701871518,0.009530321048778934 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441040,7881.969557348806,0.01710123305397948 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441031,7317.877031983506,0.01514841267490441 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441052,7742.107320332599,0.009325667075544608 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_40,leaf,2441051,7863.302494945677,0.016071462851671825 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441047,247.3179250243055,0.14929741233698257 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441049,158.89962828155103,0.04283530056148166 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441040,150.36938986936508,0.06679874425251642 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441031,112.9869354860476,0.19092995226128373 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441052,311.28856912621177,0.2492049913705987 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,fruit,2441051,191.8426975049749,0.03898709061075856 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441047,1601.4588847834566,0.04033360073737713 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441049,1344.5318681253475,0.11627829363792896 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441040,2043.436588916127,0.06551177143188358 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441031,1509.2518951590089,0.06608766411010736 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441052,1930.070579132711,0.04072379667185677 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_41,leaf,2441051,1913.169317821125,0.0369040133431664 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441047,45.825931521668096,0.024669424413756635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441049,48.754302991551945,0.002232225782014652 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441040,45.08564141469443,0.03174247362964677 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441031,53.919015018683275,0.04596122378688183 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441052,48.254405311325336,0.0022437584788770337 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,fruit,2441051,53.92689484750439,0.04602468778260849 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441047,174.29953685562418,0.007347814848510659 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441049,174.93286469326225,0.005772639776408628 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441040,179.6143219993466,0.005696915310333228 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441031,181.61340099114088,0.01050384336781951 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441052,163.07543383150565,0.0362555054087772 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_42,leaf,2441051,187.19249227165164,0.023644378541180178 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441047,53.78838152338797,0.3721249456814366 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441049,16.60556266397949,0.8825598265198304 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441040,160.53281129944514,0.10275038889125021 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441031,160.1121188045481,0.10161078232464549 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441052,723.144830190907,0.7564118633840926 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,fruit,2441051,93.30935835397833,0.13288821937365203 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441047,406.38058246741815,0.04610988679733108 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441049,401.06079164429775,0.04038714505183583 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441040,300.4307162569919,0.08507872848084652 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441031,281.1418129388916,0.1138976206221658 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441052,405.0739633871816,0.044711267614454986 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_43,leaf,2441051,329.83095424303536,0.04453165042756435 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441047,28485.29515918539,0.08273852509480761 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441049,35637.31109613538,0.014545679257347288 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441040,27051.720436017204,0.1051643583946209 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441031,76786.39190817736,0.3479250121531736 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441052,103849.2146504918,0.4790439675868239 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,fruit,2441051,33289.66797198776,0.015049785421235917 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441047,131472.07179697353,0.15172129864459283 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441049,93501.12337634445,0.29973797667478763 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441040,241891.25980736467,0.11306537095555402 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441031,199624.21391098693,0.02965841352331644 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441052,334878.52417204366,0.2543324915966432 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_44,leaf,2441051,173269.2757643433,0.031833245319430326 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441047,39605.70719273433,0.08765587086768978 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441049,47618.00954713328,0.007642405494865834 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441040,49308.737782207434,0.007510242240455156 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441031,121092.4618327748,0.3977034653231204 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441052,135725.45508649334,0.4472476632657285 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,fruit,2441051,38251.30974727782,0.10276733300878682 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441047,21242.99803128373,0.14126294079062962 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441049,15954.329661753776,0.26560018808319885 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441040,39911.31732840113,0.1326173128641912 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441031,32736.377713287275,0.04655187331514288 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441052,67881.17412829233,0.3632705959747602 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_45,leaf,2441051,26081.41809279535,0.0521475485879499 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441047,3926.995917512495,0.15316092745858656 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441049,4518.054709064409,0.0922698917563336 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441040,7589.596505378318,0.1329973103636113 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441031,20333.120573090066,0.5609826587369193 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441052,6657.044128173535,0.0760600585712008 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,fruit,2441051,2572.6431164483793,0.33684183327745654 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441047,19072.86218384438,0.04239013113035206 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441049,15988.88403743562,0.11898784908414761 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441040,29276.84837543449,0.14371832171439092 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441031,24426.68552832531,0.06505853948636098 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441052,22043.17187190471,0.020468085078629628 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_46,leaf,2441051,20013.606075482458,0.021480654418892797 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441047,135.12531129456414,0.018914347498934614 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441049,115.57941100097148,0.08677057801870847 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441040,196.8015966177445,0.14437756250040845 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441031,147.15530089558413,0.01812485610579051 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441052,204.84485100333623,0.1617739969991301 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,fruit,2441051,103.35401044461534,0.13532372175154261 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441047,334.42449287284285,0.03793882829383932 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441049,425.3149838254235,0.14235143428001962 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441040,261.8548640375807,0.06829860340532212 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441031,603.7204854399229,0.29447666370506553 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441052,278.4749753499084,0.041573074701296786 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_47,leaf,2441051,268.02136516878966,0.05818983393296451 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441047,113.45023066962374,0.08281703321640022 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441049,50.77236200998066,0.266360982087388 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441040,95.01839016492008,0.005819318152222808 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441031,171.61839986236123,0.262575498351604 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441052,92.4889812556712,0.005898354201840927 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,fruit,2441051,39.47063490589532,0.3757142377164362 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441047,3270.671219783942,0.09528545436026725 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441049,1630.6987024977293,0.20697770939371596 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441040,2787.290562737063,0.02583080931754944 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441031,1788.7648718085825,0.16679817752689585 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441052,2465.395325832642,0.027464866775198882 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_48,leaf,2441051,3105.750883927577,0.07281518246032759 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441047,30.619395563041294,0.008635879857378015 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441049,32.1806965120566,0.012962946452813151 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441040,30.75888193100564,0.00666194814511889 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441031,26.68656629956668,0.0683397954995899 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441052,32.105497097644744,0.011946905409357944 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,fruit,2441051,31.709821041199884,0.006561297844443592 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441047,29.800072716751306,0.024093634221528326 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441049,31.23446752620214,0.003676851392877767 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441040,32.423767355853485,0.01255251658920753 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441031,31.76559111616405,0.0036459833553150744 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441052,29.99121163437167,0.021316946586434016 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_49,leaf,2441051,36.5611716188648,0.06470914639867753 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441047,708.6290137331849,0.005936610923396923 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441049,689.3875424511515,0.006018887719860366 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441040,1534.7645553655132,0.3415594418617247 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441031,320.3621969647935,0.3388410556768813 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441052,946.9639391856888,0.1318511222258576 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,fruit,2441051,640.4847658998906,0.037973514568304445 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441047,16009.657717830503,7.367759957119802e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441049,13857.4354515772,0.061962406613599974 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441040,17789.915275631844,0.046528608840097796 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441031,17871.83183479938,0.04852379836819232 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441052,15955.383338783056,7.380280528002103e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_5,leaf,2441051,13415.616326108951,0.07603464155806616 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441047,113.4173035960452,0.06002751936178674 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441049,76.93130352337667,0.22860374625491886 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441040,158.48161948018,0.08527206305214685 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441031,73.31426122521573,0.2495183748153318 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441052,224.51073994793472,0.23653028379777385 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,fruit,2441051,147.0401756727501,0.05272917546818823 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441047,4677.739877756623,0.04672393801502528 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441049,4891.271443854519,0.06610963525475899 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441040,4615.919303466084,0.040946078129373564 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441031,1843.141087532504,0.3577535490760302 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441052,3785.296203387079,0.04521226048812155 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_50,leaf,2441051,3523.7556382105454,0.07630634587515273 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441047,41.172334316802086,0.007976170688257733 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441049,39.6738105597832,0.008125404612737475 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441040,36.856251485156555,0.04011815725194823 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441031,34.234717829730535,0.0721625672091557 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441052,48.48683153474703,0.07899448536050135 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,fruit,2441051,45.028304043067415,0.04685627002445214 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441047,243.1978909263859,0.025344196150427045 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441049,240.2156259262697,0.0307027457952036 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441040,285.1558654695247,0.043778308710380465 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441031,272.42714495988236,0.02394637855190007 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441052,236.2741983685201,0.03788770209048087 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_51,leaf,2441051,299.4346692205268,0.06499808205578805 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441047,142.45965345221197,0.10538101836227742 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441049,156.0810092894935,0.0657228371684635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441040,161.36477334085728,0.05126416962067548 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441031,201.79931585360137,0.04584678763852157 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441052,205.34033090488936,0.05340135564391835 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,fruit,2441051,236.7689290344648,0.115251807824583 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441047,1567.3421482609967,0.03226622029255166 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441049,1720.0653426657143,0.008114912512629413 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441040,1721.268722210695,0.008418644209390092 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441031,1840.482023806914,0.03750154710579068 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441052,1552.321140984524,0.03644846073449326 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_52,leaf,2441051,1656.3823691600207,0.00826943375075917 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441047,92.55811221403444,0.03159525221289772 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441049,106.5274363690652,0.029451735139808477 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441040,137.55880984184398,0.14047866913837392 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441031,18.20899267772417,0.7377238192445124 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441052,273.92743334852287,0.4396257877430445 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,fruit,2441051,25.875660616900856,0.5851182941800561 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441047,212.125004799289,0.022563511453175256 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441049,138.48081415093364,0.16263874553657942 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441040,344.61529461009565,0.23330619456558077 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441031,138.77602132127947,0.16171392149514885 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441052,190.6461399553075,0.023800337233629953 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_53,leaf,2441051,386.3981378300888,0.2830066710531782 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441047,443.4531627624867,0.03084430631038826 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441049,478.340622794238,0.0020452016431486975 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441040,993.4956699005388,0.31947391560313587 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441031,316.8781909758748,0.1767997129348151 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441052,682.6990052027122,0.15653720702158713 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,fruit,2441051,473.84596240617304,0.002054878599839771 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441047,5639.896983721729,0.028954082322800723 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441049,6218.948189444049,0.01349168497069364 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441040,6238.850717290161,0.01487934027608162 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441031,4244.300275528965,0.15241915195673306 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441052,5838.495694868685,0.01392428940715229 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_54,leaf,2441051,6548.245321556301,0.03589968761096163 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441047,80.76739128212814,0.09980991469076494 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441049,47.600420103974386,0.12981535541327283 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441040,93.81648704400152,0.1648530256940135 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441031,15.642202603583788,0.613128234344742 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441052,87.69623380965793,0.13555480154007005 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,fruit,2441051,2.1255352181832987,1.4799578358487275 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441047,173.40673899586838,0.3431195093437043 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441049,43.23590156981615,0.26010194237160467 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441040,213.1331104536679,0.43270446122668815 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441031,48.952506861231214,0.2061715248760123 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441052,108.43724747396575,0.13923202326284745 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_55,leaf,2441051,35.9792480809285,0.33989437891523444 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441047,111.77291276248675,0.24770633384217122 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441049,199.3716245625158,0.0036204452115113916 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441040,125.78034732394649,0.19643011284653733 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441031,589.1236845705376,0.474163580569801 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441052,196.06136501634103,0.0036508805282573498 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,fruit,2441051,266.6488807190594,0.1298968625542556 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441047,2164.6324692401013,0.19119007742101068 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441049,4289.784613090724,0.10586124117935869 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441040,4232.502236479469,0.10002295031644914 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441031,894.7672097346486,0.574864185691689 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441052,2491.1345031071432,0.13017706904204962 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_56,leaf,2441051,5041.60040994312,0.1759941751949392 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441047,162.85378646734375,0.005809859609642309 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441049,100.82463701308684,0.20242133392299122 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441040,269.9242459360537,0.22525389572864674 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441031,158.5255847618471,0.0058886371994884 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441052,268.29417335969293,0.22262323997926048 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,fruit,2441051,114.2299409695446,0.14820804870199122 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441047,52456.007360123,0.10367323519544325 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441049,65962.9088299232,0.004168667893109657 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441040,142002.041135593,0.3288261201815281 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441031,67235.32383476713,0.004129034179507052 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441052,97470.30535595072,0.16540385983895156 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_57,leaf,2441051,55135.74966051802,0.08203518289704537 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441047,228365.42193354643,0.2809789071543598 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441049,592407.560235279,0.6949691538217406 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441040,111969.0254282634,0.028553540325981785 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441031,59635.497271271706,0.30214659350325146 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441052,127187.05889056958,0.026791486212633053 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,fruit,2441051,100771.5970158757,0.07431329721625257 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441047,110162.76333829602,0.09399690502210944 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441049,61591.37739368953,0.3465118098039701 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441040,155804.4831955754,0.05654822380978253 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441031,136167.55794619708,0.0019580774957033142 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441052,198623.27487591325,0.16199841189559372 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_58,leaf,2441051,137398.19111374076,0.0019492888391487995 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441047,755.8732771928325,0.0012260485411670352 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441049,502.5327908400921,0.17605853798862237 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441040,932.1878979126494,0.09228051720660879 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441031,751.6115125599841,0.0012295195769516098 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441052,776.1983941856713,0.012749796710029404 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,fruit,2441051,527.1992101266706,0.15524819231091636 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441047,1837.7558217944843,0.06187234246392448 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441049,1250.6231650451823,0.10528899598395514 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441040,1349.70944041071,0.07217517922763594 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441031,1324.0958338207029,0.08049604566723456 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441052,2723.101033186495,0.2326482901893394 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_59,leaf,2441051,3056.2232554841826,0.28276961128971756 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441047,82.95273358191167,0.11118767902625137 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441049,109.04108047933464,0.0075717650967352945 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441040,185.69873052224352,0.23879055367596802 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441031,105.27185098674812,0.007706121972229418 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441052,132.07218748512315,0.09079298989222462 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,fruit,2441051,92.30979670598748,0.06477058661970259 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441047,102.2900608391386,0.0860447611038464 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441049,198.7371684603293,0.2024008998297524 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441040,189.56086237951635,0.181870477773157 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441031,147.11668372683258,0.07178372854785575 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441052,63.709662830199456,0.29167289134093344 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_6,leaf,2441051,44.13455758691181,0.45109942052236685 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441047,99.54690487610296,0.005839117236302371 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441049,42.892655362230585,0.3714839456685175 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441040,71.28610437974517,0.15086199649994425 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441031,102.24180994048116,0.0057616503256925355 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441052,491.5276325248209,0.6876810591911555 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,fruit,2441051,108.42179247623262,0.031249704273893286 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441047,39.3627076640466,0.17675603630398573 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441049,37.07924217203167,0.20271015171804097 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441040,90.00360272784414,0.18241889289156799 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441031,36.72656477502673,0.20686069269952334 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441052,78.90631196246801,0.1252707440294547 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_60,leaf,2441051,505.33298966058743,0.9317366500741464 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441047,146.488395590658,0.028610235990091937 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441049,133.87430770722244,0.01049574842794776 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441040,116.65088034201544,0.07030496576366874 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441031,119.51424658528074,0.059773308401474434 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441052,215.86733104076873,0.19699393554659128 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,fruit,2441051,140.4239077173362,0.010248067972542518 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441047,480.6494260439405,0.09892117778556653 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441049,755.8757635284232,0.09770081447403589 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441040,859.2497271439943,0.1533697970668748 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441031,604.0049789512221,2.9091279309412243e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441052,603.1960626734553,2.91107792080858e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_61,leaf,2441051,593.7516408318733,0.007144783024755963 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441047,865.7382971642869,0.13176273227720436 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441049,1089.4866191328388,0.03192746116030776 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441040,1255.710529680981,0.02974017416319308 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441031,1439.9919091096815,0.08921069007613092 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441052,1892.7275414200792,0.20793873981579525 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,fruit,2441051,616.4733789173442,0.2792350345936909 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441047,769622.571197947,0.11586020803365127 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441049,1188237.2360442071,0.07276515375940029 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441040,1280085.620454022,0.10510101498617352 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441031,1039649.8871411422,0.014749106684571522 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441052,762635.0946516971,0.11982121747773444 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_62,leaf,2441051,970220.2605962086,0.015267664546956716 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441047,1157.0156834827342,0.005973334628604388 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441049,1189.0630144545316,0.005892290153895363 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441040,716.034701115531,0.21437851054632873 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441031,2205.0729368077727,0.2741103785905694 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441052,1988.732146799427,0.22926371340100182 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,fruit,2441051,247.84337661334257,0.6751352632576717 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441047,3921.7473661397207,0.0237789739489922 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441049,3353.2855106021675,0.09178805512353572 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441040,4363.177669644858,0.022544310426082514 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441031,4589.195758439738,0.044477996019961274 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441052,4785.243398774215,0.06264544532806093 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_63,leaf,2441051,3911.973453249307,0.024862688504402097 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441047,301.1433030152377,0.17266865145127896 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441049,373.6771988861098,0.07894526220776754 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441040,1174.0360530240616,0.41823957270564405 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441031,457.82117119561394,0.009254011051171407 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441052,1321.8850608580526,0.46975183348616323 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,fruit,2441051,438.51692797625054,0.00945549799013623 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441047,7615.488192091867,0.014590668855739342 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441049,7112.284609456551,0.015097952927173086 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441040,4595.523136078027,0.20477212333316652 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441031,6872.236740308835,0.030008968221510557 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441052,10604.025729628976,0.15836369260919136 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_64,leaf,2441051,10977.11592170285,0.1733811702869663 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441047,56.417971223607935,0.07729177894866579 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441049,73.93556611549522,0.04014415863645859 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441040,47.817032925210995,0.14912661953603723 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441031,60.87975161581664,0.04423637204410702 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441052,74.92936213576783,0.04594279159368653 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,fruit,2441051,92.2344786056652,0.13618405314846616 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441047,2344.744464310945,0.08215556257912393 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441049,999.1798672044912,0.2882962819156609 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441040,1339.0604797593344,0.1611397639114558 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441031,2150.192190070099,0.0445373234503057 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441052,1731.0429279903535,0.04963211858927297 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_65,leaf,2441051,2696.882644193689,0.14292209175426906 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441047,395.30721502033265,0.1303353439017001 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441049,406.7301097055896,0.11796376106522555 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441040,1295.4877799416895,0.3851632358140695 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441031,552.5691952737282,0.01511658520850645 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441052,962.6228438002172,0.2561860786942085 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,fruit,2441051,514.7641570343886,0.01566178550724029 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441047,6589.853998224944,0.008604176684101628 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441049,6331.309195930096,0.008778092735125309 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441040,3238.8205503724644,0.2998847297687619 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441031,6306.609756408712,0.010475657656737525 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441052,10086.706851923736,0.19347778320463505 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_66,leaf,2441051,10157.01987047356,0.19649468608810494 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441047,492.2430196164159,0.06033132971366273 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441049,359.8722423898189,0.07569988650142268 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441040,702.329098246761,0.2146924255632796 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441031,356.99789331004314,0.07918258321848759 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441052,403.5855137358454,0.025912667195906014 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,fruit,2441051,453.2120682408509,0.024453229332819237 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441047,436.7284592538592,0.08860815532148525 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441049,512.0837287632116,0.019478672273383513 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441040,1024.6169053793362,0.28174186830990555 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441031,559.0646738479022,0.018642402136956004 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441052,800.3921557187082,0.17448317485179654 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_67,leaf,2441051,309.94733709447485,0.2375317393371441 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441047,232.81460501583672,0.010738916880532301 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441049,215.73339974255407,0.02235391670783482 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441040,198.7708209770832,0.057918672805129745 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441031,221.44205141774776,0.011011208223918434 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441052,297.4182003916056,0.11709623720049267 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,fruit,2441051,237.5870993365651,0.019551551055431382 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441047,706.1826659562622,0.03130587094657189 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441049,474.0416233567134,0.20440644736422797 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441040,882.7498747745432,0.06561474056637451 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441031,784.239896558114,0.014226008285640912 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441052,1116.458389208267,0.1676196173425244 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_68,leaf,2441051,733.6942115973884,0.014707831292389617 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441047,105.00000998394076,0.0980966633070457 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441049,96.49093986124385,0.0613938595710104 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441040,71.05066559409043,0.07152452635682494 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441031,70.70118077462992,0.07366601008380447 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441052,99.32194073370412,0.07395251994735386 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,fruit,2441051,42.417587884782634,0.2955467087309931 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441047,78.76304322857278,0.23199999420733497 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441049,189.9894350998981,0.15040696928166097 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441040,200.7241413658881,0.17427712664856898 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441031,44.54726490349205,0.4795014376298088 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441052,234.66728460144063,0.24213006585548236 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_69,leaf,2441051,73.16656366613483,0.26400982369007764 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441047,75.6786136245696,0.059490780338587346 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441049,98.03002976988978,0.05289518666901705 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441040,97.89909200731437,0.05231471597931958 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441031,18.090886728023705,0.6810040934534465 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441052,137.6855067571354,0.20042427949836927 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,fruit,2441051,72.79126712807012,0.07638466834503799 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441047,307.16230243845274,0.01650417350549649 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441049,365.50330639251627,0.05901922216334077 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441040,125.69300519411892,0.4045609779305721 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441031,330.95729640128667,0.015899872303958063 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441052,225.33282635673643,0.15104762373173886 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_7,leaf,2441051,372.27933459274334,0.06699684115405269 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441047,945.5864963974371,0.0075385616151741885 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441049,978.70038381117,0.00740993545031543 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441040,979.6916214098356,0.007849570676531581 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441031,2877.3419227809063,0.4757516502307064 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441052,601.3261114248171,0.2041297605293706 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,fruit,2441051,850.2110188545761,0.05371309399804014 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441047,484101.9567663479,0.0397929357649085 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441049,373996.6206153013,0.07227622433146585 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441040,316405.21708941617,0.1449002665144823 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441031,473974.003538468,0.030610619881399792 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441052,409459.5660403238,0.03293288050471599 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_70,leaf,2441051,512642.4242825367,0.06467064152726731 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441047,118.72857591128005,0.033001954528761424 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441049,97.06442666356747,0.054493210553064886 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441040,97.86138138674958,0.050941962305219635 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441031,162.11154201628602,0.16826063267986546 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441052,174.32274659326313,0.19980075578190215 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,fruit,2441051,101.3528037009779,0.035717537173778346 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441047,3118.327600385654,0.025631117230955347 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441049,3681.0927714152353,0.09768614128557207 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441040,2558.570024990956,0.060293313859783204 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441031,2208.798716144974,0.12413448024990803 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441052,3430.0993104971135,0.067016072755687 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_71,leaf,2441051,2760.904655731249,0.02723921234892268 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441047,86.31115723127971,0.04310265144451764 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441049,70.00154960565004,0.047856634098540685 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441040,94.50543350744132,0.08249249052896523 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441031,33.50421513872767,0.36786483936205405 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441052,146.113873646478,0.27172716647158923 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,fruit,2441051,55.55712903837732,0.14822449296959594 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441047,711.1147377392717,0.08069343269616391 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441049,590.7619011240624,1.6623269960236442e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441040,387.40989894952736,0.18307553326977066 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441031,590.3097417823183,1.6629635201548254e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441052,755.3239070804549,0.10688698423425702 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_72,leaf,2441051,261.2456769251281,0.3541971342167023 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441047,72.51362347743647,0.039613011877750015 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441049,99.66309315983123,0.09850174280489843 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441040,65.0628083521074,0.08669981396196058 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441031,86.3639560268805,0.036299908536670866 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441052,112.43300659973444,0.15086120532604674 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,fruit,2441051,70.69653959670374,0.05063446228922408 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441047,1592.3204316905362,0.0519282149427176 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441049,1772.249358385297,0.00543385489135062 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441040,1968.3717782659064,0.040148446978562013 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441031,1662.959588285561,0.03307698716334917 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441052,1816.8764217009616,0.005366706262875276 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_73,leaf,2441051,1852.3101070011448,0.013755013744727318 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441047,174.49275194017972,0.0532368982476612 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441049,133.99037760298913,0.16794067922166445 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441040,304.0745115935568,0.18796572760481522 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441031,237.73793208595217,0.08108419052276128 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441052,216.2361007179454,0.03991391109348141 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,fruit,2441051,178.26142703590926,0.0439569113852496 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441047,913.3299100340744,0.02517559196237862 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441049,591.7035775028753,0.21369907718879588 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441040,783.4843589273125,0.09177294140160042 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441031,1022.3487755823091,0.02379580892618005 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441052,1064.2910327366317,0.041257130721498836 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_74,leaf,2441051,1061.566168185304,0.040143796969688506 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441047,131.13881165163994,0.024504892179263216 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441049,110.0159909520233,0.10078032110195423 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441040,144.02480037323843,0.01620114588605137 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441031,133.47720871404846,0.016829019978342963 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441052,180.5324565989145,0.11431915580752783 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,fruit,2441051,147.22880951588814,0.025756664364134707 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441047,7543.72901305292,0.09289604290630793 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441049,9653.928098446608,0.014221937784745453 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441040,11736.64537411936,0.0990618603316542 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441031,11438.219909447424,0.08787631984418054 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441052,8786.89,0.02664693247059846 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_75,leaf,2441051,9031.890043038424,0.014703480408602143 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441047,45.54788582951517,0.12011847317773738 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441049,94.5153513432668,0.4371526028854067 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441040,86.65793376696496,0.3994585795008281 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441031,23.53647532144968,0.16660832410540527 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441052,12.556540847049275,0.4394797364292522 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,fruit,2441051,20.329773760669188,0.23021720456681205 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441047,328.43648131037475,0.16839355483450458 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441049,190.90132156556388,0.06724890092954006 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441040,271.8535108164652,0.08627711015943618 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441031,116.71943791452544,0.2809146483938689 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441052,224.74444025549195,0.003631121075723609 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_76,leaf,2441051,221.00194657249017,0.0036617369106792808 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441047,529.0978381664212,0.0769543266117827 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441049,683.5134002624741,0.03425671964973587 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441040,540.5107345503549,0.06768599020046873 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441031,675.2115379698892,0.028949541206636287 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441052,761.2375843632001,0.08102990877062988 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,fruit,2441051,588.1286432569125,0.03101798258334565 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441047,13356.597010848842,0.12409560946517839 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441049,19071.638445307985,0.03059657260650006 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441040,19950.07409824422,0.05015308077480274 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441031,17792.158592696476,4.372087584627593e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441052,13937.904109837022,0.10559395997086263 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_77,leaf,2441051,17756.353517279305,4.376493446338614e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441047,61.6929467578164,1.7311187386237492e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441049,62.915193223171805,0.00834690808478511 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441040,61.49085305654057,0.0015981086375163045 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441031,60.87855076340639,0.005944321304931943 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441052,61.74213877314932,1.7304289812813956e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,fruit,2441051,64.2571150458119,0.01751259646851344 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441047,95.56797224717177,0.015707939677343186 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441049,97.8063057328112,0.0056534555945613185 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441040,103.49340981554954,0.01889238499675261 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441031,100.36935125220728,0.005580806089347634 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441052,97.07317267137115,0.008921086929953859 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_78,leaf,2441051,107.9011150587167,0.037005621778120945 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441047,100.72079162827518,0.025168065970957443 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441049,106.63447552741803,3.8955922986572133e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441040,113.28894860052776,0.025900349784583998 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441031,106.8258621658242,3.892101109896906e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441052,103.68318197391714,0.012578879513567731 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,fruit,2441051,113.69469339295914,0.027452998341573664 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441047,242.69111491656483,0.002632173890844136 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441049,245.31100476186364,0.002030980585488784 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441040,263.16764925473126,0.032546450447908715 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441031,243.02196470294757,0.002040523120804494 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441052,234.3071620588598,0.017900486839292462 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_79,leaf,2441051,264.67024754742863,0.03501907287137351 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441047,58.253449763899624,0.0424757256893753 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441049,66.4251642960262,0.014535262239786517 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441040,69.87180565421131,0.03650459157725372 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441031,21.28253195750695,0.4797740808334985 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441052,110.79661579364814,0.2367291203410431 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,fruit,2441051,62.052422519522395,0.01503863405506456 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441047,356.8794482040003,0.032747821209304195 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441049,202.2800071382555,0.21382075724572003 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441040,305.037823072368,0.035420024633822766 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441031,494.1184426947829,0.17405734645877136 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441052,304.989494160299,0.035488837879652735 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_8,leaf,2441051,457.879589720974,0.14097756746953438 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441047,45.31603482369015,0.006511563649019614 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441049,46.80854879027632,0.007561711351848244 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441040,46.68515864260849,0.0064153734252083705 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441031,43.68720983248319,0.022409156968202337 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441052,44.83660968623414,0.011130699462815974 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,fruit,2441051,53.458775367633535,0.0652555402139865 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441047,143.36605929123178,0.004203798139407411 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441049,164.2984375721083,0.054983287373364664 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441040,151.92112206213253,0.020968013288241494 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441031,130.49144521821427,0.04506810502236247 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441052,144.26284916580212,0.0014956408955448808 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_80,leaf,2441051,145.25819855947242,0.0014905078193980792 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441047,289.7118791888576,0.042888097882129994 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441049,244.38792621880248,0.11677465488183847 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441040,593.13495519278,0.26829911801609674 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441031,348.6220051343661,0.03750039542161465 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441052,526.3131211176291,0.21638979619568266 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,fruit,2441051,290.9425642611716,0.04104713879802535 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441047,6761.575198944948,0.006709453648933383 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441049,6554.260394729659,0.006814737250982805 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441040,5641.09670998988,0.07197488350094483 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441031,5706.78618403024,0.06694682760317328 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441052,7180.774042232213,0.03283283221657074 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_81,leaf,2441051,7737.087249147627,0.06523906555273129 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441047,6902.21231430757,0.022094589763652195 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441049,9135.954514849722,0.14386020424892942 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441040,5769.31672028988,0.05576934320196125 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441031,6217.482117815854,0.023279179573991726 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441052,9010.766127314871,0.13786799336950262 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,fruit,2441051,6018.5641506554175,0.0374008304928819 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441047,71121.56884030672,0.21965925371561834 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441049,78179.09171800035,0.1785699611927205 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441040,161824.15221997426,0.13738275877207684 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441031,132152.19689730665,0.04941380553663066 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441052,138372.09227313063,0.06938792609472166 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_82,leaf,2441051,103727.50886456158,0.05576663376063529 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441047,203.2174658801736,0.07522717069988483 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441049,244.56856776519243,0.005212438144349907 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441040,273.7282542524421,0.05413142552128836 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441031,324.3407295803728,0.12781328717364016 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441052,238.73299314929577,0.005275759007866032 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,fruit,2441051,176.20598807386352,0.13716753899565726 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441047,1545.0272410177952,0.021714941732946524 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441049,2056.239687900936,0.10242265451271981 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441040,1670.2777503430425,0.012137613156895988 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441031,1197.9637972173464,0.13220738903037388 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441052,1578.2088407602696,0.01248661091796377 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_83,leaf,2441051,1942.5067052090212,0.07771144379970574 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441047,247.81991023472764,0.02354339916331405 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441049,275.4305152484471,0.02233246005263867 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441040,411.5131673041699,0.19670414151982385 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441031,246.827698189254,0.025285701306628106 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441052,1212.3444907256614,0.6659464487370013 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,fruit,2441051,243.5292845800403,0.031128401565458486 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441047,30670.648179744578,0.03817039670834088 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441049,16406.65483172343,0.30987330960408244 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441040,33962.68145276387,0.006108620768775275 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441031,39333.771981413774,0.0698722448689324 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441052,37130.30505568128,0.04483516635059548 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_84,leaf,2441051,33013.95700920213,0.006195769560868314 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441047,41.72718517161261,0.0024581635559974835 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441049,41.256156821518466,0.002472156321607022 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441040,40.128192973761855,0.014511322236638646 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441031,53.81885520462908,0.11297352998202825 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441052,35.661644488080846,0.06575955935039701 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,fruit,2441051,49.67365902645038,0.07816522632194745 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441047,383.2406873357334,0.015682799724316965 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441049,403.0876432270088,0.0062450748103675124 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441040,417.9156910742522,0.021934267363816762 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441031,391.577942830342,0.006336189645588686 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441052,373.7775120110773,0.02654124122809165 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_85,leaf,2441051,431.59223438178986,0.03591921172283152 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441047,1288.0938758335576,0.04989783458170427 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441049,722.538785424491,0.20118851611915956 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441040,1162.3733054820882,0.005295946775685234 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441031,1159.1575430819282,0.0040927848537992695 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441052,671.2847559110755,0.23314289584732162 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,fruit,2441051,1137.4123994656786,0.004131722436606644 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441047,14957.83800690437,0.016433465779055467 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441049,11932.11267149878,0.08171801410608026 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441040,14675.249517786344,0.008150134396283093 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441031,10251.001674437655,0.14766905527526575 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441052,18052.11962877701,0.09809284313113853 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_86,leaf,2441051,14129.583064987602,0.008306012834680132 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441047,244.64090263084267,0.015712811117358783 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441049,244.40184310326504,0.016137404848064918 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441040,270.81050388378463,0.028423623682368948 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441031,262.66729156719623,0.015164114414396579 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441052,401.88102127738114,0.19985561566858934 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,fruit,2441051,227.4542668415221,0.047347793344173716 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441047,25728.883820082337,0.039513289917746164 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441049,31873.79752774754,0.053499573725281024 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441040,25868.022719106673,0.03717100211049562 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441031,24112.10708125983,0.06769907214784165 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441052,30491.100931154466,0.03423886974874968 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_87,leaf,2441051,32470.917114982218,0.06156031928463701 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441047,59.596913937580446,0.1755202985639739 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441049,64.64400213595154,0.14021583419668504 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441040,101.36344981381735,0.055137312808753114 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441031,109.35692180833531,0.08810220701887173 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441052,191.3830400345452,0.33115937873558843 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,fruit,2441051,77.19239291462259,0.06316956615131497 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441047,1372.706873089884,0.04210252024142758 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441049,1687.7608462765488,0.04763057920833447 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441040,1604.5499510122777,0.02567291317614684 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441031,912.4986083279334,0.21944811764770433 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441052,1420.345188610388,0.027286423977775254 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_88,leaf,2441051,1718.528417326043,0.055476389536022186 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441047,7021.635533926274,0.002359032787080828 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441049,6945.561059257562,0.002371916771331417 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441040,6559.0264979064395,0.027239864954192505 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441031,23132.82380351808,0.5201493995808097 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441052,16289.52604910316,0.3678291981317563 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,fruit,2441051,4794.444715522618,0.16334093520542003 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441047,111250.86468583504,0.03953851890769222 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441049,91888.86580561363,0.04350198525260307 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441040,56178.02604795416,0.25719840113017245 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441031,79502.10815420923,0.10638623128882507 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441052,115603.8862973654,0.05620755789617693 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_89,leaf,2441051,177465.32943535532,0.24234864334551443 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441047,95.75135320428478,0.029622385979397148 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441049,42.298320709888515,0.3251994086175618 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441040,95.8201787614634,0.029934442376043258 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441031,86.18205434958627,0.016105692069439126 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441052,9.13711118109102,0.9907136248901212 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,fruit,2441051,92.69413319671058,0.01552971325525454 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441047,130.850029471629,0.008201068838245451 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441049,133.36985779214143,8.27944672883163e-5 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441040,140.1112534744659,0.02149812477794555 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441031,133.3190110312581,8.281025434309086e-5 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441052,129.96222420106147,0.011157758286825192 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_9,leaf,2441051,144.52071437369295,0.034955206011137996 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441047,50.603942075002486,0.016328090309632337 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441049,54.481471046895514,0.01573638514315423 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441040,66.3542039260951,0.10135600291533198 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441031,34.232454297072444,0.18607440323397695 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441052,152.7631030842605,0.4635060313886117 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,fruit,2441051,10.16845827844643,0.7132573292042195 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441047,2331.2821315992546,0.007400086582963095 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441049,2411.4098206682415,0.007276103708205195 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441040,3939.774442468937,0.2204764370063832 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441031,2653.1362642424833,0.04876463421119359 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441052,2318.582265778862,0.009772411833727901 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_90,leaf,2441051,2256.1629977908574,0.021624449272805712 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441047,477.805417634845,0.05070574492544111 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441049,453.31116920532855,0.02785109504172656 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441040,396.9949812999716,0.02976030823107756 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441031,535.0898598503021,0.09988139621306624 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441052,316.4279886857688,0.12827043406249228 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,fruit,2441051,273.97396662435966,0.19083602726518878 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441047,920482.4748359538,0.048467542457967916 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441049,620826.2392808761,0.12257791774559834 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441040,883315.3744285037,0.030567807675849323 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441031,763246.2053841237,0.032883328078913365 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441052,573838.814729705,0.15675806109345558 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_91,leaf,2441051,908857.915159279,0.04294801191723874 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441047,37.093262992205325,0.09578072230757573 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441049,155.11212588520382,0.5255699890908707 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441040,21.133667775399715,0.3401008850432399 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441031,2.596053049575018,1.2507621981082282 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441052,61.093939311818175,0.12092236815625812 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,fruit,2441051,55.39907481389947,0.07842675089587692 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441047,124752.92259331142,0.10825897290115538 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441049,169995.12176331625,0.2426447031446255 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441040,64809.762875070504,0.1761513232869163 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441031,66468.91967894179,0.16517313552109592 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441052,100745.32005518922,0.015433125150101645 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_92,leaf,2441051,93710.86058418085,0.01600182955649121 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441047,21.5558859445614,0.2918449663552847 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441049,69.08137636791385,0.21395013843775357 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441040,1.4259624358553322,1.4713027583257907 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441031,1.4686723497457914,1.4584859247517936 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441052,177.89591875455233,0.6247551413506536 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,fruit,2441051,62.863237622968406,0.1729859012039543 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441047,25.84298872947562,0.43156731169013063 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441049,77.39493531827664,0.04480249175226181 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441040,36.452555016910445,0.2821820757658966 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441031,139.5204923461986,0.30072795027912536 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441052,204.34380454358347,0.4664514250950411 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_93,leaf,2441051,62.222625216357535,0.049961719520873915 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441047,295.54980622357897,0.005735625803303002 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441049,287.79461490021646,0.005812389808842244 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441040,369.693978790722,0.10294732413472518 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441031,185.50626278608223,0.19653647693584153 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441052,741.6305261468443,0.40529254429900563 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,fruit,2441051,259.81631389794114,0.05022863614121409 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441047,3884.779714390154,0.04671338767375843 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441049,3994.701628674201,0.03459543829353473 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441040,4887.7761996412055,0.05303152738270667 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441031,4432.232143905495,0.010542714120303831 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441052,4334.98,9.073132097836556e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_94,leaf,2441051,4316.885922805928,9.092127066328004e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441047,140.55253539434548,0.05468811895493664 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441049,86.5757546121252,0.15575427955763566 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441040,136.76650415225828,0.04282918099615918 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441031,111.0787235184982,0.047519684863576384 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441052,197.59907033291736,0.20263433178532786 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,fruit,2441051,105.1413240979216,0.07137712318875211 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441047,33.88587919414803,0.23723057102609113 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441049,44.49306717588602,0.11895698391715981 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441040,41.493030398892245,0.1492741750210851 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441031,323.6143747047207,0.7427784751604904 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441052,147.70123605515863,0.4021348005323695 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_97,leaf,2441051,72.53211473771754,0.0932810106454236 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441047,1020.4794327992324,0.06388124058770117 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441049,1301.4390866450874,0.041738349173104705 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441040,2254.6653536500726,0.2803965945303961 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441031,739.1577691136324,0.20394835073179562 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441052,1686.5621926041188,0.154316863828043 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,fruit,2441051,1062.9311975563992,0.046180342764211346 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441047,20284.25005776023,0.0909774148040734 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441049,22163.48504985512,0.05249831942272021 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441040,52019.74205151013,0.3180318237875541 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441031,46498.01652757295,0.2692980569676484 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441052,27859.1270590969,0.04683113351417045 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_98,leaf,2441051,19863.671898283807,0.10007683748687768 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441047,6981.267670254013,0.027269002940094822 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441049,7886.072840475207,0.025657491516848374 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441040,6616.693930219182,0.050562246783439235 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441031,21225.058487896607,0.4556456030201743 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441052,21401.87974357755,0.4592486268012661 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,fruit,2441051,6896.760000869879,0.032558179326793724 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441047,65576.15892962844,0.04454556383412012 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441049,74591.77275749522,0.011399390307011537 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441040,82687.82588647856,0.05615003469665947 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441031,66191.21194742463,0.0404912054617963 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441052,73992.64384710671,0.007897007003576206 +1015695 Sl10g074590 #30.1,panK4-1,0.8,m_99,leaf,2441051,71326.06621003516,0.008043266083070932 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441042,6.792923264374221,0.5376990647865146 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441038,11.071854543060564,0.325535401848996 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441053,12.902112988458937,0.25909493258956484 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441043,33.95610507398695,0.16116209535781767 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441041,64.89205008978796,0.4424357213038237 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,fruit,2441036,37.01300523662483,0.19859857522657487 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441042,482.3295432843354,0.22138066728253714 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441038,28.97739757021628,0.9999038171780819 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441053,40.5864540837869,0.8535820865568997 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441043,97.09007035022036,0.4747883807592741 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441041,701.7650375425711,0.3842285310122957 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_1,leaf,2441036,650.1999650349339,0.35108374527440267 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441042,55.47979590225641,0.09976837096483848 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441038,55.491509321165,0.09967668828696308 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441053,100.87202075680518,0.15986749538652623 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441043,71.54712601373484,0.010688967514984382 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441041,74.4777652192021,0.028123411025992917 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,fruit,2441036,68.06824069399957,0.010958699813343964 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441042,328.2761677557349,0.011680137128092571 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441038,346.269399745431,0.011494622081827277 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441053,334.5806084365526,0.0034187254301687453 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441043,383.2171448453773,0.05552543882445704 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441041,339.8689702122191,0.003392023601697769 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_10,leaf,2441036,318.606548243934,0.024664794516416677 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441042,27.712143619599555,0.09193384704074625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441038,40.77892839648036,0.07583184090647443 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441053,13.53162961587928,0.40325386625010284 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441043,129.73326187930004,0.5784473695403556 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441041,6.968838520333898,0.6914435668315616 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,fruit,2441036,51.82620587471043,0.1799454477640925 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441042,1552.0660860067892,0.16118342326693824 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441038,2735.8953254868147,0.08500584482148632 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441053,2323.1715690521096,0.013987651590248174 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441043,2175.90752585162,0.014453198284854363 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441041,1265.4744639087571,0.24984024664503224 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_100,leaf,2441036,2930.836642212816,0.11489798001164431 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441042,32.80089498822066,0.007537008443011084 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441038,32.7348307733996,0.00666141476236537 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441053,27.99454031170084,0.061275344868749526 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441043,31.738288308740735,0.006765184436328564 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441041,42.6600130376736,0.12167229847721539 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,fruit,2441036,23.677427767364502,0.13401416497900898 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441042,136.7723174985896,0.5479464879847935 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441038,37.550718786171025,0.013433463202511486 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441053,494.5857740739344,1.106189902681058 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441043,39.910034030009186,0.013030380318002077 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441041,28.006344244941957,0.14079529505895505 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_101,leaf,2441036,27.612573927156724,0.14694482615732807 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441042,101.05404499127228,0.021151275460012275 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441038,157.4826087931326,0.1715276229257099 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441053,111.14087046108789,0.02016881628107603 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441043,96.53825222009807,0.041005545743225014 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441041,94.97202812042347,0.04810926517016756 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,fruit,2441036,151.76982211201997,0.15548044749744028 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441042,644.8097443728204,0.016306905206693312 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441038,608.180111363773,0.009092472911499616 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441053,631.7988950223292,0.007454175311770506 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441043,610.2957297853476,0.007584355477288529 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441041,676.033214958087,0.036843347579313956 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_102,leaf,2441036,596.4932972568636,0.017519118798927202 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441042,7265.978710283912,8.794704214309945e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441038,7295.436547134474,8.776930437153219e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441053,2548.017165284818,0.4559712420487245 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441043,2316.966587981239,0.49725382038966526 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441041,7823.983186651403,0.031254317060082304 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,fruit,2441036,22145.13715796309,0.48310478302896165 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441042,834086.398630906,0.011671605997816137 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441038,555557.0543347343,0.18815397871504302 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441053,793654.4936486655,0.033251165693477525 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441043,906804.3658569928,0.024630957142079524 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441041,879526.1780776634,0.011366125007022276 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_103,leaf,2441036,987267.1937534518,0.06155206067980856 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441042,7123.080491148387,8.794704214314386e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441038,7151.958987954975,8.776930437148778e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441053,2497.9059373602704,0.4559712420487245 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441043,2271.399375026098,0.49725382038966526 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441041,7670.110830497048,0.031254317060082304 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,fruit,2441036,21709.614183211463,0.48310478302896165 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441042,834086.398630906,0.011671605997816137 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441038,555557.0543347343,0.18815397871504302 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441053,793654.4936486655,0.033251165693477525 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441043,906804.3658569928,0.024630957142079524 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441041,879526.1780776634,0.011366125007022276 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_104,leaf,2441036,987267.1937534518,0.06155206067980856 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441042,54.55388734346268,0.0011724360843448078 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441038,49.17026807558908,0.04395069037771426 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441053,57.760998184839465,0.025981423355866173 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441043,56.8484862474583,0.01906563841107478 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441041,54.25973353402741,0.001175609802294364 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,fruit,2441036,37.33325187560379,0.16355744608070433 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441042,84.75354184095859,0.0367848857261448 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441038,55.76485097073392,0.21858219619402908 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441053,115.25024984861484,0.09669913346272585 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441043,99.73641861026098,0.03391102718117334 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441041,261.8898055469949,0.4531758510930204 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_105,leaf,2441036,84.50391309269538,0.03806592196224923 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441042,194.91344409437875,0.0032561481175248375 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441038,197.84717802114585,0.003231916522902001 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441053,198.71008188355353,0.005121958719715103 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441043,192.8294042362538,0.007924684133198134 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441041,203.317625045622,0.015077084468366753 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,fruit,2441036,187.28275876888603,0.020600145484487076 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441042,3380.9458656739725,0.024191129609377082 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441038,3144.8926799507108,0.007241257812020674 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441053,3165.337023251158,0.004427129970144161 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441043,3230.2009683269675,0.004382455521571682 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441041,3586.306987403597,0.04980037490157585 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_106,leaf,2441036,3111.0797700191597,0.011935940634034914 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441042,514.8813728818513,0.015337777056292357 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441038,464.2158190217624,0.029649467600481483 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441053,481.07569912961657,0.014155983694398522 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441043,179.5040866343406,0.44229506308656186 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441041,512.9540888185327,0.01370909261035802 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,fruit,2441036,762.0856465465929,0.1856343786432082 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441042,10889.9971218863,0.00516741856082259 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441038,10632.385208854224,0.005229643807195039 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441053,11433.980923781011,0.02633711689543805 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441043,8699.489347286812,0.09236658576971868 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441041,13383.000300160298,0.09469314128641848 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_107,leaf,2441036,8948.91533777484,0.08008994700630367 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441042,154.21388726789206,0.1053018879834946 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441038,161.99269373792268,0.12667383067727211 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441053,132.35485472536456,0.03891827910862977 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441043,98.48747129284088,0.08944060967704592 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441041,109.66533231556608,0.04275223758450597 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,fruit,2441036,108.2529196391431,0.048381978238280166 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441042,669.432776548497,0.11893254881643855 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441038,384.9355556792404,0.12138639570443965 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441053,521.7257154479647,0.01066781977136566 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441043,953.0166329000696,0.272326056890678 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441041,496.4070619120641,0.010936472344182047 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_108,leaf,2441036,183.02711347581095,0.4442589930108838 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441042,94.92799270863726,0.002303921802650599 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441038,95.93785042150772,0.002291764021162601 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441053,99.86185576333484,0.019701412982818356 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441043,124.53406813411505,0.1155899559188669 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441041,85.08006966429033,0.04987038260324783 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,fruit,2441036,69.18887913061057,0.1396619244081827 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441042,971.3678853802722,0.1278409490157486 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441038,1584.2251831765827,0.08459222256589793 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441053,1303.4832489307687,1.1923565934823799e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441043,1095.156465207413,0.07574851873700483 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441041,1304.1990905018542,1.1920293215306188e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_109,leaf,2441036,1587.1082976252465,0.08538187212390724 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441042,1187.825656316929,0.03849883344747651 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441038,805.9470036815583,0.12994738306916886 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441053,986.2961086940228,0.042246548420105334 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441043,491.27562513558536,0.34492865114302873 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441041,2175.0104078021677,0.3012074713766726 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,fruit,2441036,1579.180191352457,0.1621778196382655 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441042,6803.139493177679,0.5689752668765022 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441038,1857.06257189384,0.005092428059116028 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441053,1931.037905928095,0.02205668993402421 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441043,1676.6040528274618,0.03930359741501821 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441041,1813.7660113209067,0.005152849782477098 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_11,leaf,2441036,1550.0020130118623,0.0734018468562132 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441042,664.7990098990034,0.09241374201630181 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441038,457.02482577725783,0.0703368301889169 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441053,513.8145522812408,0.01947022174074542 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441043,266.3963332036797,0.30474837923601594 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441041,560.9333784482113,0.018634661599712832 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,fruit,2441036,755.0811020850892,0.14771697907324288 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441042,4205.247824154702,0.09474754626918758 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441038,3450.453457387765,0.008832125141117864 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441053,3265.2841467767116,0.01512306871777147 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441043,4150.455554226872,0.08905171900228881 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441041,3311.5290690522943,0.00901547681629511 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_110,leaf,2441036,2619.320412954452,0.11085542100437573 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441042,193.4683554360848,0.001018011365674365 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441038,194.37642131307516,0.0010156306676036841 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441053,143.7055962173807,0.13015427048703065 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441043,325.862963998949,0.22540705212025136 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441041,67.96637673762382,0.45533383288785223 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,fruit,2441036,443.4010647582029,0.35916878032069866 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441042,50947.685532547395,0.07218604502882275 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441038,41070.95452438807,0.021403618146595527 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441053,59940.78886203069,0.14278403976580734 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441043,44072.7,0.009231242757657299 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441041,42218.8778461283,0.009431728672097961 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_111,leaf,2441036,38193.01090295444,0.05295451765692505 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441042,1614.2113962453268,0.04437731510010101 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441038,1771.0228002878814,0.08464105838838298 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441053,924.5533590675268,0.1976511131732379 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441043,583.6695983582201,0.397416021208965 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441041,1300.6176569015936,0.049433448380209466 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,fruit,2441036,3230.1657932781222,0.345641719762976 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441042,3034.4738038262367,1.8568067733835796 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441038,503344.1948737518,0.36297489818353235 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441053,306867.72980774037,0.1480610544262957 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441043,373846.3080673672,0.23380293008837594 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441041,1724.4798621749055,2.1022320388188134 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_112,leaf,2441036,129567.86313592488,0.22639286968662287 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441042,200.74079622193932,0.0100541861043828 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441038,127.71123459204536,0.18635235303884068 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441053,191.55301062999024,0.010292474146896602 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441043,83.87395236537219,0.3689543476870105 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441041,363.50777479229754,0.2679322477835897 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,fruit,2441036,304.8456675548576,0.19149857093289713 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441042,378.9116745315539,0.3551129535139905 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441038,179.18231538251447,0.029870111335395855 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441053,139.94888591588017,0.07745558733190494 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441043,149.3793804059056,0.04913437913668117 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441041,155.36305830260395,0.03207727120013093 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_12,leaf,2441036,246.13523420706008,0.16774875443539727 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441042,82.82092129661336,0.001997475071138677 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441038,83.82747093116804,0.0032488313839538208 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441053,111.22741568206747,0.12607431436718142 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441043,83.58452184199672,0.001988330016857054 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441041,77.35315891429492,0.03165947841415573 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,fruit,2441036,15.665515383850138,0.7251928449193381 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441042,88.19330506333671,0.42090943769978906 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441038,261.1044774674953,0.05046926336005164 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441053,226.58780608433716,0.011108521467547039 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441043,274.80049404924347,0.07267245329502403 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441041,238.32879227249992,0.010831456326971356 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_120,leaf,2441036,212.9638765618296,0.03803911226321732 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441042,80.6395018965606,0.20112243746509506 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441038,75.31707068831673,0.17146802158577001 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441053,26.180440879919313,0.28744844322717933 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441043,13.13232551249592,0.5870837599449672 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441041,164.19866032723468,0.5099442104089 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,fruit,2441036,19.166924876592766,0.42287295837543826 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441042,383.8617570824057,0.0877084904180081 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441038,555.6740427243004,0.07293677268102527 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441053,657.4582354519663,0.14598483248023797 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441043,599.390302394907,0.10582637484366586 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441041,209.76933226523025,0.35014134155571774 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_121,leaf,2441036,204.6377830276421,0.36089751515271384 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441042,319.3684275893571,0.15350910453733402 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441038,201.5119547756524,0.046482059581855584 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441053,216.0283553461076,0.016272116204621767 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441043,110.31091937378548,0.30816437133205143 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441041,232.5237208072552,0.01568438833701613 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,fruit,2441036,543.3160871397878,0.3842696888108388 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441042,11630.197341513409,0.06876417081170016 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441038,10106.879103888436,0.007794157703198135 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441053,9002.150244475779,0.04247665613043061 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441043,12770.556933967386,0.10938692449798237 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441041,8382.465799875345,0.07345112289978672 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_122,leaf,2441036,9747.344502088134,0.007936597419037739 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441042,176.27961780225326,0.015256925447951541 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441038,125.09194711262558,0.16422967311626158 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441053,135.92391357690187,0.12816315525311017 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441043,208.9518957156638,0.05858728995491935 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441041,188.8852782253971,0.014739084521714574 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,fruit,2441036,788.4337170789444,0.6353061627704517 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441042,346.85299963087,0.15565337974251836 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441038,376.05950763456065,0.19076449815335783 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441053,132.94717953728255,0.26081294669961963 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441043,311.27224733651235,0.10864832628321386 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441041,136.6213766171434,0.24897341790961658 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_123,leaf,2441036,173.4824996348528,0.14523640386117886 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441042,5526.4682788786195,0.054319237491052164 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441038,6409.289860653394,0.010042993961523194 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441053,7281.149255572407,0.06543301463347628 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441043,3096.4677487516183,0.30590035809325444 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441041,6116.263306037357,0.010280745485599319 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,fruit,2441036,6423.7173972723695,0.0110195074248165 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441042,161825.2561955213,0.14631735101271826 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441038,89854.28339942612,0.10919016725863173 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441053,136840.79021662282,0.07348662121119887 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441043,93768.18373408169,0.09067344832050228 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441041,123816.30299140798,0.030048880113996645 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_13,leaf,2441036,107261.88210253471,0.03228353906483683 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441042,77.63095196161292,0.18869783971684306 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441038,72.08839658279224,0.1565282938071091 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441053,72.69899692188231,0.16019134655757084 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441043,2.877538837953366,1.2423158780972192 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441041,15.457777146745691,0.5121900302566555 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,fruit,2441036,28.458128939540085,0.2471307293192726 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441042,117.4004867929094,0.06197304135925519 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441038,9.655441243703242,1.022924730949101 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441053,63.38353115760522,0.2057204258353782 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441043,118.0917641250968,0.06452275407366148 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441041,155.29659753926111,0.18346508435821285 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_14,leaf,2441036,86.17564220421121,0.07231232775569918 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441042,76.68909319140202,0.02481605700289613 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441038,72.82026950850832,0.0023347364379289193 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441053,3.2467446713253794,1.3484694090653162 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441043,72.03941704931727,0.0023473556867412704 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441041,75.06275712176121,0.015506966901252861 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,fruit,2441036,13.007253631276118,0.7457319367611099 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441042,458.578702122325,0.1283649831863669 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441038,603.152653179437,0.00935162144860957 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441053,526.9998042379201,0.06796841012138888 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441043,629.4095892223233,0.009154491210741522 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441041,732.4653786219036,0.07500823774263976 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_15,leaf,2441036,777.7284074875234,0.10104909837675624 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441042,81.30349992329604,0.5062733930814893 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441038,129.59233348601597,0.7087434617326935 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441053,2.1575611107676416,1.06987274274511 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441043,12.337051511995854,0.3126244701782761 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441041,14.688795773614038,0.2368496556271802 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,fruit,2441036,35.994616237035515,0.1524016993525168 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441042,43.490027829492,0.10849763566359538 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441038,828.7325024888999,1.3885223220886622 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441053,24.26196058162677,0.14496615711400307 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441043,15.370192382634448,0.34321274648263356 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441041,111.19441667343992,0.51619093096291 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_16,leaf,2441036,3.158374702210414,1.0304283974955493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441042,2208.712169353134,0.029653667700023423 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441038,2394.0169809876256,0.005334434855822412 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441053,3535.5516815238034,0.17466439828223512 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441043,808.6117442058677,0.46605274701877697 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441041,2335.5653223233276,0.005400773346207366 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,fruit,2441036,8415.220942340973,0.5512727311829559 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441042,58748.059215115914,0.13308190307728118 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441038,44891.44324261963,0.01625194715726508 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441053,36621.78158704868,0.07217215270576904 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441043,41593.72140191333,0.0168838423169273 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441041,27010.276774837435,0.2043825864348996 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_17,leaf,2441036,68688.519075028293,0.2009725322159257 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441042,42.99948544867613,0.1277005356784493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441038,29.539711110417805,0.03535647924176999 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441053,34.55065000797121,0.032693499284326855 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441043,1.5847642569084792,1.305798055491773 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441041,95.51413402413912,0.4743049195531992 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,fruit,2441036,28.47894809707005,0.051238778876295576 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441042,2509.446965035811,0.2651469647921445 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441038,2075.766160709123,0.1827473708835856 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441053,2717.8810093105285,0.2997993822138909 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441043,547.2554419361257,0.39624096798133834 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441041,468.95404811706976,0.46330076774976403 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_18,leaf,2441036,649.8271365694162,0.3216332135056774 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441042,3.767586573534945,0.013618681451950998 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441038,3.5349636873915737,0.014059602187163844 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441053,2.0935712176231243,0.24155682008985763 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441043,2.181975621458606,0.22359466504955056 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441041,3.800047405117234,0.01734445532954565 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,fruit,2441036,7.724263589233421,0.3254125264979646 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441042,3733.477322135392,0.18161236491735933 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441038,2899.2022643761575,0.07177736242960009 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441053,3117.9974756833394,0.10337460648401597 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441043,1630.4703112583957,0.1781882574892215 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441041,2015.8840443568283,0.0860356053221234 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_19,leaf,2441036,1837.7094895349887,0.1262242948257981 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441042,473.42537646363706,1.2799569455853361 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441038,4.293490783183664,0.7624840526701347 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441053,121.21575199584478,0.6882644724893012 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441043,28.039423529499256,0.052474492994391664 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441041,4.558975379273349,0.7364273408051273 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,fruit,2441036,21.65693683514783,0.05969755774101948 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441042,710.4253364601961,0.1239433804886736 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441038,1120.5406418114271,0.07396579081826804 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441053,810.9517447779156,0.06646680958873619 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441043,1001.2219102613932,0.025068522810162364 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441041,888.9087100710957,0.026604660419269344 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_2,leaf,2441036,1128.7278456644376,0.07712741707913473 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441042,13.13190990906834,0.7534401104231163 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441038,9.129667020153862,0.9113130669214136 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441053,104.17793091475625,0.14600772259787398 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441043,120.57538853588828,0.2094906650131434 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441041,84.70575221037312,0.05614489843303061 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,fruit,2441036,64.16109841835613,0.06449621470279987 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441042,25.85372392690165,0.4223713895788561 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441038,68.86822636113932,0.0031244017069091967 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441053,67.88087851129815,0.003147042259188826 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441043,107.5422298147026,0.19668454047300332 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441041,101.96784733144158,0.17356875433980679 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_20,leaf,2441036,9.321339368314272,0.8654161766452282 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441042,8085.490620919505,0.05658819762018785 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441038,6687.6128023617075,0.02584705956196487 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441053,2713.2164119451572,0.41763374465360625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441043,6259.53607517397,0.05457603333816641 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441041,7507.804883181939,0.024394797366781074 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,fruit,2441036,10585.363348436911,0.17358758995529167 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441042,189257.09850256515,0.3172205476264338 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441038,384820.17907540424,0.0090148879153924 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441053,400962.98754471913,0.008831559950172263 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441043,438550.8900737114,0.04774727150922775 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441041,466258.0306023839,0.07435359968778421 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_21,leaf,2441036,378792.2017301491,0.015871695754070103 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441042,5.121981100878953,0.5042955759973291 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441038,15.018049196762563,0.037120024995452194 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441053,17.69820269839215,0.03419561712107111 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441043,26.56069778604897,0.2105059326890686 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441041,40.00752708381664,0.3884081602438343 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,fruit,2441036,3.995674080862027,0.6121434912030208 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441042,108.26042398793204,0.18640349161936332 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441038,87.38345752573692,0.09336299256780167 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441053,18.153494843480026,0.5891059858134464 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441043,216.3704882176791,0.4871317930222383 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441041,53.57665172314057,0.11909066314301109 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_22,leaf,2441036,45.05194807957424,0.1943526570612215 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441042,2104.5971633226927,0.10221348629576488 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441038,2502.2998493048212,0.1773838553562337 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441053,1798.081773335648,0.03385394432850841 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441043,1090.0862861393314,0.18349461837987846 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441041,1528.402618729487,0.036717721276937176 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,fruit,2441036,1420.6572719764104,0.06846617568985103 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441042,144881.494465594,0.011738506653165892 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441038,237267.61953249827,0.202487049307849 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441053,152820.2773577157,0.011429559792190958 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441043,176977.5417919328,0.07516673471360136 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441041,120365.5097085164,0.09224936449766652 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_23,leaf,2441036,138229.43319244267,0.032150896562280096 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441042,241.01016653798,0.01083031438630977 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441038,292.9608940567139,0.09560460390742342 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441053,209.89444246445072,0.0492041088423707 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441043,211.83531586900065,0.04520668374235459 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441041,229.138321830789,0.011107320358762163 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,fruit,2441036,365.6565889614085,0.19186835518491296 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441042,132.8961574256008,0.1761240368114314 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441038,123.028254582459,0.20963159803670717 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441053,166.0081127367939,0.07950714837478712 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441043,232.7104511185808,0.0671794273656583 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441041,604.090687278508,0.48146567995824663 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_24,leaf,2441036,253.0146022282775,0.10350912563426329 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441042,69.22870238752898,0.014330663992075054 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441038,72.0009179436986,0.03138250596635084 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441053,64.73450068364086,0.01481972483591587 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441043,73.26357465207376,0.03893257745337331 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441041,64.31806438850884,0.01762256122551653 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,fruit,2441036,51.19131773559676,0.11675921830755565 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441042,2862.8819620920176,0.12789895041487176 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441038,3763.673813902224,0.009090415237475113 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441053,3482.8320894460257,0.04276985542465317 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441043,3922.8926772352015,0.00890403418484631 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441041,4482.361621737378,0.06680449836948732 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_25,leaf,2441036,4174.961145749382,0.03595004543023661 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441042,251.38319654182212,0.033533420837299044 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441038,239.86080342833355,0.013156460540034942 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441053,261.70179920551044,0.05100388493121466 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441043,225.54609810722093,0.013567505193313067 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441041,201.5753097844305,0.062365487599662206 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,fruit,2441036,206.94613926426544,0.05094549478040511 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441042,5611.971560501371,0.08309392624378642 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441038,4656.3382742641115,0.002022988203146614 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441053,3940.336913843056,0.07048817801763851 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441043,4600.355728278632,0.003230119920630603 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441041,4613.059748697304,0.0020324556068476163 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_26,leaf,2441036,4987.681670287464,0.0318771923690675 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441042,96.07586258724724,0.03477104762877903 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441038,112.09279213894736,0.03219234725594289 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441053,85.65840750464044,0.084615343894618 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441043,123.28302548922072,0.07351794390317368 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441041,117.90253910389455,0.05413781803472828 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,fruit,2441036,84.15936985349994,0.09228286493528803 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441042,863.6740552990838,0.008446139694824328 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441038,928.8173576006878,0.04002658891038546 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441053,881.6974434658774,0.01741584760476922 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441043,717.4344046449561,0.07212153444819647 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441041,830.4052203504723,0.008613663217240664 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_27,leaf,2441036,703.8428313456874,0.08042804225573486 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441042,73.58946167802526,0.05732474948123101 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441038,94.35681153222043,0.05063288148954448 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441053,54.45348438298247,0.18811470074256142 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441043,141.03327533905343,0.22518121655960477 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441041,100.92343187687048,0.07985163470949197 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,fruit,2441036,29.964258156962963,0.44753684538816696 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441042,231.81659064428823,0.13559523138448037 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441038,331.75867475886804,0.020082541827834532 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441053,283.8036785622951,0.04772172537308883 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441043,845.1105361246207,0.4261737704545392 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441041,301.7750541280839,0.021056409209279536 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_28,leaf,2441036,756.7009522486044,0.3781845347917776 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441042,396807.8931826815,0.0641500526890102 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441038,287828.9165127592,0.07529582687704028 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441053,107142.117542328,0.5044700242745312 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441043,275964.21150279074,0.09357748562001333 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441041,426144.33100214135,0.0951264656641051 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,fruit,2441036,820065.8757710787,0.37941849086318946 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441042,771478.83199342,6.551270510479767e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441038,938845.4849069092,0.0846149806604064 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441053,542973.7493308829,0.15320030769859994 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441043,798613.6810925048,0.014357604497621246 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441041,773808.1180971902,6.541402895345882e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_29,leaf,2441036,564957.3282880714,0.13596349492258764 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441042,79.2868034205088,0.012591586605283478 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441038,74.7552566365444,0.012967585525167857 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441053,40.682395770232986,0.2772028018594468 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441043,10.72485121277062,0.8562180464181162 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441041,196.0603887913945,0.4057805372229071 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,fruit,2441036,100.39180343364043,0.11508893365399064 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441042,60.494568941403216,0.09492937025394932 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441038,25.152075350880544,0.2862131907966763 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441053,36.73917578353408,0.12165760722154362 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441043,194.88812716946572,0.6029983659334526 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441041,22.046940707210556,0.34343868210812833 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_3,leaf,2441036,77.27991229112212,0.2012796042825511 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441042,195.31840735006463,0.015273709384272749 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441038,158.40995742195773,0.07568698771483051 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441053,181.81886926540673,0.01583051239987565 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441043,199.16088810757756,0.023734589281594776 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441041,173.88715247536123,0.035201969293493285 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,fruit,2441036,316.53742957427056,0.22495560641969226 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441042,8480.510470872738,0.018908340566131 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441038,9033.404241515243,0.04633779104082514 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441053,7404.820969011362,0.039999091369885775 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441043,8682.8714907703,0.02914971923059806 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441041,6182.0217827220295,0.1183831231522241 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_30,leaf,2441036,7757.905032838362,0.01976919519499365 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441042,87.15371382361616,0.02022686271460472 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441038,79.22165494583984,0.021215124824753184 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441053,129.49558981487112,0.19219594262731432 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441043,101.30205772439344,0.08555923173999691 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441041,72.27977540604374,0.06104224101579847 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,fruit,2441036,41.410607620497395,0.30294743244961975 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441042,551.5453543290755,0.011460831363352408 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441038,513.7688607433222,0.04227428386638188 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441053,612.0793907214611,0.033765694411539204 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441043,549.9469499389072,0.01272126448861366 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441041,581.0429117393911,0.01116614527070725 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_31,leaf,2441036,591.5107121890283,0.018920551819449738 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441042,107.32578662860855,0.09897206978916184 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441038,217.95539208976345,0.4066356072080808 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441053,150.92188533694613,0.2470202113575617 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441043,63.58206152054022,0.12839740553902712 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441041,45.67688596840857,0.2720355223450013 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,fruit,2441036,34.38411941623048,0.3953741040146306 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441042,2377.617930842795,0.048586079919882064 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441038,2618.932269378673,0.0066038803707639815 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441053,2474.172897004041,0.03129810208308603 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441043,2860.203220582798,0.031668744074293986 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441041,3180.902001420307,0.07782214213329786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_32,leaf,2441036,2699.18785589283,0.006504964033058336 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441042,132.80066287651454,0.009478452404930948 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441038,206.15797473152273,0.2004783486927315 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441053,85.42355733030709,0.18214413743878355 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441043,86.78195167323608,0.17529237749854376 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441041,142.72986146167204,0.04079305383205778 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,fruit,2441036,127.06672802716486,0.00968994345254659 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441042,3756.01512396783,0.14256536911615925 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441038,2507.0170575202187,0.033004674342139495 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441053,2902.916843237982,0.030672632027848312 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441043,2259.914079570312,0.07807003533726142 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441041,3536.0190424347757,0.11635263193124068 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_33,leaf,2441036,2481.8356604811065,0.0373889427404257 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441042,386.9162470099591,0.00490972203153861 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441038,435.2305820011552,0.04619271538095493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441053,401.2387171880647,0.010876144640001861 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441043,394.8869802074587,0.003946126271616723 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441041,387.04851008690906,0.004761288593164714 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,fruit,2441036,387.7433673845675,0.003982310961199609 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441042,50309.47319053946,0.03590894651993093 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441038,44923.91334799334,0.013263242288375388 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441053,50062.29905668333,0.03376996706395552 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441043,43227.90307857906,0.029976654104530098 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441041,42413.64357881686,0.038235240682624294 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_34,leaf,2441036,47710.17223578715,0.012870161215259301 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441042,48.24478003449217,0.762716457888331 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441038,276.87477355732096,0.003883400146014182 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441053,104.57729222596792,0.42672939588217185 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441043,2685.7546711975724,0.9828995512261876 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441041,1073.1344827483058,0.5844873616387454 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,fruit,2441036,281.8485282543743,0.003848982855631622 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441042,44617.49928077386,0.2939886861406418 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441038,29660.619508314456,0.11666367852965465 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441053,23986.56407465067,0.024451503278227982 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441043,20843.853225452083,0.036538532807621316 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441041,21360.22437069485,0.02591072890663426 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_35,leaf,2441036,19778.563728352023,0.059321788188068325 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441042,3656.271202760166,0.11879895567389598 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441038,1765.9992678272947,0.19724892705282526 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441053,3367.224381992554,0.08303261122895567 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441043,3101.0163475026216,0.04726460945751443 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441041,2461.4761970632867,0.05304380581857826 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,fruit,2441036,1533.4120490192165,0.25858057476972496 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441042,30978.58523556572,0.23807180679797835 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441038,22263.55250640816,0.09460469093363777 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441053,18978.486380601953,0.02527179930451595 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441043,16832.787406451593,0.02683373479936879 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441041,15165.139923284689,0.07214335149142848 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_36,leaf,2441036,15763.523101729495,0.05533648567542393 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441042,855.2559124950279,0.0880138206138108 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441038,419.47069585635177,0.22138063809384745 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441053,803.842998628404,0.061088968877617056 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441043,788.3858851874132,0.05265657572782034 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441041,608.3434680798042,0.0599334152911184 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,fruit,2441036,484.1678926248392,0.15908627856958502 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441042,619.27970363021,0.07241824158723498 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441038,503.52165175797336,0.017450454784471603 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441053,556.2825076042877,0.02582679867317017 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441043,544.8097640482822,0.016776277354070057 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441041,194.59985516745832,0.4303260923151404 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_37,leaf,2441036,411.13992854931655,0.10547894894890142 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441042,13.28125506829294,0.18109562235086307 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441038,56.36870358754795,0.44670330687029014 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441053,10.376281826272043,0.2882929808688768 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441043,27.024284135330507,0.12741945864187354 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441041,59.35601117718376,0.469129968125517 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,fruit,2441036,1.7571956128067514,1.0595146295226314 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441042,30.990065526743138,0.4517273804456359 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441038,130.31059126609114,0.17202984036323632 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441053,155.4449633497238,0.24862677983665482 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441043,28.987348197014203,0.48074138766896035 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441041,128.94139488036336,0.1674424890954087 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_38,leaf,2441036,46.4385263329105,0.2760714454703652 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441042,101.94597807923934,0.16819911773781815 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441038,93.68555646676346,0.20489657390087213 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441053,134.80647375026405,0.04685846599801957 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441043,1022.4509576775532,0.8330732714223568 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441041,3222.903261173729,1.331678055277556 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,fruit,2441036,165.523868003454,0.04229141185371965 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441042,1872.0255224529335,0.08371995665184695 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441038,2570.4019474462634,0.05396931949074579 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441053,1938.615770361041,0.06853998075394951 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441043,2541.7299611792364,0.049097686202453694 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441041,1998.331349350396,0.055364220553626 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_39,leaf,2441036,2999.49350270539,0.12101620344305042 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441042,54.018175163551014,0.017294200784907288 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441038,53.36427141872725,0.012004876366647377 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441053,50.45445661507824,0.01234617475694888 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441043,20.14377525526636,0.41110484066908626 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441041,11.088435251930605,0.6703754431538222 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,fruit,2441036,88.71891876951464,0.23277053234003886 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441042,155.7045074936465,0.21143918089020142 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441038,356.7750458790289,0.14865410461712125 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441053,221.2101360024401,0.058935343277921604 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441043,291.9811250421645,0.061614411587957996 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441041,148.7677070194277,0.23123169683029854 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_4,leaf,2441036,285.5125658591292,0.05188486094679989 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441042,142.3808487731672,0.023002993618758794 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441038,239.80193141147788,0.24940409272510378 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441053,127.69054119545012,0.024289856287398326 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441043,119.15530525819808,0.05433520034969108 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441041,154.5583961364326,0.05864401844561229 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,fruit,2441036,99.47436023394852,0.1327374292673471 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441042,8646.360840510972,0.027300739501958216 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441038,8301.893028977127,0.009644516552338889 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441053,7497.541763065506,0.0346137230222463 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441043,8269.633432962704,0.007953642477783962 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441041,7847.737007008294,0.014788176023037725 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_40,leaf,2441036,7969.491098105805,0.008102026722394129 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441042,200.86691818399612,0.026727822894931474 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441038,176.88840171765625,0.028481235662395132 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441053,236.15232517117911,0.09701163249668321 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441043,256.7589419851813,0.13334498390968585 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441041,170.74142781269344,0.043841684672192294 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,fruit,2441036,134.38910908830644,0.14781651866893553 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441042,2460.582891246354,0.1280274789385496 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441038,1852.9785263507677,0.004859865394006846 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441053,1811.7390972364472,0.004914864555256138 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441043,1542.0691504695112,0.0749066719692153 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441041,2036.7159353102395,0.0459199402999948 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_41,leaf,2441036,1335.754239675091,0.13728395973198815 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441042,44.38121637324475,0.0029039889528086338 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441038,49.21964611323552,0.04203529693310726 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441053,38.74965254497845,0.06183537720142418 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441043,44.86055453317784,0.0017614478195111527 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441041,45.44207396066523,0.007354954316887596 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,fruit,2441036,44.49739313609207,0.0017686211507119687 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441042,181.563677334239,0.01227708571249142 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441038,177.98206431629504,0.00362435509433201 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441053,150.75588287390272,0.06847761610635539 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441043,175.0237674902436,0.003654856460828082 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441041,181.11069558421104,0.01119221404010906 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_42,leaf,2441036,146.35258573229763,0.08135148463497233 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441042,1201.7510292928926,0.6433776942771439 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441038,350.75011154355934,0.1085610093178424 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441053,195.59467619548352,0.14507977875037525 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441043,0.37925383173719646,2.857506831180925 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441041,113.61458038436707,0.381002739670969 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,fruit,2441036,371.6069299809312,0.1336469959240798 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441042,271.51498646330384,0.10371925600659049 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441038,301.40837281657645,0.05835774938360361 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441053,338.437108894899,0.008035085360881933 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441043,435.0401789232485,0.10101630707334808 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441041,440.3783674048241,0.10631291529900411 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_43,leaf,2441036,351.07684167512997,0.007889120955780093 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441042,93682.26356557244,0.07329993625419373 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441038,74649.14913259886,0.02533257752305662 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441053,24438.323656571683,0.5102860272060648 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441043,45265.06810767839,0.24259426126410055 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441041,83616.78123093185,0.023936006247729402 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,fruit,2441036,335988.491317234,0.6279669622381716 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441042,615296.773147877,0.24994995896059002 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441038,532443.5024469193,0.1871388530633702 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441053,309632.42956983414,0.04828823799626658 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441043,351185.8139187449,0.00640228582229696 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441041,296952.4122654613,0.06644782094824819 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_44,leaf,2441036,340907.53267348575,0.006498081045557491 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441042,107922.54335353436,0.011494372367930161 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441038,117003.80149747278,0.04658217316127011 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441053,35295.85959494826,0.47389403604182956 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441043,70174.48478616255,0.17543856643217826 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441041,102284.7570818775,0.011806881118159751 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,fruit,2441036,347458.36099431204,0.5192849674940154 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441042,190413.38612394323,0.4545386001292897 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441038,140379.57926629606,0.3221450604098335 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441053,65764.74006694708,0.007165768118921001 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441043,66035.6,0.005380747839978106 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441041,50695.17138244698,0.12019228044867081 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_45,leaf,2441036,67682.09192162153,0.005314897396950791 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441042,6952.595350479964,0.013643392318307246 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441038,6522.553058422725,0.014085940732185165 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441053,2425.1046818786504,0.4437730712703991 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441043,5690.960551666283,0.07331798613825757 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441041,11161.673902399172,0.21922576875605282 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,fruit,2441036,16619.205454144947,0.3921066954700785 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441042,74822.61052047102,0.21961931399193269 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441038,32390.84452203551,0.14399127097640108 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441053,55302.82430920244,0.08833376880835608 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441043,25142.04701808394,0.254012908206823 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441041,37359.859687262186,0.08200830595681108 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_46,leaf,2441036,52889.37714428692,0.0689549101130833 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441042,155.76560402759935,0.0375438585468757 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441038,169.32690480182563,0.0012894522916155893 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441053,170.33388705834207,0.0012856351434247237 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441043,71.37956388939429,0.37644153188642004 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441041,282.12939392007695,0.22043291380992258 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,fruit,2441036,227.84473399477503,0.12762357342272734 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441042,591.5603868069288,0.10294361554211573 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441038,431.3432432624288,0.03423246924214185 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441053,434.1739519478307,0.03139170408568592 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441043,459.9087916013656,0.006383757089887698 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441041,473.5291814254477,0.006291279033022068 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_47,leaf,2441036,563.711364466751,0.08200132161802554 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441042,72.76301654987884,0.06413343917405245 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441038,101.20266338887556,0.20741468592923784 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441053,31.27084901232207,0.3026375835975317 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441043,101.02568956855713,0.20665456726039677 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441041,41.779441829115065,0.17681462268321835 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,fruit,2441036,52.78424719886802,0.07527292412620867 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441042,3468.740836270078,0.025417872438410427 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441038,3741.8364853341072,0.05833082461689054 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441053,2299.658735230548,0.15309058834514389 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441043,3499.8180166430343,0.029291481805879815 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441041,3074.3654701090845,0.026998487026098417 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_48,leaf,2441036,2699.451490349705,0.08347845318542024 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441042,31.438680691314676,0.0063365102003065665 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441038,31.356877331062694,0.005205004432259797 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441053,29.25206506785649,0.024971271804885786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441043,30.609741280963835,0.005268143718515805 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441041,32.402342628862556,0.019448607425394338 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,fruit,2441036,27.312088252564937,0.054772895503317987 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441042,32.090145087248196,0.005706014997901798 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441038,32.93894710844687,0.0056320172099872945 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441053,30.00374035264477,0.03490229715251747 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441043,35.49446170563784,0.03808289858175118 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441041,33.38697995222901,0.011499440705504682 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_49,leaf,2441036,30.443783128576538,0.02857907613704702 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441042,1254.4453263404394,0.15882761382744137 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441038,492.8514690392568,0.24690806858334957 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441053,611.5918212571495,0.15316245496261072 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441043,268.86697721423934,0.5100866594021847 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441041,1128.8283963612612,0.11300380184957382 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,fruit,2441036,1812.525310660491,0.31865995593241925 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441042,30330.017091918933,0.03809567836324668 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441038,29085.087115427352,0.01989339224570763 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441053,19441.169797266375,0.15505458331739597 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441043,23430.94867682532,0.07398710393336394 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441041,26493.327307271364,0.020640471750779987 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_5,leaf,2441036,29072.39604525964,0.019703849592510814 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441042,120.05684550150625,0.016079283076682493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441038,111.32945403641445,0.016697565709778317 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441053,97.75014775081006,0.07319022247692097 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441043,161.39704457744517,0.1445879328859898 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441041,128.81546901279305,0.046660374118966175 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,fruit,2441036,99.8700687478576,0.06387229615490253 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441042,4708.228325318665,0.046215130548298955 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441038,8930.682077422305,0.23181198290837113 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441053,3979.4312818858866,0.11925163675720629 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441043,5331.592448165177,0.007784297819047659 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441041,5142.168128383475,0.007926374085599708 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_50,leaf,2441036,5548.768384645319,0.02512395065519657 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441042,38.06112690764733,0.049542458870374784 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441038,40.44889504335136,0.023117439196342016 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441053,45.6600596264549,0.029512372758044636 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441043,59.57491478336053,0.14503932826711097 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441041,44.87174352509998,0.021948843165269682 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,fruit,2441036,28.02876765026724,0.18242009811545912 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441042,330.93525867827907,0.061105422640612694 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441038,275.811740149572,0.018024869486482853 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441053,251.96103389753785,0.057304236048732804 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441043,299.187953731131,0.017306485637104352 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441041,331.71504204143724,0.062127547787624415 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_51,leaf,2441036,274.46449586445044,0.02015144479388331 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441042,163.6947182610694,4.2646326716688776e-5 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441038,174.6086805458455,0.027988517434814675 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441053,163.72686843333122,4.264213939464412e-5 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441043,273.2769236048323,0.22252564688634147 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441041,163.17860515134643,0.0014140966458744408 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,fruit,2441036,143.6958141395557,0.05663319579536408 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441042,1631.033604512392,0.04108499761309892 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441038,2085.777919452863,0.06572015899845463 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441053,1493.9557864515173,0.07921016185624286 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441043,1827.5706772572096,0.008326274732168404 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441041,1758.1619443364134,0.008489031147105308 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_52,leaf,2441036,1989.97940886215,0.045300676006952756 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441042,108.56231991733216,0.02658641432137987 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441038,92.96624515869428,0.09394023924323558 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441053,74.26145258157737,0.19150208977300487 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441043,122.26942013285442,0.025052322846503827 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441041,231.2930662494525,0.3018970838900219 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,fruit,2441036,174.16345917973163,0.17869151223131619 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441042,556.1174047767986,0.2186577188939003 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441038,380.8577206161372,0.05425399539937059 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441053,214.5931866956689,0.19489283942855495 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441043,291.4045904429805,0.06201237963792172 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441041,432.2606874955261,0.10923697137212374 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_53,leaf,2441036,270.8418732927762,0.09379295952942313 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441042,598.9303497978445,0.03333167634821477 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441038,421.8869327177531,0.11884857043938535 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441053,510.4351103957662,0.0361041046572792 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441043,258.7672710593649,0.3311352986333227 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441041,730.8658420990529,0.11979302063621411 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,fruit,2441036,1505.0686493399628,0.43351166502139593 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441042,10321.66639339658,0.054317771576848806 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441038,10593.05995626058,0.0655893838267092 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441053,6711.710262750966,0.13259884634718944 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441043,6642.960469939166,0.13707037844456105 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441041,9382.039666933872,0.012865218245857069 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_54,leaf,2441036,8834.338864158914,0.013257992809053487 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441042,29.529075825530047,0.5814574312167129 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441038,169.67698253625744,0.17791564603146925 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441053,66.6891507067238,0.22765209956776422 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441043,158.59844587759946,0.14859164107016642 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441041,15.39501921192612,0.8643270510269736 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,fruit,2441036,175.1028443353383,0.19158591449664186 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441042,133.4137790227088,0.026157438886360573 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441038,117.8172300864818,0.02783443895515525 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441053,157.0343448601664,0.09695139990842883 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441043,63.10360731354834,0.2989890607305161 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441041,145.5653770888784,0.06401484266211988 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_55,leaf,2441036,72.72979071388336,0.23733090924550626 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441042,176.47875142250234,0.06425199126601111 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441038,143.6853070773169,0.025028070762280752 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441053,221.4714506324715,0.1628773190483339 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441043,116.0940446952194,0.11763048903226547 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441041,160.73276199552663,0.023663976357795047 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,fruit,2441036,98.8595038025708,0.18742200491988426 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441042,1968.3517550266272,0.26388875599116046 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441038,946.5649188189924,0.5818410629823196 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441053,1030.03127509021,0.5451410562832777 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441043,5259.703492783305,0.16296979442215243 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441041,5509.20882756888,0.18309776691948132 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_56,leaf,2441036,7155.916769658268,0.29667381287558703 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441042,158.3324374376718,0.05963278091474056 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441038,170.92797055845216,0.026389542204925398 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441053,263.61907787542697,0.16177415811054185 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441043,137.56615295649837,0.12069108606483114 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441041,221.36700856122576,0.08591021782464603 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,fruit,2441036,192.34465610229904,0.02487744638862477 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441042,220280.31047784103,0.22803981298205755 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441038,94327.44903731727,0.14029777728099635 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441053,150613.83636241587,0.06292900384970501 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441043,77682.22052384638,0.22461423569162253 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441041,337450.6713472284,0.4132744295417492 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_57,leaf,2441036,109981.03397249436,0.07361806862281917 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441042,503951.99562164926,0.7602625947300963 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441038,231260.8386671526,0.4219755216848906 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441053,52890.39202977411,0.21874978852089288 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441043,68129.87475792941,0.10878898400986348 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441041,98806.24742512128,0.05265783088982534 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,fruit,2441036,76241.51764272433,0.059935041930251565 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441042,300877.3466820568,0.11670142247223314 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441038,363691.5526643418,0.19904514587854294 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441053,187137.64463443417,0.08952690906218841 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441043,247868.24597725665,0.03253282543967728 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441041,187936.3653169059,0.08767724472865002 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_58,leaf,2441036,212089.6341922426,0.035168625046109625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441042,1103.1496848204797,0.033454376196632385 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441038,999.3049351698462,0.0763907892152198 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441053,1279.821644127011,0.031060629170777343 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441043,603.6075910019815,0.2953341285901834 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441041,1383.0354760909013,0.06474449885301636 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,fruit,2441036,1512.6819370958806,0.10365879958775359 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441042,1941.7114580928348,0.14631363749826454 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441038,1502.679031844262,0.0349951704653364 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441053,1101.9086907766955,0.09972544753861401 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441043,1871.937441458329,0.13042027498932418 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441041,950.765113883283,0.1637978179850852 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_59,leaf,2441036,1270.0092793558597,0.03806416175517624 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441042,157.97977789961828,0.01994944196796755 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441038,66.98855546808481,0.35265144413075045 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441053,143.7943841153641,0.020910131934589238 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441043,96.45671540156086,0.19431958795969906 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441041,161.14356441633456,0.028560908837592436 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,fruit,2441036,1021.2287551524636,0.8304709779534631 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441042,215.0391641389195,0.15619218477513463 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441038,188.5408144372567,0.09908000027412056 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441053,45.57845323255184,0.5175657957771043 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441043,137.0620020725089,0.039408307199389814 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441041,136.29891655371904,0.041832974869628003 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_6,leaf,2441036,163.09976550323543,0.036127958142177174 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441042,47.617143244244325,0.19437616522602186 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441038,324.1452229765564,0.6386001237646701 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441053,28.294347047731534,0.42043982577831995 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441043,171.15555973856468,0.36125150922948346 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441041,101.37710303597773,0.13380037471853634 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,fruit,2441036,47.20482771447383,0.19815308498774797 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441042,14.44851593693774,0.6325102760397305 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441038,39.01337156996901,0.20112003330816952 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441053,14.293657086890198,0.6371901584398356 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441043,111.19857086200815,0.2537656883208308 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441041,145.717343291235,0.37117772726050924 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_60,leaf,2441036,84.97002019961467,0.13693220414245433 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441042,138.00080627301713,0.08069732977390842 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441038,106.28837348564116,0.03269853284751134 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441053,127.67610216744652,0.04692532159210483 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441043,122.91145572278025,0.030408068333344307 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441041,105.26083127098076,0.036917498584248865 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,fruit,2441036,68.24656028372172,0.22510352675858591 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441042,1089.359751382808,0.1128707530448092 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441038,857.4055358307255,0.00888571090830581 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441053,743.8119085196375,0.05283744510717936 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441043,676.2440071682764,0.09419714285218861 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441041,1080.4643778628651,0.10930988078351955 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_61,leaf,2441036,822.6768086316688,0.009071317633853937 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441042,2961.2538795628366,0.008984275670842035 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441038,4446.441330146269,0.185521199232483 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441053,4378.802425469666,0.17886398294002026 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441043,1208.4886733019282,0.38024878274496476 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441041,2663.4978151831924,0.03703902215563426 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,fruit,2441036,2839.9931986704246,0.009174067050645718 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441042,950031.5615201948,0.02319032277219346 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441038,1250381.650983488,0.1424948812106681 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441053,665735.8367962535,0.13124577488484324 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441043,851233.8363957964,0.02449883226816585 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441041,1120887.696417513,0.09501439140416412 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_62,leaf,2441036,836408.6097696023,0.032129216010302386 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441042,252.84734676530584,0.7980791674887611 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441038,1294.3539284066542,0.08888452209976494 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441053,741.4066998904406,0.33088106193237943 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441043,2089.195411879978,0.11904149515937767 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441041,1882.2828803527584,0.07374732403695994 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,fruit,2441036,3827.2934370116454,0.3819541924354608 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441042,12906.437441715503,0.1735072581140118 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441038,8312.982774864495,0.01754224196686982 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441053,9465.363148056837,0.03883815818018643 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441043,6182.4830067303465,0.14613619125198696 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441041,8093.718416252647,0.029151031541194694 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_63,leaf,2441036,8998.294727721142,0.016861091248615345 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441042,1318.56530755495,0.02911862918376018 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441038,1321.774168911997,0.030174244553748952 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441053,1147.5479131035638,0.03121218825016614 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441043,313.9512240432361,0.5941208351206431 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441041,976.7821350245669,0.10118530783193647 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,fruit,2441036,2317.4515724781663,0.2740276517492295 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441042,5434.8683443313585,0.00503803647869816 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441038,5561.697024665326,0.004980262267483049 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441053,4932.915111901087,0.04712342259832347 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441043,7836.971323319488,0.15392119305508078 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441041,5203.469841290222,0.02393402278119039 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_64,leaf,2441036,5907.60864096524,0.03118465249087432 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441042,60.81255801765051,0.08326504032546334 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441038,62.5325456457637,0.07115220347997675 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441053,84.79647703640019,0.06111949711336839 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441043,37.121722767353205,0.29763018925726126 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441041,134.44313542913147,0.2612803200854088 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,fruit,2441036,281.3612155022635,0.5820059192261049 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441042,530.8699862872544,0.5541757076739029 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441038,2204.6190417788994,0.06416967412018604 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441053,1679.9046992657509,0.05387923510468795 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441043,1962.9402238192624,0.013743194434945316 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441041,1864.5145191528657,0.008598110467294973 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_65,leaf,2441036,1939.0770468656392,0.008431185513576356 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441042,1351.307782869689,0.16460766363443735 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441038,859.2099807934383,0.03204730120521715 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441053,979.9314128893336,0.02504906526609796 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441043,338.6369480754321,0.4364122730039388 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441041,870.0893823009633,0.026582745467478297 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,fruit,2441036,1996.352108051392,0.3340905282505724 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441042,4228.7917516888765,0.039199605910634094 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441038,5027.688954927005,0.035952497001660255 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441053,3101.298596477518,0.1738723219962086 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441043,6434.205704043058,0.1430790367480519 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441041,2833.3937845766623,0.2131089677154181 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_66,leaf,2441036,5410.869446534373,0.06785115079883886 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441042,766.2880840610864,0.12242676074381365 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441038,429.8500490598273,0.1286483308545976 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441053,600.7227246440295,0.016708749618758567 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441043,217.7621670241845,0.42398288180549404 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441041,611.1930966169251,0.024213128773726833 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,fruit,2441036,555.3770250556236,0.017377401688389416 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441042,3424.751783487571,0.32832032396258093 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441038,1996.969127041716,0.094062574223297 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441053,1726.689470235969,0.03090546403806904 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441043,1424.9423202947614,0.05251149148969514 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441041,1489.4788682077624,0.03327443044974698 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_67,leaf,2441036,1426.7352893307147,0.05196537319180772 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441042,262.41960004855406,0.0861609721882517 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441038,171.2592805132084,0.09918118191239289 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441053,230.3510054433905,0.02955481515166225 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441043,268.55447657762045,0.09619709903266171 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441041,200.04208718320805,0.0317139198570624 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,fruit,2441036,132.2322796044941,0.2114978120888047 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441042,1443.8298596007992,0.17180997346441806 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441038,1335.5775965829316,0.13796307976881028 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441053,883.6241522395648,0.041438467674591806 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441043,974.4538991466198,0.0010552520411377664 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441041,767.4528659607178,0.10265433342523256 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_68,leaf,2441036,969.7241766139956,0.001057822347204418 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441042,37.99089973443904,0.2523459041218912 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441038,45.73171356844399,0.17180800843785016 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441053,90.11698393115074,0.12278116501677983 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441043,110.78836738523373,0.21246867935931713 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441041,39.02279698431756,0.240707088635274 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,fruit,2441036,183.88209736643392,0.4325139655380168 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441042,67.66744940422429,0.36628516386089416 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441038,93.40262793965177,0.22630587520762413 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441053,221.15119402075376,0.14802431776928104 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441043,61.05680586058991,0.41093088997041405 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441041,320.55063771778225,0.3092316744769139 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_69,leaf,2441036,249.7025276745169,0.2007579678764584 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441042,107.4717443826641,0.10861518530273329 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441038,55.707109209604155,0.17676849035489406 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441053,59.91039265024908,0.14517694675282988 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441043,14.768512548436435,0.7533423563553305 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441041,279.7852453334455,0.5241456952420152 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,fruit,2441036,181.72548796955036,0.3367367309982676 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441042,251.55720725425823,0.03197255558860279 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441038,290.9289317267273,0.0951227032254578 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441053,286.16800046010997,0.0879568599440459 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441043,163.89097592292012,0.15410916769167748 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441041,137.08360808849034,0.23167868233962707 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_7,leaf,2441036,215.84870842067593,0.03451475472919663 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441042,626.0260099957868,0.029822272201043276 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441038,386.78212519229305,0.23894825443751433 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441053,18.516830533879908,1.558847997838895 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441043,945.6273001929184,0.14930535200770167 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441041,715.0229862634154,0.027905353783712616 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,fruit,2441036,863.0114797579887,0.1096019229671259 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441042,442220.65443680965,0.11471551620851628 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441038,577181.75,9.5805145291461e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441053,574638.0366390042,9.601695830694368e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441043,559585.2921849864,0.01248824793478942 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441041,731920.2003779918,0.1041091943231729 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_70,leaf,2441036,635849.0911801765,0.04299951572624661 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441042,148.30921474450827,0.02463731489728005 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441038,213.33224940218128,0.13325106230182948 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441053,165.62268344028806,0.023314366520820418 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441043,103.40155937330992,0.18127836204327075 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441041,118.60907479267192,0.12168753212260075 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,fruit,2441036,260.82981336875395,0.22055178028592026 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441042,1924.8289314856904,0.02041972925920721 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441038,2061.76212434223,0.009426690098027546 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441053,2012.5009950490503,0.001075763275014019 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441043,2022.4834301369904,0.00107310515304615 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441041,2010.120046503195,0.0015898723224392342 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_71,leaf,2441036,2304.379880513748,0.05774220771122929 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441042,90.52293557978211,0.09063891407251856 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441038,132.54006455286208,0.0749496344011904 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441053,78.80280468063864,0.15085586857978273 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441043,170.6584896290046,0.18473035432259133 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441041,79.13478262326538,0.1490301296484462 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,fruit,2441036,180.2454871359309,0.20846685658283493 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441042,371.42638949280246,0.00542155760645624 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441038,362.21055728451455,0.00549009464073924 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441053,355.5853956924843,0.01350728342182661 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441043,487.65775170132537,0.12366393295242784 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441041,316.15705694274436,0.06454831895863222 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_72,leaf,2441036,511.1630328640653,0.1441082391527435 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441042,66.93354703075337,0.08983588776542661 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441038,110.2320001042124,0.1268279594556918 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441053,90.81978671747676,0.04270074957817904 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441043,57.935516577063694,0.15253484441687815 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441041,73.8104959062936,0.04736160487827501 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,fruit,2441036,151.31674293818523,0.2644072565373681 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441042,1761.7860344441224,0.03126837444601538 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441038,2091.804228464869,0.04329949907672459 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441053,1686.40398618526,0.05025991740376279 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441043,1967.422824303404,0.016676167895981475 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441041,1882.9546576078292,0.0023816753507901467 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_73,leaf,2441036,1903.6636748803433,0.0023686854234861165 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441042,258.87978118298213,0.05451897086841262 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441038,197.7972379711833,0.062358939137087344 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441053,193.96044518955705,0.07086598971521241 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441043,132.11853587275027,0.23761540974971807 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441041,310.0340891873978,0.1328302864753601 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,fruit,2441036,354.77401207017346,0.19137263737779175 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441042,1057.3348428105598,0.0015982786655190928 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441038,933.4689557269506,0.05251438602824354 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441053,1049.5667959567634,0.0016041823401478084 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441043,1090.242684259311,0.014908915884396912 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441041,1035.24200240453,0.007572381155056984 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_74,leaf,2441036,1173.2649036325015,0.04678181436192741 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441042,143.9318388485484,0.0354945334016068 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441038,129.80416804578724,0.00937370250088243 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441053,131.93977336598812,0.002286606744594799 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441043,122.27946918914834,0.03530879569738321 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441041,133.33279128595154,0.0022746305447713944 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,fruit,2441036,240.90502537799247,0.2591835191559593 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441042,16008.569944447769,0.2383102123460783 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441038,9096.202074891551,0.0071822257379579035 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441053,10120.01537883696,0.039138846969372754 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441043,9377.771907839371,0.006057339834780517 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441041,9117.9940450246,0.006143021280944794 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_75,leaf,2441036,9021.324636971263,0.010772014098647809 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441042,24.279287664801263,0.37110886019707134 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441038,75.4273792553449,0.12118421737028573 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441053,489.4897650990385,0.933398814500507 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441043,11.057909432501985,0.7126717723097586 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441041,64.6153417462632,0.05399084469319515 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,fruit,2441036,49.50808315940495,0.0616686891682654 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441042,203.60886939004232,0.08675535322043393 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441038,314.6292361304734,0.2757577367605166 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441053,161.58632385190805,0.013636738422092343 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441043,116.52607957389948,0.15561820391261572 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441041,165.6398682089123,0.0028764628395325786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_76,leaf,2441036,167.84131581450495,0.0028575364483409693 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441042,697.6088859001997,0.023289691751346986 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441038,678.6484844602727,0.035256812028485296 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441053,716.8477727436685,0.011474755384299762 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441043,779.1650628155776,0.02472777526049752 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441041,755.233172770972,0.011179362003840065 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,fruit,2441036,755.6914956723775,0.011442839220503931 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441042,22014.07086860083,0.15747350543145977 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441038,15292.866508422168,7.379572247225852e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441053,14785.087021606896,0.015402969782352116 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441043,15344.88225086333,7.367054077391799e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441041,15404.899279215304,0.0024320083357372013 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_77,leaf,2441036,15283.763658661646,9.965414778454473e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441042,64.09883251778469,0.0010347502780454487 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441038,62.31959020659773,0.011190780273114598 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441053,61.62996124253936,0.016023474553037653 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441043,63.79375227511595,0.0010372215639018467 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441041,65.20105253075687,0.00843923737139618 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,fruit,2441036,1630.6504742532345,1.4065455119399215 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441042,105.11994994777598,0.008009159327059034 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441038,101.27828630388336,0.008159641918707994 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441053,95.40092175713838,0.034123415254269984 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441043,112.2293996144998,0.036430653508287225 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441041,105.4638848828458,0.009427778922132202 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_78,leaf,2441036,97.94493682572002,0.022693995648603194 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441042,130.6449173654146,0.018626276407139652 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441038,121.84218227315104,0.011668573214376199 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441053,123.0004983978137,0.007559370906679241 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441043,103.72920906092853,0.08156517571353161 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441041,127.31989794427034,0.007430039721796788 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,fruit,2441036,131.57211791861246,0.021697623482051842 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441042,271.0001940705067,0.002495013497632481 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441038,260.8379695944861,0.019093804452935625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441053,248.95182458128824,0.039349301791358204 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441043,283.3724020964461,0.01689293624266286 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441041,292.69302549197926,0.03094775848172837 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_79,leaf,2441036,274.1229374024224,0.002480761531077569 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441042,67.48374933794217,0.018325833366016342 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441038,89.20505694565529,0.10286443782071508 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441053,80.56569087488249,0.058625098678114496 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441043,45.955774816088926,0.18518494425128562 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441041,44.60812392270794,0.1981110784073532 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,fruit,2441036,73.30081221204038,0.017583749907920776 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441042,584.9693932440194,0.07603428961364589 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441038,487.4146336113202,0.0032002900828436154 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441053,494.6246245941347,0.003176879740731664 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441043,438.34984446265986,0.04927799712446923 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441041,586.1283485882838,0.07689387298934891 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_8,leaf,2441036,397.0171184637619,0.09228962097180426 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441042,48.04812774776825,0.06113850907456775 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441038,50.8337832509475,0.036662545793362034 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441053,60.37895304171179,0.038070599568081454 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441043,60.16698009499647,0.03654323529188663 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441041,52.25963504925269,0.024648606066667966 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,fruit,2441036,58.363248363551165,0.023324477111772657 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441042,123.9933157806896,0.03373378056143528 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441038,134.59586662148757,0.0018996686535395213 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441053,127.0721463907927,0.02308168874714278 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441043,167.25114034171548,0.09623703307955989 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441041,139.57891455980658,0.01768776224612223 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_80,leaf,2441036,133.42095344102063,0.0019080146065602044 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441042,726.509331917045,0.023483444002005083 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441038,681.4482798142488,0.00432485354510348 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441053,695.0882747955219,0.004282209484033128 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441043,208.73343500053,0.5181657330316449 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441041,612.3302392337041,0.05077204601823171 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,fruit,2441036,998.3336061877034,0.1615179375791267 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441042,6076.097804000125,0.001265083925357402 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441038,5296.51250394536,0.05836967005197513 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441053,6750.6545548796985,0.04698621285061 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441043,6053.196533362086,3.748972654347149e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441041,5834.547958202335,0.01635245798838625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_81,leaf,2441036,6063.651681574815,3.74573920899568e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441042,6192.996410580569,0.01582149648719433 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441038,5749.890708014875,0.01641974196335516 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441053,8131.460117062502,0.1340892044189106 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441043,5741.574790338524,0.0170483054463606 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441041,4254.612072847623,0.1472193636983543 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,fruit,2441036,9213.072268648782,0.18832514603549244 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441042,334864.8933079929,0.31580228132361476 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441038,150668.66567812164,0.031044395699018068 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441053,172997.52278614012,0.02897254648011227 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441043,118841.39474284436,0.1340995977585191 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441041,291894.27073206234,0.25615823291434836 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_82,leaf,2441036,98552.45943650824,0.2153998710406606 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441042,233.81205977997828,0.01319689408994007 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441038,219.81610323895933,0.013610509064941656 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441053,251.97740051519503,0.045691577524868965 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441043,180.84896780542547,0.09835397939477941 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441041,283.96409519985093,0.09759341697705803 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,fruit,2441036,213.62109437123735,0.02602587815895463 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441042,3141.727598160315,0.137997790856613 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441038,2633.8693109659907,0.061423485850417237 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441053,2398.3427164726213,0.020740506460294572 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441043,1920.1766190034873,0.07582955899576449 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441041,1646.8828435786645,0.1425080309010407 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_83,leaf,2441036,2174.652339702093,0.021780899749892058 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441042,1186.9928767205022,0.03399627843722053 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441038,3810.4750769018942,0.4725347342417745 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441053,1380.2939172215072,0.03152718295955914 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441043,269.8472807988737,0.6773263450308296 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441041,934.4873444416309,0.13787096694976997 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,fruit,2441036,3676.788697488847,0.45702428083263724 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441042,991265.0914599176,0.2342653911393322 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441038,1164819.4180155755,0.304334180767051 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441053,694889.2351901823,0.07999116277162788 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441043,263678.7609511883,0.3408492718934042 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441041,424392.10836171254,0.13415712159879778 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_84,leaf,2441036,461101.668737959,0.0981277271843366 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441042,49.2339087103891,0.03212246094635818 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441038,49.6676698406337,0.035931930439983883 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441053,38.66782018448244,0.0727921647598273 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441043,42.21359414760879,0.03468952469546527 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441041,50.44520588037915,0.04267804374389472 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,fruit,2441036,36.42930100896049,0.0986910168511197 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441042,1212.4215481040396,0.16115502995954234 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441038,1155.410569394471,0.14023771961034237 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441053,894.2998116953189,0.028984522880966868 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441043,651.8018023698553,0.10838305937895454 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441041,778.8260495680921,0.03105814739079671 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_85,leaf,2441036,773.6657415439003,0.03394525000361881 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441042,1112.6643477251407,0.14423791901041705 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441038,629.8751031519242,0.10287181099986231 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441053,919.1370920851542,0.0612540390704126 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441043,707.4107215406151,0.0524546157758814 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441041,626.9212936983895,0.10491323236531258 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,fruit,2441036,889.0426895479687,0.04679636169095591 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441042,28552.53861760299,0.1705068921356645 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441038,20425.39207371396,0.02503256628523598 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441053,18137.3432069917,0.026564164368811483 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441043,13676.313222571558,0.14916879676507833 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441041,11428.488878061931,0.22714902547489935 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_86,leaf,2441036,21548.151265923683,0.04827218013102641 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441042,293.93483532238275,0.012122728323714416 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441038,369.6480277058,0.11166006264700057 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441053,228.83828162399664,0.09659965273794935 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441043,206.47176968423057,0.14126765050643186 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441041,277.7521775008555,0.012470858295047016 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,fruit,2441036,453.4416623475883,0.2003930900521591 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441042,32723.34258011885,0.00446990385902879 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441038,35163.62559826091,0.02676608443855688 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441053,33400.420099489646,0.0044243664043959186 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441043,40802.83105974265,0.09136273432769837 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441041,27545.771492550168,0.0792726224035123 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_87,leaf,2441036,30717.38665838341,0.03194329837403931 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441042,93.93994899049608,0.06766803062579596 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441038,118.22039359469906,0.03217405027423803 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441053,101.33714143379169,0.03474970130821564 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441043,155.83960681723087,0.15215949316183197 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441041,59.50084814620329,0.2659951942903449 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,fruit,2441036,127.2313073329142,0.06407563903403579 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441042,1705.4833374046057,0.012179502081730575 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441038,1940.928628048695,0.04398258299470914 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441053,1536.8344819003887,0.05739988657014505 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441043,1814.7322186091744,0.014785566941717843 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441041,1431.9453851110686,0.08810052863591267 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_88,leaf,2441036,1802.4956107793632,0.011847233068156271 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441042,17088.566341994556,0.024353712624393786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441038,15224.778238458948,0.02580094067438754 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441053,6206.04410712174,0.4155370583218869 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441043,9673.19275453998,0.22278207426221197 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441041,23324.294703490184,0.15945660394805916 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,fruit,2441036,62241.379109892274,0.5857272907785376 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441042,77839.81893157134,0.2423924168753695 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441038,244008.43857263337,0.2538106119604837 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441053,161980.52662684192,0.07586857270382907 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441043,145393.11633641168,0.0289496113630765 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441041,126641.53642114566,0.031018063127708828 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_89,leaf,2441036,95196.5832430796,0.15497287275141947 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441042,86.39587866264154,0.10358234133905886 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441038,39.94187428889109,0.23148224405045514 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441053,14.833213374804409,0.6616754404429221 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441043,49.72999502451281,0.136292268729576 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441041,135.11626691673806,0.29779695323750954 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,fruit,2441036,605.921809720398,0.9495059003852278 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441042,145.1056887817815,0.007329832963881788 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441038,140.24872976057858,0.007455669542931531 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441053,127.9436649367452,0.04733581917036256 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441043,152.06216879658922,0.027666574285101664 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441041,150.298867198681,0.022601101262177625 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_9,leaf,2441036,137.26301996342067,0.016801056364818212 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441042,75.55361948429173,0.023388335784904735 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441038,120.18599088252026,0.2249869096182282 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441053,67.63118618917021,0.024719934152089396 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441043,40.51921173656691,0.24720595079560415 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441041,85.39436846013642,0.07656229225234168 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,fruit,2441036,45.042037155094874,0.20124891427345792 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441042,4657.569701943796,0.09511273768380146 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441038,3821.762306666128,0.009217047465087003 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441053,2750.721219622305,0.13360004758377686 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441043,3661.252782266024,0.009416910562156655 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441041,3502.1014493422804,0.0287179026516311 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_90,leaf,2441036,4013.2071051870994,0.030444947190395144 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441042,355.92277496364346,0.023945795130845937 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441038,276.0290586809016,0.13434676948953506 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441053,396.2741774989766,0.022694199354490685 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441043,449.1105750212721,0.07705170746068468 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441041,292.0079663584305,0.10990687414495826 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,fruit,2441036,734.4709800514131,0.2906730670236124 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441042,669011.396317389,0.08985210837218816 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441038,836176.5995956693,0.007012385432107138 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441053,724194.4150402923,0.055430452988705525 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441043,856007.2691136407,0.017191828450640045 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441041,809390.5913679902,0.007127472522273415 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_91,leaf,2441036,1068508.684587973,0.11349243213798754 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441042,16.764905560749483,0.1933744200444414 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441038,82.89650608027223,0.5007606949341512 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441053,97.21539373556166,0.5699595080944704 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441043,35.57169701363835,0.13332905313239563 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441041,9.835065524170448,0.42499827370390786 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,fruit,2441036,11.875381370374948,0.3431279657556747 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441042,48211.82553251678,0.11889500409904041 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441038,77360.00074524705,0.08646788487915114 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441053,65689.72814587466,0.015448884182805322 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441043,80990.60342030799,0.10638605430855108 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441041,51740.4199183403,0.08821863130870611 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_92,leaf,2441036,61098.39588990402,0.01601877218788239 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441042,91.40780368633683,0.08068966417797019 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441038,77.8323427252445,0.010866492932746885 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441053,47.3725700503374,0.20476666316563907 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441043,416.1025836612075,0.7389068026006174 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441041,73.98577599253342,0.011145376597785583 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,fruit,2441036,0.4028943769531864,2.2751024036746275 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441042,20.17164823281736,0.516392370619243 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441038,138.50290924349116,0.32032513917594896 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441053,90.4028183776464,0.13504821350793783 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441043,58.2678418726728,0.05570482367754548 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441041,65.62409771218667,0.0040704114501777244 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_93,leaf,2441036,66.86,0.004032615612355572 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441042,308.3041437057484,0.02572835935213824 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441038,316.9714136314257,0.013687624451157454 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441053,337.2695258287877,0.013269380874251002 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441043,638.0674877892983,0.2901588948896605 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441041,267.40989539559433,0.08753024705793999 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,fruit,2441036,736.5562291634786,0.3524981855829208 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441042,4976.8716780918985,0.0227211175621167 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441038,4807.1688674928355,0.007654052777283482 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441053,4030.450282194159,0.068881757367933 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441043,4639.209160036573,0.007791372382367712 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441041,3217.8926001806694,0.1666637805617608 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_94,leaf,2441036,5451.3877208118265,0.06227174596292029 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441042,95.93751203371224,0.032784251608600545 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441038,110.9825971534278,0.030482180475946308 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441053,92.6710965313496,0.04782840139687994 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441043,132.51405546411,0.10748924210206612 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441041,73.54176538629272,0.14823865224789512 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,fruit,2441036,161.65361557736608,0.1938127193335042 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441042,164.1366741354742,0.3625241297335482 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441038,55.44367878149384,0.10882946070105937 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441053,46.556322555212695,0.1847028309908778 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441043,45.172333361883496,0.1978089749532954 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441041,460.0004343650516,0.8100767423420463 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_97,leaf,2441036,87.02240790449349,0.0869495965922662 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441042,1954.727116507899,0.014283070573239076 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441038,1526.685148894354,0.09305358614816539 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441053,1949.5450646322809,0.01313021147342841 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441043,503.4450063799767,0.5748510295924318 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441041,1833.4263771198912,0.013539591921192251 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,fruit,2441036,3849.335838050576,0.30858273599576425 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441042,59748.23927892933,0.04250737626321133 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441038,54876.60213603832,0.0055694774506669376 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441053,53478.09210955896,0.005641830392500324 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441043,41621.330205836595,0.11450177929481509 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441041,88622.7743764204,0.21372760637553867 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_98,leaf,2441036,50412.41081100889,0.03128026865181788 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441042,17521.273305272993,0.09726719968399955 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441038,10782.81355185883,0.11356636853878754 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441053,4879.873124544605,0.457889933722297 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441043,11242.130129801311,0.09544985629863323 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441041,16768.859967454413,0.07820507373173946 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,fruit,2441036,55622.571080006775,0.5989525953557617 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441042,109439.56444930776,0.003618437667403107 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441038,127983.73941566356,0.07159887689517141 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441053,88990.79252621249,0.08621084380600674 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441043,89180.0306976766,0.08528830078746541 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441041,108079.36999300244,0.001813113825350321 +1015695 Sl10g074590 #30.1,panK4-1,0.6,m_99,leaf,2441036,108983.68644232213,0.0018055758083299622 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441035,5.5752424659964,0.023042901656519676 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441034,4.364965919103007,0.08324000068144699 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441048,95.1349394021223,1.2551191880434174 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441045,3.8620072829092966,0.13640776941078614 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441030,4.99903868932039,0.024334359916776016 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,fruit,2441046,31.440393053476665,0.7742671089128854 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441035,11.1000619141271,1.5546385659416724 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441034,639.3761394331312,0.20579245786300104 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441048,69.91868718226016,0.7553707019130209 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441045,789.196362656256,0.29722110780503774 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441030,478.2070621626739,0.0796520183379914 +1015695 Sl10g074590 #30.1,panK4-1,1,m_1,leaf,2441046,317.9412208146898,0.09761712966748304 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441035,62.5244810871379,0.010206898263471986 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441034,61.7825608608109,0.005022707869695386 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441048,61.075504972183765,2.3868616481959037e-5 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441045,52.28184798279763,0.06749226779982931 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441030,61.06879179572658,2.3869928361675008e-5 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,fruit,2441046,41.30220552142886,0.16986995436088614 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441035,332.5271849549276,0.005569779657125462 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441034,354.111079908269,0.021742580324598748 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441048,336.5885480369614,2.975998235976718e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441045,340.80518234066346,0.005109254657948981 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441030,337.05,2.9739603328016173e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_10,leaf,2441046,328.8806742387897,0.010358581320520699 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441035,109.84935750747078,0.16702774493980943 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441034,74.94766798673662,9.883480252670385e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441048,19.84399088989012,0.5761407572149888 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441045,74.60693072640616,9.906023950216891e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441030,22.14314023509788,0.5285305657070589 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,fruit,2441046,141.44742298457027,0.2768252633000814 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441035,2228.1082973300468,0.05199097562264665 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441034,1603.686266471443,0.09082591025899989 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441048,1151.674103173675,0.2346157190053293 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441045,2353.318265194812,0.07573534528273207 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441030,1835.0664154276587,0.03229353327492035 +1015695 Sl10g074590 #30.1,panK4-1,1,m_100,leaf,2441046,2118.3750767442257,0.03005753789764931 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441035,36.19897592198683,0.007049620143328772 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441034,34.063551462664485,0.019356738776034055 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441048,38.205898815840854,0.030483756903110892 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441045,31.05187913909805,0.05955877714213709 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441030,49.89600741278957,0.14641913129900308 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,fruit,2441046,35.03327364953968,0.007165942833555983 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441035,246.50414002449355,0.49690398340239805 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441034,29.82408557475824,0.42035309742158455 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441048,108.5886219924875,0.14086408766832714 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441045,43.30015279703003,0.25843080533690665 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441030,48.429663127819445,0.20980878608034836 +1015695 Sl10g074590 #30.1,panK4-1,1,m_101,leaf,2441046,112.9093163481604,0.15780954358637778 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441035,118.16860820321244,0.02076008305541066 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441034,108.28904701851346,0.05867767168138549 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441048,108.65312649477632,0.05721997580419247 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441045,129.74033791391145,0.019812821264573177 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441030,249.33359963180115,0.3035186035207942 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,fruit,2441046,151.8085628271198,0.08803406534844616 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441035,561.2631624272507,0.008734687446096956 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441034,556.7440615964878,0.005223741898124246 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441048,666.1649583391012,0.08314993264984949 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441045,525.1112767754478,0.02018050664393245 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441030,503.431014709647,0.038491884039600244 +1015695 Sl10g074590 #30.1,panK4-1,1,m_102,leaf,2441046,543.4311289321955,0.005287339374998812 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441035,2673.903985390685,0.13512054378092087 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441034,3147.2142062602475,0.06434004938159843 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441048,4314.115122535105,0.07262537777691147 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441045,2085.736162694692,0.24300698128491893 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441030,4529.044660458778,0.09374025090869642 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,fruit,2441046,4152.340168424082,0.056026572283476295 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441035,780548.0341699619,0.01701076284941916 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441034,861240.61140996,0.02571410346140901 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441048,764774.9750374765,0.025876728613085653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441045,848437.1659017445,0.019209287456186885 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441030,842907.4806806662,0.016369511021903094 +1015695 Sl10g074590 #30.1,panK4-1,1,m_103,leaf,2441046,681172.7391906818,0.07615313813496272 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441035,2621.316972286599,0.13512054378092087 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441034,3085.3187172635503,0.06434004938159843 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441048,4229.270479750318,0.07262537777691147 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441045,2044.716501735076,0.24300698128491893 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441030,4439.973051227552,0.09374025090869642 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,fruit,2441046,4070.677113937989,0.056026572283476295 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441035,780548.0341699619,0.01701076284941916 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441034,861240.61140996,0.02571410346140901 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441048,764774.9750374765,0.025876728613085653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441045,848377.3309605889,0.019178658315726516 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441030,842907.4806806662,0.016369511021903094 +1015695 Sl10g074590 #30.1,panK4-1,1,m_104,leaf,2441046,681172.7391906818,0.07615313813496272 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441035,57.113766036184394,0.033197640018437946 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441034,48.70754890276377,0.03594688288821879 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441048,58.30634622809833,0.04217266905258166 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441045,44.923079379339,0.0710736395708047 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441030,28.90982665061894,0.2624976705646058 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,fruit,2441046,59.94589495702111,0.05421629022073371 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441035,184.76228512455043,0.20846315151506056 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441034,276.28057357467486,0.3832001755452241 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441048,100.5898812773176,0.05559587784428288 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441045,88.32615903537078,0.11206082835823228 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441030,128.06483785456842,0.04927973055773549 +1015695 Sl10g074590 #30.1,panK4-1,1,m_105,leaf,2441046,73.231575689906,0.19345179465997653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441035,172.09546860907932,0.019043314457703353 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441034,153.99754756835316,0.02921231605732455 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441048,159.56421494080723,0.013790620931068087 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441045,169.86045267614332,0.01336615638921268 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441030,102.54474198711895,0.20581272405741968 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,fruit,2441046,170.83856539609238,0.015859795064244064 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441035,3118.437734319274,0.007498476038477531 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441034,3382.797723945941,0.02784047673483503 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441048,3337.3911317864963,0.02197155461311784 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441045,3221.4014215243324,0.006609293012948214 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441030,3061.3638184953984,0.015520607902758776 +1015695 Sl10g074590 #30.1,panK4-1,1,m_106,leaf,2441046,3124.0941980179127,0.0067114326815986836 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441035,221.32446285589893,0.09529260256453043 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441034,322.3329639488832,0.06798270022933428 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441048,212.3063756912671,0.1133589849524097 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441045,342.00046784679915,0.0937046787137854 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441030,270.00962245433146,0.008942779862591621 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,fruit,2441046,281.2447117567351,0.008762343713558884 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441035,4915.874365052183,0.006816359860458476 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441034,5071.403446624809,0.006711026502238315 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441048,4113.091781237857,0.0842487343126419 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441045,6873.013009796417,0.13873003102031234 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441030,4850.308363003872,0.01264778478933426 +1015695 Sl10g074590 #30.1,panK4-1,1,m_107,leaf,2441046,5564.233096230814,0.0469881801596399 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441035,83.85355713080013,0.007322069506328521 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441034,81.04976940051547,0.007447637374858207 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441048,61.59659059352379,0.12664274654226726 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441045,90.07033932162358,0.03838237793840116 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441030,164.5691823175413,0.30014909037411086 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,fruit,2441046,30.251751538863285,0.4354488960964029 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441035,288.26669045881846,0.3750219500081986 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441034,95.89057315014732,0.10299659759314062 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441048,248.5078575223658,0.310567613098538 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441045,147.21925018341503,0.08319208939209277 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441030,58.770459195234366,0.31561342803165005 +1015695 Sl10g074590 #30.1,panK4-1,1,m_108,leaf,2441046,81.34181890075442,0.17445863253866967 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441035,100.55164184114405,0.01324666734347657 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441034,117.32244006836412,0.053745253204211085 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441048,106.7801157514261,0.012854553663598889 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441045,69.42676741233211,0.17410888914881184 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441030,100.0026555400836,0.015624300930086488 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,fruit,2441046,113.923421150332,0.04097718482524204 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441035,1876.5429499812235,0.058495505084525945 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441034,2688.639933016771,0.09767863069988847 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441048,2155.575668195463,0.0017092587005294035 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441045,1280.0340786305946,0.2246324818823262 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441030,2138.6415569971095,0.0017160124427975099 +1015695 Sl10g074590 #30.1,panK4-1,1,m_109,leaf,2441046,2269.3340651143967,0.02404441839948257 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441035,413.2945132297655,0.015604281732832792 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441034,384.12223635119585,0.016185909375796115 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441048,424.4084218231861,0.027128635285951663 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441045,849.3657201518378,0.3284393711376521 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441030,332.9961542744001,0.07821614009822797 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,fruit,2441046,367.7253048637195,0.035131841336702774 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441035,879.2828166258747,0.04488666574674349 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441034,1129.9649825079357,0.1538230646536718 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441048,488.68506494166814,0.2102128538567971 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441045,1217.1284776441346,0.18609450360592605 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441030,669.1489497920564,0.07371911961297872 +1015695 Sl10g074590 #30.1,panK4-1,1,m_11,leaf,2441046,706.6030034621629,0.05006644119969028 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441035,243.28618169238615,0.051595429890359146 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441034,333.5202154846778,0.08540929049698454 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441048,223.75215127468292,0.08794565266445309 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441045,304.6662617391234,0.046111491584555075 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441030,217.53054201368852,0.10019263024986946 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,fruit,2441046,428.1287863985127,0.19386155756635315 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441035,7637.425242536972,0.06927016072223191 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441034,15280.017036316223,0.23190670546670322 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441048,4607.574782713538,0.2887447402708827 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441045,4436.632554921312,0.3051636713593271 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441030,12519.10452500395,0.1453561324892929 +1015695 Sl10g074590 #30.1,panK4-1,1,m_110,leaf,2441046,10278.82536682301,0.05972635464469622 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441035,248.34710173059568,0.006469682430035206 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441034,241.00269164302347,0.0065675205835624695 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441048,236.1841635400502,0.015338639376077712 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441045,112.45465682291233,0.3376119690410877 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441030,302.0551662812172,0.09149685458920542 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,fruit,2441046,330.60452534658504,0.1307193803293334 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441035,57720.36544728711,0.08117756705627954 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441034,47403.880725473224,0.004337608330802212 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441048,77501.30386096191,0.20915750398048072 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441045,46631.03164410089,0.011476481342348244 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441030,47198.21529559179,0.006225928057099317 +1015695 Sl10g074590 #30.1,panK4-1,1,m_111,leaf,2441046,48355.5378969463,0.004294713613844259 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441035,2129.813684103506,0.09422946890612849 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441034,2752.825524744637,0.2056665423414521 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441048,731.0819839373693,0.3701460624429136 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441045,1201.179341209945,0.15450428988825093 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441030,1298.9862063199698,0.12050760474522848 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,fruit,2441046,2622.213047643432,0.1845558298725316 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441035,536542.9226082832,1.841329490443139 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441034,9118.952519911074,0.07166997431346633 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441048,4461.711893462426,0.23877345702374653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441045,6021.710187714579,0.10855513014205354 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441030,10559.302764580483,0.13536026234935905 +1015695 Sl10g074590 #30.1,panK4-1,1,m_112,leaf,2441046,6344.446968980578,0.08588120852108538 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441035,73.09297283524447,0.0033941626049414086 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441034,71.95493165200757,0.0034208982531611642 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441048,66.08914340700139,0.04035134031083176 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441045,140.79010197236565,0.2880906602352262 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441030,84.75406078612816,0.06767905229417193 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,fruit,2441046,57.20844436778789,0.10302132481327697 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441035,33.20523889974506,0.43458098674182644 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441034,144.3593151750162,0.20365721722584063 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441048,18.456807908388974,0.6896310036534115 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441045,142.8974263447455,0.19923681107667646 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441030,114.59098409999817,0.10336285321483274 +1015695 Sl10g074590 #30.1,panK4-1,1,m_12,leaf,2441046,66.0505411561192,0.13591121575410048 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441035,70.04310445128723,0.01529950036027694 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441034,102.85178412340208,0.182145943323349 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441048,126.40444732579031,0.2716964678461222 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441045,65.19400572689858,0.015858219989611344 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441030,52.29047135267555,0.11164332965213863 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,fruit,2441046,55.96427746853066,0.08215498514518305 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441035,116.41579229257826,0.2615790438501211 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441034,367.687111092574,0.23788746433679098 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441048,234.38125169905416,0.04233192721574364 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441045,283.486297683206,0.12494113006626995 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441030,190.84585133292745,0.046908218478223684 +1015695 Sl10g074590 #30.1,panK4-1,1,m_120,leaf,2441046,130.03491543591943,0.21353096245847558 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441035,100.45419149292904,0.08999189057013268 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441034,109.4145482476689,0.12709889956329867 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441048,157.95342485524077,0.2865528750060147 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441045,62.853322507121646,0.11364793201885148 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441030,46.6159379080906,0.24344174540305286 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,fruit,2441046,60.39203340743414,0.13099651940527024 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441035,121.03391874959368,0.27289111594291704 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441034,283.62032456331195,0.09693913894076545 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441048,170.14176219108978,0.12498728417063232 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441045,347.69980639725316,0.18540623812916124 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441030,321.92177531290196,0.15195214333025397 +1015695 Sl10g074590 #30.1,panK4-1,1,m_121,leaf,2441046,73.25918182159724,0.49093614669753016 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441035,214.60759404378928,0.006484632913583255 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441034,436.0042889503088,0.30136104278316944 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441048,184.58047463681552,0.07194396022479754 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441045,221.06447109993312,0.00638923088329113 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441030,186.6102647360509,0.06719418964704227 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,fruit,2441046,344.4746706263249,0.19902757491637457 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441035,11398.727218626573,0.11432626806203139 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441034,22498.5894999798,0.18097266301586856 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441048,10614.44921392846,0.14528516535134006 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441045,12513.36761307532,0.07380842550796896 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441030,17149.465233301882,0.06306795331047166 +1015695 Sl10g074590 #30.1,panK4-1,1,m_122,leaf,2441046,17934.069420355063,0.08249621771814741 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441035,192.3838710699916,0.1410787740696624 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441034,164.37118127794326,0.07273579117364859 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441048,158.87095002791224,0.05795460746193415 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441045,115.76451024382898,0.07951444634071247 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441030,109.77169380203212,0.10259951959389957 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,fruit,2441046,119.17711734662409,0.06689700860297076 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441035,297.2033308512387,0.2153056746272246 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441034,159.48248409904235,0.0550350061499536 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441048,200.91525806831424,0.04526492177843622 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441045,67.02109601462166,0.4315364720677253 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441030,161.14261302496865,0.05053759605056962 +1015695 Sl10g074590 #30.1,panK4-1,1,m_123,leaf,2441046,369.0148489883987,0.3092958445580978 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441035,1091.3626963393713,0.05920043836799982 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441034,994.3290778429924,0.09963940356178824 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441048,1410.13172793127,0.05209014078423024 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441045,3258.08635094312,0.41579304695056996 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441030,941.672355683482,0.12326972234255873 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,fruit,2441046,1583.9898715811162,0.10258285674536793 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441035,74281.03304237193,0.054974397118130014 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441034,72292.17792437227,0.04318777098253612 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441048,51084.283603870885,0.10761623052099889 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441045,78866.74136064711,0.08099035907005359 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441030,53191.2933944124,0.09006298710664673 +1015695 Sl10g074590 #30.1,panK4-1,1,m_13,leaf,2441046,58605.97955862197,0.047961608544222045 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441035,5.084941519376037,0.6834410424714615 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441034,26.186883089391117,0.028356804273039327 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441048,41.06105425876814,0.22370309081173834 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441045,34.12720397180931,0.14337370311455633 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441030,21.83799018401853,0.0505143386049578 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,fruit,2441046,22.876444610426802,0.030338476450554097 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441035,62.28259914887756,0.13197931972420496 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441034,149.0380643964385,0.24695115383098942 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441048,88.80653109631835,0.022098858483765138 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441045,79.99486859177972,0.023283918456632913 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441030,117.77766737810364,0.14471690096013168 +1015695 Sl10g074590 #30.1,panK4-1,1,m_14,leaf,2441046,54.14149791309458,0.19281578070881822 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441035,72.89821544875794,0.002551651527934018 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441034,73.16547395002581,9.623582223738936e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441048,86.71653417627809,0.07283336354373526 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441045,73.49008993645604,9.602304356510771e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441030,35.996481390544695,0.3090084973110978 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,fruit,2441046,79.60602156269469,0.03567737147559624 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441035,666.9722439434811,0.08066287309735065 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441034,945.4578103515022,0.07087151964737037 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441048,1013.966760873459,0.10125308428160684 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441045,876.7799797793091,0.038119990438389983 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441030,729.423749386528,0.04179073477195194 +1015695 Sl10g074590 #30.1,panK4-1,1,m_15,leaf,2441046,606.5236669413651,0.1219228822391405 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441035,8.085747283900028,0.6836845540669696 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441034,25.056314111702008,0.19248753278663222 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441048,185.7557428620671,0.6775375317622274 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441045,53.004794231510814,0.1329104352722985 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441030,63.569732507312,0.21184566636900826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,fruit,2441046,22.42372434955183,0.24069697152576408 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441035,274.12930294572817,0.3271162571750126 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441034,7.06859769165574,1.2615059400372939 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441048,66.9453095140953,0.28511905077396826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441045,94.34444662986192,0.13612286308481547 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441030,163.8038122633,0.1034848004426685 +1015695 Sl10g074590 #30.1,panK4-1,1,m_16,leaf,2441046,223.20185048501253,0.23785858627095724 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441035,1151.7239582308157,0.06794818528033186 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441034,2053.441614125126,0.3190821431215296 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441048,813.4441036566561,0.08307250040161085 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441045,785.3298580802768,0.09834810631712143 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441030,1154.2589239150584,0.06890302502392043 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,fruit,2441046,818.1126828581741,0.08058709047166168 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441035,25461.908912639443,0.05382070066401745 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441034,20444.700794702072,0.04148950040129051 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441048,18461.9592949007,0.08579247040432492 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441045,24543.66888326336,0.03786922377520252 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441030,16403.61928631746,0.13713057836332787 +1015695 Sl10g074590 #30.1,panK4-1,1,m_17,leaf,2441046,26266.91971161259,0.06733888710853453 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441035,23.615629067667975,0.11322861481319313 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441034,11.913747932541447,0.18392249670027438 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441048,12.775949922805754,0.15357770303626062 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441045,1.5598617084038089,1.066884806778341 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441030,137.58384951115107,0.8785965526853801 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,fruit,2441046,40.127290175004894,0.3434689286132504 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441035,197.7418768012473,0.17215399682773747 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441034,559.8854343617148,0.6241545143277909 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441048,560.7153638345172,0.6247978011376647 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441045,63.33625934894841,0.3222922446917298 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441030,68.31509922871096,0.28942795148272427 +1015695 Sl10g074590 #30.1,panK4-1,1,m_18,leaf,2441046,52.2704516897204,0.40568840194859335 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441035,3.5167708575568843,0.008668585482936475 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441034,3.5428739847041686,0.011880218928146391 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441048,3.377772102939343,0.008845141873057738 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441045,2.757628916559425,0.096939661959494 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441030,2.640336722723617,0.11581617033235125 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,fruit,2441046,5.385295497278281,0.19373405211407146 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441035,1843.385144334402,0.12479303827081001 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441034,1589.2054295533508,0.060356995202732744 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441048,2532.4779432523233,0.26272262657928636 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441045,1105.0871959903711,0.09742649793954161 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441030,1060.2999639205198,0.11539429833000803 +1015695 Sl10g074590 #30.1,panK4-1,1,m_19,leaf,2441046,1176.8000786384282,0.07012035621849622 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441035,11.789965291931564,0.925264855244829 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441034,101580.82100443788,3.010034336758122 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441048,280.7356107943374,0.451520123745198 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441045,2.9934732653433085,1.5206019980146905 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441030,177.2037315905338,0.2516954812673302 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,fruit,2441046,21.317690470327054,0.6680372298094746 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441035,1121.727483323191,0.06419501644736547 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441034,819.1802151687986,0.07231288947573233 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441048,1732.9663192232474,0.25309777797946387 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441045,996.1897952849768,0.012649744458094414 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441030,938.9945397032624,0.013029277327857525 +1015695 Sl10g074590 #30.1,panK4-1,1,m_2,leaf,2441046,486.13755904354576,0.29893316814653437 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441035,37.79215127152072,0.09637125322407991 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441034,117.9176913352799,0.39780610019350293 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441048,114.53259127994544,0.385156219145534 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441045,4.822271715359369,0.990521190066493 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441030,56.57109286533972,0.07882170119234955 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,fruit,2441046,27.71785642938665,0.23101322660653345 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441035,40.504830758387925,0.02425730660317349 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441034,28.499075384977836,0.12841874516924268 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441048,91.59217995050555,0.37860888032550144 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441045,98.18711135844748,0.4088049680818653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441030,36.10411941868213,0.025692758297709783 +1015695 Sl10g074590 #30.1,panK4-1,1,m_20,leaf,2441046,21.826430374230945,0.24426680090941488 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441035,5156.54982710092,0.03610032624569204 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441034,3991.2702595036258,0.07514775638211679 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441048,7990.219587828677,0.22629982239836144 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441045,4333.945683115691,0.039375428343005225 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441030,2736.64261686587,0.2390408065867522 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,fruit,2441046,5883.110554015707,0.09334811722888547 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441035,284906.9389339554,0.14605764128451781 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441034,402729.3271517378,0.00425258858310773 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441048,518486.8531015956,0.11397708083798364 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441045,394880.80749080994,0.004294641827939927 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441030,313268.02504307654,0.10484459879736541 +1015695 Sl10g074590 #30.1,panK4-1,1,m_21,leaf,2441046,521868.25926179474,0.11680021534318374 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441035,31.094346588388703,0.4163151491283281 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441034,97.77458447577136,0.08122939477622726 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441048,89.74399661818288,0.04400882212077084 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441045,236.1332845760075,0.4641606239451128 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441030,72.44693928048397,0.04897654194514178 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,fruit,2441046,5.986156642534219,1.1318485071414024 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441035,19.9588269320608,0.7149058043913175 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441034,139.24143989677816,0.12872768897980347 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441048,67.80645169733238,0.18376979829946305 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441045,147.29923649734351,0.15315967905246675 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441030,63.3386330377409,0.213372130421553 +1015695 Sl10g074590 #30.1,panK4-1,1,m_22,leaf,2441046,355.86189569619256,0.5362406712359249 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441035,2362.772857324677,0.012871825687109428 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441034,2479.298235507234,0.03377862380970553 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441048,2224.7700915701826,0.013265010000637734 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441045,1683.5502654676495,0.13432405993767738 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441030,1061.295044763683,0.334714011017081 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,fruit,2441046,2680.410894402308,0.06765122692646397 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441035,150455.57619599305,0.28013154891941383 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441034,80441.11774647552,0.008201357270976928 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441048,77431.47264298749,0.008359220268110867 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441045,59954.75311750869,0.11945312033425015 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441030,110052.6811820218,0.1443238883005673 +1015695 Sl10g074590 #30.1,panK4-1,1,m_23,leaf,2441046,60729.7195554097,0.11387546371718749 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441035,249.42470474924244,0.01424608887468537 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441034,266.0597243200007,0.013793581068954008 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441048,241.59941444432977,0.028089678312535504 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441045,219.64543008008073,0.06946338386961903 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441030,288.57980291216217,0.04908037679292354 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,fruit,2441046,294.713329878591,0.0582142237465022 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441035,105.21077937202514,0.09619641195786333 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441034,157.38433721485254,0.07870485977095942 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441048,178.8815812635984,0.1343089755631559 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441045,234.4292803885819,0.25175520472931634 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441030,75.09720437465634,0.24263287977284143 +1015695 Sl10g074590 #30.1,panK4-1,1,m_24,leaf,2441046,40.41816020379453,0.5116801087454945 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441035,94.02211106151408,0.08569163068059038 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441034,78.3369746255048,0.006428427663012215 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441048,76.03496576117404,0.006525012702127242 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441045,70.9879579342743,0.036353684137909736 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441030,64.73111992972794,0.07642524649356197 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,fruit,2441046,93.12181161325482,0.08151304883642152 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441035,3346.3259238055493,0.012834109000555927 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441034,3687.3824268973863,0.054984052733686894 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441048,3357.881816443697,0.014331277814805699 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441045,2850.2788770401085,0.056846774549728085 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441030,3151.4409325429224,0.01322495732961082 +1015695 Sl10g074590 #30.1,panK4-1,1,m_25,leaf,2441046,3058.0877364583625,0.026284187733560227 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441035,129.2301018446004,0.1063366056439139 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441034,211.0934570778249,0.1067744801621009 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441048,165.74618869856783,0.0017432584431884557 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441045,164.41824496254011,0.0017502840945988751 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441030,126.72168044162804,0.11484936881836605 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,fruit,2441046,259.01738963853626,0.1956286300375112 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441035,3852.082692580264,0.012650533850736334 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441034,3630.905558703039,0.013030114804897241 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441048,3624.7327939425495,0.013769070687217777 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441045,4588.934345980728,0.0886667765825444 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441030,3594.2836893190924,0.017432715608665106 +1015695 Sl10g074590 #30.1,panK4-1,1,m_26,leaf,2441046,4212.552727149551,0.051500282143323695 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441035,94.8645239211139,0.014555394566424962 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441034,88.61112510317705,0.015060186111048202 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441048,85.6151345181891,0.029997893600368863 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441045,114.1234188283727,0.0948263364878752 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441030,19.589781396758465,0.6705188472675114 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,fruit,2441046,154.54020543735135,0.22649304825902217 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441035,836.02055238946,0.0438114047491176 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441034,574.0276101499677,0.1194727673125775 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441048,842.1246790076726,0.046970845480753365 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441045,900.2758033734164,0.07597002846999823 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441030,640.6295252916372,0.07179859881543926 +1015695 Sl10g074590 #30.1,panK4-1,1,m_27,leaf,2441046,675.5747897532193,0.048732114591789166 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441035,72.09468019690004,0.018909038326696992 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441034,83.08598908021389,0.04271553618302826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441048,78.51131272704913,0.01811998090279965 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441045,111.8530367265006,0.17183552134368396 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441030,16.461294304618555,0.6603482784650594 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,fruit,2441046,69.37602409085106,0.03560285102499927 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441035,424.9896810752174,0.16448939106724847 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441034,250.6658403423309,0.06479384004692346 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441048,331.32880633456426,0.056370201620941085 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441045,411.1311004161656,0.15009133639402927 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441030,193.33665815479193,0.17757478676759897 +1015695 Sl10g074590 #30.1,panK4-1,1,m_28,leaf,2441046,210.74983706059845,0.14012174673597988 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441035,175208.48929065562,0.04219293768376353 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441034,175069.74511783512,0.04253698322176369 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441048,267674.3875697041,0.14185873501453905 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441045,210961.10718713744,0.03845431341669947 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441030,165931.43452965096,0.0658194148643041 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,fruit,2441046,220013.6933742516,0.05670162892084196 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441035,421890.24600584694,0.0421689328232695 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441034,572854.8416983265,0.09067617050348353 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441048,199025.51121300264,0.36845966943148234 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441045,467155.66817714,0.002093205131207476 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441030,508668.7688255465,0.03906665615327398 +1015695 Sl10g074590 #30.1,panK4-1,1,m_29,leaf,2441046,462663.3251010688,0.002103342806687003 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441035,36.3301457032429,0.31367050199468727 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441034,113.28227068424718,0.1802243040269611 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441048,29.318384162977296,0.4067976104476445 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441045,24.149283741165583,0.491033387348526 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441030,198.3175048721183,0.4234234081132662 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,fruit,2441046,117.00043061169342,0.1942498185256134 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441035,13.734532884284784,0.31180323797271026 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441034,602.4374164242628,1.330294805875194 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441048,26.240594496946755,0.03064346146470065 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441045,4.24303837748483,0.8219401715943223 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441030,103.42969384588471,0.5650281076742552 +1015695 Sl10g074590 #30.1,panK4-1,1,m_3,leaf,2441046,30.07739301305014,0.028623059168528586 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441035,154.7903966046805,0.005208364455002279 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441034,163.9688190763048,0.030225620297429145 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441048,148.0786871807001,0.014043093096402615 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441045,151.09986028182797,0.005271585781128962 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441030,7.790504954590098,1.2929700404322793 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,fruit,2441046,203.89596311881488,0.12487297884458348 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441035,8152.558161077373,0.08159031199610434 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441034,6713.9916999135985,0.002722793767203413 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441048,5860.018486036961,0.061804607741225315 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441045,7167.398646524083,0.025657966558067624 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441030,5728.392363353121,0.07167083668788132 +1015695 Sl10g074590 #30.1,panK4-1,1,m_30,leaf,2441046,6798.442416751766,0.002705829609736199 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441035,45.14800407770005,2.5739414127423643e-5 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441034,45.14265264549734,2.5740939720630962e-5 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441048,41.149287828395714,0.04025049291387495 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441045,57.22971129372316,0.10300873884861872 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441030,31.010035315595413,0.1631105553520098 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,fruit,2441046,177.4030759207735,0.594348329435485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441035,560.4077818605178,1.6318829832950854e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441034,560.8290129837548,1.6312700255127766e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441048,475.73318675987406,0.07130389709039076 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441045,604.3338288032936,0.032609559840652835 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441030,538.9587854939151,0.017111789903249797 +1015695 Sl10g074590 #30.1,panK4-1,1,m_31,leaf,2441046,591.4433845465483,0.023245832858787008 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441035,127.79382589434952,0.044000026039258344 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441034,117.22905701485958,0.08147462673524863 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441048,118.34093426718648,0.07737490470765085 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441045,212.13294746273343,0.17609822798182284 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441030,155.0455654243998,0.03994945087516344 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,fruit,2441046,239.33353396967,0.2284936553068211 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441035,1897.3377292179407,0.037022535146522095 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441034,2086.1507389844787,0.004178507994646807 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441048,2735.2150072177333,0.12182429258081351 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441045,2383.220755544249,0.06199709446364121 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441030,2046.199980505679,0.004219101851747453 +1015695 Sl10g074590 #30.1,panK4-1,1,m_32,leaf,2441046,2032.1672401891497,0.007207732058880367 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441035,159.21623267493845,0.04332050337852911 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441034,192.61779710998024,0.039388564764323064 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441048,117.09567719327048,0.17676698436976235 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441045,148.53990900191863,0.07346469341856965 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441030,237.23138251030045,0.12986429284939582 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,fruit,2441046,956.614517401433,0.7354291204150516 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441035,1732.13515126971,0.0937955485866091 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441034,1047.7416885741366,0.12453200221142247 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441048,2525.5461033042075,0.25756907427274855 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441045,1489.740628599,0.02832443552038999 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441030,1301.6217589620221,0.030301426593621894 +1015695 Sl10g074590 #30.1,panK4-1,1,m_33,leaf,2441046,1064.819299946813,0.11751031243590271 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441035,322.7909467847196,0.011161102209098495 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441034,351.75762050771783,0.026161066891784657 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441048,339.5970341844849,0.010881440837806178 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441045,301.18158566053967,0.04125403247497328 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441030,345.00847021371055,0.017747309545264045 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,fruit,2441046,250.52070554595363,0.12123882176805711 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441035,59243.4208152715,0.08721559710453963 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441034,45787.28734277464,0.0246796157523006 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441048,61052.29736840229,0.10027748051332264 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441045,51141.88982613512,0.0233522419337433 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441030,39246.05054350655,0.09162857153879589 +1015695 Sl10g074590 #30.1,panK4-1,1,m_34,leaf,2441046,38152.91836589825,0.10389676706010409 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441035,72.24393193832178,0.05329349027669328 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441034,75.7918895252246,0.032472130723502524 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441048,41.65139703619095,0.2924652923492401 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441045,87.5602626628048,0.030212190614853363 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441030,343.3130340142111,0.6235954268221264 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,fruit,2441046,169.20417057251964,0.3163161983202598 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441035,9792.34202272637,0.2661847950417937 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441034,4778.256455457122,0.0454323236672316 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441048,10008.515766779734,0.27566789879386855 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441045,5832.143982418216,0.041126458312652936 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441030,4467.437276071484,0.0746433152580459 +1015695 Sl10g074590 #30.1,panK4-1,1,m_35,leaf,2441046,3205.6974382731187,0.21877924872118681 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441035,2675.695195007779,0.06870787788805632 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441034,2597.2943976189217,0.05579241789129208 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441048,2305.370839213047,0.004012034584916169 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441045,2104.121023192696,0.03565804524277061 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441030,1336.062139048167,0.23290210359940433 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,fruit,2441046,2262.972711870188,0.004049443822105481 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441035,4499.504559704384,0.0708854642728931 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441034,5401.1418749285385,0.008435424766255473 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441048,10056.114671521002,0.27838005650717834 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441045,6173.63289906253,0.06649064105737912 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441030,5193.350584346725,0.008602519292931543 +1015695 Sl10g074590 #30.1,panK4-1,1,m_36,leaf,2441046,4018.6692400627257,0.1199678978380696 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441035,657.2928241350265,0.08479161949891134 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441034,593.029499475289,0.04010902582860565 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441048,546.5983292135116,0.004701028368371496 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441045,493.88116950925365,0.03934480360055925 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441030,405.5350629462992,0.12493886179935298 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,fruit,2441046,534.8288170453974,0.00475247209516283 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441035,87.75844149619273,0.47593697064820306 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441034,220.2920144556276,0.07622711829723583 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441048,626.6758485129108,0.3778170850895375 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441045,368.1740479772491,0.14682729985686027 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441030,304.8247316921889,0.0648243275664826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_37,leaf,2441046,24.547093217070884,1.0292258008048607 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441035,42.907724215362464,0.0047107519202085335 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441034,201.56326518569637,0.6671651525114533 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441048,103.63559164216548,0.3782626985776367 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441045,14.31439190494487,0.4814733291773492 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441030,43.843623044114224,0.004660202644535705 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,fruit,2441046,4.139602862618397,1.020287553902329 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441035,115.821032810534,0.3801218211912343 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441034,44.11298629245723,0.03909915318905788 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441048,84.52982850614116,0.24334437572500667 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441045,42.04539835448605,0.05994714064562068 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441030,52.4244158960056,0.035867988172300524 +1015695 Sl10g074590 #30.1,panK4-1,1,m_38,leaf,2441046,25.3478370144925,0.2797247061889725 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441035,113.7696685158462,0.04737134168210444 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441034,90.25615838396654,0.05317830653341349 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441048,75.4235477194299,0.13114819444082326 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441045,75.48083755907317,0.13081844043963087 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441030,186.5643747667947,0.26217356598613106 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,fruit,2441046,314.77306418455714,0.48934241072681894 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441035,2674.1719071428383,0.020325142145124264 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441034,2325.9443498432593,0.08091514460537175 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441048,3222.428019503935,0.06066876088207618 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441045,3081.06060344773,0.04118577656570199 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441030,2718.089816250098,0.013250660853789231 +1015695 Sl10g074590 #30.1,panK4-1,1,m_39,leaf,2441046,2886.5080862310892,0.01285831419926664 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441035,45.61285006582327,0.08250106664265178 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441034,35.55939889148216,0.025631731936724966 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441048,39.8831127394417,0.024202903318245594 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441045,43.653521684100795,0.06343314269678668 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441030,11.897523369433236,0.5011295763066534 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,fruit,2441046,20.27095450294428,0.2697119439357403 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441035,168.30804919394953,0.0454333466803587 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441034,134.87263955736438,0.05074768251634909 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441048,44.77901116368467,0.5295970405642039 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441045,623.4854990606233,0.6141548176027762 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441030,334.88413125823394,0.3442230290815136 +1015695 Sl10g074590 #30.1,panK4-1,1,m_4,leaf,2441046,133.7490835887588,0.05438072452897025 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441035,160.22778834159547,0.020747032478080296 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441034,174.1328804703915,0.056889978497693505 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441048,147.87862996839243,0.014085387223552459 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441045,157.62811375634206,0.01364287304547318 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441030,91.43605879668492,0.2228733073625826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,fruit,2441046,111.31152769491844,0.13745066232661607 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441035,7294.549751094523,0.003467339784402057 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441034,7439.325721384393,0.01200242328162604 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441048,7131.157882649356,0.006371099110913381 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441045,7322.290269157676,0.005115790252175234 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441030,7178.536376076845,0.0034952454312344727 +1015695 Sl10g074590 #30.1,panK4-1,1,m_40,leaf,2441046,7002.298797499479,0.014290512119218057 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441035,162.14394525008862,0.025572222278404944 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441034,143.60045340338726,0.027172702539512095 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441048,136.56570590954033,0.048986859760026036 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441045,220.4410505690612,0.15896395841419197 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441030,106.30387985973329,0.1577793980734632 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,fruit,2441046,182.9012895596989,0.07788825382678555 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441035,2254.578131640818,0.12272595695912836 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441034,1489.1272324715471,0.057407527394076396 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441048,1849.9826068732111,0.03682831200937686 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441045,2067.626192441887,0.08513269184888772 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441030,1549.1595591691812,0.040243182073469885 +1015695 Sl10g074590 #30.1,panK4-1,1,m_41,leaf,2441046,1268.4747676159182,0.12705750057473653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441035,48.93765509470638,0.010372803978663248 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441034,46.51951049387394,0.011635215630790174 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441048,48.089445393460814,0.0027794166611898596 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441045,47.475881008976835,0.0027973191269594633 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441030,60.34285221056892,0.10135548220842217 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,fruit,2441046,38.24215940868045,0.09672794433058418 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441035,163.16744691346352,0.004917025635430949 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441034,185.83430705691953,0.05157534879393477 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441048,151.9297977864206,0.0359075839950278 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441045,160.42206896662074,0.012286430658277503 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441030,192.13624996239224,0.06605876626129126 +1015695 Sl10g074590 #30.1,panK4-1,1,m_42,leaf,2441046,166.88316286995277,0.004861978367321829 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441035,258.5067849185976,0.1127173432961226 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441034,270.7922532297065,0.13288163295406674 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441048,657.1129707539533,0.5178854367869792 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441045,43.44535578748209,0.6618112448820281 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441030,107.96538547361446,0.2664700633496886 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,fruit,2441046,140.32025820675702,0.15263422784894454 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441035,370.25684558331267,0.005362971264971428 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441034,379.45791900445033,0.005297552568646946 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441048,355.424753538034,0.023118397152446235 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441045,461.7657738220462,0.09055567168304535 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441030,425.1476122000782,0.054673676155899464 +1015695 Sl10g074590 #30.1,panK4-1,1,m_43,leaf,2441046,326.3478748213018,0.0601852791773414 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441035,31085.455150724538,0.13061652666509183 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441034,28281.84059158825,0.17166608724667487 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441048,49903.44958053671,0.07495680998642573 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441045,54897.04721584427,0.11637522807028677 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441030,54838.10753121792,0.11590870150787769 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,fruit,2441046,34081.94229744759,0.09064942049152958 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441035,229374.3260247395,0.1718666753740168 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441034,216240.5167537752,0.14625894040540022 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441048,57833.52665717097,0.42649845397402153 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441045,148820.9627984004,0.016014020245465943 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441030,160000.96222512602,0.01544446432702351 +1015695 Sl10g074590 #30.1,panK4-1,1,m_44,leaf,2441046,128344.3337810622,0.08030143017778535 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441035,40633.56417404492,0.02519463539266109 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441034,37406.18557689053,0.06113612942074198 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441048,66085.57177185865,0.18602709832253783 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441045,42366.91577361213,0.007052704155086964 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441030,60475.59150583848,0.1475005713058284 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,fruit,2441046,43754.18043872963,0.006939999925958951 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441035,36850.94763345456,0.21596660223056308 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441034,30065.51670033567,0.12758661382492686 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441048,11086.37993316536,0.3056923002263483 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441045,21984.579963803295,0.008363885696215156 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441030,22839.56910716883,0.008205848098187474 +1015695 Sl10g074590 #30.1,panK4-1,1,m_45,leaf,2441046,21427.007819543014,0.019520530021848614 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441035,1974.1139073060217,0.130731625804418 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441034,1495.3244947741844,0.25136838634954284 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441048,3360.87879290004,0.10034901645024741 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441045,3967.844207874753,0.17245077796370367 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441030,3622.917216094283,0.13295457663134558 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,fruit,2441046,1304.7477158905635,0.31057728861178413 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441035,17462.870564479952,0.12350358417121932 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441034,15511.597230695892,0.0720444686251902 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441048,8842.943793516004,0.17201518622439504 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441045,17065.557865355364,0.11350843890000917 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441030,10769.412467438267,0.08642004012072046 +1015695 Sl10g074590 #30.1,panK4-1,1,m_46,leaf,2441046,10087.389529481285,0.1148332591906378 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441035,69.80635644468674,0.03236716057286815 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441034,51.59800522866459,0.16362921890173365 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441048,80.6089825275102,0.030121308290538273 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441045,143.70600480800147,0.2812127845749084 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441030,88.05118361829285,0.068473067205721 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,fruit,2441046,49.3515789561906,0.18296107903113423 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441035,393.2507163351136,0.038509288109786155 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441034,303.7584294355345,0.07363189564124273 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441048,363.9467318293201,0.004877589568154761 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441045,355.8174487081819,0.00493299292142213 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441030,177.15809498750028,0.30779923269357656 +1015695 Sl10g074590 #30.1,panK4-1,1,m_47,leaf,2441046,395.25754190681687,0.04071993116813433 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441035,72.2094542782413,0.02612242099553974 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441034,63.77887479161502,0.02779478883313735 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441048,80.6537574771642,0.0741529631612674 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441045,123.96908422089494,0.2608417511764234 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441030,48.33470317741226,0.14821258589608677 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,fruit,2441046,51.70404959535289,0.11894708234113471 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441035,2560.3271177137667,0.04465289246377813 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441034,2299.265315028223,0.002053475676093708 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441048,2321.0600442444393,0.002043811897309844 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441045,2617.292765175743,0.054209741069391804 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441030,1628.6028797166225,0.1518273652241442 +1015695 Sl10g074590 #30.1,panK4-1,1,m_48,leaf,2441046,2021.1611394167064,0.05804162407970548 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441035,35.26863041380153,0.017041374029786782 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441034,33.89675570268993,1.8908764411751378e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441048,33.92627877266592,1.8900535300137022e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441045,30.14115194370808,0.051187374719686485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441030,30.145156231511976,0.05112968201458035 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,fruit,2441046,33.99204468644979,0.0010300679978287874 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441035,31.852588696657964,0.01667873518088303 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441034,35.18112609733708,0.02648626758624184 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441048,34.91233373061158,0.0231554114934569 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441045,33.221437100401936,0.0015949464296216576 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441030,32.9778731713396,0.0016008254675801137 +1015695 Sl10g074590 #30.1,panK4-1,1,m_49,leaf,2441046,32.4473135048762,0.008644723952333955 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441035,691.1661379153625,0.004428027928919498 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441034,1441.9606407142471,0.32379898137462604 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441048,472.8710308934937,0.16041171580347902 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441045,677.1436086283251,0.004473641175862131 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441030,101.9618075636834,0.8267168988373843 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,fruit,2441046,1319.9365806342803,0.28539864022696726 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441035,14658.832883260626,0.06657833451339545 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441034,11907.135529426196,0.023713762337632005 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441048,12851.483273416048,0.009432196095600531 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441045,13520.417719030593,0.03146905030454317 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441030,9495.74410531131,0.12199205663816937 +1015695 Sl10g074590 #30.1,panK4-1,1,m_5,leaf,2441046,12299.27336082186,0.009641605074147463 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441035,191.90455844876865,0.04539390664392684 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441034,95.46228824420623,0.2578595440736775 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441048,175.57496718102982,0.006771211581519498 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441045,170.14254570048766,0.006878457824970763 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441030,168.65657920033678,0.010688096882856879 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,fruit,2441046,233.7810167366779,0.1311178587636439 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441035,2845.931008251767,0.22940561507393653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441034,2747.55188396984,0.24468408041436618 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441048,5112.365703586692,0.024991930032911558 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441045,5188.554206684368,0.031416375645880734 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441030,5308.696591743658,0.04135792211384759 +1015695 Sl10g074590 #30.1,panK4-1,1,m_50,leaf,2441046,4540.582555809175,0.02651840635323266 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441035,43.466419010941735,0.0488190016648391 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441034,41.38814752387811,0.02754112784899765 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441048,39.8121575962957,0.010680853986393402 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441045,34.69735519128585,0.049038488647282996 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441030,23.421614246238295,0.2197180366940723 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,fruit,2441046,37.8777949597164,0.010950171775528705 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441035,272.2604542459182,0.0013389902954030752 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441034,329.84386577824944,0.0846628372906344 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441048,221.12496710445,0.08900779316437024 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441045,275.506413150822,0.006486138200000102 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441030,270.5842059267185,0.0013431313594955974 +1015695 Sl10g074590 #30.1,panK4-1,1,m_51,leaf,2441046,230.8848629774759,0.07025011336700882 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441035,179.81316459913657,0.025161848941801512 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441034,206.74667202367905,0.08577889202344036 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441048,169.4555611831096,6.038094121110227e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441045,169.92708466834736,6.029710876758188e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441030,91.03157445077416,0.27046758126734827 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,fruit,2441046,163.5081489538067,0.016120233475167556 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441035,1516.5177149573367,0.08029366589032261 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441034,2196.8350854350138,0.0806563023144653 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441048,1784.3037133709756,0.009672374399182448 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441045,1723.0651915139808,0.024839444582784864 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441030,1864.673483369972,0.009461641265267495 +1015695 Sl10g074590 #30.1,panK4-1,1,m_52,leaf,2441046,1922.206458489239,0.022658878411133454 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441035,84.88715335625464,0.00398478944800984 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441034,109.41033615851936,0.1142011718336764 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441048,54.6494146995723,0.18727166557736985 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441045,83.336544851227,0.004021689988929156 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441030,29.067525040397825,0.46144912528930715 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,fruit,2441046,253.6874417864003,0.4794417884511122 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441035,222.12313294778477,0.09867208711812436 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441034,268.8886991331854,0.015693327433878412 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441048,235.42951791126816,0.073404964174411 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441045,288.6767748048978,0.015145967075247402 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441030,493.94008611174866,0.24840839562381722 +1015695 Sl10g074590 #30.1,panK4-1,1,m_53,leaf,2441046,474.1730193562116,0.23067096131497378 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441035,489.2112368888485,0.010049339323919604 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441034,874.04119800275,0.26208481898367975 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441048,334.2947829055153,0.15531748571008697 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441045,466.83100209762785,0.010287394950032613 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441030,415.1235863746518,0.06126967493807234 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,fruit,2441046,627.3025309710237,0.11802995514551418 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441035,5238.367846553664,0.1288315007800631 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441034,6982.712524860054,0.004003330091800095 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441048,7112.041087473166,0.0039667641706242485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441045,7502.304405423784,0.02716718884538194 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441030,7295.659960207448,0.015037091184198825 +1015695 Sl10g074590 #30.1,panK4-1,1,m_54,leaf,2441046,6700.132330419412,0.021944112508577085 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441035,61.82589952046808,0.07196011380599088 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441034,74.49272964724244,0.008983330933397315 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441048,71.44263687883371,0.009173081977438713 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441045,100.7587419014046,0.1401521786072346 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441030,118.4831686883559,0.21052610280231332 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,fruit,2441046,63.948042475751535,0.05730330278732487 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441035,155.9069760695769,0.031424819860592645 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441034,179.3056464104718,0.02930359786999137 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441048,150.4791182730966,0.04681413020692915 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441045,203.4282317451948,0.0841208560805411 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441030,289.45349867128914,0.23728843529820987 +1015695 Sl10g074590 #30.1,panK4-1,1,m_55,leaf,2441046,39.81629522731918,0.6242295200971832 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441035,149.6922599143932,0.0638218659962253 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441034,288.4582978934645,0.3487055575289122 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441048,117.10065323946148,0.04281816124701843 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441045,89.9286086129977,0.1574796050083358 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441030,60.25216132971614,0.33140484873384835 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,fruit,2441046,141.36775882010866,0.03897289393302561 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441035,4128.592962185014,0.016020906214550656 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441034,12449.228188490792,0.4953612657310704 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441048,609.9945442178858,0.8144552109903191 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441045,2039.4251908483504,0.2902733823178334 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441030,3950.225103515595,0.0031593170992123554 +1015695 Sl10g074590 #30.1,panK4-1,1,m_56,leaf,2441046,4007.907243366163,0.0031365002258882946 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441035,205.3314061481397,0.09777490704161096 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441034,175.01831622737762,0.02840302712188203 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441048,94.68779588887044,0.23838646694476262 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441045,202.45600233929557,0.09165018284309578 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441030,122.10693317316752,0.1279401505738198 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,fruit,2441046,152.85831925956393,0.030391394223643342 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441035,90266.74080055348,0.05162963661314102 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441034,128210.48411598496,0.20402541470631164 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441048,70031.26555568397,0.05860615067322339 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441045,103021.92215120044,0.10903152319646026 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441030,69071.49848126531,0.06459924738537293 +1015695 Sl10g074590 #30.1,panK4-1,1,m_57,leaf,2441046,29924.27883616605,0.4278744324846384 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441035,485092.867177472,0.14997355521135614 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441034,446820.22548506747,0.11428148981073072 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441048,687229.6182744508,0.3012505349028416 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441045,94658.60701968124,0.5596912244067376 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441030,240060.4990603217,0.15553062896461167 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,fruit,2441046,58641.61645888288,0.76764540043472 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441035,118054.11961844422,0.06776519411956983 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441034,100439.18160241823,0.0024127873656425436 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441048,26368.980904564876,0.5832226069890591 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441045,101558.29695065173,0.0023994567936780342 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441030,102704.602430249,0.007273953064532712 +1015695 Sl10g074590 #30.1,panK4-1,1,m_58,leaf,2441046,93493.1587223906,0.03353611977883908 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441035,479.7220105393289,0.020856147174934225 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441034,460.73130110435153,0.0033142203102722867 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441048,433.88817777485457,0.022755680993171712 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441045,670.259551715814,0.16610951374269556 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441030,375.241982481579,0.08582207622295268 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,fruit,2441046,453.7261304325629,0.0033397066523925822 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441035,1791.9939368680673,0.06037750065152103 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441034,2780.4366568701057,0.25115397028928443 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441048,1024.818700630112,0.18231199355716265 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441045,1189.2432023934564,0.11768835754990192 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441030,1790.2636513657903,0.059957958792407506 +1015695 Sl10g074590 #30.1,panK4-1,1,m_59,leaf,2441046,1328.5471592154745,0.06958206016274282 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441035,113.51378762257691,0.10237155538359399 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441034,179.2648596948949,0.09607499511028861 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441048,74.55537804220718,0.28494119374140703 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441045,109.88022660003044,0.11650062406326045 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441030,429.7237366971855,0.475769173083755 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,fruit,2441046,173.86199439601543,0.08278448673771832 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441035,111.33999443973713,0.11080130784346176 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441034,65.20111805386875,0.1215948444607351 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441048,96.48846646739476,0.04862551658952485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441045,76.04759621521046,0.05476439642630915 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441030,52.48313950291576,0.2158300811169387 +1015695 Sl10g074590 #30.1,panK4-1,1,m_6,leaf,2441046,115.44254170283884,0.12651599262984314 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441035,56.38764755357842,0.030379874906459214 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441034,32.508313687555024,0.20880965984346256 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441048,66.87687275330185,0.10447185509932977 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441045,56.481630671667375,0.031103125017616806 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441030,48.76836202832546,0.03266593236174331 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,fruit,2441046,18.391729428341435,0.4561815325060634 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441035,37.50620636298373,0.004535565213547255 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441034,71.31007326938264,0.2835833090630566 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441048,22.64730933931463,0.2145509614575858 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441045,36.7268888606983,0.004583432848044522 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441030,115.3222350971811,0.4923454773860818 +1015695 Sl10g074590 #30.1,panK4-1,1,m_60,leaf,2441046,14.64238933465528,0.4039556232430348 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441035,134.44235334644733,0.011209584117169324 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441034,119.93114184245708,0.03839455331674779 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441048,112.08217439224198,0.06778997419057609 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441045,127.59096548429268,0.011506598091217235 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441030,349.4815172731935,0.4260976906768503 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,fruit,2441046,196.73204636306545,0.17654858755572 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441035,693.5919654380523,0.024974241791633656 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441034,822.793919691042,0.04921277824495229 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441048,890.3196236193475,0.08346765038127346 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441045,775.7006338345518,0.023615850885437162 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441030,580.031301750063,0.10262686425900291 +1015695 Sl10g074590 #30.1,panK4-1,1,m_61,leaf,2441046,470.6638987800805,0.19336740742746672 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441035,1055.5515276425594,0.01245591624753839 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441034,766.4343404349734,0.12654856710106088 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441048,1199.5315607274747,0.06798815675603809 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441045,1764.5445134248237,0.23560909623216109 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441030,995.863431103906,0.012823737341407515 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,fruit,2441046,993.8308419251724,0.01371105212472612 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441035,1288508.72521641,0.05975374102504194 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441034,1264579.2614395774,0.05161243256762038 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441048,921195.1430537744,0.0859819832171631 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441045,1076662.6975903178,0.018253956119549386 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441030,1169098.7305952956,0.017517566232917225 +1015695 Sl10g074590 #30.1,panK4-1,1,m_62,leaf,2441046,808629.6709796662,0.14258394990327528 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441035,346.0550103189522,0.05944688077771998 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441034,312.39242941031995,0.10389152174348348 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441048,447.5821928342019,0.05228077740467807 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441045,289.3839616488596,0.13711756447303136 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441030,3093.7889570386455,0.8918986626706076 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,fruit,2441046,1465.057954525758,0.567262782496516 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441035,3349.6889499977888,0.015161496511844508 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441034,3330.0111119853123,0.012602698629514464 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441048,2727.205840264773,0.07412506582971679 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441045,3656.3864245384143,0.05320910373539789 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441030,2753.822089038374,0.06990710489860952 +1015695 Sl10g074590 #30.1,panK4-1,1,m_63,leaf,2441046,3139.522592318546,0.012979371453633703 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441035,597.5371398871797,0.033851783565701954 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441034,1044.1154643607963,0.20853184055792218 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441048,385.8051016146859,0.2238487214238929 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441045,593.1183561614881,0.03707532254184187 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441030,694.4157664185706,0.03140288518054346 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,fruit,2441046,892.3005050530448,0.14029445122828044 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441035,6614.885770185593,0.06625904627683399 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441034,10324.993274446928,0.127108382227763 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441048,7217.167544840926,0.02841460774886606 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441045,6529.511451312808,0.07190070733774157 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441030,8193.143009504232,0.026669140232403965 +1015695 Sl10g074590 #30.1,panK4-1,1,m_64,leaf,2441046,8507.13878466965,0.043002122694867584 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441035,70.79984268140943,0.056084363361237344 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441034,72.73253864965969,0.04438790963195349 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441048,69.00449600950063,0.06723926778970668 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441045,94.98292493271548,0.07152888320510509 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441030,146.62474640689004,0.26009061795378985 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,fruit,2441046,88.38642201667557,0.04026889747666074 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441035,2197.862127499839,0.0015405719777228377 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441034,2635.1759198686714,0.08034973972730386 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441048,2182.2968070687557,0.0015460563060458732 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441045,1735.2736453943332,0.10109190260064915 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441030,3222.3411529690584,0.16771164422325002 +1015695 Sl10g074590 #30.1,panK4-1,1,m_65,leaf,2441046,778.3558142667785,0.44928169963707587 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441035,666.4012778192277,0.02154495657970834 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441034,1458.7979683605815,0.3187143720732246 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441048,461.08636656943673,0.18149849657269357 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441045,580.5389522253361,0.08144941297360608 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441030,734.1879229448508,0.020526458545856663 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,fruit,2441046,995.478166111184,0.15275096132263233 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441035,5206.38056106335,0.08927883213578491 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441034,9489.23944834128,0.17141666373668096 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441048,5202.686516249775,0.08958708326604903 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441045,4866.204960746127,0.1186243447569515 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441030,7720.814076883539,0.08184835255579115 +1015695 Sl10g074590 #30.1,panK4-1,1,m_66,leaf,2441046,7582.859445680647,0.07401826418737123 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441035,412.1627539303914,0.009535578245546183 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441034,496.23817884108513,0.09015700941502658 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441048,349.5890471770145,0.06197534743161759 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441045,395.1045124134337,0.00882117521048098 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441030,234.61179071372644,0.23518333056572827 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,fruit,2441046,411.31896068181686,0.008645564846408327 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441035,553.1568076359102,0.22456717211716315 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441034,46.31469486054154,0.8525622823607306 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441048,399.5569605553289,0.0832976113207553 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441045,260.08927006799917,0.10315865362291499 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441030,60.9781028830579,0.7331071807440781 +1015695 Sl10g074590 #30.1,panK4-1,1,m_67,leaf,2441046,2576.491172479896,0.8927475693745954 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441035,256.21456145482216,0.0749543774449255 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441034,228.96895515594423,0.026127171401788107 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441048,202.23171446923897,0.027800167232239215 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441045,182.1184136726052,0.07329557217846094 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441030,72.10438730529611,0.47568774008799153 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,fruit,2441046,242.8094365701587,0.05161613025038214 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441035,894.8830047484025,0.03569447976653173 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441034,802.055795944184,0.011867198914768284 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441048,463.4277551433924,0.250089739894618 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441045,846.4928846732661,0.011551531480382238 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441030,701.0189048284323,0.07034205042687702 +1015695 Sl10g074590 #30.1,panK4-1,1,m_68,leaf,2441046,985.1236972075563,0.07741898572400574 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441035,76.28874236427286,0.03915755161511769 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441034,66.5831998726292,0.019938241146082447 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441048,52.79411931898199,0.12071735427909114 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441045,72.83931095156541,0.01906292488003425 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441030,44.69749897533188,0.19301968080859577 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,fruit,2441046,80.87417273430326,0.06450694737617035 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441035,55.68734967628501,0.31546790601098507 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441034,67.96707705266891,0.22892586170745455 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441048,258.3744029290229,0.35102503098721005 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441045,156.04124245888318,0.13201494462004826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441030,95.4910495872831,0.08126178814605955 +1015695 Sl10g074590 #30.1,panK4-1,1,m_69,leaf,2441046,134.78801185389125,0.06842681239344417 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441035,40.33497344819325,0.09772527311582357 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441034,43.5546361504623,0.06437265845326645 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441048,34.261692887247975,0.16859823064092572 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441045,90.88773616975294,0.2550982376514539 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441030,57.47226786417089,0.05605128628972267 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,fruit,2441046,68.18424984049624,0.1302770182713724 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441035,169.0890945289618,0.15084272499641838 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441034,469.8049481906492,0.29295926314933407 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441048,459.00931976606984,0.2828631800853154 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441045,243.4253314885728,0.00740744659134851 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441030,235.19188771010457,0.007535985612838747 +1015695 Sl10g074590 #30.1,panK4-1,1,m_7,leaf,2441046,106.35943945297907,0.3521822836954578 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441035,974.824060602696,0.018364222862024437 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441034,894.1015385088035,0.01917517485203879 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441048,1535.8832351228125,0.21579618285786673 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441045,660.2211281081927,0.1508725987182178 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441030,1635.0058841631933,0.24295730292849926 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,fruit,2441046,456.9140174381992,0.3107275352724441 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441035,384797.0365662391,0.0037796505881511067 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441034,529266.1268506263,0.14222203177507797 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441048,524456.2447607816,0.1382571928100944 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441045,369932.237807178,0.013329888532187972 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441030,359273.56677104323,0.026026802607685973 +1015695 Sl10g074590 #30.1,panK4-1,1,m_70,leaf,2441046,378128.34545771405,0.0038128337662639566 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441035,110.40011384324004,0.012834889220048051 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441034,106.21317980531016,0.029625999530408897 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441048,117.02289766845314,0.012466437260231888 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441045,109.3176285483098,0.017114208576807677 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441030,141.4068900883154,0.0946661606379453 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,fruit,2441046,128.34583235455526,0.05257736037485161 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441035,3632.6206436266775,0.059414451195531015 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441034,3048.783510409035,0.13550791098453807 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441048,2932.4857938616424,0.15239858094248993 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441045,5455.118256961417,0.11716967189611704 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441030,4697.753233561291,0.05225570231773036 +1015695 Sl10g074590 #30.1,panK4-1,1,m_71,leaf,2441046,5238.373295618848,0.09956194593600687 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441035,84.22349245115747,0.021246166394319754 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441034,92.66900281104267,0.020255077195025173 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441048,93.45047005978068,0.023902077727520954 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441045,82.2826516289055,0.03137113375251244 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441030,37.180314622373686,0.37636635203113156 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,fruit,2441046,136.61922037601136,0.18883239017175968 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441035,630.6179238800819,0.03497149674426181 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441034,627.7256071140392,0.03297503172089877 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441048,576.003797173506,0.004369467255998849 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441045,572.739077065158,0.006837998338314666 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441030,387.4050975020067,0.17662948277952184 +1015695 Sl10g074590 #30.1,panK4-1,1,m_72,leaf,2441046,587.6527285085057,0.004325943273694843 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441035,78.17716709475287,0.008784824130794178 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441034,83.29321724016575,0.03631453251425265 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441048,75.46394368530169,0.006555607385550166 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441045,77.75945820636142,0.006458121230558778 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441030,72.97073014684689,0.021146412890394206 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,fruit,2441046,52.81889124541915,0.1615058243077785 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441035,1641.9930987132032,0.039643643506201975 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441034,1788.0318194004226,0.002639727823698035 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441048,1718.3693032527283,0.019898465053274972 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441045,1924.8409345588311,0.02937987504513062 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441030,1809.834033995529,0.0026237799211932256 +1015695 Sl10g074590 #30.1,panK4-1,1,m_73,leaf,2441046,2021.123416965272,0.050577862930193174 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441035,165.39183683709354,0.00860533882117176 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441034,174.0996664930569,0.013678529870370326 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441048,147.33331868748525,0.058818437851342775 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441045,178.40392950883717,0.02428500656728172 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441030,163.0298706918654,0.014852225223440652 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,fruit,2441046,172.01152457477482,0.008438135805094671 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441035,782.5143937264205,0.0642491151050284 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441034,990.5836290907454,0.0381496964286816 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441048,897.1778363015942,0.004862913575549577 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441045,1061.453091745017,0.06815935647497096 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441030,917.3826335887755,0.004809064613137792 +1015695 Sl10g074590 #30.1,panK4-1,1,m_74,leaf,2441046,803.8042767233748,0.05259113732598619 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441035,143.8399612019093,0.03338038389137843 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441034,126.63352519981608,0.021950476506181094 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441048,131.84921427388278,0.0044216272994952455 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441045,134.5476871230318,0.004377063279484172 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441030,86.01038340551476,0.1899482897451532 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,fruit,2441046,165.5966390392988,0.09455234471270568 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441035,8131.366139215268,0.06335569619088455 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441034,10347.383093174596,0.041311315242830826 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441048,9846.07976798744,0.01974413677565101 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441045,10011.287236100134,0.026970708883289785 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441030,8970.869272819076,0.02068468510609245 +1015695 Sl10g074590 #30.1,panK4-1,1,m_75,leaf,2441046,8160.852157680981,0.06178370287959467 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441035,65.84774469500863,0.025336361264785445 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441034,120.55083044198216,0.23729294035955473 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441048,12.546468553051952,0.7453557636901056 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441045,78.44414670836906,0.0506832771424679 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441030,73.75927686833273,0.023939384167418698 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,fruit,2441046,38.116577153400875,0.26276337177737563 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441035,191.90980175998052,0.10468214285314703 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441034,19.14185454313598,0.8964310022146997 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441048,240.34817426149027,0.2024258135146777 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441045,109.69969334111434,0.1382096004321185 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441030,281.9079598545155,0.27169232466729953 +1015695 Sl10g074590 #30.1,panK4-1,1,m_76,leaf,2441046,83.89551196345212,0.25467628533648967 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441035,726.0521320944076,0.0024590658273759836 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441034,655.9841312054037,0.04161540570129718 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441048,805.3867094766441,0.047495719321793306 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441045,630.06316680330406,0.05912464755817881 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441030,755.9135958340477,0.019963417352222734 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,fruit,2441046,717.8532490498112,0.0024730688962737446 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441035,15359.262592707602,0.09099538157017495 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441034,21644.606622172847,0.05798395014656421 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441048,18770.362670534763,0.003893083131457864 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441045,15070.170071062814,0.09924759355456114 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441030,19108.39638798738,0.003858494756129538 +1015695 Sl10g074590 #30.1,panK4-1,1,m_77,leaf,2441046,27359.45015131577,0.1597416179963549 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441035,70.68655003053466,0.022014898908988778 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441034,67.48964780648609,0.0019152749525135349 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441048,66.89568850241675,0.0019237589038294534 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441045,60.054629906384655,0.04877539191251179 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441030,74.07904333435985,0.042373478342283555 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,fruit,2441046,58.38947832994123,0.06098729169242145 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441035,100.7940559204493,0.009758880155720906 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441034,109.4351043989748,0.025962854981051997 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441048,98.95220096473632,0.017768343045629242 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441045,107.39077397316024,0.01777317080158758 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441030,103.67137679107124,0.0024650645718358177 +1015695 Sl10g074590 #30.1,panK4-1,1,m_78,leaf,2441046,102.49782867327887,0.0024791362390268468 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441035,118.2630456184436,0.008798262725351336 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441034,119.03322527764732,0.011617404798864417 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441048,113.5195340377183,0.008980196621986458 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441045,103.59947217082284,0.04869325370472044 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441030,130.98428408482752,0.0531683943028467 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,fruit,2441046,98.50490281664295,0.07059294955614903 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441035,250.3169687067776,0.006983455111688297 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441034,262.3939340292049,0.013480044832156146 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441048,241.13384419659175,0.023215576256061077 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441045,254.67614923830175,5.145285553931345e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441030,254.0730535794117,5.151388640607379e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_79,leaf,2441046,258.4817667865536,0.006956167475472785 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441035,54.34794462101198,0.01258881862684258 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441034,83.80291100008357,0.17548716183619528 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441048,57.54480301045399,0.012234164884586729 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441045,46.94301700547582,0.07620094476382788 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441030,26.136386980824003,0.33052639105398396 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,fruit,2441046,69.89255294767001,0.09665896130455764 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441035,242.1193994176882,0.07912058027997748 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441034,285.41955203945247,0.007666448057976005 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441048,361.0445389819501,0.09441061216729851 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441045,294.7912811510339,0.006364466287901216 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441030,318.2217027449954,0.03957962699307638 +1015695 Sl10g074590 #30.1,panK4-1,1,m_8,leaf,2441046,286.2141122476589,0.006459124704732755 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441035,51.711389134663506,0.010007344183278422 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441034,53.53968027240338,0.025096913048545 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441048,49.35549016806134,0.010243390887344939 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441045,44.14927357369348,0.058655298147302304 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441030,59.241494445537754,0.06904714534790868 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,fruit,2441046,49.147164070374814,0.012080397417926214 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441035,158.94947731849155,0.012481047132743228 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441034,143.05534241971415,0.058236070047577915 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441048,169.73159516146336,0.01602254152769156 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441045,168.21801629457494,0.01213235599268181 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441030,184.91959130256305,0.05324277364361896 +1015695 Sl10g074590 #30.1,panK4-1,1,m_80,leaf,2441046,152.87443178687676,0.029405295438830414 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441035,265.9797475202032,0.011147227774327195 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441034,298.0836100597341,0.03834230007363715 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441048,180.16960286593095,0.18031427594103588 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441045,279.8105272444835,0.010868252614632201 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441030,189.36441589544236,0.15869742460919722 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,fruit,2441046,319.23232511962306,0.06811106388850074 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441035,5892.313890566943,0.04115575476491529 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441034,6310.926175661476,0.011348529047269462 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441048,4350.2224003436795,0.17293016858444776 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441045,6834.308790742053,0.023252968454932965 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441030,6645.0942672620095,0.01105951728582788 +1015695 Sl10g074590 #30.1,panK4-1,1,m_81,leaf,2441046,7529.988298830536,0.06535267239735143 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441035,6361.7046780768505,0.02751901619276209 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441034,7100.559002001444,0.02020001984909081 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441048,6150.598693167728,0.04217512906433907 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441045,7714.650790394804,0.056223751479290485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441030,8050.800778347219,0.07474655922001938 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,fruit,2441046,6455.158708851411,0.02118559623695848 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441035,142235.50813668952,0.15037200120559113 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441034,208884.0317636338,0.016525211579664578 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441048,297997.2259802469,0.17083219147367945 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441045,230831.2958716727,0.059914659851363794 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441030,193286.2963830285,0.017178965328850104 +1015695 Sl10g074590 #30.1,panK4-1,1,m_82,leaf,2441046,155091.2116632712,0.11279284087416297 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441035,202.09763498150852,0.028379589366068103 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441034,120.19580077629698,0.19729234671893892 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441048,156.37923747491288,0.08300255078651331 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441045,192.25948394236136,0.006706130345979222 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441030,186.36756590671283,0.006811308856807585 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,fruit,2441046,239.69202466605688,0.10247194197256526 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441035,1725.5598054722752,0.0275392099528724 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441034,1141.5191279133169,0.15190761280949383 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441048,2577.0333617051156,0.2017292348973192 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441045,2046.931532232469,0.10171251022844974 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441030,1199.8831791195637,0.1302518408673894 +1015695 Sl10g074590 #30.1,panK4-1,1,m_83,leaf,2441046,1513.51368441184,0.029404453992937007 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441035,331.63286743455905,0.08083437650521708 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441034,1007.5826555583692,0.4017887404550633 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441048,297.58765521776155,0.12787703104998194 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441045,427.8519935858945,0.02980161740753884 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441030,371.10230588084835,0.03199828963845475 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,fruit,2441046,553.619885118512,0.1417197383472404 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441035,12952.98520192442,0.03047765916471068 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441034,16747.255566738328,0.14205143759441174 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441048,12637.386706109311,0.019765064972375512 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441045,11392.468449912243,0.025274375674579908 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441030,11512.895268592682,0.020707656247779482 +1015695 Sl10g074590 #30.1,panK4-1,1,m_84,leaf,2441046,9207.418130502434,0.11775434427106957 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441035,47.99213390822168,0.016489278479728586 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441034,47.84969940773726,0.015198431654423583 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441048,44.55855742388084,0.01574966004560885 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441045,39.372953933477866,0.06948278351591308 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441030,67.29139668753072,0.16327876030550859 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,fruit,2441046,33.36452432031699,0.14139584475208444 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441035,372.6115225526562,0.04854222502120553 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441034,462.38587483687496,0.04520605278864309 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441048,400.88850638586297,0.016774900757495992 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441045,370.13662134948584,0.05143644945660819 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441030,432.4635309082092,0.01615098404009485 +1015695 Sl10g074590 #30.1,panK4-1,1,m_85,leaf,2441046,436.3869375312632,0.02007323646474335 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441035,971.0051013429172,0.027436390936654398 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441034,1075.6453741200985,0.07188399323258299 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441048,1031.9149000880298,0.05385876277157875 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441045,753.7159204267443,0.08257743182865651 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441030,618.451737085415,0.1684793069286057 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,fruit,2441046,852.1143146879208,0.029287259527858378 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441035,9353.401739411323,0.07392066700300104 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441034,7763.506604735418,0.006990994379833193 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441048,4679.114657978359,0.22688523382980863 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441045,9677.506439135914,0.08871454776541654 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441030,6659.009839350572,0.0736392645864048 +1015695 Sl10g074590 #30.1,panK4-1,1,m_86,leaf,2441046,8015.473073998004,0.006880238356233193 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441035,329.56383054031227,0.029245892873185575 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441034,310.4005550477832,0.0032288400047573163 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441048,305.80221293600073,0.0032530253155464983 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441045,251.2975454799422,0.08850540248123417 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441030,42.021323991301614,0.8652239173080631 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,fruit,2441046,440.13788798717275,0.15489510597391387 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441035,27344.381087389025,0.17259775126386767 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441034,19323.520025655427,0.021815894827078353 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441048,17534.356439270006,0.020380516070599874 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441045,16571.654307437646,0.04490448160644611 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441030,19219.282314832803,0.019466819501051447 +1015695 Sl10g074590 #30.1,panK4-1,1,m_87,leaf,2441046,10779.682370649203,0.23166438242826892 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441035,95.13361475139084,0.028892797774220602 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441034,110.76972032038314,0.09497985818599353 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441048,82.88736900643178,0.030952846418122792 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441045,78.00733692438658,0.057305749119278326 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441030,32.74665722580922,0.43427422711787056 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,fruit,2441046,152.87101141472203,0.23488393794781648 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441035,1475.8104238030417,0.15337926093488097 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441034,1066.2556898854502,0.012210049165541914 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441048,801.6667632487397,0.11165743423962704 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441045,1034.7643458779555,8.098564187464241e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441030,1038.627127533799,8.083490386758818e-4 +1015695 Sl10g074590 #30.1,panK4-1,1,m_88,leaf,2441046,668.4436202368038,0.19058652990346125 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441035,3079.2631220885255,0.014178007354842759 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441034,2850.3784709033325,0.047722279073356244 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441048,6001.606137581447,0.2756426827671179 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441045,4832.103832593966,0.1815114496905137 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441030,3283.632569975935,0.013729746558748701 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,fruit,2441046,2393.4161670496096,0.12360658789768975 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441035,67712.44092315894,0.05159689007976187 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441034,77715.59275425221,0.008242804049061192 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441048,74793.36581222664,0.008402282209715395 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441045,68416.77980373023,0.04710273052647551 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441030,85970.64340620367,0.05208481725219194 +1015695 Sl10g074590 #30.1,panK4-1,1,m_89,leaf,2441046,110264.4094370968,0.160169996014778 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441035,36.54140472675689,0.06058810803155601 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441034,40.82791344523053,0.10876005492088536 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441048,69.79514058745433,0.3416280559046001 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441045,19.8601000233904,0.2042156990338011 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441030,26.477255538516676,0.07932416354249261 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,fruit,2441046,27.02492351194766,0.07043265702614532 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441035,136.5847244393692,0.003260873184513624 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441034,148.59989742039593,0.03335550563860146 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441048,136.878244241318,0.0023285781839610387 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441045,135.59132995963196,0.006431083419026429 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441030,142.7285692646739,0.01584790838347505 +1015695 Sl10g074590 #30.1,panK4-1,1,m_9,leaf,2441046,138.35,0.002316159487592895 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441035,88.15690357573146,0.010864086742867096 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441034,66.63254415058721,0.11070584513700066 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441048,83.80103751767899,0.011142845322979156 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441045,102.92140160499284,0.07811345102340872 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441030,4.054709916695966,1.326432451638359 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,fruit,2441046,165.33989314484563,0.28398541175037706 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441035,2652.6759261214083,0.0866692391130841 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441034,1820.8214442226792,0.07674759740389092 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441048,2657.8352145825347,0.08751309431074805 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441045,2385.3728053145237,0.04054130679502643 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441030,1693.5185646998946,0.10822499510008798 +1015695 Sl10g074590 #30.1,panK4-1,1,m_90,leaf,2441046,1960.1792089520973,0.04471917848365514 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441035,461.5556607992393,0.00260101401414925 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441034,467.10081483127766,0.0025855290893863625 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441048,483.7384059794932,0.01778547337899905 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441045,317.8006743982076,0.16467028132188544 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441030,715.5908555961488,0.18783968636001536 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,fruit,2441046,385.2145189462703,0.08112244824357662 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441035,1012379.1910153496,0.028732391592170003 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441034,1112236.589160736,0.06958635966357196 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441048,598301.2248111475,0.1996909263561415 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441045,973426.9774304164,0.01169255979167616 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441030,921710.909346073,0.012016090445786887 +1015695 Sl10g074590 #30.1,panK4-1,1,m_91,leaf,2441046,669740.559688957,0.1507042175276183 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441035,76.20043903672608,0.004757223813813827 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441034,71.81397107483468,0.020991307327524966 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441048,121.11094260992364,0.205983134503823 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441045,14.5389065940988,0.7146685033530225 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441030,74.54016299286148,0.004809911699018787 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,fruit,2441046,148.83313115693684,0.2954993687897285 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441035,151199.74485897555,0.1965052590750478 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441034,101747.53996490204,0.02447811848108028 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441048,288682.9510119483,0.47737533690590883 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441045,84118.30944723822,0.058155263297476445 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441030,90595.19846415245,0.025940618517787506 +1015695 Sl10g074590 #30.1,panK4-1,1,m_92,leaf,2441046,60489.210755228625,0.2013678812409756 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441035,12.387901850005036,0.9118557878092772 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441034,1150.44206758141,1.0560112103665302 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441048,274.9966739099446,0.43447389749218557 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441045,2.7164671712347443,1.570849082658585 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441030,15.292837669315416,0.8203654649736196 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,fruit,2441046,186.95483802258607,0.26688316475080587 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441035,35.83890345670842,0.4610730772396381 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441034,176.48077938621913,0.2312696224979769 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441048,143.08706463567242,0.14017258385905773 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441045,337.13139414374155,0.5123714059468414 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441030,62.98874413069243,0.2161648410880117 +1015695 Sl10g074590 #30.1,panK4-1,1,m_93,leaf,2441046,64.14539718144572,0.20826229197828994 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441035,344.7259944211939,0.021137012256841725 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441034,379.11144232734654,0.020155847158560558 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441048,302.3741462379883,0.07806639019663608 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441045,280.19954457458186,0.11114362026046143 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441030,618.0122476001894,0.23238603657964685 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,fruit,2441046,510.9220809509222,0.1497436270336716 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441035,3709.713605166107,0.08801972995131857 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441034,3213.402698974138,0.02564450127265694 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441048,2841.1800616760397,0.02782189454835038 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441045,2876.506034145151,0.022455363448252275 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441030,2800.133324464451,0.03414194268121573 +1015695 Sl10g074590 #30.1,panK4-1,1,m_94,leaf,2441046,3181.792197305418,0.021351159639999562 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441035,61.05394116630429,0.06747879798724798 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441034,70.27034197107652,0.006420434798601438 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441048,55.06198770449758,0.1123406167291141 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441045,72.3634727485066,0.0063268987949356426 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441030,94.39876672629258,0.12177381865229697 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,fruit,2441046,75.8101754272381,0.02653499977456253 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441035,28.34130661421435,0.19300821212964125 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441034,24.18212408081467,0.2619336354585684 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441048,102.08927882503524,0.363552055196914 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441045,220.2204000772703,0.6974294665868497 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441030,51.0254243161259,0.062358544195998844 +1015695 Sl10g074590 #30.1,panK4-1,1,m_97,leaf,2441046,37.37575858445864,0.07283806477065036 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441035,937.1324714619152,0.0953755325843253 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441034,1496.8387164185444,0.10799848891743524 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441048,899.1532965725315,0.11334277806867554 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441045,1379.7017644253522,0.07260870074422643 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441030,1157.456675631706,0.0036717748806101014 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,fruit,2441046,1177.1112505612366,0.003640991664936255 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441035,20663.23640040976,0.01692840346378599 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441034,18394.4585962485,0.033582931088148804 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441048,13911.823522147735,0.15488588105693246 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441045,35792.21476603987,0.25551863181984036 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441030,20486.359272052305,0.013194843866715544 +1015695 Sl10g074590 #30.1,panK4-1,1,m_98,leaf,2441046,19260.236364587123,0.013608328312153972 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441035,8035.562951042854,0.013022703375205502 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441034,7465.774481391874,0.04496414404654292 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441048,11265.067840411642,0.1336948003689029 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441045,7460.8418344566435,0.04525117780929255 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441030,12223.389424976507,0.16915263706594885 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,fruit,2441046,8524.767811066007,0.012643547851351133 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441035,67918.03002168836,0.05185240728813323 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441034,53108.28565110422,0.05497039080797972 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441048,77562.70153588412,0.10952025398039211 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441045,61756.233291056335,0.010548125817091858 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441030,58792.50492660592,0.010810709086595871 +1015695 Sl10g074590 #30.1,panK4-1,1,m_99,leaf,2441046,43037.85670050569,0.14628203812958596 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441050,147.3953028679332,0.05072175183975558 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441037,223.66247728967232,0.23183123885440393 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441044,8.281885166035893,1.1996326875682122 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441032,12.843248176582778,1.0090870172612227 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441033,144.95235017917318,0.04346336917614435 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,fruit,2441039,117.3437826791792,0.0483018080209181 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441050,37.86228219545058,0.9801909801354061 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441037,394.37865558231266,0.037515633993551845 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441044,834.9147385943279,0.36324435945676825 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441032,14.847822575079316,1.3867349989055957 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441033,1216.8656881441834,0.52684487732866 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_1,leaf,2441039,329.1034000014754,0.041065399125141955 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441050,61.39857351232314,0.05326127377222911 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441037,55.648393087454224,0.010555620670772203 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441044,52.97590999171443,0.010818581894908474 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441032,62.22132012411963,0.05904221369851714 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441033,44.64541199765587,0.0851201723351287 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,fruit,2441039,46.4980079060671,0.06746266042017002 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441050,338.6989595091602,0.005831853131523346 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441037,314.6630888630084,0.026136207790898425 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441044,328.3709100932317,0.0076173327249469125 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441032,356.5258295788567,0.028108989736176593 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441033,329.6634330599908,0.005911232367282526 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_10,leaf,2441039,352.03594924486345,0.02260500572053692 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441050,113.1587858333092,0.07903709433340378 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441037,244.84797962098656,0.2561711514923841 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441044,109.46270056457438,0.09345921480885933 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441032,158.3321714998695,0.06684379481845992 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441033,66.10014388238811,0.31252296843754634 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,fruit,2441039,173.77824171685612,0.10727002546279252 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441050,2750.621744920518,0.0924164399968137 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441037,4014.525869636877,0.07178694889664072 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441044,2862.876089996977,0.07504476051475395 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441032,3256.564889902595,0.019087575667473988 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441033,3549.205729654787,0.018283861989054184 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_100,leaf,2441039,3886.6149761518063,0.05772420782771581 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441050,41.935142856341024,0.09762545612233398 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441037,45.59302102150741,0.13394569907173315 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441044,31.36900131260839,0.028451978313814186 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441032,35.6167860277559,0.026702056514223083 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441033,22.825731281120415,0.16652797053004087 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,fruit,2441039,25.93115198704961,0.11113086004514527 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441050,27.507425707748887,0.14032800261354184 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441037,40.857311771350815,0.031491837298183833 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441044,27.147312644905934,0.1460511067407475 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441032,110.54432900384046,0.46375851659522427 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441033,35.141700324723125,0.03395518037437406 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_101,leaf,2441039,244.5682703379705,0.8086221607984854 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441050,107.32919675019184,0.008386753052431306 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441037,103.2236519966838,0.008551905959596873 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441044,100.71615199675642,0.019232001487030637 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441032,117.28829527490686,0.04692354801554366 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441033,109.22974349165668,0.01600978771664474 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,fruit,2441039,74.17355222117293,0.15208204790406743 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441050,513.2635766718319,0.03444004639127396 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441037,576.2627482518532,0.01584005369831365 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441044,530.8826080334022,0.019781994513770496 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441032,547.3724378148044,0.006497567070113952 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441033,586.6445042684813,0.023594514127950994 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_102,leaf,2441039,563.8742718452818,0.006401786888975636 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441050,15674.69226810824,4.310317675502162e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441037,32820.5869881372,0.3205162889274158 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441044,1017.7722405546928,1.187979453667606 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441032,41192.83136008959,0.41919158879673013 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441033,359.92251816500436,1.6394210364394675 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,fruit,2441039,15705.821579999189,4.306043981090468e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441050,1016708.5128168308,0.043441697421762626 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441037,541568.967082591,0.23010099196068445 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441044,910355.915283047,0.004543543961685437 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441032,929504.0021890814,0.004496501602256231 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441033,1008657.6502939388,0.039989024371726245 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_103,leaf,2441039,787182.971824114,0.06767907150417685 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441050,15366.421944188927,4.310317675502162e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441037,32175.112562930117,0.3205162889274158 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441044,997.7559638134752,1.187979453667606 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441032,40382.702060622265,0.41919158879673013 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441033,2801.1082992296765,0.739673885735399 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,fruit,2441039,15396.939043546712,4.306043981090468e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441050,1016708.5128168308,0.043441697421762626 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441037,541568.967082591,0.23010099196068445 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441044,910355.915283047,0.004543543961685437 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441032,929504.0021890814,0.004496501602256231 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441033,1008657.6502939388,0.039989024371726245 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_104,leaf,2441039,787182.971824114,0.06767907150417685 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441050,52.26115864769955,0.008331492341089985 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441037,54.28566863476224,0.008174665091593258 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441044,47.31739213225873,0.05148972554237097 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441032,55.38267740403639,0.01686342102727756 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441033,63.71631138936341,0.07774009975333906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,fruit,2441039,41.66114641235176,0.10677930980295547 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441050,69.30517686401627,0.27535613283563753 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441037,205.5877170339212,0.19687535490553643 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441044,75.08691049206521,0.2405575736793848 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441032,99.03181381990709,0.1203470755433953 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441033,233.51687114545197,0.2521964539791366 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_105,leaf,2441039,162.27564389132337,0.09413153203902613 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441050,256.4597693429416,0.005356437273507986 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441037,291.67940468069577,0.05053008030876738 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441044,262.825114038362,0.005291176918267304 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441032,241.89352888629196,0.030751434294801427 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441033,231.89419680980853,0.04908580412200436 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,fruit,2441039,285.0074620481385,0.0404805462236717 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441050,3479.299123579356,0.004345648047265005 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441037,3576.9469053607936,0.0076750779947163394 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441044,3879.481567109269,0.04293627698664082 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441032,3549.2779472654574,0.0043025949608668235 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441033,3388.6624802873503,0.015809101607636045 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_106,leaf,2441039,3357.855237301618,0.01977544667279485 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441050,528.855719098169,0.1519943879386827 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441037,775.1367357749525,0.014046726581015356 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441044,726.2201181801955,0.014263317330257319 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441032,798.3005453403362,0.026834832792310248 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441033,607.3235660315661,0.09191145973915038 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,fruit,2441039,774.7138584014158,0.013809731718289697 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441050,11434.640497626777,0.15842162881063082 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441037,17689.617455436553,0.031074297378426152 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441044,14811.084173926973,0.04605729373688572 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441032,16627.419401966054,0.004180707504130687 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441033,16353.761672481773,0.00302647947445589 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_107,leaf,2441039,16582.487496109447,0.0030055346413133677 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441050,230.64479545476027,0.12940634248681038 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441037,296.28772612683713,0.02063634062325681 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441044,356.4822818403688,0.05968794748104589 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441032,325.1247913636782,0.019700084911113525 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441033,416.4529022890995,0.12721589145854084 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,fruit,2441039,238.2627962297059,0.11529376728461971 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441050,966.6801733316944,0.23866961516741458 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441037,597.3665590598391,0.02962771077067039 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441044,518.5794715974098,0.03179787524805855 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441032,76.04164266677877,0.8655617060999306 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441033,622.6260908548393,0.047614119523794685 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_108,leaf,2441039,36.786345867306224,1.1809265463195824 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441050,86.68729810157977,0.0020472690116040138 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441037,44.126767202061906,0.29120608641616963 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441044,57.822293671071314,0.17381288282450513 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441032,104.2271521200482,0.08207267344439817 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441033,85.87193166246608,0.0020569655882760607 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,fruit,2441039,90.92191089850002,0.022760356764567558 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441050,1084.8578137978811,0.02074802079388105 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441037,1112.6603336026894,0.03173780511462443 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441044,1100.630425585706,0.02701671359301594 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441032,757.4844700691881,0.13525106722011682 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441033,983.638714156611,0.021789187178075764 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_109,leaf,2441039,853.0748072315105,0.08363768390791959 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441050,1139.2384360978488,0.29954804385578226 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441037,3515.4417857887606,0.18981723779747783 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441044,2255.104583632467,0.0029959851070260335 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441032,2168.3551803635414,0.020032250915224203 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441033,2652.3867239001784,0.06747417265075395 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,fruit,2441039,2286.32587598167,0.00297545879202632 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441050,1162.5428288271294,0.37361615145934346 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441037,8305.804094172954,0.48035657035198787 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441044,1992.144336155562,0.13970431198678845 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441032,2418.6360127950634,0.05545459789985108 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441033,3077.470095624022,0.04916872849513876 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_11,leaf,2441039,3609.9519126557952,0.11847630380197494 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441050,682.4520003924624,0.05984994692844792 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441037,756.9771836451337,0.014839268577083953 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441044,811.7650798772166,0.015508307081198325 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441032,873.0397797765628,0.04711197461555594 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441033,752.1131286927202,0.017638888352670357 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,fruit,2441039,809.6009259851411,0.01434893819337324 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441050,2043.84807369059,0.021489860556022755 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441037,2949.9847860705663,0.13788130559622358 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441044,2251.2043227492995,0.02047644341640753 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441032,1717.643118125331,0.09700553691245695 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441033,2530.71644026497,0.07130501579126225 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_110,leaf,2441039,1771.43751574005,0.08361263261911844 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441050,124.88258158103052,0.03388650428876794 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441037,86.39339549802172,0.1939078288927163 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441044,115.0416704045929,0.06953319316160878 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441032,222.53821659674992,0.21701623112505075 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441033,184.25203159816877,0.1350239129712434 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,fruit,2441039,145.15136756616778,0.03143275975959092 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441050,24893.71437806113,0.010477985536993195 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441037,26371.197519719462,0.03551813485528221 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441044,24853.47031118189,0.009775321452708319 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441032,15366.000772384166,0.19905086607608258 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441033,23747.1388129142,0.010000425855008821 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_111,leaf,2441039,14806.01132637667,0.21517363948323442 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441050,704.3107960405964,0.2915293045644627 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441037,1605.7864572761864,0.06639414078635753 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441044,499.1785455839638,0.4410377387581441 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441032,4371.034005699572,0.5012905351214463 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441033,1350.5992311997247,0.008767151927314476 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,fruit,2441039,1405.6827486865627,0.0085936648657845 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441050,158913.72051274186,7.353350974446116e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441037,258848.8977123894,0.21114958927133198 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441044,159452.31275619043,7.340921531371336e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441032,140115.3340502546,0.055411064099712526 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441033,176988.432189364,0.04604815153649966 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_112,leaf,2441039,127940.45087732072,0.09488885375219525 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441050,218.35673243926215,0.201062542537771 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441037,513.7977558020012,0.17056307369856016 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441044,324.12179659946395,0.029520891771483537 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441032,352.91441755750043,0.00744027158964089 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441033,374.56887895784183,0.03330256189905745 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,fruit,2441039,340.9252494638537,0.007569962340194802 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441050,171.1531027374988,0.2646492461400838 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441037,664.9460516631659,0.32475238883210755 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441044,283.4761377905301,0.045517515661886776 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441032,64.35765441983216,0.6894338153522683 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441033,346.12284607631284,0.04119624338233674 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_12,leaf,2441039,536.9996420443633,0.23193997344206618 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441050,72.05860587579237,0.030937134250494047 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441037,82.69935026751477,0.02887910772023483 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441044,71.60738431835506,0.03366517972046168 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441032,98.91248592739638,0.10662812716241876 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441033,137.81080394444726,0.25066027647729316 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,fruit,2441039,20.41184954763306,0.578740631225455 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441050,170.60684659749188,0.017039762611032128 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441037,115.62700250888696,0.1518974259499397 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441044,163.98377451452367,1.5581456395041826e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441032,91.41848698813575,0.25392266390764884 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441033,278.9328130928777,0.230542913620996 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_120,leaf,2441039,164.1014626063204,1.55758681428253e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441050,96.84914640803406,0.10981463495487387 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441037,75.03637219076323,0.0010093335146221794 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441044,75.38555831037169,0.0010069931845722024 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441032,103.05576861948248,0.13679114432736594 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441033,46.54839179592,0.20837648130678255 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,fruit,2441039,20.35477201150376,0.5676149200854745 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441050,967.391792336474,0.08248551972174001 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441037,1296.1110752474422,0.04455430357787238 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441044,1442.6637933956886,0.09107721432467386 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441032,1026.862108150821,0.05657578967829657 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441033,2343.249791536069,0.30173066896635214 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_121,leaf,2441039,1043.361259055092,0.049653211155773036 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441050,162.3782621071047,0.10546868785226415 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441037,298.71572144117334,0.1592615033677589 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441044,155.99553361968557,0.12288441275790163 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441032,425.6176158670091,0.3130230178483093 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441033,183.8255904302006,0.05159060724575237 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,fruit,2441039,230.19941588728017,0.04610764050336913 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441050,8437.237101923836,0.081941429224071 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441037,10368.99680750093,0.007595057784318904 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441044,11154.524680329629,0.039309385759658255 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441032,10335.827779225036,0.006203581298918515 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441033,9668.256698765052,0.02279351027730403 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_122,leaf,2441039,10042.647112378336,0.006293480650551686 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441050,142.73403755227147,0.029773281150359043 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441037,111.96843891755728,0.075658646563463 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441044,114.29417675725956,0.06673016598070047 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441032,172.58725445025317,0.11225445015478641 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441033,356.0018125333658,0.42669793931909705 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,fruit,2441039,123.81938636542196,0.031965622440006225 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441050,152.52003034624155,0.11617397588381762 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441037,369.559747214175,0.2681838024765768 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441044,233.09790936580328,0.06803751949474579 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441032,222.47040085715332,0.047771378446471946 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441033,154.9364475423162,0.10934726486385671 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_123,leaf,2441039,176.1236886662181,0.05368308631722085 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441050,10609.961776272325,0.055199533093872155 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441037,14962.4468349029,0.09408926786934746 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441044,12807.414653111786,0.026548118080726546 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441032,9168.854262980458,0.11859828263274563 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441033,11288.496215724806,0.028277260668143178 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,fruit,2441039,13590.41241089338,0.052319283515307013 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441050,130982.41249631294,0.12044954736727664 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441037,232370.8707989221,0.1285191529144738 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441044,220607.40928514017,0.10595756191822225 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441032,169568.4059513524,0.008317595027637736 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441033,164637.16148138518,0.021134662788685254 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_13,leaf,2441039,176126.14042970064,0.008161285639339155 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441050,96.87783838293456,0.10066565597704114 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441037,156.93289005003652,0.3101551887811669 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441044,56.79205133499004,0.13127122820454695 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441032,114.2746013192341,0.1723909308645648 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441033,55.74469219284553,0.13935526218928618 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,fruit,2441039,21.415462599920236,0.5548313238140881 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441050,135.31054485798492,0.008205227153014416 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441037,30.82169237133914,0.6342699342028417 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441044,132.87485515722102,3.163884440189335e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441032,21.17060039828217,0.7973932408898834 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441033,382.31872836150006,0.4592991573223939 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_14,leaf,2441039,132.6813239897359,3.1661910462954523e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441050,91.63886224118146,0.07928192815484136 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441037,104.31230434275771,0.13553777908899534 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441044,76.85672240448474,0.002884099471159418 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441032,54.179831993031506,0.14896010634489176 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441033,75.83931117355863,0.00290338055728534 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,fruit,2441039,53.24201825882858,0.15654325030765492 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441050,686.8416816417487,0.026006693744208942 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441037,510.4965512563578,0.10285713663391638 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441044,781.5668693629214,0.08211619222933564 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441032,536.6174799055212,0.08118513374059555 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441033,1040.863561528811,0.20654385593588298 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_15,leaf,2441039,606.9964451799132,0.027663801442626923 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441050,252.0377067611739,0.8980344940664742 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441037,11.58032631643923,0.4397102280002354 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441044,151.42602069503005,0.6767694843907603 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441032,19.00668566978835,0.22452463287212354 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441033,3.5879857681314444,0.9485803136076459 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,fruit,2441039,44.74050071032636,0.14726981482633894 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441050,35.60599607417441,0.08685692385938437 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441037,219.7859110184362,0.877333633550021 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441044,11.117434085710208,0.41866165252622967 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441032,29.65854111547168,0.0074835687909935444 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441033,5.452798431070132,0.7280467719696552 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_16,leaf,2441039,28.645171653248003,0.007614786702523357 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441050,9961.482056979848,0.01809158257416499 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441037,25321.14157686211,0.4232509070411896 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441044,9148.59200190789,0.018878114577746796 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441032,4587.308423035299,0.3186744339892522 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441033,8991.630296059675,0.026393932508840035 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,fruit,2441039,13943.455457801036,0.16413803921559245 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441050,35411.76910343617,0.026717302933144893 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441037,43436.15027939377,0.06198640027551594 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441044,34445.55041686361,0.038731797865820816 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441032,28245.646585530205,0.12491340590180489 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441033,51311.88936927253,0.13435307948219233 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_17,leaf,2441039,39905.56202980222,0.025168505044726786 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441050,20.98670306315514,0.0873943519164988 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441037,32.97680578320234,0.10887001675410435 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441044,24.05722279399783,0.0280930795131622 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441032,27.272458223345975,0.026385715432826196 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441033,17.842772707162876,0.15787622653653854 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,fruit,2441039,326.0160793369161,1.1039004505683778 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441050,2595.8693954915343,0.4471505431887004 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441037,635.8661024574726,0.16376662138739828 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441044,1520.694944820969,0.21490980716281172 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441032,418.178855917964,0.34577022496495546 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441033,1082.0299794484022,0.06710699871478543 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_18,leaf,2441039,772.1944163693079,0.07940563810045154 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441050,4.444401424781231,0.01472171895055474 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441037,4.138605758073972,0.016237501544404842 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441044,4.37125134362455,0.007514219612487993 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441032,4.221288504409538,0.007646524126125542 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441033,2.06827413431083,0.3174834584657217 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,fruit,2441039,6.544862370774724,0.18280895918512818 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441050,2869.1206258205666,0.26906518573377536 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441037,1365.0718463048152,0.05352811212976505 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441044,2278.645077943976,0.16899306283722337 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441032,1268.7306363592645,0.08531419483365843 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441033,1718.5094056042603,0.04646829157913501 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_19,leaf,2441039,1369.7488958655708,0.05204266281693615 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441050,349.02436667855255,0.27984668596288564 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441037,205.9905012665491,0.05083813267947912 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441044,160.48002970447627,0.05758806569131947 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441032,237.1043784559806,0.11193051213807248 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441033,16.224397546494167,1.0528404824510784 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,fruit,2441039,15.089903648934731,1.0843225949988198 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441050,852.3367547135546,0.08263299101731114 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441037,489.3422324961087,0.1583655266038284 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441044,863.4248463311444,0.08824631636609936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441032,568.1147190094201,0.09354218425345717 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441033,841.2007577341078,0.07692142961473047 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_2,leaf,2441039,362.8461854523155,0.28825566383349344 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441050,106.23223046379024,0.6167489353422908 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441037,6.282507059441994,0.6113743794597194 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441044,36.27527882841013,0.1501033945822159 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441032,15.074356108814609,0.2312685941208943 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441033,74.63188083713617,0.46341702191440315 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,fruit,2441039,14.626080260444828,0.24437941244604633 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441050,25.169967649438902,0.024830773135880335 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441037,22.943607086279354,0.015390187546850065 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441044,85.8998460990527,0.5579405015148586 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441032,24.598878104677855,0.01486341621332743 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441033,12.453244609901947,0.28076936551275633 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_20,leaf,2441039,17.692892156627664,0.12825305385515362 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441050,11183.682308571912,0.07121263737982719 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441037,20250.534893262964,0.18663903997630005 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441044,11628.94561467944,0.054257119636436535 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441032,14723.896176257666,0.04822528732461162 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441033,20311.654319474965,0.18794783765932355 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,fruit,2441039,5825.9169899974195,0.35443316675298897 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441050,904792.5050058936,0.07703723744677404 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441037,521313.0803188435,0.1624131349472151 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441044,868012.22561401,0.05901408515074369 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441032,694306.1474002522,0.03796074641195624 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441033,618706.9705822503,0.08802674796709109 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_21,leaf,2441039,821144.343064975,0.03490774839959965 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441050,183.44644528838592,0.7251073275088153 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441037,126.0102418726816,0.5620038720060776 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441044,46.688994667182975,0.13081254939142317 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441032,22.40367422915608,0.18808272418954908 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441033,17.5414397983718,0.2943367358654856 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,fruit,2441039,7.999889090886118,0.6353180071269717 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441050,123.82050152784956,0.2803149011059074 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441037,79.49366005364725,0.08785483560692531 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441044,93.30851921660692,0.15744363967606234 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441032,8.52356049165382,0.8818566099737741 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441033,50.37598492763431,0.11025410730523677 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_22,leaf,2441039,33.59987815325886,0.2861399551941237 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441050,1808.9950965681096,0.14448734825035947 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441037,2634.9310332926243,0.0188445145494458 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441044,2411.155962425532,0.01969943487180803 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441032,4437.889507276332,0.24525174722715581 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441033,4459.252278289135,0.24733730495389805 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,fruit,2441039,2120.105421434192,0.07556728132710644 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441050,257275.494715017,0.08046748079985022 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441037,218988.35508525537,0.010490080252062661 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441044,205191.0649531429,0.017772495684362788 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441032,208536.0751201461,0.01074974579981891 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441033,232649.2722134639,0.03677075710842104 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_23,leaf,2441039,163171.94623184926,0.11728544756950754 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441050,251.1753302886653,0.053685599037643694 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441037,305.81179991589244,0.03179165783528726 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441044,231.75925903059087,0.0886254873621386 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441032,484.73802864279594,0.23184451125266925 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441033,338.63451307235033,0.07606863755270998 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,fruit,2441039,262.6386004772125,0.034304025553254736 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441050,376.1641466340496,0.12054917331217396 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441037,228.849190891018,0.09527884463326064 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441044,290.3222777892885,0.008052136634629115 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441032,381.96046674000416,0.12719018943186056 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441033,279.6558908377197,0.00820425392968005 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_24,leaf,2441039,264.8511870611336,0.03182630214636051 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441050,68.19722545061053,0.05591698539891943 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441037,59.95425345167145,2.9721165185847553e-5 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441044,59.962459732520266,2.971913134208748e-5 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441032,68.27672349130093,0.05642295103656281 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441033,56.77630217932883,0.023682617031052233 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,fruit,2441039,57.30770357658388,0.01963671485408658 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441050,5094.385123584896,0.0035707913829035043 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441037,4751.041102178439,0.03387377729603758 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441044,4882.671296447295,0.022005076522305433 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441032,6185.688313951675,0.08072546797947178 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441033,5178.503049330106,0.0035416714171474517 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_25,leaf,2441039,6321.878699353756,0.09018359368837503 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441050,267.1428712686593,0.03620635448402565 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441037,266.5727362106861,0.03527849477622835 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441044,223.37610628721708,0.0415005186069517 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441032,192.67606929774112,0.10570945712615787 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441033,224.97673208541715,0.03839963088872267 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,fruit,2441039,295.6464444212921,0.08023542534086703 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441050,3402.589616045753,0.06699631975359566 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441037,4044.9952415394737,0.008112122998145566 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441044,3896.7712869599186,0.008100975541952327 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441032,3111.270052879249,0.105868183296709 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441033,4265.245627551879,0.031138154379941163 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_26,leaf,2441039,4043.51,0.007952629447019799 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441050,155.65829238394036,0.19636610827691503 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441037,109.48394771368466,0.043544295051691995 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441044,88.59400983077309,0.0484017949062614 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441032,123.4683664939854,0.095749548871215 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441033,83.94044178973549,0.07183490289584737 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,fruit,2441039,49.83424465530907,0.2982782735430971 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441050,839.5176348913327,0.14731081177407335 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441037,998.5255795082552,0.22264018321472445 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441044,550.1443276680784,0.036242372106532805 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441032,548.2370179912701,0.03775065500620656 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441033,645.9047685901315,0.03344947928988207 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_27,leaf,2441039,337.79245923317256,0.24806906128013972 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441050,335.07515942962755,0.562812079329567 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441037,91.95152678410832,0.0012287911872155277 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441044,91.43192759292874,0.0012322777917357364 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441032,107.01072953873074,0.06709717127135262 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441033,28.542126327911145,0.5068438295691353 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,fruit,2441039,21.35588547986204,0.6328125702671279 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441050,430.5834020760022,0.2251857210956345 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441037,513.0087659403412,0.3012532223625559 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441044,270.73091210569237,0.02366628268853388 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441032,213.04513857671137,0.08039993514426946 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441033,242.0142358700492,0.025030650740725857 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_28,leaf,2441039,104.55483514611332,0.38952744213889634 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441050,769566.6195697172,0.09397634240520869 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441037,1141397.6185151266,0.07721439802363772 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441044,657254.6638137723,0.16248888755069402 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441032,1761151.2241094178,0.26557408491875023 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441033,1400189.964027714,0.16596439643653316 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,fruit,2441039,526512.0299154981,0.2588142655162162 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441050,862300.6505935999,0.06585583154249264 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441037,1550124.0705891522,0.18885191480369468 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441044,978430.5264619316,0.010984551338055759 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441032,1028556.3883510462,0.01071356061483364 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441033,1418530.7944551834,0.15032422288924607 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_29,leaf,2441039,805089.2662336235,0.09567050881600014 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441050,30.697130207471204,0.3310313806498488 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441037,59.32622333661624,0.044882454643481395 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441044,78.60506208685277,0.07732135807113583 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441032,72.24446677872785,0.040675432986156945 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441033,72.48864440221504,0.0421408211648604 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,fruit,2441039,29.110916805489996,0.354073273876361 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441050,129.0307023436409,0.2882182361567449 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441037,118.90638360334626,0.25273034567303343 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441044,13.98744724803,0.6767363634374493 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441032,12.665849974952756,0.7198404855173512 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441033,12.880027232741048,0.7125580438172658 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_3,leaf,2441039,155.50061787220645,0.3692572939211858 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441050,192.5107230610265,0.013150641133749197 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441037,199.19507738892617,0.0016730353750955551 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441044,197.66330879517648,0.0016795053522011827 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441032,228.40888065555365,0.06110741915954687 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441033,166.68112887652953,0.07571913320781665 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,fruit,2441039,240.48491886158956,0.08348228002554636 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441050,7430.634949327334,0.0069035532110923725 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441037,9491.25782768182,0.11320139836941134 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441044,6792.660275426495,0.032082478134593195 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441032,6750.925638774279,0.03475904841480526 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441033,8603.637132339494,0.07055971257383664 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_30,leaf,2441039,7196.267613742749,0.007015067237210015 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441050,137.32913016687905,0.006005227172360517 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441037,193.56740220630667,0.1550747794960632 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441044,148.2436239501252,0.03921858106117737 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441032,133.55741714687824,0.006089430415441743 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441033,78.27252916988259,0.23814807497794876 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,fruit,2441039,130.849717609278,0.01498465238987956 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441050,510.70572340028286,0.16892982322810113 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441037,820.2439280751386,0.03684247598625445 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441044,880.5568484498212,0.06765685092983142 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441032,565.8603987674284,0.12439124689324199 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441033,686.8160746600854,0.040260097082838175 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_31,leaf,2441039,832.147718049741,0.043099878396383406 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441050,87.55332850992936,0.11959861823167528 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441037,117.60231224169064,0.00854458120545809 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441044,115.87326561629996,0.0021119671952058994 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441032,114.74902170675324,0.002122287867973416 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441033,121.83018599535204,0.023883627723934264 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,fruit,2441039,114.62745581198236,0.0025826262845440873 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441050,4444.618872876266,0.0342970846786228 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441037,3968.942866182222,0.014862594183046696 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441044,4883.052671934663,0.07515396753643167 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441032,3457.9683803731145,0.07471642359744024 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441033,4111.531225788664,4.6615156865170704e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_32,leaf,2441039,4102.709706818713,4.666524518137649e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441050,56.74454417595447,0.020691310951578057 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441037,62.282436833392,0.019750173566795093 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441044,34.044630846395435,0.24256679327682162 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441032,89.86690148556124,0.1789843452767692 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441033,100.46718892835918,0.22740882820746822 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,fruit,2441039,38.50915139074196,0.189051474292375 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441050,1657.627441914184,0.06506563138890176 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441037,1489.9794581408953,0.018758984525102385 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441044,1740.390015495244,0.0862252866559503 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441032,911.0145642619806,0.19489597641914447 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441033,1364.0029520200917,0.019605986216680193 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_33,leaf,2441039,500.0061926034442,0.455445913322853 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441050,475.66175936040895,0.007276198902695263 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441037,427.16403520370994,0.03942735856686541 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441044,459.8559963949025,0.007400185049372343 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441032,498.2741191757544,0.02744629110789676 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441033,531.1287957639744,0.05517780884973833 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,fruit,2441039,450.9922671649275,0.015852943575528577 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441050,32008.06362115779,0.08476070287195459 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441037,27046.989319867032,0.011620230803858433 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441044,30753.553731322325,0.0673966092427607 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441032,19376.49279893251,0.13322352745516053 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441033,25618.8117516319,0.011939716243678511 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_34,leaf,2441039,18151.39666897515,0.1615886510495148 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441050,62.61807989385346,0.36256677166211815 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441037,33.090104986507654,0.6395683729745945 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441044,290.85819990354446,0.3044147939377333 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441032,116.64635297036943,0.09239535322086079 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441033,580.6639117556849,0.6046583174404723 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,fruit,2441039,171.95377126236727,0.07614518709615092 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441050,11891.828172080432,0.18887512065516487 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441037,9444.7929284525,0.08881893601393864 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441044,10615.170829801278,0.139553482957107 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441032,3302.7085102323326,0.3675032591865932 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441033,5951.051016592773,0.11177983133804936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_35,leaf,2441039,2027.4950704666935,0.5794136977302062 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441050,2056.32884535019,0.03463176867768114 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441037,2151.546961828658,0.01497350647539486 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441044,2302.495284854294,0.014474413157747001 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441032,3586.0754383482804,0.20689508499693732 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441033,4775.011928009243,0.33125012444568513 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,fruit,2441039,1691.8737114136154,0.11935639400391107 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441050,10994.805523146326,0.16719799911231803 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441037,8979.88306795252,0.0792811286916848 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441044,9680.366366916622,0.11190224127492288 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441032,3975.997347229181,0.27454346685696596 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441033,5983.146994549849,0.09705988005955613 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_36,leaf,2441039,3167.2429544068896,0.3733081741014348 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441050,469.5406698988064,0.05887851385243392 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441037,508.026879483631,0.0246650378604234 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441044,567.4020741454522,0.02333918994525508 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441032,898.4463450614988,0.22294041720050517 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441033,1197.343280881577,0.34766695233005196 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,fruit,2441039,428.1240293307503,0.09898212490811087 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441050,354.58081080988933,0.07520381541874377 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441037,451.89751691535656,0.1805285416274658 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441044,320.1782901397596,0.030880467661186906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441032,180.8359956597956,0.21722653167786454 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441033,276.22689289361585,0.03324545501421072 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_37,leaf,2441039,108.6512484114234,0.4384766925876331 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441050,2.355574635266922,0.7843336189691696 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441037,65.93446550312362,0.6626820017594639 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441044,13.958261168128846,0.011599168178800356 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441032,14.713903608216013,0.011297418446652108 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441033,18.857774461154047,0.11905994909698925 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,fruit,2441039,12.771810918340313,0.05017800782118842 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441050,28.117272794922545,0.3459679811406846 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441037,113.22154050840274,0.9509238463445149 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441044,7.289665435964287,0.24029761677509198 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441032,11.303463272475096,0.049793685790583186 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441033,7.766823155699272,0.21276179658488803 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_38,leaf,2441039,14.049878387045842,0.0446673517738474 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441050,76.66498876166168,0.2152043704326514 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441037,139.75277521295038,0.04555899409093955 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441044,84.14459872914348,0.17477520308650996 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441032,111.91722092068323,0.05090452937257428 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441033,212.3155142223967,0.2271802831135119 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,fruit,2441039,164.77296805579,0.11708451794040542 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441050,2715.5831249907096,0.020052827704962084 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441037,2697.09265820791,0.017085593290260714 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441044,2633.161204133292,0.006667174218961236 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441032,1981.4935817841672,0.11681760358176962 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441033,2552.9314218896548,0.006771124812656737 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_39,leaf,2441039,2040.0278827118225,0.10417417021920272 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441050,49.55198360284861,0.16329349836546836 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441037,70.68783683628395,0.009009850925280283 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441044,73.65144440395368,0.008826725694828452 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441032,37.30375813308093,0.28660195605253724 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441033,126.37064528648706,0.243291660467444 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,fruit,2441039,79.14297266015313,0.04005781594537705 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441050,156.90193593061898,0.12373638575539125 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441037,187.44946208115965,0.0464804894312163 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441044,355.0487488031801,0.23092329862054672 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441032,196.8019485005036,0.02533529391926903 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441033,363.170309481113,0.24074564820969702 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_4,leaf,2441039,220.44645494110017,0.02393843130478901 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441050,331.0067023060828,0.040806725253007325 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441037,337.29755615582263,0.032630318242289125 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441044,533.7623328034997,0.1667044098854169 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441032,389.93532769107185,0.03034907072926174 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441033,396.90731865460384,0.03804559420458631 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,fruit,2441039,296.8006543561577,0.0881786587237734 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441050,8193.966394169156,6.875780348281069e-5 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441037,9051.416511931971,0.04315361368617543 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441044,8143.263868293639,0.0027644286790193817 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441032,8196.561148446626,6.87469194229351e-5 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441033,8729.710523951137,0.027436906539903383 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_40,leaf,2441039,7959.625868670571,0.01267028145755944 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441050,198.7487011103328,0.0265938047417964 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441037,204.7963923703447,0.013575801844503133 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441044,205.94424434032004,0.011148444871337038 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441032,252.6345721504885,0.07759467813591092 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441033,242.026209946682,0.058964296123668714 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,fruit,2441039,216.65439994482952,0.010869409548481812 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441050,1591.6736694618494,0.0960780866775024 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441037,2051.3966492645063,0.20627369654027383 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441044,1233.5642372645716,0.014614175176313804 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441032,1234.6063763608706,0.014247429633444053 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441033,1316.9545383869893,0.013794837994849374 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_41,leaf,2441039,744.6294025477216,0.23383576442960274 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441050,51.75204467812213,0.039856877917671785 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441037,49.26486705068256,0.0184666799662625 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441044,45.16309804173672,0.019286909681549558 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441032,53.203110443817565,0.05186638829727008 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441033,35.00324361724045,0.12996234451600852 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,fruit,2441039,37.65927648773037,0.09819866307696823 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441050,148.8504342448166,0.012639653307703558 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441037,179.56311445963547,0.06882737021172369 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441044,174.53088618265713,0.05648253455699326 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441032,156.28633987341067,0.008531261124106848 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441033,150.20609189515656,0.00870221260148929 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_42,leaf,2441039,130.1159195886581,0.07105932384146785 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441050,145.16038860322442,0.12407512594331926 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441037,765.8909571365494,0.5982436937392768 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441044,732.6973664920326,0.5790013824664282 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441032,111.4941079611248,0.2386713309246007 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441033,241.1649943447698,0.09639102109069997 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,fruit,2441039,121.56974179324294,0.20109775382296435 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441050,356.52932568774185,0.017763221093741954 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441037,327.95267507537363,0.01852085893940636 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441044,402.7841225955869,0.07074030601707593 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441032,201.77578131889737,0.22946299902099154 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441033,293.34225244352695,0.06695741427345103 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_43,leaf,2441039,486.8483561488776,0.1530616712564754 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441050,180131.14926757364,0.06607191194794915 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441037,234975.36250297487,0.049361596423502796 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441044,184484.80651930385,0.05570012675467417 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441032,244366.15162266413,0.06638031758802487 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441033,351164.2878104089,0.2238496113893076 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,fruit,2441039,139371.7581947042,0.17748595308514314 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441050,444607.48119744833,0.05927537801328864 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441037,537259.431426035,0.1414826600613326 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441044,384873.6198391694,0.0033832435472191946 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441032,309069.78149353235,0.09864484296862308 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441033,390893.5272412111,0.0033570909851166064 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_44,leaf,2441039,180293.3011522996,0.33272179738668406 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441050,210760.07584093115,0.12155738777214964 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441037,378760.9422331194,0.13301945431211148 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441044,192033.84318529896,0.16196796038654693 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441032,346907.93059624586,0.09486849432755928 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441033,427245.9244966944,0.18533219472139795 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,fruit,2441039,149868.4548905486,0.2696355040964509 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441050,104954.20911815274,0.05585525688032167 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441037,151245.6831057019,0.2145383842771862 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441044,91760.1662656622,0.0024904116584929525 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441032,71711.84195258365,0.10955372577203537 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441033,92815.5656045999,0.002476212067064054 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_45,leaf,2441039,40551.32447443336,0.35713955990947 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441050,13397.900349922062,0.1324934328021552 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441037,36368.42379001549,0.3011943030094084 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441044,15182.021291807789,0.07820057994028229 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441032,21172.645775102366,0.06624495559537635 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441033,23169.67158637924,0.10538970191760733 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,fruit,2441039,10025.980741675165,0.2584033100337457 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441050,52987.5138999052,0.38595120781515746 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441037,200365.81651660113,0.19169887922852968 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441044,185777.26366990744,0.15886781050975518 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441032,105659.74809674258,0.08621518036609732 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441033,99123.56717542016,0.11394782864424524 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_46,leaf,2441039,152064.1829443057,0.07190218146391647 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441050,273.9518306581003,0.20499232461628614 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441037,575.1858257042311,0.1171416436642767 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441044,420.4400670740873,0.01896243483020621 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441032,311.96586165209794,0.14855945965026018 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441033,487.97426199413223,0.04573038438935795 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,fruit,2441039,457.96842802592096,0.01816900759457063 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441050,513.915028190159,0.2879529831759391 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441037,1643.807990862697,0.21700678637600834 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441044,1810.8844937837796,0.25904644904755436 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441032,792.6908114344938,0.099740476879699 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441033,973.0817243467014,0.010694984871503 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_47,leaf,2441039,1021.6031598969848,0.01043792663510379 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441050,151.3153891461281,0.07021996774363037 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441037,100.22395804200076,0.10869158144776137 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441044,199.32659107967385,0.18990210809771302 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441032,54.901378686530535,0.37007988072486975 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441033,257.05715595729947,0.30036656692192354 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,fruit,2441039,106.13474769613175,0.08380553950109837 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441050,4097.075915195491,0.06999924902855392 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441037,3826.5111983217857,0.04032822654226598 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441044,2814.4106613356785,0.09308729481432465 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441032,3147.8551752237354,0.044460018725217765 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441033,4837.7193082003105,0.14216590424135678 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_48,leaf,2441039,2461.230740822403,0.15132243129519107 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441050,34.40939375876224,0.022173645618825066 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441037,30.983923861640456,0.023366958694994944 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441044,29.558317338920997,0.0438236680389279 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441032,34.59527416665565,0.024513401265132684 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441033,25.72826596750551,0.10409285882355168 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,fruit,2441039,45.1179261591074,0.1398457536717237 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441050,30.35988146260685,0.010294107820229659 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441037,31.91344977435947,0.011379573634242357 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441044,30.900400342755105,0.0026300732429240803 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441032,31.4330857646559,0.0047928381206752135 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441033,31.275799534973643,0.0026142414338192754 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_49,leaf,2441039,30.427931582826147,0.009321748310347377 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441050,473.05051028462105,0.06509642083139155 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441037,501.11947984386063,0.09013019078341777 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441044,202.14914769304147,0.30413917987720573 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441032,1210.567318989658,0.4731778508629523 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441033,341.3557251209684,0.07660390335397427 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,fruit,2441039,237.86923861571375,0.23347281200527803 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441050,24224.608202336072,0.09737419935986491 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441037,29447.11843235839,0.012588158037606156 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441044,39878.01309043136,0.11910255053111829 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441032,29237.522335075628,0.015690394477600123 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441033,31179.16656198846,0.012233540992967917 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_5,leaf,2441039,37363.90725215523,0.09082132430607714 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441050,140.69593770161202,0.05707655769348996 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441037,106.04146923720208,0.06572926419881142 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441044,220.88198955622505,0.2529553048957718 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441032,69.73375978158445,0.2477619192269933 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441033,82.98108004652137,0.17222591746289595 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,fruit,2441039,149.57703867795232,0.083659930237165 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441050,8948.099730066248,0.007755878927009796 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441037,6158.558732156063,0.15449584940223637 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441044,8692.367975889314,0.0048368337865047906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441032,8887.067823862717,0.004783557700816843 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441033,10172.444297298558,0.0634503834975364 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_50,leaf,2441039,6037.45891255652,0.1631207486928914 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441050,44.8429505733886,0.060955024085462384 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441037,37.853505534330075,0.012633051649977078 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441044,36.69321987774056,0.02615333312272705 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441032,40.08806490603264,0.012275936439010149 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441033,27.712340677453657,0.1480659471528203 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,fruit,2441039,40.99257778147426,0.021966072937880554 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441050,216.22630167569935,0.03380683197432921 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441037,304.6696355698901,0.11511382088702593 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441044,224.54586062426665,0.01741029870177435 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441032,233.1402434458479,0.0010981065748465468 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441033,236.29388619226705,0.0047371327515417505 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_51,leaf,2441039,234.32071789344195,0.0010953370314026323 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441050,190.25876254754527,0.05000259494958437 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441037,158.85209246329822,0.028349132895957307 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441044,147.2697953990846,0.061228389339813116 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441032,179.53234310887936,0.02480062618037726 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441033,159.60223174203418,0.026303112935130546 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,fruit,2441039,216.54496478480053,0.10620601694657283 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441050,1459.4453246386213,0.01944400910820354 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441037,1554.4346574157526,0.007940631942123133 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441044,1515.13174369029,0.0031814414737940666 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441032,1396.6514359023502,0.03854380651091516 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441033,1537.4115654293405,0.0031583050817824976 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_52,leaf,2441039,1883.3459362026715,0.09129826058224877 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441050,66.25168932462165,0.2127502926128253 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441037,108.7104541293149,0.002324060717896703 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441044,72.50956155689086,0.1735519701699766 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441032,126.72390577522096,0.06891130064313788 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441033,195.73329360179164,0.2577174547722012 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,fruit,2441039,107.55006686841934,0.0023365645167316984 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441050,278.97146791186697,0.13191149656628864 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441037,308.78638233277945,0.0878131447699122 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441044,407.49605237252274,0.03265212165329556 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441032,563.1624351620209,0.17316239398507438 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441033,540.6164811213634,0.15541799717038707 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_53,leaf,2441039,348.46823579567894,0.035308087559898116 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441050,459.0538943769627,0.02899016780663155 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441037,753.6885398280209,0.18633806779886752 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441044,453.36396331495513,0.0344068476216397 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441032,883.3352640095248,0.2552717245601115 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441033,384.93322277195654,0.10546844813090983 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,fruit,2441039,522.4314962901275,0.02717550787129097 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441050,12430.35595126114,0.0022933187600289173 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441037,11077.807424382469,0.05232307274268155 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441044,16686.119535665435,0.12557846656606841 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441032,12561.981694706468,0.0022812723331240292 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441033,14392.02058094732,0.06134488750746936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_54,leaf,2441039,11682.483592875493,0.029241704117860756 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441050,31.931425787330113,0.23091578077724906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441037,110.31819643901554,0.30751306140121026 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441044,50.971072238400815,0.027810322070389137 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441032,155.45162238337983,0.45646116728520947 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441033,28.214506798876204,0.284661628639838 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,fruit,2441039,57.712545759457214,0.026136140238256278 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441050,74.9401271428433,0.07118659575307396 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441037,30.480513385303176,0.4618787437523033 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441044,121.9159202452654,0.14015939981712489 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441032,166.467631215896,0.2754287783663596 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441033,90.6366478466581,0.011402813645206455 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_55,leaf,2441039,85.93908483980555,0.011710296735710779 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441050,113.1383153958636,0.002592464200223965 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441037,93.58975119393274,0.08497387938883949 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441044,114.49308372994666,0.002577080608632265 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441032,187.61597659881232,0.21706764623016594 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441033,148.3226333240836,0.1150052552396188 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,fruit,2441039,87.06517733829014,0.11635768315720507 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441050,2225.2199400475715,0.04907599411968544 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441037,4237.489572035423,0.23065970537487823 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441044,3667.726248159233,0.16794797623571034 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441032,749.3874596781463,0.5217425157968791 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441033,2757.6428994683974,0.0440890894956989 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_56,leaf,2441039,1732.496129264498,0.15777666410377966 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441050,248.6249708561676,0.050654924212097274 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441037,290.7548298636691,0.017327268291406295 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441044,465.0265837890348,0.22127811111549667 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441032,268.0107751039963,0.018047414683386886 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441033,456.97722005934185,0.21369488194814723 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,fruit,2441039,240.74883056816785,0.06463548321019541 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441050,121622.98158606996,0.02397131839614186 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441037,150256.73161774105,0.1157896103036613 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441044,141455.6486742237,0.08957596705752469 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441032,43181.71570460216,0.4257444337189016 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441033,108560.5893627236,0.025372135143559404 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_57,leaf,2441039,48480.088566818005,0.37548092297700997 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441050,397912.395801443,0.35062194285668014 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441037,204864.70364253657,0.06230161410877866 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441044,150108.46014963303,0.07276035580320173 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441032,60112.64675185041,0.47019967536184826 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441033,274928.962097149,0.19005496686081091 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,fruit,2441039,123197.0038657687,0.1585653797051636 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441050,285325.16468864644,6.782352032299599e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441037,468587.3454751927,0.21477224418236318 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441044,248465.14522104457,0.06075283745690463 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441032,286217.04227614624,6.771776585479117e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441033,366535.8657314596,0.10809816519028104 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_58,leaf,2441039,191045.3320152736,0.17488188117344716 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441050,1681.0256369933602,0.06521799728712407 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441037,1973.7199216751196,0.004493190558258142 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441044,1933.0904300470731,0.004540163300468247 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441032,1638.6063762137824,0.07631769364579455 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441033,2226.60033032781,0.0568499350449474 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,fruit,2441039,2169.000379098021,0.04546729380287351 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441050,1475.3402312620726,0.05725169419975895 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441037,2553.6553541691924,0.1810184041202918 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441044,1597.7116597276809,0.02264547502785419 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441032,1768.751570297118,0.02152295882233135 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441033,1852.291828868095,0.04156553128752982 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_59,leaf,2441039,1430.7145902698649,0.07059087354929572 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441050,66.27652626725178,0.006687678558041199 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441037,64.25098421270437,0.006792274546247867 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441044,29.801944706121212,0.34042745463332724 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441032,163.56576166592905,0.3990203411070006 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441033,41.08726959317656,0.20096477754749076 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,fruit,2441039,72.77184512114322,0.047291327311566045 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441050,137.50723792357422,0.23643666231824811 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441037,233.99308616799243,0.0055591954733995586 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441044,240.0220574835168,0.005488933321939893 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441032,319.9113871879567,0.13026747808976813 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441033,123.11984126690056,0.28443417399634585 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_6,leaf,2441039,338.2855910051882,0.15452127886487022 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441050,33.66766445296657,0.30224888255308735 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441037,48.085250067126275,0.14744999377057488 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441044,220.5245377565188,0.5139950477171693 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441032,486.0403742642264,0.8572104739067687 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441033,86.96390406510466,0.10987715556582622 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,fruit,2441039,43.7936289854456,0.18805093794792338 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441050,109.26689919738862,0.01298537295034441 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441037,181.7122121792472,0.2079101238639134 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441044,376.19288737359386,0.5239365884592679 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441032,65.72263543436335,0.23375902165289242 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441033,115.8997097709114,0.012608356743241789 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_60,leaf,2441039,43.63365848111337,0.41165236358389157 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441050,115.11388162385452,0.033047271782642884 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441037,123.26095999109098,0.003349424480577401 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441044,121.72080934869987,0.008810138880001261 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441032,180.36628751699905,0.16198039598315406 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441033,144.06219853490168,0.06437506796821335 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,fruit,2441039,125.1695700526514,0.0033237901716178797 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441050,578.9733233239206,0.03020006485276472 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441037,1053.9030802229202,0.2903421849607488 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441044,519.6486610033253,0.01674867629508414 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441032,395.69161688067726,0.13510163945300446 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441033,560.5123186309467,0.01612667286354874 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_61,leaf,2441039,486.0559310771727,0.04577224189828266 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441050,5940.807261224435,0.07437860630183746 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441037,6578.5747808767,0.03009225317986708 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441044,7251.50419841973,0.0122040337463023 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441032,6849.63061507225,0.012556917391136402 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441033,15291.771970140408,0.33623374421961794 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,fruit,2441039,9221.646347788914,0.11658439390571296 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441050,849908.5189380882,0.059354015547893546 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441037,926463.8112736504,0.09681029314814538 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441044,738495.0250605062,0.0016705928102691558 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441032,634907.4603578717,0.06730773660544109 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441033,744187.4777589408,0.001664191187949804 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_62,leaf,2441039,714928.2882630965,0.015755685245102846 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441050,1729.8550059751065,0.08762612188930374 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441037,2503.3160719019234,0.07287986306113936 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441044,324.7634927457389,0.8140686211069679 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441032,1682.5930479521817,0.09965673439948697 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441033,2854.32462141898,0.12986753917082172 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,fruit,2441039,3632.6945903589985,0.23459306259548418 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441050,18296.642115022623,0.11051289666226793 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441037,30843.844679390833,0.11628421751839912 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441044,29163.7612091382,0.09195924364509 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441032,20794.274141621947,0.05494052475801414 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441033,19329.29215186204,0.08666833971627153 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_63,leaf,2441039,26402.71404860709,0.04876428220382767 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441050,1332.7065265509816,0.11862055282831374 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441037,1929.4574417951017,0.04208012635599001 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441044,1528.89249952638,0.05897812729455687 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441032,2062.3701497728935,0.07101153679846561 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441033,1668.9362367786837,0.020915333005226522 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,fruit,2441039,1833.6196454489811,0.019954175967499932 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441050,4478.733341037232,0.05875566100373675 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441037,5887.887350182604,0.06004862549144718 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441044,5173.226384234523,0.003850617082373109 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441032,5081.8963510639605,0.00388506373618025 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441033,5933.108455693602,0.06337142040910138 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_64,leaf,2441039,5001.51548694815,0.010809248877168276 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441050,78.38618210322957,0.1612047540643451 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441037,232.77441576813692,0.3114909791301055 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441044,128.4491375584513,0.05328692647189648 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441032,132.21548074549915,0.06583804229628809 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441033,98.78535867331996,0.06075168513277429 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,fruit,2441039,85.0558778364255,0.12573993501096958 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441050,1693.2993898530997,0.012560672134957596 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441037,1792.676826076504,0.012207580374881566 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441044,980.5909965858752,0.24980652262023906 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441032,1878.4080563744856,0.032495518211635765 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441033,1686.5814056972742,0.014287116034644054 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_65,leaf,2441039,2134.518661735695,0.08800553209806994 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441050,1013.5042146026614,0.02064349745197358 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441037,1198.028156397636,0.05199796861041239 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441044,870.5366623712703,0.08668199046416714 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441032,1603.2128061525327,0.1785221167860267 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441033,986.9120496237786,0.03219060498565529 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,fruit,2441039,1112.181491234959,0.019706606859514864 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441050,4049.251025874008,0.014149557983418326 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441037,3873.294955807604,0.03344368861131786 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441044,4378.053825370744,0.019756837763051482 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441032,4186.329717274381,3.0917171052680104e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441033,4830.665361524711,0.06248269443133703 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_66,leaf,2441039,4180.371390920709,3.0939196487267395e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441050,470.5039786296195,0.22473256088005478 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441037,784.3715307417949,0.002774038806939494 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441044,549.1814012737435,0.1575800402182086 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441032,794.4238852620015,0.0027564321462660857 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441033,1337.7089344801243,0.22906576660924616 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,fruit,2441039,1010.2469979032744,0.10713170744974398 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441050,691.817597778051,0.277463626551016 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441037,427.2018350233621,0.06810513108872396 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441044,619.6897172123583,0.22964631134234503 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441032,263.32485491556497,0.14203612485191552 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441033,303.1934720119877,0.08080813205787774 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_67,leaf,2441039,61.036802007316254,0.776936207524284 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441050,171.54618431745024,0.019386285411386872 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441037,194.8908467150652,0.03602409448211219 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441044,164.70991300039876,0.037047610151073496 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441032,241.85979727060916,0.12979633655917988 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441033,162.41337152945863,0.043145566007896985 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,fruit,2441039,187.20830437155135,0.018557761747015622 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441050,988.9768696298032,0.017682565046650556 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441037,1830.1416140064216,0.24961599677502733 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441044,990.4528730563422,0.017034883294274827 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441032,1052.5389138390815,0.009369461875726515 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441033,1178.1836551570896,0.058344294106301486 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_68,leaf,2441039,1007.610386308758,0.009576063907875021 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441050,65.31449740145094,0.02947094809173345 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441037,56.74417356839406,0.03161736592986286 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441044,109.8624978548073,0.2553108278130747 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441032,30.93736651829861,0.29505529870311253 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441033,0.2666790292068362,2.359549775695326 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,fruit,2441039,74.40687838153907,0.08607444362045058 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441050,225.48997802001043,0.021699216167346158 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441037,203.7303092145819,0.06577081609839652 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441044,358.2992191509197,0.1794194012580279 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441032,248.5952857176173,0.02066642811855468 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441033,270.20996991637793,0.05687490866962852 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_69,leaf,2441039,210.61754781096604,0.051331908407337146 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441050,86.61086079911574,0.20592326222022028 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441037,238.43000036498256,0.23386528228253534 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441044,153.67794068388733,0.043115915093582036 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441032,124.63000962760182,0.04787298859274314 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441033,117.8632948540294,0.0721170395852937 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,fruit,2441039,206.18747070626696,0.17076665402439195 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441050,272.47084623577257,0.14665260309051353 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441037,1118.1998873145455,0.4665468004952653 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441044,332.8150312146235,0.059769711180888585 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441032,346.2797523797825,0.042545545374867544 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441033,417.56067324999793,0.03874694548283353 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_7,leaf,2441039,819.3871550339323,0.33151650787427167 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441050,386.44807046884887,0.15249269976206392 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441037,518.868213284284,0.280458622469796 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441044,112.2542507870929,0.38439564781935376 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441032,170.01112766995686,0.20412109543887347 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441033,71.31873492832737,0.581394812514876 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,fruit,2441039,374.0258748458517,0.13830320397577012 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441050,1015537.611615379,0.04045459151689279 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441037,827213.0890177587,0.04862402346355754 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441044,976564.7692802784,0.023459631425247984 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441032,805302.9465128893,0.060282132992544035 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441033,873859.9302845473,0.024799595329705326 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_70,leaf,2441039,1046565.7108709178,0.05352508051798033 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441050,207.0788532216877,0.13016039948257951 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441037,308.21865004769745,0.04256276323892427 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441044,286.5410122059354,0.010890639974006078 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441032,463.87037516076,0.2201004866867895 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441033,272.34873989637845,0.011170780508002576 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,fruit,2441039,218.19018841986505,0.10746093339764284 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441050,2162.511343592881,0.09263653969697527 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441037,3227.644864913484,0.08129080965765656 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441044,2099.401276961158,0.1054994769332307 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441032,2626.5040501551343,0.008216859123611808 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441033,2956.5625281089265,0.04319213433262403 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_71,leaf,2441039,2726.8372140642637,0.008064278370125244 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441050,124.3090294504452,0.08488493940367858 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441037,145.0060284309697,0.018001557273054747 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441044,178.6575375116105,0.07263372859446315 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441032,256.33019308391255,0.22941214956696054 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441033,64.1401004365234,0.372257979441851 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,fruit,2441039,157.27967709058217,0.017284993749661304 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441050,243.2583910056555,0.06127316046720921 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441037,220.4505066064932,0.01851643181836682 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441044,340.48799541170445,0.207307135218334 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441032,194.51926216323903,0.035832055811930275 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441033,202.04750077828325,0.01934118655925321 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_72,leaf,2441039,180.5916347012165,0.06809704016061913 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441050,148.72173954336108,0.0219001670864456 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441037,152.66988113353713,0.01052125620448141 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441044,220.25440591488405,0.148649981028373 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441032,179.8367749274473,0.06060388194931532 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441033,160.15739942818075,0.010272384629886222 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,fruit,2441039,122.35953574545329,0.10663680313969204 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441050,2022.0492593758945,0.02598930984470993 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441037,1871.7120406742351,0.007563387273281208 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441044,2072.246540635299,0.03663900186951041 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441032,1594.6135100716608,0.07714698218366456 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441033,1937.476043432552,0.007433919795615029 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_73,leaf,2441039,1566.7087309625097,0.08481415776609413 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441050,262.58033890750687,0.0010268866930509546 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441037,280.7779390536371,0.028073890714644723 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441044,263.8235473750938,0.0010244643521200025 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441032,237.9160726348176,0.04386530903648511 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441033,261.94485418904196,0.00207921990880644 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,fruit,2441039,293.2280650603901,0.04691644336271894 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441050,1000.1869814282344,0.0019715499650572177 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441037,978.4509052209188,0.011513708007560464 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441044,1183.752827083556,0.07120828183458938 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441032,975.4043534626242,0.01286805775670441 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441033,1009.2886458193024,0.001962640227429091 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_74,leaf,2441039,1123.7977040089002,0.048635393091594814 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441050,166.06604155493883,0.006288542367224537 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441037,149.5893120712663,0.039091726372881386 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441044,153.86180082927163,0.02686148012896883 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441032,166.49710663954377,0.00741439947704281 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441033,180.1349031659668,0.041605579089577294 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,fruit,2441039,161.29145212644875,0.006380939394614149 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441050,8951.506704985872,0.04772503293119135 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441037,10613.457409450508,0.02623570723994373 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441044,9793.012738600552,0.008704854804566953 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441032,10681.497747615387,0.029010979012129567 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441033,9865.087690476576,0.005520224198267254 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_75,leaf,2441039,10117.474344805903,0.005450937576377157 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441050,49.416947963155856,0.08732213555372481 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441037,92.40980346211904,0.184519991568997 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441044,66.96191558430289,0.04462981404082167 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441032,53.8829076218105,0.049747031994913815 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441033,27.313734442240737,0.3448169723497996 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,fruit,2441039,153.0930149627998,0.40375732097149775 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441050,193.7999859934257,0.038070920379187356 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441037,161.26906272760027,0.04173175904753368 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441044,194.6170648060481,0.03989809733912031 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441032,118.84338120599888,0.17430782155366353 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441033,113.0520189813182,0.19600449818828247 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_76,leaf,2441039,208.38832202484133,0.0695905567207471 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441050,539.4440930790979,0.11831072143144938 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441037,691.253551614025,0.010619787665608005 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441044,541.2398427736908,0.11686740414844321 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441032,735.3691443318672,0.01624823980762269 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441033,725.4766721985346,0.010366288840108595 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,fruit,2441039,738.2114604983375,0.017923619836008875 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441050,15120.511359145929,0.008714835081576666 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441037,16417.30423751662,0.02702053253650849 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441044,12164.97107884525,0.10317023308828333 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441032,15733.47687146765,0.008543392186705745 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441033,14803.700100687092,0.017911035459363234 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_77,leaf,2441039,18626.53477437328,0.08185075368622119 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441050,69.81601325008648,0.036216644511640084 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441037,62.58162184116578,0.01129158690570331 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441044,60.00867551853419,0.029524359528613653 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441032,69.8278357692816,0.03629018093872882 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441033,61.24842664501883,0.020643463885014812 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,fruit,2441039,65.87851979972267,0.01100543173410573 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441050,95.29872108695692,0.010884594833236338 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441037,98.10578418462632,0.001722946291757843 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441044,98.92759013544814,0.005345762583807145 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441032,99.53226995215068,0.007992241526532995 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441033,97.32890971540768,0.001729808851136827 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_78,leaf,2441039,96.2274510304385,0.0066726853423662025 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441050,148.15093560020486,0.0044257645771992316 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441037,139.17690866131522,0.022711447995861445 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441044,141.07797472622613,0.016819417459691177 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441032,145.1467456548487,0.004471330966018261 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441033,150.00938884032385,0.009839807785470445 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,fruit,2441039,151.60081165870557,0.01442289258395446 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441050,263.1801416270999,0.008227502331607184 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441037,253.3023568802328,0.008386383215022608 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441044,303.25766704623413,0.06978617566735368 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441032,242.05789344765356,0.028106364523381888 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441033,275.0301770927049,0.0273547345034304 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_79,leaf,2441039,244.50500244227436,0.02373786498156827 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441050,93.4899686213498,0.06082565574903098 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441037,201.91278419051628,0.39522445908027826 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441044,68.71241397688821,0.07290415199869393 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441032,123.25328335218047,0.18085913903547524 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441033,47.851990393187315,0.23003935139308385 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,fruit,2441039,69.05343664395055,0.07075406089344916 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441050,366.8013790498576,0.031943957096966624 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441037,383.98093642959253,0.012065253492526296 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441044,309.9839480547194,0.10503571161902103 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441032,405.6150144460918,0.011739105783026726 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441033,445.85401902806,0.05281776892407697 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_8,leaf,2441039,537.169748794299,0.1337366300951235 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441050,57.04658922946618,0.013219872694425039 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441037,53.62593267757641,0.013634952079359275 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441044,49.1886319630642,0.05114506660651896 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441032,62.271017872725665,0.05127615398012231 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441033,57.88212336518144,0.019534643816506048 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,fruit,2441039,51.16665179129093,0.034022811878096526 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441050,121.9650196260806,0.016118001226665957 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441037,128.25846899608348,0.005732760266297543 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441044,132.80207769500942,0.020851578411943184 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441032,124.8946525502419,0.005809447073990004 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441033,131.21480996472783,0.015629564562321452 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_80,leaf,2441039,116.03597447298355,0.0377606374100079 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441050,1465.0169409653397,0.03324071970781972 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441037,1619.1054239663888,0.07667320061665217 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441044,1249.1210414029338,0.03599740295150866 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441032,1076.069894962822,0.10076144566972056 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441033,941.1901017654266,0.15892457587360642 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,fruit,2441039,1637.2533371981588,0.08151395727281141 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441050,6409.506917294319,0.07145983881909901 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441037,7693.481058935032,0.007838429512546874 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441044,7418.258321277997,0.007982506977649795 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441032,6928.350545840003,0.037654606326194884 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441033,8606.96600731575,0.056565628356333164 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_81,leaf,2441039,8123.2766182819405,0.031446782927341044 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441050,7262.79078455293,0.1980675188439429 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441037,3919.10631567722,0.06984897002692891 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441044,8883.928351204328,0.2855690323080311 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441032,3607.739558488399,0.10580083657361739 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441033,2995.0428944520913,0.18663296834639764 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,fruit,2441039,5286.788547120051,0.06015592550446458 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441050,73670.63506611835,0.03128319190873263 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441037,131928.62457038922,0.2217614291520391 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441044,94908.33986624626,0.07872677125067984 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441032,62567.97100021501,0.10222553395925438 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441033,84675.54874489148,0.029180414249807995 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_82,leaf,2441039,51659.76623947866,0.18542516888845384 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441050,266.9950511205362,0.1292694452451184 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441037,404.6256553392664,0.05128075897183937 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441044,286.83314996873395,0.09814331451940816 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441032,373.1624981505756,0.016125334983652095 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441033,361.2446618421073,0.002028781356919751 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,fruit,2441039,357.87746603368015,0.002038303188849344 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441050,2591.4096602707928,0.20264190212779187 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441037,1607.2295082620776,0.00481627393904116 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441044,1457.6917396662598,0.047228478508081206 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441032,2133.7656030851294,0.11825253862570317 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441033,1548.3161178288844,0.021034536492761102 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_83,leaf,2441039,1643.0758734446194,0.004763447341428861 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441050,10383.614868120816,0.002074345335937977 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441037,11226.78354945525,0.03183243264226565 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441044,13517.29808374581,0.11246697401254035 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441032,9323.879698692765,0.048826255555401765 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441033,10483.043828998949,0.0020644846025241748 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,fruit,2441039,5376.078297214835,0.2879573318003805 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441050,1644285.2990960265,0.191611487565031 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441037,2487044.417639798,0.011905119850552204 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441044,1895781.13719028,0.12980046374765575 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441032,2770429.104296309,0.03495837945683 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441033,2625282.963135956,0.011587458682028817 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_84,leaf,2441039,3030318.872251152,0.07389966902029066 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441050,68.2393147238964,0.04058473060585088 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441037,59.83704336190024,0.01647980003820848 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441044,59.40567909697308,0.01962196139276151 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441032,60.33733491021532,0.012863802733272811 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441033,70.73475130932752,0.0561829046841833 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,fruit,2441039,63.96518185877799,0.012493712680070157 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441050,1514.0666827373695,0.01712578557659583 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441037,1654.0239803865782,0.055522584487452065 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441044,1396.9802876381057,0.017828939306494096 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441032,1348.903708729729,0.03303826852926228 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441033,1680.557057893891,0.062434044856825466 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_85,leaf,2441039,1304.5630593598746,0.04755414059975083 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441050,1075.899654839295,0.09545086502475852 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441037,1304.3850630198642,0.01181681631136211 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441044,1668.631718162311,0.09513786139452396 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441032,1470.70709202764,0.04030355346312531 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441033,1257.5365035465677,0.02770203267810345 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,fruit,2441039,1376.3421860011445,0.011503788344903842 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441050,17905.52374498895,0.019058803472950636 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441037,24263.60928369994,0.15102717854704473 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441044,15039.372570943731,0.056698507119013364 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441032,16367.957655701648,0.01993373253925501 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441033,23609.721770140015,0.1391626437668707 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_86,leaf,2441039,16174.926577304155,0.025085907422316644 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441050,306.0078961662778,0.06250961852177239 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441037,349.66086363828657,0.004595225683428961 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441044,357.0996004719942,0.004547112702836031 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441032,575.6037279417607,0.2118813464197462 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441033,397.38261142953667,0.0509666078430584 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,fruit,2441039,254.1744268354266,0.1431103987014981 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441050,41022.38753720635,0.023002658715755686 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441037,34309.44084951002,0.10060995148913143 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441044,41887.922602585786,0.013934769371056532 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441032,48391.21176965907,0.04874290567555839 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441033,44619.54274334081,0.013501523578599794 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_87,leaf,2441039,48568.41147816049,0.05033030749700895 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441050,97.4829932528206,0.022382680182494674 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441037,107.73120580970348,0.021029984748433872 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441044,97.54638011894237,0.022100378427890144 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441032,168.34046418119866,0.21487698428397284 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441033,76.86915672088645,0.1255594193323899 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,fruit,2441039,140.24328066080832,0.13557052642064704 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441050,2087.38628369273,0.018623692971595496 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441037,2059.9103097116854,0.012869178820125171 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441044,1915.408591224264,0.018717701361893546 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441032,1783.552292060191,0.04969328543783247 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441033,2069.668238097297,0.014921602471048345 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_88,leaf,2441039,1939.6212497539864,0.013262198965828365 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441050,40767.67609131912,0.004322969427548173 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441037,53699.40881152469,0.11533057929373847 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441044,25413.190675438647,0.2095797302005309 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441032,41583.33217910227,0.004280362331335219 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441033,59380.867546385016,0.15900761309989786 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,fruit,2441039,32249.720855723528,0.10611296532983516 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441050,254258.7396171721,0.2593450883536521 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441037,136300.47415994835,0.011433434816225052 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441044,142480.20532131934,0.007823730826022057 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441032,111104.97723169206,0.10019728676133077 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441033,137392.6619562995,0.007967263484733422 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_89,leaf,2441039,149355.2022226027,0.02828955273610312 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441050,46.012945065078725,0.10674181441721742 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441037,127.57946701229018,0.5496425666525382 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441044,200.700230737764,0.74640965496322 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441032,20.56408936124439,0.2430287343914983 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441033,14.71784571901688,0.38829397072954497 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,fruit,2441039,25.959824085885472,0.1418364716313394 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441050,134.04258160120744,0.00794689270202431 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441037,137.47021799519027,0.0030189450901985104 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441044,143.3359198807012,0.021165361661511728 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441032,136.4186329409418,3.1598313998371097e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441033,136.6172155850942,3.157534047217858e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_9,leaf,2441039,130.55669016458756,0.019390544825276024 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441050,95.84191976427974,0.006186647289013081 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441037,113.49265997180656,0.06722562329185933 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441044,98.5920517756911,0.006099753137728703 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441032,71.45474734275479,0.133711063630916 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441033,52.59792651030459,0.2667735276224066 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,fruit,2441039,105.9846031477361,0.0375006263968205 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441050,3416.146890624191,0.05970398775485197 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441037,4060.003705699843,0.015285905605671335 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441044,3850.009399346168,0.00777873457785061 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441032,3081.4139122018346,0.10449048534489869 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441033,4283.243482634552,0.038532238369638705 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_90,leaf,2441039,3989.168495607845,0.007641856181650031 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441050,279.88551238177547,0.09510239458173375 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441037,246.51336003209087,0.03996243703507396 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441044,203.17124516285708,0.04401578198927503 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441032,344.76427529064716,0.18564423336442282 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441033,0.1743996137936887,3.110332505372677 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,fruit,2441039,170.45153853767357,0.12027709859739977 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441050,843733.452518156,0.2845861318388154 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441037,439058.5319962749,9.032843833880477e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441044,694860.4816759146,0.20027847644221897 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441032,258001.6531308193,0.2299966479178801 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441033,437234.0438615055,9.051670311617244e-4 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_91,leaf,2441039,238450.3037687114,0.26422125657656004 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441050,66.47375356335718,0.025406651463365737 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441037,16.19765681685325,0.5877913580044611 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441044,58.919319774572266,0.026985826987917294 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441032,75.50950219890203,0.0807580559202361 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441033,88.0573263977992,0.14752194400292762 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,fruit,2441039,29.386832710997723,0.32909077055603153 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441050,49834.80120696499,0.364167044334641 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441037,18931.126777294336,0.05618922198422904 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441044,34318.206535647245,0.20215889775733142 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441032,16856.699186632173,0.1065931490923866 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441033,24160.777010026373,0.049745211226573716 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_92,leaf,2441039,13752.485668142011,0.19498448481618436 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441050,33.3351513024573,0.018911630069772478 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441037,41.902217418372146,0.1182462053680966 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441044,30.4942537227326,0.01977279112599528 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441032,17.846550962779148,0.25243650408851015 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441033,11.825760705773806,0.4311617137787589 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,fruit,2441039,65.98005179761932,0.3154218515687619 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441050,93.17932475834456,0.10429878134130166 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441037,60.237003837403314,0.08515741547535183 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441044,49.50640354674881,0.17035939996147476 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441032,17.68809976125012,0.6173395985774786 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441033,101.52252614897854,0.14154163803157505 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_93,leaf,2441039,86.33491493944062,0.0711656878752549 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441050,350.5444433616669,0.043881712043526644 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441037,425.0859076427904,0.03985190821990736 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441044,343.9422670427622,0.05213924982578888 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441032,563.5762117815271,0.16232785416307616 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441033,294.84855753371033,0.11902579189645301 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,fruit,2441039,463.73762700535855,0.07764753600832641 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441050,6451.230755926012,0.10075593347201561 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441037,8637.64437640931,0.025996809535886012 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441044,5752.679493464535,0.15052833176334746 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441032,7774.635043373488,0.019718498505893578 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441033,8496.899245213523,0.018861958445504534 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_94,leaf,2441039,8823.05827934316,0.03522063785308216 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441050,120.72865772024193,0.005996518015608299 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441037,148.04774140120563,0.08259489610873727 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441044,94.14514092969776,0.11400898023426498 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441032,129.71387220206697,0.025179533908495255 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441033,124.08570075129042,0.0059148475200876405 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,fruit,2441039,84.58506984075356,0.1605131778866915 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441050,263.3986774494911,0.31057543515149355 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441037,44.00414944686104,0.4665445238833539 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441044,152.75530803821653,0.07395815547188889 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441032,173.49953341430808,0.12926015635214538 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441033,104.9172390700897,0.08919130137092512 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_97,leaf,2441039,94.51661211487747,0.13453000860234354 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441050,2328.204896662751,0.14100486414386681 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441037,4576.76939695584,0.15253296836471764 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441044,3938.9286375023826,0.0873520502176044 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441032,2503.595555802086,0.10946189049296473 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441033,1763.303808509897,0.26169891691370095 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,fruit,2441039,4211.030802646126,0.11636235574090747 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441050,74103.77152938771,0.01786410520358661 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441037,73024.5467493342,0.024235547204578545 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441044,80327.20331395601,0.017158229485334076 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441032,80891.91244625444,0.020200685857788336 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441033,84446.94310233374,0.03887951588316518 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_98,leaf,2441039,67293.98467648056,0.059728172339432284 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441050,33328.61699485212,0.013766784632927909 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441037,35475.44410346467,0.013343763757054816 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441044,25417.46259658985,0.13145188403472652 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441032,48267.2169246027,0.14706818105935415 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441033,62932.28398144367,0.26228941657317506 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,fruit,2441039,21475.459845664776,0.20464160519078423 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441050,119928.789737059,0.02057170743691472 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441037,125178.17167294292,0.03917686046873037 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441044,108832.0801045244,0.02159481366760918 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441032,97274.29552533946,0.07035364931442967 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441033,120713.29423625044,0.023403358297032995 +1015695 Sl10g074590 #30.1,panK4-1,0.4,m_99,leaf,2441039,91540.74434963906,0.09673730407234782 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441800,117.3193695567586,0.28264462886983743 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441809,47.30446351377317,0.11182297020590104 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441793,64.25834496696798,0.02120444404264754 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441801,59.701515673623206,0.010739734730716544 +967514 MM WT,MoneyMaker,0.8,m_1,fruit,2441812,61.19628966783315,0 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441800,59.20740423775249,1.4229947031537147 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441809,3666.4861358686776,0.36887932275267765 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441793,2487.3469860174996,0.20036564939191415 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441801,1869.324278516664,0.07631392218700839 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441812,1266.853837648668,0.0926442130188403 +967514 MM WT,MoneyMaker,0.8,m_1,leaf,2441798,44.69094745219187,1.5451511625378578 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441800,59.31972190883099,0.0037826001331724424 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441809,58.68075848989281,9.207874853192077e-4 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441793,60.85203406700564,0.014858593475030935 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441801,53.076250043024494,0.04451627486313936 +967514 MM WT,MoneyMaker,0.8,m_10,fruit,2441812,58.805304921948256,0 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441800,327.2376319484268,0.004560004257173844 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441809,329.13954481738705,0.0070768272211076955 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441793,310.61110138966745,0.018086263413239934 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441801,320.4017246198471,0.0046083918895787335 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441812,400.9296251553324,0.09276491098335882 +967514 MM WT,MoneyMaker,0.8,m_10,leaf,2441798,307.2684700768492,0.022785238952677034 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441800,48.08932148712369,0 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441809,40.2831496760074,0.07692522945931901 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441793,57.34319234150584,0.07643321733578978 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441801,8.394203899874773,0.7580691352120311 +967514 MM WT,MoneyMaker,0.8,m_100,fruit,2441812,287.87465430865666,0.7771547799847047 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441800,1342.1620760749447,0.1601580914745271 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441809,2382.047610045802,0.08898738271816953 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441793,2118.3704265615424,0.038038850078423 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441801,1763.0711221490817,0.04169322271251108 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441812,2803.8788466728292,0.15979618941815055 +967514 MM WT,MoneyMaker,0.8,m_100,leaf,2441798,1555.259508200836,0.09616018965396655 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441800,36.73930232134871,0.040716827568358926 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441809,32.82290924443619,0.008237005308181722 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441793,34.77063153409594,0.016798501548760614 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441801,30.39135826491048,0.041663967028390925 +967514 MM WT,MoneyMaker,0.8,m_101,fruit,2441812,33.45138295926953,0 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441800,24.303390221984483,0.22935043659362386 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441809,214.58529396706092,0.7165826587373518 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441793,40.34614389554629,0.009215263581773936 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441801,188.8584771613796,0.6611191867865609 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441812,42.07664251992577,0.00902378157035666 +967514 MM WT,MoneyMaker,0.8,m_101,leaf,2441798,26.573351247290116,0.19057096861320577 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441800,97.6678691345844,0 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441809,115.60816842786026,0.0732368081267798 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441793,100.32964352340794,0.011677556560566682 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441801,89.79322128472565,0.036508160690923 +967514 MM WT,MoneyMaker,0.8,m_102,fruit,2441812,87.00507328797782,0.0502071354382474 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441800,573.2120481616103,0.005853374734902328 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441809,613.6272222468941,0.023735933051704627 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441793,527.8537935621993,0.041655037778320914 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441801,559.0849851061164,0.016690855934481164 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441812,770.8710182474804,0.12281303334074911 +967514 MM WT,MoneyMaker,0.8,m_102,leaf,2441798,588.7680253511933,0.005775531573288362 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441800,15970.452737435116,0.5386721291983472 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441809,4620.033223798378,0 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441793,2950.114505444844,0.19480622571885897 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441801,3821.364441269261,0.08242664061435212 +967514 MM WT,MoneyMaker,0.8,m_103,fruit,2441812,44745.51910930679,0.9861044521716993 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441800,768220.134153567,6.89582510676523e-4 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441809,839924.3034818232,0.03944404507405963 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441793,765782.4756612704,6.906791867979933e-4 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441801,734117.8454888137,0.01903032146267236 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441812,840909.3996824943,0.03995310422996923 +967514 MM WT,MoneyMaker,0.8,m_103,leaf,2441798,716185.8317687341,0.029770377661971992 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441800,15656.365764989474,0.5386721291983472 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441809,4529.172164834175,0 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441793,2892.0953278662905,0.19480622571885942 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441801,3746.2106051380983,0.08242664061435212 +967514 MM WT,MoneyMaker,0.8,m_104,fruit,2441812,43865.51997223738,0.9861044521716993 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441800,768220.134153567,6.89582510676523e-4 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441809,839924.3034818232,0.03944404507405963 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441793,765782.4756612704,6.906791867979933e-4 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441801,734117.8454888137,0.01903032146267236 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441812,840909.3996824943,0.03995310422996923 +967514 MM WT,MoneyMaker,0.8,m_104,leaf,2441798,716185.8317687341,0.029770377661971992 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441800,55.73358542016681,0.0075210262785545545 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441809,54.77671155853383,0 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441793,57.17696647087027,0.01862515364716666 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441801,47.357917988383434,0.06320335534859245 +967514 MM WT,MoneyMaker,0.8,m_105,fruit,2441812,53.30840536916703,0.011800264919003656 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441800,71.67066488165496,0.048312539408253086 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441809,77.60585646082659,0.013759476639886303 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441793,119.29091033058744,0.17295337997292215 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441801,79.97577672282523,6.955061691300557e-4 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441812,80.2321383013329,6.943941229966555e-4 +967514 MM WT,MoneyMaker,0.8,m_105,leaf,2441798,194.13770507800433,0.3844559186748757 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441800,203.5713125138691,0.04276538677008768 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441809,157.43728467123105,0.06884359911257398 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441793,184.48080709185652,0 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441801,140.51089645763267,0.11824118538344353 +967514 MM WT,MoneyMaker,0.8,m_106,fruit,2441812,252.64300448912857,0.13655608745984793 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441800,3229.062627091891,0.016121555034101842 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441809,2993.723986540962,0.016743156082041022 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441793,2788.2798075011015,0.04761855950016214 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441801,2767.8606136101243,0.05081069738143018 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441812,3257.498003416942,0.019929245068766033 +967514 MM WT,MoneyMaker,0.8,m_106,leaf,2441798,3253.2227002662235,0.019358880920709698 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441800,496.8049360096423,0.1920489817625639 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441809,250.4271654468435,0.10545548255174841 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441793,319.25442123871,0 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441801,154.92222843637427,0.3140231850148614 +967514 MM WT,MoneyMaker,0.8,m_107,fruit,2441812,2263.274075830852,0.8506002285592862 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441800,4942.795069751508,0.061033643455667086 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441809,5851.1665764125155,0.012236213915174599 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441793,5955.774110013457,0.019931969248320414 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441801,5033.044999931184,0.05317543487160625 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441812,7993.863531746163,0.14775048160627424 +967514 MM WT,MoneyMaker,0.8,m_107,leaf,2441798,5526.055725299799,0.012590988196179875 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441800,232.11785848419268,0.4078067221319106 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441809,81.25542898343544,0.04804944550276957 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441793,67.80606190188121,0.12663331119957655 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441801,90.76153515166882,0 +967514 MM WT,MoneyMaker,0.8,m_108,fruit,2441812,216.62936330049763,0.3778154902881905 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441800,172.48115397567292,0.11034052955797069 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441809,626.974968884501,0.4501680238677497 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441793,170.0328784358505,0.11654927177439545 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441801,272.2649725868059,0.08790959341436322 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441812,169.98055820183563,0.11668292760475651 +967514 MM WT,MoneyMaker,0.8,m_108,leaf,2441798,414.2078109331099,0.2701361056549363 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441800,87.46253378136834,0.023392454313927225 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441809,106.9715708621507,0.06405386442781946 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441793,85.04885250887908,0.03554605054958415 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441801,92.30272209573492,0 +967514 MM WT,MoneyMaker,0.8,m_109,fruit,2441812,127.20198149206654,0.13927936762304594 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441800,1867.5424450131952,0.0393417817080981 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441809,1694.9908993227928,0.0027613286733618736 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441793,1716.6137303040136,0.002743882477196813 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441801,1553.379060661632,0.04065125279474424 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441812,1483.406862435147,0.06066841563840919 +967514 MM WT,MoneyMaker,0.8,m_109,leaf,2441798,1859.2350241001625,0.037405592565022516 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441800,1213.8226671847358,0.2071732556938386 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441809,555.515462354814,0.13228583593942833 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441793,753.324318973952,0 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441801,310.57543416933834,0.3848148866275585 +967514 MM WT,MoneyMaker,0.8,m_11,fruit,2441812,4856.2128415928255,0.8093157254109768 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441800,788.9510845338385,0.033049259929259556 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441809,913.714402966204,0.030711133349696773 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441793,594.8480218210319,0.1556933157717908 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441801,556.7980271499797,0.18440164963036887 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441812,1916.80430661436,0.3524784390283511 +967514 MM WT,MoneyMaker,0.8,m_11,leaf,2441798,1040.426697776186,0.08711215040065667 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441800,385.2580863263167,0.25079251486022347 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441809,189.36380892767815,0.05766226764056581 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441793,215.43861953030188,0.0016356906192469545 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441801,216.2515595641949,0 +967514 MM WT,MoneyMaker,0.8,m_110,fruit,2441812,1029.351811499531,0.6776045849534489 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441800,8757.303939069796,0.13061178239894566 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441809,4250.488339556598,0.18331981148822063 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441793,3797.39134317876,0.2322732845865776 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441801,7408.674567713001,0.057981877854235364 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441812,5737.914541105064,0.053004564897709106 +967514 MM WT,MoneyMaker,0.8,m_110,leaf,2441798,7227.566553762928,0.047233458889444524 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441800,219.2341006077055,0.2766359139716257 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441809,189.9738236942659,0.2144215709547801 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441793,115.9503844955639,0 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441801,109.56507874823852,0.024600037901831406 +967514 MM WT,MoneyMaker,0.8,m_111,fruit,2441812,90.74585792145776,0.10644538224603006 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441800,57737.78803442881,0.01603549703297702 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441809,50921.59054329641,0.03852268433144168 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441793,63386.20010255466,0.05657007254296165 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441801,53551.827078782815,0.01665035211642607 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441812,44528.78164397802,0.09678383225312626 +967514 MM WT,MoneyMaker,0.8,m_111,leaf,2441798,66513.47695049559,0.07748500612423292 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441800,729.2533347107177,0.22590708269862825 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441809,352.95426774654135,0.08925290349502069 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441793,170.4221638019868,0.40544526591082075 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441801,433.48227207138984,0 +967514 MM WT,MoneyMaker,0.8,m_112,fruit,2441812,1735.8973117113906,0.6025526895590159 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441800,267764.2598307303,1.6001642001819545 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441809,3937.3256181662055,0.23238707578690576 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441793,6972.1322972307,0.015777210953940468 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441801,5459.424168332662,0.09044157036646538 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441812,8163.84698085798,0.08430644755409444 +967514 MM WT,MoneyMaker,0.8,m_112,leaf,2441798,6474.6509382148315,0.016372048690338925 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441800,219.08265026897257,0.23768542735023024 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441809,97.87460166442841,0.11225255109705445 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441793,126.74258442910744,0 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441801,62.07857143742216,0.30998084434338 +967514 MM WT,MoneyMaker,0.8,m_12,fruit,2441812,759.9716615466743,0.7778748395995652 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441800,26.05590878505712,0.12225880596594796 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441809,135.93,0.5951502857251663 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441793,8.345186666070177,0.6167289757021479 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441801,24.69079481246451,0.1456299607998055 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441812,42.9990748748258,0.09529408065985101 +967514 MM WT,MoneyMaker,0.8,m_12,leaf,2441798,141.47573942738364,0.6125169412933287 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441800,66.80854636248674,0.00930976893932045 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441809,79.972802486469,0.06880052395809733 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441793,68.25615049148446,0 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441801,67.68992411542006,0.0036177640782941722 +967514 MM WT,MoneyMaker,0.8,m_120,fruit,2441812,70.7502803504742,0.015586373801971476 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441800,260.09894953013884,0.1403817761160533 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441809,219.2716621586787,0.06622568664121564 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441793,149.11669840014562,0.1012305427027469 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441801,196.5889316633589,0.018802240481597288 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441812,102.68237507114084,0.26326091661993667 +967514 MM WT,MoneyMaker,0.8,m_120,leaf,2441798,179.93,0.01965324212838704 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441800,68.95214693855746,0 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441809,88.00298317470532,0.1059496011630019 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441793,67.89247553733266,0.006726148719273128 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441801,66.37228710402331,0.01656101006411337 +967514 MM WT,MoneyMaker,0.8,m_121,fruit,2441812,78.78168292086818,0.057877460701102335 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441800,307.80400764286276,0.043867031685627556 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441809,248.66019843403973,0.04880096252377841 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441793,107.77805078687936,0.4118769134840874 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441801,312.39675543468127,0.05029927621892272 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441812,101.05362271298912,0.43985535107737306 +967514 MM WT,MoneyMaker,0.8,m_121,leaf,2441798,370.23574088702713,0.12407110285959488 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441800,223.75857348297623,0 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441809,225.43005100273797,0.003232124654973134 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441793,165.4568045999913,0.13109505191649617 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441801,154.79927222590965,0.16001077007868014 +967514 MM WT,MoneyMaker,0.8,m_122,fruit,2441812,630.1866058827975,0.4496894837147658 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441800,16244.05410924625,0.1514296263220798 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441809,8538.400201284921,0.12788829448500927 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441793,8440.5621520487,0.13289342899403733 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441801,15607.078139758987,0.13405680361523853 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441812,9598.900499930742,0.07704331124339481 +967514 MM WT,MoneyMaker,0.8,m_122,leaf,2441798,13325.331595551936,0.06541322393639337 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441800,140.94509611803048,0 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441809,129.8489435966955,0.035611549407209786 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441793,146.2513611229911,0.016049946511121238 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441801,133.85266998624877,0.022422931557420256 +967514 MM WT,MoneyMaker,0.8,m_123,fruit,2441812,181.55961986528325,0.10996929465487648 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441800,98.99889209044912,0.1458324907253048 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441809,119.10450996454112,0.06553461848548148 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441793,164.4533801019779,0.07457997910324954 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441801,74.75100139801312,0.2678458100641756 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441812,309.5852751217091,0.3493174709463456 +967514 MM WT,MoneyMaker,0.8,m_123,leaf,2441798,157.90381474661802,0.05692979700968914 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441800,6623.650619810928,0.31643109560521143 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441809,1810.5943642296963,0.24684515665730622 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441793,3196.4382639487376,0 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441801,607.2661438195687,0.7212872517829574 +967514 MM WT,MoneyMaker,0.8,m_13,fruit,2441812,11047.108554750534,0.5385823007560098 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441800,83216.47008506453,0.089887480629117 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441809,66622.38468652639,0.0067016353112459015 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441793,50169.01888883493,0.12988620111575244 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441801,68694.4420551826,0.006599791375633046 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441812,83706.47890407995,0.09243726469125679 +967514 MM WT,MoneyMaker,0.8,m_13,leaf,2441798,55320.41613133369,0.08743637081288558 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441800,77.79119193633153,0.19541741478326102 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441809,48.187288589707904,0.012580521091457353 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441793,28.21298821389824,0.24506392369245988 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441801,49.60357880218383,0 +967514 MM WT,MoneyMaker,0.8,m_14,fruit,2441812,87.9535969913886,0.24874059413997496 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441800,138.92044687898925,0.01650316843766353 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441809,149.6815527019168,0.01589893949588239 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441793,90.99372538164153,0.20025789423553553 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441801,199.1697955321303,0.13995413740357954 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441812,12.47129573985388,1.06335776206392 +967514 MM WT,MoneyMaker,0.8,m_14,leaf,2441798,247.53568409144057,0.23436847441368958 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441800,61.90871946873034,0.04843202018149895 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441809,69.21238919826035,0 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441793,95.82025666544476,0.14127348856994137 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441801,77.07679891516739,0.046739828366212155 +967514 MM WT,MoneyMaker,0.8,m_15,fruit,2441812,59.75594814410523,0.06380269954713946 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441800,714.7096470976965,0.0034380598566463583 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441809,726.070447401784,0.003411056343735286 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441793,539.3547791113874,0.12569317279249503 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441801,2611.700256041525,0.5593556275597131 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441812,525.2620577865395,0.13719167332234017 +967514 MM WT,MoneyMaker,0.8,m_15,leaf,2441798,744.6548080430684,0.014387293905818943 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441800,15.574585758637644,0.6595566397978441 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441809,71.11695352211702,0 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441793,57.456121057035546,0.09263684141918915 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441801,110.37537217823692,0.19089903676164455 +967514 MM WT,MoneyMaker,0.8,m_16,fruit,2441812,92.20238517791314,0.112769011698713 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441800,3.9378101630758935,1.326748146020366 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441809,63.27781165048325,0.12075147007665277 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441793,54.284284088714344,0.18732880688614273 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441801,109.13783970921712,0.11597243151105241 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441812,227.58594636140907,0.43514251894190714 +967514 MM WT,MoneyMaker,0.8,m_16,leaf,2441798,103.84391623216366,0.09437813664206063 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441800,2444.56187808283,0 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441809,1722.5422609628768,0.15203114911846827 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441793,3579.7783184761975,0.16565509849799742 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441801,705.5116128968582,0.5396968680931198 +967514 MM WT,MoneyMaker,0.8,m_17,fruit,2441812,44504.545027398424,1.260203330739333 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441800,15014.520007243647,0.04314498826800239 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441809,17357.820745955712,0.01983875784921274 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441793,13649.242962443352,0.0845478767861021 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441801,15807.670689375977,0.02078856127921913 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441812,25492.79105123754,0.1867609450931571 +967514 MM WT,MoneyMaker,0.8,m_17,leaf,2441798,21731.303335532943,0.11742933267476108 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441800,67.21869292081152,0.08502715732953714 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441809,55.2666201494044,0 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441793,46.04760876077059,0.07925582362473071 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441801,9.08947385451362,0.7839241612025027 +967514 MM WT,MoneyMaker,0.8,m_18,fruit,2441812,363.6079481790993,0.8181704620297097 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441800,581.0114323847209,0.11237081452985143 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441809,794.6341357562695,0.023611724983290117 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441793,844.6495925867434,0.05012108443228547 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441801,190.00618718063788,0.5977877493490498 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441812,710.5356371285989,0.024969627504176195 +967514 MM WT,MoneyMaker,0.8,m_18,leaf,2441798,1288.7833960129196,0.23362443974807867 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441800,6.119843328091671,0.29496174864752955 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441809,2.8046137765977823,0.04390549241284397 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441793,3.1029769922898995,0 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441801,2.4640534198282755,0.10012843647446112 +967514 MM WT,MoneyMaker,0.8,m_19,fruit,2441812,7.217314138179807,0.36659705322871694 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441800,1581.1478648357247,0.007657353780915255 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441809,1684.8494261561298,0.01993125463735046 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441793,1637.3989862972321,0.007524677482168229 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441801,1058.4020267007804,0.18197917690554766 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441812,1519.7012768203658,0.02487161134892002 +967514 MM WT,MoneyMaker,0.8,m_19,leaf,2441798,2280.687119449568,0.15143587011729176 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441800,250.06732888219588,0.027048048453154117 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441809,200.22272523791324,0.06949553844513678 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441793,234.96810087411305,0 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441801,82.1320750613255,0.4564961113332191 +967514 MM WT,MoneyMaker,0.8,m_2,fruit,2441812,418.6874110213024,0.2508809961198235 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441800,4504.425643108075,0.3754459607062177 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441809,584.5898124071101,0.5113422188058263 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441793,589.6909814068966,0.5075689756507393 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441801,3172.1432353061173,0.22315932778613723 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441812,622.9588025797036,0.4837341345734689 +967514 MM WT,MoneyMaker,0.8,m_2,leaf,2441798,4738.95747671018,0.39748935025207777 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441800,21.97131335915683,0.13882947757874264 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441809,48.36397136350104,0.20383645964890618 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441793,24.615456342485505,0.0894776041925116 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441801,30.24722212894152,0 +967514 MM WT,MoneyMaker,0.8,m_20,fruit,2441812,101.03915702170694,0.5238042185062564 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441800,9.078804478716687,0.6975097352599873 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441809,113.0995324004244,0.39792241089282965 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441793,103.49644050717995,0.3593870151266272 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441801,48.56947335246659,0.030824995879509043 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441812,41.913818911346425,0.03318116579413943 +967514 MM WT,MoneyMaker,0.8,m_20,leaf,2441798,2.1868215359654597,1.3157250562840694 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441800,21368.444554702983,0.4390559435804291 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441809,5943.550424106792,0.11667101516182621 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441793,7775.29663389202,0 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441801,5670.28595640291,0.13711200548948854 +967514 MM WT,MoneyMaker,0.8,m_21,fruit,2441812,32907.39936023299,0.6265765950772528 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441800,339029.2895302829,0.16535116209024991 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441809,202349.17974764245,0.058784609191683934 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441793,97074.86036759708,0.37777928291616636 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441801,141459.29179819638,0.21425457794589775 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441812,261008.16673946092,0.05176803883646297 +967514 MM WT,MoneyMaker,0.8,m_21,leaf,2441798,453583.1241378,0.2917708305241522 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441800,29.05938839378472,0 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441809,27.875684775213653,0.0180609247911534 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441793,180.6543087788205,0.7935618548053516 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441801,108.53311260822684,0.5722757887056045 +967514 MM WT,MoneyMaker,0.8,m_22,fruit,2441812,25.570333897538553,0.05555007048012395 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441800,71.76005142637945,0.20626615138473947 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441809,167.20020794673627,0.5736202233492032 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441793,12.892917070855807,0.5392654006589319 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441801,16.888216642971898,0.4220327983969232 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441812,80.50075997243103,0.25618339048553196 +967514 MM WT,MoneyMaker,0.8,m_22,leaf,2441798,17.497832278512842,0.40663234050188035 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441800,2194.3456886146337,0.08250683485225041 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441809,1814.6723034286174,0 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441793,1273.9971775565807,0.1536297449715227 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441801,2044.3384138372337,0.05175457843389086 +967514 MM WT,MoneyMaker,0.8,m_23,fruit,2441812,1687.365103119375,0.0315891477300867 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441800,109532.2892013421,0.029064670868184983 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441809,95351.4488958754,0.03115019688130971 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441793,94392.70256589905,0.035539072965666385 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441801,120710.6321979818,0.07126803090230105 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441812,195582.70503588812,0.2808529548512775 +967514 MM WT,MoneyMaker,0.8,m_23,leaf,2441798,81335.61534537032,0.10019673688111297 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441800,64.66918895478564,0.01967885276775405 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441809,61.8042814419399,0 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441793,59.34376731639758,0.017643448388804828 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441801,50.27466556265947,0.08966937126941277 +967514 MM WT,MoneyMaker,0.8,m_24,fruit,2441812,73.70797053052846,0.0764958920019756 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441800,116.87086225991536,0.11790765703932138 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441809,248.3779266125912,0.20949909213058193 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441793,150.56232939170408,0.007897580040482133 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441801,217.64839514855316,0.15214156392649958 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441812,95.47546464273483,0.20572212467006024 +967514 MM WT,MoneyMaker,0.8,m_24,leaf,2441798,156.08832861703118,0.007756524979036783 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441800,75.43313356810526,0.0015383770515227102 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441809,75.16640368839178,0 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441793,71.75902172944336,0.020147262606081906 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441801,69.03603735968056,0.03694791697111288 +967514 MM WT,MoneyMaker,0.8,m_25,fruit,2441812,79.66939550934515,0.025267749905529158 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441800,3406.1796716608324,0.03480699996090397 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441809,2881.5020287533703,0.037841623066094954 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441793,2237.625181078003,0.1476732120366635 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441801,2343.384459006895,0.12761700733701797 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441812,3743.272109432083,0.07579084564860361 +967514 MM WT,MoneyMaker,0.8,m_25,leaf,2441798,3460.6355525511185,0.041695312403189355 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441800,125.97664752012945,0.2028278365731464 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441809,200.96382275582206,0 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441793,212.5062982737824,0.02425392288886874 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441801,151.79251901168317,0.12186751514625316 +967514 MM WT,MoneyMaker,0.8,m_26,fruit,2441812,231.9804014632611,0.06233341235164813 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441800,3496.84423161846,0.015094160588848826 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441809,3918.625912288874,0.034363358467187854 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441793,4624.198463442687,0.10626601755908238 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441801,2724.510305235308,0.12348199257427428 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441812,3548.057587015156,0.008779787434432418 +967514 MM WT,MoneyMaker,0.8,m_26,leaf,2441798,3692.9740198276672,0.00860580488774021 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441800,74.99694365106332,0.02476513078702891 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441809,62.34212080614833,0.05549686178776825 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441793,70.83998069581246,0 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441801,59.47583466083284,0.07593788869835483 +967514 MM WT,MoneyMaker,0.8,m_27,fruit,2441812,192.5874499259498,0.4343495484851374 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441800,810.1886779819276,0.011558499064020733 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441809,639.909288240724,0.0909092567878722 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441793,584.1364848160749,0.130513337897312 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441801,885.59640867863,0.050208175940126054 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441812,860.9602953501875,0.037955452927826094 +967514 MM WT,MoneyMaker,0.8,m_27,leaf,2441798,767.63208375915,0.011874552651567338 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441800,74.13049354790756,0.10718757116718214 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441809,57.917435064687176,0 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441793,44.24835280047642,0.11691221223429649 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441801,47.609356900053626,0.08511700529078858 +967514 MM WT,MoneyMaker,0.8,m_28,fruit,2441812,413.9306844813751,0.8541183012127462 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441800,866.3671331986853,0.3881095294481631 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441809,338.2712820098062,0.020327309591330334 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441793,370.68986382302006,0.019418271867662096 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441801,927.0460509705028,0.4175088693021416 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441812,330.085777915948,0.030965626226336695 +967514 MM WT,MoneyMaker,0.8,m_28,leaf,2441798,312.7983086163206,0.05432804288853621 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441800,501071.71346086625,0.24127283862861937 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441809,272256.6121741241,0.02364861190912837 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441793,230370.0613299633,0.09620101005203541 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441801,287492.8498700879,0 +967514 MM WT,MoneyMaker,0.8,m_29,fruit,2441812,671623.9019969889,0.3684990955917016 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441800,402403.31167660735,0.01437469019081572 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441809,388818.2040580847,5.402660648909929e-4 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441793,263372.0212781787,0.1697172192052694 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441801,389786.1923956216,5.395948042341558e-4 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441812,853136.2776421353,0.34073155371013186 +967514 MM WT,MoneyMaker,0.8,m_29,leaf,2441798,348797.3338199069,0.047713699445090185 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441800,98.48150389218414,0.28626901069769106 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441809,46.15389398040162,0.04287731319329047 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441793,50.943134263017974,0 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441801,28.967911111765,0.2451684821286746 +967514 MM WT,MoneyMaker,0.8,m_3,fruit,2441812,219.587617487157,0.6345221853637026 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441800,248.68424854292377,0.35695051466519745 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441809,104.91680866250304,0.017852691777592522 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441793,74.77327128660701,0.16495138242801888 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441801,113.72225524718726,0.017147700060130777 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441812,10.654556784396318,1.0111623752737935 +967514 MM WT,MoneyMaker,0.8,m_3,leaf,2441798,240.06055288617733,0.34162303837404195 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441800,153.03679200773425,0.03577015368945613 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441809,140.93721964266092,0 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441793,129.4648090881647,0.03687396439951396 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441801,139.49454300413595,0.004468481207617447 +967514 MM WT,MoneyMaker,0.8,m_30,fruit,2441812,204.5682716161112,0.16181257620939205 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441800,6332.736276859706,0.028896381394772686 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441809,5517.445621057378,0.030956959539363726 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441793,4173.165681483905,0.15222939381331324 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441801,4734.5681390497,0.09741464984580173 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441812,7340.70051436888,0.09304248503592794 +967514 MM WT,MoneyMaker,0.8,m_30,leaf,2441798,6512.127880056486,0.041027899232516596 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441800,90.48080860772755,0.15952162849948226 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441809,56.63159556602124,0.043976046810475955 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441793,62.66641416312612,0 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441801,42.48664766106602,0.16878237948182262 +967514 MM WT,MoneyMaker,0.8,m_31,fruit,2441812,261.61192903761463,0.6206226985253327 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441800,622.5130093761042,0.0022670993302917886 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441809,632.6094564109488,0.0047201484270593674 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441793,629.0292739252448,0.0022553260750513004 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441801,618.7706599478591,0.004885818436392686 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441812,596.6699185910736,0.020681387923219052 +967514 MM WT,MoneyMaker,0.8,m_31,leaf,2441798,636.2332930840327,0.007200860162528411 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441800,70.12544905337052,0 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441809,98.49943063524873,0.14755806480587097 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441793,57.69255795825453,0.0847558602836398 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441801,77.96565523308246,0.04602767779734385 +967514 MM WT,MoneyMaker,0.8,m_32,fruit,2441812,46.142548882228745,0.18177407433707926 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441800,2520.3941459300668,0.03520308615325929 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441809,2592.680412038859,0.04748361049272898 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441793,1449.803203430916,0.2049563210456311 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441801,1962.8398606735495,0.07338050716306554 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441812,2389.7147238793164,0.012080683361482158 +967514 MM WT,MoneyMaker,0.8,m_32,leaf,2441798,2258.5983574202673,0.012426368102457452 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441800,30.103984957631816,0 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441809,28.949474259905415,0.01698330722084873 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441793,27.373267836884292,0.041297341466577375 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441801,49.072594923032014,0.21221503546014375 +967514 MM WT,MoneyMaker,0.8,m_33,fruit,2441812,31.930468569847942,0.025581303421265744 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441800,2217.238684718533,0.013559783339446962 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441809,2627.7628362156324,0.06021393565558908 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441793,3126.299742751467,0.13565838430975186 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441801,1010.4202170694005,0.3548702033223208 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441812,2357.878541002787,0.01314919939512027 +967514 MM WT,MoneyMaker,0.8,m_33,leaf,2441798,1947.4927178024425,0.0698963881664465 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441800,673.0841861869478,0.18953298917264272 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441809,355.6660515275976,0.08749398437333644 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441793,435.0472201379905,0 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441801,317.41239199266994,0.13691252005095889 +967514 MM WT,MoneyMaker,0.8,m_34,fruit,2441812,625.1108100655439,0.15742061129048412 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441800,47204.84092331685,0.058927456724730654 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441809,59061.74442411738,0.03839227480992591 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441793,56978.509342410805,0.022797087990767295 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441801,35352.35747008495,0.18449561515399182 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441812,55506.199038861974,0.011427493515664189 +967514 MM WT,MoneyMaker,0.8,m_34,leaf,2441798,52623.25017989367,0.011736327165649207 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441800,103.57713062262656,0.0639983617369757 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441809,86.74431971313112,0.01302446848936789 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441793,89.3851789482972,0 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441801,85.19045238436233,0.02087458946315013 +967514 MM WT,MoneyMaker,0.8,m_35,fruit,2441812,105.46941277451458,0.07186101404683898 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441800,5478.005203202924,0.04937423268342833 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441809,8611.737990096812,0.14709413494524215 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441793,6797.140866617686,0.04432959739517761 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441801,3221.6089536273166,0.27992384949978044 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441812,12523.5773146983,0.30973172813848837 +967514 MM WT,MoneyMaker,0.8,m_35,leaf,2441798,5440.80732265815,0.052333326764284926 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441800,3327.2798342874203,0.1199169077563127 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441809,2524.482823562973,0 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441793,2961.347575988698,0.06931696378236207 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441801,1346.8686138533217,0.27284718747832315 +967514 MM WT,MoneyMaker,0.8,m_36,fruit,2441812,1926.3406380435067,0.11743933352620672 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441800,2421.679109784028,0.19648376255551936 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441809,3840.584507733128,0.0037969677369029675 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441793,6173.657109833808,0.20994214675529577 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441801,3773.7219761092697,0.0038304570300597973 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441812,11482.54867477801,0.4794379371020425 +967514 MM WT,MoneyMaker,0.8,m_36,leaf,2441798,2485.3121126433784,0.18521942153130544 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441800,787.5242194721534,0.1169708238816134 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441809,601.5795923243775,0 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441793,691.2873088711755,0.060365488826619185 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441801,321.45926054581406,0.27216715368946076 +967514 MM WT,MoneyMaker,0.8,m_37,fruit,2441812,446.2474062290564,0.1297173902197164 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441800,172.38211956747148,0.007306553538691585 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441809,163.25756386583836,0.030925458266809258 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441793,104.84030005266638,0.22327051469753023 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441801,239.12070289772856,0.134818408722579 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441812,365.27713364813866,0.31882371630079387 +967514 MM WT,MoneyMaker,0.8,m_37,leaf,2441798,178.2314865629667,0.007185659477691786 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441800,105.65087022272763,0.2856513915256602 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441809,29.343946574832806,0.27070316377373294 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441793,25.538451026207618,0.3310271344335336 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441801,54.7295260291876,0 +967514 MM WT,MoneyMaker,0.8,m_38,fruit,2441812,57.18277117144258,0.0190435110946523 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441800,100.54947610571418,0.14006067533278577 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441809,329.4018980414478,0.6554069604867876 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441793,47.00826836854009,0.1901448833064343 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441801,77.33090724330881,0.026033968539042718 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441812,42.088372769062815,0.23815700152212216 +967514 MM WT,MoneyMaker,0.8,m_38,leaf,2441798,68.33205326117074,0.027694666071363283 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441800,112.24169171798532,0.11397427273681426 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441809,100.48422728721894,0.06591796611966627 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441793,86.33361595352459,0 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441801,65.41664269733378,0.12049167949493844 +967514 MM WT,MoneyMaker,0.8,m_39,fruit,2441812,66.99277522190279,0.11015196195051757 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441800,2435.2042120179917,0.014427294883891939 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441809,2293.8343278033667,0.011546043602160161 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441793,3244.956016233101,0.1391007231515058 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441801,1941.436095637695,0.08398499151022376 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441812,1944.2683880068,0.08335187637238617 +967514 MM WT,MoneyMaker,0.8,m_39,leaf,2441798,2417.436680423537,0.011247016111374464 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441800,32.51081831461623,0 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441809,41.06199427454982,0.10141213704607788 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441793,29.405860052271947,0.043594015040810286 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441801,29.94450054276605,0.03571082736142661 +967514 MM WT,MoneyMaker,0.8,m_4,fruit,2441812,79.18132720951256,0.3865948759111344 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441800,199.5392636705925,0.017952259098107604 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441809,183.37901841672235,0.018726462449182524 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441793,223.06619229566357,0.0663576478278185 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441801,256.78078849500776,0.12748642193273474 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441812,165.33177323106514,0.06371978247226817 +967514 MM WT,MoneyMaker,0.8,m_4,leaf,2441798,156.8099582880691,0.08670246688249117 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441800,229.06261181651251,0.12833579663161432 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441809,170.4584015893661,0 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441793,214.43996129149633,0.09968730846913854 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441801,150.47783579650223,0.05414587521597891 +967514 MM WT,MoneyMaker,0.8,m_40,fruit,2441812,114.73038711196922,0.1719399527488661 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441800,6780.073430841338,0.001460513265721719 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441809,7175.613179186064,0.02316410811273384 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441793,6538.135475337439,0.01724099547429736 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441801,6412.722223461658,0.02565248251950747 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441812,7139.507978080347,0.020973372500318277 +967514 MM WT,MoneyMaker,0.8,m_40,leaf,2441798,6825.752374180634,0.0014556180814553343 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441800,163.87122197219074,0.178392200364629 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441809,108.67020638088268,0 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441793,107.51179451066744,0.0046543809956332005 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441801,89.17648690338687,0.08586013247770019 +967514 MM WT,MoneyMaker,0.8,m_41,fruit,2441812,236.99013420424424,0.3386197750456881 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441800,1434.3761585685804,0.04015940138478813 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441809,1661.166147034653,0.02359061263608586 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441793,1308.501613410992,0.08004819691810239 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441801,1485.5129490714787,0.024946017530068865 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441812,1868.4817262941751,0.07466639542806996 +967514 MM WT,MoneyMaker,0.8,m_41,leaf,2441798,1892.462078162691,0.08020472632103193 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441800,47.35539356260724,0 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441809,46.879448069059166,0.004386960396998818 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441793,48.22312815173146,0.007885928584093316 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441801,43.49110438518453,0.03696901430971189 +967514 MM WT,MoneyMaker,0.8,m_42,fruit,2441812,48.699293841422694,0.01215321351216092 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441800,149.40026190717026,0.025324673830051214 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441809,164.08470386289696,0.015392064929195204 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441793,154.30933968970507,0.011283819791813698 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441801,169.1456017456969,0.028584676757908323 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441812,161.26010621737927,0.007850908867606865 +967514 MM WT,MoneyMaker,0.8,m_42,leaf,2441798,155.48216630512457,0.007995449704594204 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441800,29.94073609057763,0.5696694900391923 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441809,732.1558360118771,0.818671565213732 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441793,372.7633958153404,0.525501296161051 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441801,111.15575766359662,0 +967514 MM WT,MoneyMaker,0.8,m_43,fruit,2441812,20.98991614375098,0.7239212597245521 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441800,259.08705016675395,0.12061272684673341 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441809,415.9035042749699,0.0849341463856943 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441793,325.67157782195335,0.021278574979868736 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441801,358.379338338215,0.02028453008415987 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441812,275.43422933110486,0.09404052241119487 +967514 MM WT,MoneyMaker,0.8,m_43,leaf,2441798,369.2617842136464,0.033275930574290236 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441800,103324.07227124766,0.27078535372070967 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441809,55388.06086825049,0 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441793,44390.20261143996,0.09612903350412871 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441801,51605.19725626822,0.030722718354223133 +967514 MM WT,MoneyMaker,0.8,m_44,fruit,2441812,142954.2876281886,0.41178102488804047 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441800,150943.29416410028,0.14894812898471077 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441809,103702.19803207272,0.014077733126450553 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441793,71586.57416470756,0.17503411536256586 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441801,86808.94200504188,0.09130123151815717 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441812,378357.3541774057,0.548036485067156 +967514 MM WT,MoneyMaker,0.8,m_44,leaf,2441798,110535.39995128971,0.01363569224061667 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441800,123370.40451826827,0.25088447395720603 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441809,69235.13044418339,0 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441793,60216.639736125726,0.06060999782812626 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441801,64305.96924116891,0.032075226336130136 +967514 MM WT,MoneyMaker,0.8,m_45,fruit,2441812,174089.9483795148,0.4004471817247879 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441800,22110.185631871984,0.1537057120110319 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441809,14723.631866049962,0.022871726540945936 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441793,10467.66204642906,0.1710369840312378 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441801,12573.688209775062,0.0914239898855067 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441812,74650.28470987077,0.6821447916102139 +967514 MM WT,MoneyMaker,0.8,m_45,leaf,2441798,16316.007908384896,0.021727230331661573 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441800,10530.710870596997,0.21905957824701838 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441809,4534.269912212454,0.1468907418918759 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441793,6359.13596521254,0 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441801,3310.148765642267,0.28355059836936114 +967514 MM WT,MoneyMaker,0.8,m_46,fruit,2441812,34777.142375506424,0.7378957825520556 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441800,14962.680965390377,0.06741075962364729 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441809,11358.834309776144,0.05226489179675653 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441793,10722.993115609488,0.0772826292129487 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441801,14264.087543211688,0.046645339202624925 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441812,29391.83556237996,0.36062805285893607 +967514 MM WT,MoneyMaker,0.8,m_46,leaf,2441798,9914.161053377398,0.11134268673000935 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441800,214.07616566795656,0.11673284703114462 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441809,136.65915783906203,0.07819673039096697 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441793,163.61965419168703,0 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441801,81.08097707863126,0.30491649686557043 +967514 MM WT,MoneyMaker,0.8,m_47,fruit,2441812,666.4709890552555,0.6099457792230076 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441800,269.63625420099845,0.014897381583220959 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441809,279.00017114085097,0.029723565986340628 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441793,223.2943616517199,0.06700314673487018 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441801,251.4515386133901,0.015426606305984247 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441812,337.28723765268745,0.1121190048848133 +967514 MM WT,MoneyMaker,0.8,m_47,leaf,2441798,193.06095879201445,0.13018644500568888 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441800,56.18737779417096,0 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441809,66.09502234395067,0.07052998923634557 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441793,51.77009573795965,0.035559796381738895 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441801,37.94948227936208,0.17043290903245367 +967514 MM WT,MoneyMaker,0.8,m_48,fruit,2441812,149.7254192201565,0.42565677324943163 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441800,1358.19304507642,0.11988790254844295 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441809,2511.767826802767,0.14713008848114173 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441793,1261.563454150618,0.1519403052274524 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441801,1196.3100144261166,0.17500566651422877 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441812,2221.7770634029143,0.09385107421590932 +967514 MM WT,MoneyMaker,0.8,m_48,leaf,2441798,3660.122798965878,0.3106462516524573 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441800,33.058387406854095,0 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441809,33.15527824954591,0.0012710121980137323 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441793,34.74232876306584,0.021577260853990143 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441801,30.30251393998249,0.037803005111969545 +967514 MM WT,MoneyMaker,0.8,m_49,fruit,2441812,32.33103400412862,0.009662070455748184 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441800,29.60702995488144,0.020271952857835673 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441809,31.32166313560588,0.004178018467392519 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441793,31.35461862111854,0.004634726696547631 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441801,30.721908629573047,0.004218602767350976 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441812,33.683620205691895,0.035751965943362274 +967514 MM WT,MoneyMaker,0.8,m_49,leaf,2441798,30.537934501797075,0.00682713666583834 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441800,570.1084600908886,0.14890528452261265 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441809,404.6245237293365,0 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441793,298.9246073024245,0.13149053383289466 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441801,342.5540015347012,0.07232315613318896 +967514 MM WT,MoneyMaker,0.8,m_5,fruit,2441812,966.8756358531268,0.37831841543492484 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441800,14355.660464691911,0.010463000381564669 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441809,15198.493895672722,0.014314375016172498 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441793,10279.754505480616,0.15550343513537968 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441801,12118.950557490149,0.08402116471889531 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441812,20411.180535059368,0.14238194564649476 +967514 MM WT,MoneyMaker,0.8,m_5,leaf,2441798,15055.771795954768,0.010216845048974577 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441800,38.57883006299915,0.28710566318656516 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441809,107.2481581855354,0.15693512628077122 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441793,74.72307167558004,0 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441801,169.90169251369284,0.3567429888807163 +967514 MM WT,MoneyMaker,0.8,m_50,fruit,2441812,60.8923428418359,0.0888920324114788 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441800,3944.070762933475,0.029893380989867602 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441809,5036.32086336854,0.07627531189795134 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441793,5933.83114455092,0.14749710443478348 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441801,3108.2581232989382,0.13332100193337793 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441812,4259.010078423974,0.0034705885133874403 +967514 MM WT,MoneyMaker,0.8,m_50,leaf,2441798,4191.211070577609,0.0034985466882977434 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441800,51.309407282775965,0.0981877452057196 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441809,39.388601932528786,0.016638686444008677 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441793,40.926937906606575,0 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441801,36.346219112892,0.051550012185634264 +967514 MM WT,MoneyMaker,0.8,m_51,fruit,2441812,67.40360166354354,0.21667385078690504 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441800,248.03314027088285,0.05216508307098655 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441809,311.34409809876706,0.04656584271640751 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441793,245.6123221318854,0.05642464369718869 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441801,228.65984310756383,0.08748489367611478 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441812,318.58725580772096,0.05655360423063316 +967514 MM WT,MoneyMaker,0.8,m_51,leaf,2441798,323.6688286403662,0.06342608125962279 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441800,174.38927752465355,0.006177254596488879 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441809,171.9263819294141,0 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441793,188.6015280669889,0.04020268325990406 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441801,164.2968556703257,0.01971327190632355 +967514 MM WT,MoneyMaker,0.8,m_52,fruit,2441812,171.06936374715818,0.0021702837233408268 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441800,1645.7955198103418,0.005678156565601888 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441809,1633.443045494438,0.0024062770118309373 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441793,1913.3757418975308,0.07110254441594144 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441801,1591.6287771027542,0.008855936472822457 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441812,1615.3924007197577,0.0024196836850634007 +967514 MM WT,MoneyMaker,0.8,m_52,leaf,2441798,1571.3380711081556,0.014428086265255935 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441800,43.86332880847425,0.03650050085845402 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441809,47.70919494688249,0 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441793,53.548956386034455,0.05014892303716789 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441801,47.43590969011328,0.002494854692656423 +967514 MM WT,MoneyMaker,0.8,m_53,fruit,2441812,112.86618655159964,0.3739617633751584 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441800,331.9984575533297,0.006192157986398161 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441809,365.43758466896713,0.03548498781721188 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441793,331.85788732142026,0.006376079937048917 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441801,212.09473756066652,0.20079833093793908 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441812,474.7678982971875,0.14915312221892885 +967514 MM WT,MoneyMaker,0.8,m_53,leaf,2441798,341.5335198842476,0.006105110052398555 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441800,365.3549264945014,0.05511883192089018 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441809,321.80748102909035,0 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441793,283.1311441535923,0.05560849191636441 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441801,280.2945768024405,0.059981440862541646 +967514 MM WT,MoneyMaker,0.8,m_54,fruit,2441812,1119.3328166478454,0.5413631007270361 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441800,6815.811322573465,0.06122397412710612 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441809,6606.363751917519,0.07477905114469241 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441793,8667.8489322112,0.04316979982705549 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441801,7235.419900765809,0.03527779371926654 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441812,8459.949061968558,0.032626214348905336 +967514 MM WT,MoneyMaker,0.8,m_54,leaf,2441798,8594.350651196888,0.039471535233545296 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441800,1.4846157250613934,1.4077594353690397 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441809,15.286071373251438,0.395077608612578 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441793,41.92951255882671,0.04314632198925317 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441801,37.964133477841784,0 +967514 MM WT,MoneyMaker,0.8,m_55,fruit,2441812,63.4982860442711,0.2233885112445626 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441800,142.31690225197937,0.09284161606569441 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441809,225.51682194492955,0.10708084453841638 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441793,11.919991850780631,1.1698221396570925 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441801,217.0014059377648,0.0903644494711564 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441812,210.1579148188187,0.07644765258948771 +967514 MM WT,MoneyMaker,0.8,m_55,leaf,2441798,109.4387706934472,0.2069268921021763 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441800,164.76442615037033,0.35136949446448873 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441809,115.95498857644237,0.19879548179717577 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441793,60.906716779807326,0.08082876647231907 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441801,66.5136221282912,0.04258335682316727 +967514 MM WT,MoneyMaker,0.8,m_56,fruit,2441812,73.3658503558874,0 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441800,4300.476136643299,0.034566537421858 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441809,4426.954980416411,0.02197797405271018 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441793,5640.2765845433105,0.08321732165201245 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441801,18074.255374399523,0.58897733468357 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441812,3971.023630539368,0.06918060808291937 +967514 MM WT,MoneyMaker,0.8,m_56,leaf,2441798,4886.548371274506,0.020919122620161268 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441800,168.552565115725,0.03254543421717582 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441809,181.66898946523105,0 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441793,130.54340162716608,0.1435258753203601 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441801,192.09180131334952,0.024228028666016144 +967514 MM WT,MoneyMaker,0.8,m_57,fruit,2441812,317.2769167641083,0.24215767606051042 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441800,61661.56345428533,0.21589723495469748 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441809,109461.1244692666,0.033348138038077124 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441793,115769.48723628474,0.057682342527686004 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441801,37477.54260228206,0.43214066068470824 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441812,93279.95889944788,0.03612342114157929 +967514 MM WT,MoneyMaker,0.8,m_57,leaf,2441798,126713.14295459908,0.09690989596003519 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441800,351435.5551038355,0 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441809,491977.06286872306,0.14609915799562145 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441793,294155.0817137308,0.07726934191231649 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441801,332713.00931934535,0.02377591498122289 +967514 MM WT,MoneyMaker,0.8,m_58,fruit,2441812,460163.6528371273,0.11706661445438904 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441800,75540.87043699095,0.05155912339088342 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441809,76682.58194419355,0.05807386599621012 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441793,41545.06998791248,0.20810336645781025 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441801,58628.3378428985,0.05851527960026637 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441812,209634.7728084175,0.4948404607521546 +967514 MM WT,MoneyMaker,0.8,m_58,leaf,2441798,47991.021349674345,0.14546286865815095 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441800,819.7204378865496,0.1262491252355269 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441809,511.10073178548464,0.07891013537151981 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441793,612.9381287507568,0 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441801,353.8834530062925,0.23855638190839068 +967514 MM WT,MoneyMaker,0.8,m_59,fruit,2441812,2804.976261834179,0.6605125520846751 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441800,2180.905664506316,0.12037215711613314 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441809,984.3435961425334,0.22511800313535346 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441793,824.6351552085712,0.3020028780108728 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441801,1589.2,0.017086166994229934 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441812,1716.7381107277647,0.016439324992048476 +967514 MM WT,MoneyMaker,0.8,m_59,leaf,2441798,2123.3832111481443,0.10876365584189696 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441800,73.18154864247087,4.6665885873276025e-4 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441809,73.10295571056865,0 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441793,42.558955122326886,0.23494397985404114 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441801,53.46008875157811,0.1359052613642524 +967514 MM WT,MoneyMaker,0.8,m_6,fruit,2441812,107.25984705067864,0.16650223655877538 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441800,87.99162500196175,0.10567642580548586 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441809,84.03121405337782,0.125677125872933 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441793,171.6605019480862,0.18455261410498736 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441801,103.43504000238308,0.035450077250848366 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441812,157.5549330191419,0.14731424141680494 +967514 MM WT,MoneyMaker,0.8,m_6,leaf,2441798,121.0295087770986,0.0327735066240149 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441800,37.32333471367989,0.024192774816070628 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441809,24.484441181774017,0.20728301797656545 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441793,43.951611133743235,0.046801585263119616 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441801,39.461465912667,0 +967514 MM WT,MoneyMaker,0.8,m_60,fruit,2441812,62.81186086909484,0.2018684456702171 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441800,46.82323831617703,0.1669476511514545 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441809,150.320305323452,0.33960855165960613 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441793,34.67785643894844,0.2973568531973543 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441801,80.36022450640706,0.06763204383622967 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441812,57.18296569156275,0.08014242204458055 +967514 MM WT,MoneyMaker,0.8,m_60,leaf,2441798,145.48563957472211,0.32541103005684846 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441800,100.77748003218028,0.15725849252640156 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441809,70.16249139748275,0 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441793,64.5017290173439,0.03653364559811423 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441801,64.22867279712051,0.038376054009377825 +967514 MM WT,MoneyMaker,0.8,m_61,fruit,2441812,122.65246813957113,0.24257128997265864 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441800,485.7109654780291,0.02335896484304456 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441809,539.390533989121,0.0221664474323644 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441793,385.3262959751294,0.12390822536434731 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441801,292.2246954690431,0.24401995839717472 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441812,733.1597668809965,0.15546175133663276 +967514 MM WT,MoneyMaker,0.8,m_61,leaf,2441798,920.4352992190178,0.25425639263808675 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441800,2822.4440039286537,0.028518429460181682 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441809,2643.0592871119006,0 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441793,2172.5514404261908,0.0851368367891947 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441801,1321.0014779377811,0.3012036015032393 +967514 MM WT,MoneyMaker,0.8,m_62,fruit,2441812,2882.39862773243,0.03764713734620839 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441800,1017690.7220831204,0.005959103869129123 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441809,1050696.7749728984,0.019820687867291298 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441793,971595.5184176888,0.014171208450567185 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441801,949524.339258376,0.024150609828823555 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441812,1151418.2455783896,0.059576395720090325 +967514 MM WT,MoneyMaker,0.8,m_62,leaf,2441798,989953.2862860494,0.006042009679647187 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441800,2021.5370998946776,0.18301722170269574 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441809,711.6920404438781,0.27037238564193666 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441793,1326.3694012783342,0 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441801,663.9334593706313,0.3005399385919669 +967514 MM WT,MoneyMaker,0.8,m_63,fruit,2441812,3991.104227491409,0.47842857516002946 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441800,2792.1724981520965,0.025563619297383156 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441809,2592.2422381609435,0.0067030430811612085 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441793,1789.7725566788956,0.16758078126310094 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441801,1868.1130379461188,0.14897547436098657 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441812,5425.046778107443,0.31402486144887254 +967514 MM WT,MoneyMaker,0.8,m_63,leaf,2441798,2672.8819765230696,0.006601156678074371 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441800,912.9217515136172,0.07736051744093109 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441809,763.9642522872919,0 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441793,482.2635418649184,0.1997886059843168 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441801,424.6770267216611,0.2550142692916064 +967514 MM WT,MoneyMaker,0.8,m_64,fruit,2441812,3897.92507159078,0.7077604492008365 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441800,9936.40661023629,0.15342928951346257 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441809,5408.975284241946,0.1106850685757621 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441793,4832.956677249336,0.15958716342906776 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441801,8549.245426798056,0.08812771917701268 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441812,5393.5151102123255,0.11192816578933185 +967514 MM WT,MoneyMaker,0.8,m_64,leaf,2441798,8697.515329850221,0.09559513733001834 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441800,40.78201839517924,0.15641528650624403 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441809,62.02245104619393,0.025664922285176583 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441793,58.463391128893235,0 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441801,44.37219518555121,0.11977308799866959 +967514 MM WT,MoneyMaker,0.8,m_65,fruit,2441812,101.90602815211147,0.2413158723290234 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441800,1607.7562829428543,0.025360963947227422 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441809,1682.0694821585207,0.005737247911930865 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441793,2114.099338167322,0.09354421087559883 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441801,2200.3142198505625,0.11090352607720533 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441812,1403.7756529904914,0.08428347362126232 +967514 MM WT,MoneyMaker,0.8,m_65,leaf,2441798,1726.8062922878971,0.005662443124741401 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441800,698.9760710260049,0.010941060232332767 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441809,681.5869207580105,0 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441793,483.28333109439586,0.14931943182540186 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441801,455.3041732122976,0.1752196170206104 +967514 MM WT,MoneyMaker,0.8,m_66,fruit,2441812,2404.76553051884,0.547551490198241 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441800,7839.398117683048,0.11895968842622118 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441809,3789.455138541457,0.19674626184757704 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441793,4295.111372089002,0.1423486023312286 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441801,7230.977337067308,0.08387396850870132 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441812,4691.13,0.10404556365779749 +967514 MM WT,MoneyMaker,0.8,m_66,leaf,2441798,8415.49499778299,0.14975663429495878 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441800,392.25947756601744,0 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441809,372.3778589849727,0.022589594984582906 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441793,440.24056553147415,0.05011661211731422 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441801,309.8912962046532,0.10236406702757472 +967514 MM WT,MoneyMaker,0.8,m_67,fruit,2441812,981.5958440532702,0.3983592653982533 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441800,318.993609041316,0.029490735949810443 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441809,526.2142027439137,0.18788984758887084 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441793,363.82085749313353,0.027614875007341055 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441801,95.01992072814711,0.5554580543443881 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441812,796.3045860860807,0.36780649881621574 +967514 MM WT,MoneyMaker,0.8,m_67,leaf,2441798,304.83982618418145,0.049201012785307974 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441800,279.7217569541112,0.11456244942808214 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441809,166.48298748423116,0.11079393743633581 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441793,186.4418363295679,0.061620426189240796 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441801,214.86407000793747,0 +967514 MM WT,MoneyMaker,0.8,m_68,fruit,2441812,312.9509744295904,0.16331251015991288 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441800,676.3552849559718,0.11028765516871086 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441809,428.83693231941487,0.08759505209959029 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441793,528.2232411936337,0.0029302730015627887 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441801,473.9520837785619,0.04415279570224229 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441812,948.035369688798,0.2569373077455279 +967514 MM WT,MoneyMaker,0.8,m_68,leaf,2441798,521.1191756272673,0.0029501785308236883 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441800,60.66314293464758,0.07990259795430377 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441809,84.72863200991068,0.06520268939581686 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441793,139.03702047819246,0.28030294725751204 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441801,57.13995571380649,0.10588760569791145 +967514 MM WT,MoneyMaker,0.8,m_69,fruit,2441812,72.91678388747872,0 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441800,22.65673963758315,0.7397251757741774 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441809,159.6465423561154,0.10823692725747902 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441793,59.72306110666387,0.3187805303224496 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441801,164.3970462864183,0.1209714206086252 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441812,146.7202713331073,0.07156753175919572 +967514 MM WT,MoneyMaker,0.8,m_69,leaf,2441798,102.13828958180636,0.08573400887725802 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441800,73.84069271290879,0.034231754696493866 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441809,43.66392457836356,0.19394123937537944 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441793,68.24392665383361,0 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441801,31.898907824699975,0.33028819387740205 +967514 MM WT,MoneyMaker,0.8,m_7,fruit,2441812,175.91584381638478,0.41124094830701474 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441800,145.72719205367378,0.17383705228636215 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441809,131.36418437998765,0.2189006753609255 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441793,398.81586918091426,0.26339478182498777 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441801,289.19107081539266,0.12380723031138618 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441812,579.7196517610549,0.42584037359268834 +967514 MM WT,MoneyMaker,0.8,m_7,leaf,2441798,95.78545989760327,0.3560780602891469 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441800,1626.789469587233,0.09715297084207242 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441809,970.7592694109621,0.12706683550611775 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441793,1224.020797195349,0.026389584737408267 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441801,1300.703718001059,0 +967514 MM WT,MoneyMaker,0.8,m_70,fruit,2441812,2607.2029501231104,0.3019964572169349 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441800,445954.8740274869,0.04046775563355265 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441809,366600.8516341485,0.04462968972160297 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441793,176120.55547791935,0.36301311270030734 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441801,220157.18024557,0.2660903050549148 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441812,471889.7857487991,0.06501741772032954 +967514 MM WT,MoneyMaker,0.8,m_70,leaf,2441798,534017.8904780633,0.11873264761287405 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441800,151.84582274621573,0.08550650366515589 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441809,118.89607455050808,0.02072882910929197 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441793,124.70858322854232,0 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441801,98.68895486504412,0.10162779564750868 +967514 MM WT,MoneyMaker,0.8,m_71,fruit,2441812,313.0037652800915,0.3996532165419495 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441800,2717.503920015728,7.626430802392115e-4 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441809,2876.6675929601593,0.02395685852795637 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441793,2727.056453639467,7.613061877180805e-4 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441801,3310.0123035753277,0.08489678577394688 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441812,2387.6304761167553,0.056965708648634816 +967514 MM WT,MoneyMaker,0.8,m_71,leaf,2441798,2285.2046699936736,0.07600771940741469 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441800,71.86325557861691,0.06257281204761456 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441809,83.00030723102819,0 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441793,47.80107579629129,0.23964202912830856 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441801,93.74303859835794,0.05285932673870164 +967514 MM WT,MoneyMaker,0.8,m_72,fruit,2441812,208.2065805503425,0.39941475169856 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441800,422.25831538812497,0.04260547035079565 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441809,280.2972126398093,0.1353539613625001 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441793,325.5637270568685,0.07033672874334496 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441801,611.653708652931,0.2035328729563739 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441812,399.61,0.018663607259552073 +967514 MM WT,MoneyMaker,0.8,m_72,leaf,2441798,365.9914301805408,0.01950182403491718 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441800,105.25850040381953,0.10814109963970608 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441809,82.05708382393972,0 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441793,101.23417970271696,0.09121108935561795 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441801,73.7191132940181,0.04653597597071357 +967514 MM WT,MoneyMaker,0.8,m_73,fruit,2441812,60.00746534226386,0.13591079581011223 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441800,1699.8899207170005,0.0015692436490959416 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441809,1687.6276054629202,0.0015749343925777204 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441793,1994.3307679554405,0.07094563431766376 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441801,1580.7891830576368,0.029977599670865995 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441812,1685.5930316648532,0.0020988279505322893 +967514 MM WT,MoneyMaker,0.8,m_73,leaf,2441798,1714.8038463269106,0.005362893810957559 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441800,252.8191510850704,0.20483261105614536 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441809,141.74446988205295,0.04647123363971861 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441793,157.75290216600382,0 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441801,112.77853286035,0.145750917128471 +967514 MM WT,MoneyMaker,0.8,m_74,fruit,2441812,519.8915514473036,0.5179354022761391 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441800,1476.806684051795,0.1367996804966074 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441809,1054.9915766535048,0.00927497669429167 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441793,797.0259427196002,0.13105151116095115 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441801,1100.5378916266195,0.009081031134247297 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441812,914.439979422082,0.07136876360629829 +967514 MM WT,MoneyMaker,0.8,m_74,leaf,2441798,1449.0235158022767,0.12855146475973855 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441800,113.83789457100109,0.02401401533039893 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441809,107.71417006177896,0 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441793,96.67779084835396,0.04694612162255751 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441801,101.47184422569984,0.02592728591338389 +967514 MM WT,MoneyMaker,0.8,m_75,fruit,2441812,124.69864446110778,0.06358889294352554 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441800,7673.889172258734,0.0058665738141412405 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441809,9492.382380779718,0.08649312798328257 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441793,7508.988311205419,0.015300668271601037 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441801,8067.747542253278,0.015870203154359608 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441812,7882.617952585304,0.0057883815312025355 +967514 MM WT,MoneyMaker,0.8,m_75,leaf,2441798,7345.581021024521,0.024855943234628253 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441800,141.20660387663162,0.19195708257741217 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441809,69.16728581923624,0.11799719152760879 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441793,116.32228461716656,0.1077649978490578 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441801,24.590316806915062,0.5671338015058511 +967514 MM WT,MoneyMaker,0.8,m_76,fruit,2441812,90.76071853896276,0 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441800,156.6617001321359,0.024477970334912946 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441809,130.19286408872657,0.055897683900894446 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441793,180.65228899867176,0.08635860380244287 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441801,22.209748797493553,0.8239412184648172 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441812,201.05159935305943,0.13282266726836411 +967514 MM WT,MoneyMaker,0.8,m_76,leaf,2441798,139.490429930345,0.025940452134768588 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441800,516.4343907824752,0.07765991169813713 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441809,648.5813451005343,0.021289385952790507 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441793,671.9899014214105,0.03668767946455853 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441801,617.5541820923181,0 +967514 MM WT,MoneyMaker,0.8,m_77,fruit,2441812,605.5578058236755,0.008519460426591685 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441800,13386.143811933409,0.025079143794151548 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441809,14017.651811698988,0.005059362039588677 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441793,13977.037782046413,0.006319491128126131 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441801,14848.464209473388,0.019946906230818406 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441812,14346.16200315574,0.00500110050970104 +967514 MM WT,MoneyMaker,0.8,m_77,leaf,2441798,14508.25762910514,0.009880628661579571 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441800,66.18734338334444,4.1985237642871986e-4 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441809,65.81978191538676,0.0019986584345224045 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441793,68.21144923134536,0.013502179297675054 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441801,60.014305561545406,0.042100312272653095 +967514 MM WT,MoneyMaker,0.8,m_78,fruit,2441812,66.12338796487627,0 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441800,96.5527634202836,0.0021271627951711114 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441809,101.33397528508694,0.018863209200469466 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441793,97.50090924401704,0.002116794770188557 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441801,96.45789369571447,0.002554096746008261 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441812,103.77852926823128,0.029215640697306533 +967514 MM WT,MoneyMaker,0.8,m_78,leaf,2441798,95.71999212370412,0.005889216751664428 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441800,123.1711560063143,0.01062924157592704 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441809,111.68582933117074,0.03188170243895927 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441793,120.1931662303887,0 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441801,100.85541375311372,0.07618056049004762 +967514 MM WT,MoneyMaker,0.8,m_79,fruit,2441812,188.21627179434552,0.1947773907408723 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441800,231.98350901331725,0.011126537776508627 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441809,242.16959810942495,0.007535969924940211 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441793,237.18051386002443,0.0015046454776008744 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441801,238.8268230939559,0.001499450514784062 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441812,259.42987194037437,0.037436330157834874 +967514 MM WT,MoneyMaker,0.8,m_79,leaf,2441798,235.64992293283785,0.0043163490560647055 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441800,71.04856111206121,0.08356957930767317 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441809,58.348351700850095,0.0019571155901727533 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441793,58.611887538633525,0 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441801,41.46918463671636,0.15026021124683364 +967514 MM WT,MoneyMaker,0.8,m_8,fruit,2441812,233.53579340325433,0.6003677455146335 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441800,314.66842537939806,0.015355378249585883 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441809,269.4038068468225,0.05209406036304465 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441793,261.26201010108537,0.06542152474348173 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441801,303.8010841199651,9.153066756439898e-5 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441812,392.93623997873794,0.11182429640242253 +967514 MM WT,MoneyMaker,0.8,m_8,leaf,2441798,303.6730411116999,9.154996237414892e-5 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441800,53.78742344477178,0.029855832675750538 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441809,50.371854674666494,0.0013630334408722966 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441793,50.214010411195254,0 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441801,46.93453777238913,0.029332363147079432 +967514 MM WT,MoneyMaker,0.8,m_80,fruit,2441812,47.68068848021102,0.022482390561026522 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441800,127.9013863024022,0.02466285909177568 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441809,136.59816229243978,0.00390674581082795 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441793,167.70460074442164,0.09300686619618181 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441801,135.325365597614,1.589017804399795e-4 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441812,135.4244107239058,1.588436619468503e-4 +967514 MM WT,MoneyMaker,0.8,m_80,leaf,2441798,125.37805989668848,0.033316565572467205 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441800,276.8613979756444,0 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441809,273.8316358797613,0.004778786565789339 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441793,297.8273863119543,0.03170222273070733 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441801,210.3810804824656,0.11925572623517322 +967514 MM WT,MoneyMaker,0.8,m_81,fruit,2441812,1189.8186927208774,0.6332183801734863 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441800,8454.353214031189,0.01273192398510492 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441809,9083.101997016607,0.018421878819274706 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441793,8539.869592546505,0.00836107334863323 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441801,8367.956756410213,0.01719288502670624 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441812,8871.87579736797,0.008203141012389725 +967514 MM WT,MoneyMaker,0.8,m_81,leaf,2441798,10557.73423826806,0.08375841341505019 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441800,16361.316585735176,0.28969384994290337 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441809,5635.049360782748,0.17322667358067534 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441793,8397.00473780087,0 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441801,4626.414994080374,0.2588798113917701 +967514 MM WT,MoneyMaker,0.8,m_82,fruit,2441812,21299.11569936409,0.404237174468447 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441800,102200.00677742636,0.0844386387734195 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441809,87437.21395468812,0.016684025245660372 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441793,52385.74698003002,0.20579914483296058 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441801,44337.69979324551,0.27823912733615774 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441812,80846.57491387603,0.01735066019192022 +967514 MM WT,MoneyMaker,0.8,m_82,leaf,2441798,306398.252682083,0.5612739984616315 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441800,250.15259948480497,0.18720729651903234 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441809,146.1077344322187,0.04632451716367081 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441793,162.55402358006057,0 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441801,81.79129575831205,0.29829063528878863 +967514 MM WT,MoneyMaker,0.8,m_83,fruit,2441812,793.4536324874698,0.6885238289758018 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441800,1721.4156059510092,0.0463572090381299 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441809,2109.2385177365363,0.04188274867751707 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441793,1415.220159823392,0.13141893842337726 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441801,934.2789131167708,0.31176639806270323 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441812,3201.813680225288,0.22315311097898416 +967514 MM WT,MoneyMaker,0.8,m_83,leaf,2441798,4594.909603813002,0.3800340269829503 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441800,1757.5386815643503,0.7388236330630509 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441809,320.68692928024353,0 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441793,320.0311765907147,8.889708949486597e-4 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441801,263.53771970163615,0.08523847527400319 +967514 MM WT,MoneyMaker,0.8,m_84,fruit,2441812,6011.006082000699,1.2728659082972449 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441800,13615.617934187989,0.021890314429381164 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441809,18385.25339001787,0.15232257798811322 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441793,9684.652954606769,0.12606297923271548 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441801,7358.84937394625,0.24533712823469367 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441812,33207.06302861287,0.40908342466869474 +967514 MM WT,MoneyMaker,0.8,m_84,leaf,2441798,12277.064058820748,0.02305251991514723 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441800,56.9857494014863,0.08906019743761062 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441809,45.29956375737643,0.010612046777009665 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441793,46.420099442480456,0 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441801,39.76147673314798,0.06724356084568628 +967514 MM WT,MoneyMaker,0.8,m_85,fruit,2441812,48.561346694880214,0.01958465553467037 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441800,360.1553677324521,0.01254983588275449 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441809,398.0871188966575,0.03093839738766979 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441793,366.5880263196363,0.0048614520251644144 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441801,374.84123750021803,0.004807635247758402 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441812,427.96341123510285,0.06236691281928408 +967514 MM WT,MoneyMaker,0.8,m_85,leaf,2441798,358.6287511977175,0.014394623814121488 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441800,344.89651584006,0.4032234067276179 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441809,1146.0703511179397,0.11829906360582321 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441793,872.794928093446,0 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441801,837.244401665181,0.018059961595377594 +967514 MM WT,MoneyMaker,0.8,m_86,fruit,2441812,1057.23649524185,0.0832599324780996 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441800,8532.997445461278,0.10992305720839424 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441809,13603.035314175862,0.09261115268555731 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441793,12051.874878467312,0.04002994139107674 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441801,9578.958134928564,0.05970639765696406 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441812,18671.253431749017,0.23014880100033874 +967514 MM WT,MoneyMaker,0.8,m_86,leaf,2441798,9929.490664229914,0.04409770100564181 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441800,317.4373736974361,0.09414984186124542 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441809,227.1737745106439,0.0511500215851064 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441793,148.79406299000888,0.2349226126781656 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441801,255.5690246392487,0 +967514 MM WT,MoneyMaker,0.8,m_87,fruit,2441812,288.68624043268875,0.052917869210359125 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441800,22764.5112386771,0.012618655689715652 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441809,24632.89258037187,0.046875738359772434 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441793,16300.718590755374,0.13243292461923506 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441801,21460.674981132248,0.012996297338993656 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441812,43912.00642790776,0.29794360673283027 +967514 MM WT,MoneyMaker,0.8,m_87,leaf,2441798,19488.82504787476,0.05485401767159814 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441800,90.36201347637116,0.08544017101724655 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441809,64.83905550561678,0.05870904846973146 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441793,46.265667806620066,0.2052868932025631 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441801,74.22423469987653,0 +967514 MM WT,MoneyMaker,0.8,m_88,fruit,2441812,97.47069630430056,0.11832834012542026 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441800,1141.1171279368805,0.019742997622059555 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441809,1254.726405445815,0.06096181125414546 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441793,993.3738881705552,0.040474486525331255 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441801,883.3030020143841,0.09147752002545717 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441812,1764.0131378201547,0.20891458882948832 +967514 MM WT,MoneyMaker,0.8,m_88,leaf,2441798,1039.68981999999,0.020683434818530078 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441800,20832.403216836236,0.18563861120694902 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441809,8264.28630821416,0.21589540716553968 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441793,13586.28628540666,0 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441801,4850.8562065739525,0.4472823605797336 +967514 MM WT,MoneyMaker,0.8,m_89,fruit,2441812,74172.46332229224,0.7371419408413855 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441800,70826.39198460046,0.08664247037461603 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441809,54437.925472322015,0.02765108160175167 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441793,43574.79311205173,0.12431731448847128 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441801,57275.11089732099,0.005586709544005863 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441812,127513.69541029794,0.34200418370226693 +967514 MM WT,MoneyMaker,0.8,m_89,leaf,2441798,58758.18914476091,0.005515754605087686 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441800,66.50337738375892,0.18356568595666634 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441809,43.579075787487625,0 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441793,39.72605987130964,0.04020252282289838 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441801,27.36898336175145,0.20201935004965854 +967514 MM WT,MoneyMaker,0.8,m_9,fruit,2441812,57.14926152447647,0.11773260725386758 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441800,128.57504094324707,0.0117713540532427 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441809,136.38996062635118,0.01385437866535888 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441793,135.40810006198583,0.010716619117451032 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441801,128.8072353274523,0.010987766553692158 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441812,141.5953623416484,0.03012100384166594 +967514 MM WT,MoneyMaker,0.8,m_9,leaf,2441798,128.38379600507193,0.012417812744164536 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441800,28.986048524772173,0.30970703610545014 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441809,58.83896539062517,0.0022310234179299115 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441793,74.73973525729257,0.10165550414360136 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441801,59.14200600264864,0 +967514 MM WT,MoneyMaker,0.8,m_90,fruit,2441812,72.75145307801296,0.08994562097024761 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441800,2361.398015586592,0.07386298402004687 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441809,3411.2227583013655,0.08587790249537353 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441793,2872.1716371728003,0.0111782112465173 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441801,1905.7358850841952,0.16696946612924624 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441812,3336.7467567159024,0.07629106904786687 +967514 MM WT,MoneyMaker,0.8,m_90,leaf,2441798,2726.205784487304,0.011473543010108056 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441800,327.0334211992158,0.013022786212717019 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441809,287.2954592130771,0.06928616199280446 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441793,340.8019560720101,0.004887154894461343 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441801,336.9883784949239,0 +967514 MM WT,MoneyMaker,0.8,m_91,fruit,2441812,400.9703691430039,0.07549735647746214 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441800,752236.2584821897,0.014046311907004672 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441809,868868.9246864956,0.07664631377142772 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441793,845878.7692345033,0.06500017363248212 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441801,686436.3941985336,0.025707649751388395 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441812,704355.83,0.014515837441709145 +967514 MM WT,MoneyMaker,0.8,m_91,leaf,2441798,603057.7073194952,0.08194907878737734 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441800,123.7888242261714,0.23107648566078742 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441809,72.71180944577338,0 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441793,51.772876708039725,0.14750265548035846 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441801,72.12900380281056,0.0034950182217634573 +967514 MM WT,MoneyMaker,0.8,m_92,fruit,2441812,136.7378044457722,0.2742836500249157 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441800,119303.67910048724,0.2641780764702313 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441809,56884.2747954594,0.05748353449229704 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441793,64395.909756349014,0.0036174771345844903 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441801,65473.16782647015,0.00358759392412189 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441812,62624.79242304491,0.015729460869948753 +967514 MM WT,MoneyMaker,0.8,m_92,leaf,2441798,85615.32336018169,0.1200757410737987 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441800,36.84304245153104,0.7310673434326702 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441809,600.0136438182174,0.4807382960726554 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441793,198.34571836910257,0 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441801,286.183503430575,0.1592217660425428 +967514 MM WT,MoneyMaker,0.8,m_93,fruit,2441812,63.541575767780394,0.4943648492284527 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441800,11.796228382136912,0.5322112968127932 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441809,79.40639215936288,0.2959009952596179 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441793,39.92819726731425,0.002674766460942113 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441801,20.940957245084025,0.2829579388775698 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441812,80.98842970686289,0.30446850948793536 +967514 MM WT,MoneyMaker,0.8,m_93,leaf,2441798,40.421540670593856,0.002658393688747651 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441800,531.1044847663087,0 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441809,382.19570098135773,0.14289417100574253 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441793,266.39808812090536,0.29964886503964516 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441801,533.6868657912921,0.002106546090160144 +967514 MM WT,MoneyMaker,0.8,m_94,fruit,2441812,600.5924485474619,0.05339989865010031 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441800,3188.0396091487664,0.01623896314801687 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441809,3345.952324621706,0.03723500313778727 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441793,2954.0300990925543,0.016869829317407437 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441801,2567.2545588300836,0.07781581167951757 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441812,3661.1990564339167,0.07633859635054296 +967514 MM WT,MoneyMaker,0.8,m_94,leaf,2441798,2727.3414316107173,0.0515452354204875 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441800,118.44794620521512,0.15751377158691748 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441809,66.50298119885225,0.0931726488968736 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441793,82.4164233157379,0 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441801,47.93506764422437,0.23536041864204793 +967514 MM WT,MoneyMaker,0.8,m_97,fruit,2441812,127.9637803300966,0.19107329840059228 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441800,56.93592143463375,0.3221570100746163 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441809,242.2565828481609,0.3067322233702421 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441793,36.199995664146314,0.5188348450992899 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441801,279.8184102996236,0.3693329213390477 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441812,77.11637011007033,0.1903967846063217 +967514 MM WT,MoneyMaker,0.8,m_97,leaf,2441798,161.98020724668416,0.13191858667654222 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441800,1338.8432811389298,0.08207284545501237 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441809,1108.2988893252857,0 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441793,1103.374097480367,0.001934113651071545 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441801,821.2473171427192,0.13018293419613913 +967514 MM WT,MoneyMaker,0.8,m_98,fruit,2441812,8733.964853313593,0.8965545419179652 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441800,17469.918253603082,0.11707753020655964 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441809,20717.067905367203,0.04304011345833647 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441793,25033.701136058768,0.039156660102771745 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441801,15985.063256668524,0.15565404379789616 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441812,36203.75927181524,0.19938526548078794 +967514 MM WT,MoneyMaker,0.8,m_98,leaf,2441798,30852.39785436796,0.12992052011789568 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441800,22346.856321712687,0.24582570415231686 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441809,11680.488547793102,0.035929724624878645 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441793,9482.51760394838,0.12646707494276255 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441801,12687.928790975484,0 +967514 MM WT,MoneyMaker,0.8,m_99,fruit,2441812,26925.188267698897,0.3267680161068345 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441800,63321.19356417703,0.002373600770460449 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441809,79217.74611917746,0.09489978860838377 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441793,64015.24201951626,0.0023606985348409992 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441801,49565.134829199334,0.10874640130999413 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441812,99420.29203963872,0.19355234129990162 +967514 MM WT,MoneyMaker,0.8,m_99,leaf,2441798,58840.50622803312,0.034246292734446016 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441805,16.305115086667904,0.2550161648054474 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441810,34.99430670323506,0.07665736047566307 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441806,36.43280737549097,0.09415260428895089 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441799,20.37029628107225,0.15834268759113646 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441794,23.669471365698787,0.0931514748478599 +967514 MM WT,MoneyMaker,0.6,m_1,fruit,2441795,39.19470939514143,0.12588741542002801 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441805,2708.380439571611,0.21151009749641503 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441810,100.0195211242718,1.221114800192924 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441806,43.15937543138263,1.586124419797233 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441799,1742.4514640897569,0.01996111859990446 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441794,1585.9029620116405,0.0209229608345205 +967514 MM WT,MoneyMaker,0.6,m_1,leaf,2441795,6550.992580078869,0.5951075364479963 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441805,58.522196260657786,0.021413813046710528 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441810,54.69425432550556,0.0079650974579073 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441806,56.718984334209566,0.00782164213132619 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441799,47.46477662316811,0.0695353618552026 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441794,62.49685432472368,0.0499513551931936 +967514 MM WT,MoneyMaker,0.6,m_10,fruit,2441795,40.94196460140401,0.133738124749871 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441805,355.0988679517352,0.0021497865867918797 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441810,326.5855672023596,0.038502086321805074 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441806,358.6231094252622,0.0021391973958078125 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441799,361.70901241282434,0.005860255494797961 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441794,314.76484760521714,0.05451284923117328 +967514 MM WT,MoneyMaker,0.6,m_10,leaf,2441795,376.0410186965872,0.022736146149697767 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441805,91.60297135455517,0.1365191443567908 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441810,137.6695339755933,0.31344742540185466 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441806,188.35871581343153,0.4495953039734881 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441799,16.70881892674785,0.6024446642841228 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441794,42.18603016003803,0.20022175807796438 +967514 MM WT,MoneyMaker,0.6,m_100,fruit,2441795,24.383126601263193,0.4383010232907174 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441805,2187.332835771512,0.052755601849826306 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441810,2752.3659823415237,0.04703570718842798 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441806,2098.667340616943,0.07072687029196922 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441799,2945.3390346154947,0.0764648187534056 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441794,2159.636174308274,0.05828988101579302 +967514 MM WT,MoneyMaker,0.6,m_100,leaf,2441795,5010.123195585549,0.30717793062059107 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441805,35.582181605282116,0.028721481354811784 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441810,31.350310782051096,0.08371220282892033 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441806,42.04224365033718,0.04373183151437843 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441799,62.21566534479795,0.21394569663617502 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441794,32.94726934257638,0.062134627010658416 +967514 MM WT,MoneyMaker,0.6,m_101,fruit,2441795,40.44765356094609,0.02693927923020545 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441805,25.9776899945975,0.4451958077155955 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441810,90.63675989053124,0.09750803429916766 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441806,43.48542819010957,0.22145258672656776 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441799,54.182503186134376,0.12593727234629148 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441794,241.84077945279137,0.523733196355872 +967514 MM WT,MoneyMaker,0.6,m_101,leaf,2441795,196.170255601723,0.43283682040334215 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441805,100.039523312036,0.013039454514376159 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441810,85.39660653973459,0.055691545946626064 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441806,94.12154584856546,0.01344310773935442 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441799,109.34318194350094,0.051659548797482246 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441794,111.02999660782918,0.05830816740888278 +967514 MM WT,MoneyMaker,0.6,m_102,fruit,2441795,87.16976107521732,0.04676630351374578 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441805,586.0816772113378,0.03217681069360534 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441810,559.8154440620841,0.052090079338698914 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441806,632.2248455934733,7.366041807821411e-4 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441799,635.9751487375212,0.0033051907065151376 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441794,630.0820380191366,7.378556534862746e-4 +967514 MM WT,MoneyMaker,0.6,m_102,leaf,2441795,647.8094199840882,0.01131230406947914 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441805,10972.853543611369,0.3259594787554314 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441810,5312.297738616189,0.010922304079830969 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441806,3082.2925663823808,0.22548624499588277 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441799,5070.481616772234,0.009310891383274011 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441794,5290.242261383811,0.009115456687766699 +967514 MM WT,MoneyMaker,0.6,m_103,fruit,2441795,4133.104920449178,0.09808367373358218 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441805,802348.3788502318,0.009327264782529099 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441810,763613.6873053289,0.01216201042175058 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441806,794803.6543939728,0.005224140592106075 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441799,775796.7695327821,0.005287747836532297 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441794,467929.6737844976,0.22485512780188888 +967514 MM WT,MoneyMaker,0.6,m_103,leaf,2441795,987526.3828531714,0.0995129924336915 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441805,10757.053127351171,0.3259594787554305 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441810,5207.82208342448,0.010922304079830969 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441806,150.555792451451,1.5280363656619493 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441799,4970.761699870928,0.009310891383274011 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441794,5186.200365847112,0.009115456687766699 +967514 MM WT,MoneyMaker,0.6,m_104,fruit,2441795,4051.820160861797,0.09808367373358218 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441805,802348.3788502318,0.009327264782529099 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441810,763613.6873053289,0.01216201042175058 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441806,794803.6543939728,0.005224140592106075 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441799,775796.7695327821,0.005287747836532297 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441794,467929.6737844976,0.22485512780188888 +967514 MM WT,MoneyMaker,0.6,m_104,leaf,2441795,987526.3828531714,0.0995129924336915 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441805,54.45984597191173,0.035802275010103024 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441810,50.37231140355625,0.001917745835140261 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441806,49.92842678919421,0.0019262517393912049 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441799,42.60269904884373,0.070837019445114 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441794,48.65357793085071,0.013159350366583 +967514 MM WT,MoneyMaker,0.6,m_105,fruit,2441795,51.28984262927456,0.009757232852084519 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441805,75.52227249433626,0.09958989407809149 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441810,93.93274044745876,0.004847950776497356 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441806,200.07394278819305,0.32352558706088175 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441799,96.04159733830976,0.004794430862053112 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441794,71.41377031804707,0.12388298122557928 +967514 MM WT,MoneyMaker,0.6,m_105,leaf,2441795,142.99346318069547,0.177651240878558 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441805,181.83388883859044,0.059805611236135814 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441810,164.12523690017576,0.01530615021668602 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441806,152.75796042287183,0.01586536457260035 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441799,143.8820873197164,0.04186248617728339 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441794,140.2396678081045,0.052998341392308745 +967514 MM WT,MoneyMaker,0.6,m_106,fruit,2441795,200.1121500352781,0.10140424237014134 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441805,2762.2396695320554,0.059520639342026005 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441810,3023.154617133117,0.020321637944773485 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441806,3312.7990545339862,0.01941309616878506 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441799,3413.4424996284156,0.03241059406129576 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441794,2863.2329215825657,0.04392531843041203 +967514 MM WT,MoneyMaker,0.6,m_106,leaf,2441795,3477.3157920665176,0.0404621355029704 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441805,442.86141767141527,0.06198324807724198 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441810,419.4428020002054,0.038388148046009984 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441806,348.4747488337571,0.04211328414197846 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441799,276.99083327054274,0.1418192011143029 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441794,297.4342381950292,0.11089363839349264 +967514 MM WT,MoneyMaker,0.6,m_107,fruit,2441795,459.2316895617784,0.07774725129547777 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441805,8742.16868284418,0.10388000446242973 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441810,13466.840425119295,0.08376652745064739 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441806,8483.477781889047,0.11692525977539825 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441799,18888.034405345737,0.23068757861393685 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441794,7197.894073452557,0.1882937353977998 +967514 MM WT,MoneyMaker,0.6,m_107,leaf,2441795,17164.650178722335,0.18913577024298167 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441805,197.41458416927557,0.12539653623294456 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441810,109.68087017602308,0.12985180979696098 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441806,84.6546092458014,0.24233208774862858 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441799,124.2007980453342,0.0758583107731785 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441794,171.6090939127825,0.06455760110719044 +967514 MM WT,MoneyMaker,0.6,m_108,fruit,2441795,196.18351244682916,0.12267980866778094 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441805,532.3052694431265,0.15554722645353403 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441810,189.7885764739511,0.292343470600513 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441806,351.75488720403547,0.02437339880714484 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441799,351.7089720173826,0.024430091733059545 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441794,816.3605868435754,0.3412684902557439 +967514 MM WT,MoneyMaker,0.6,m_108,leaf,2441795,392.3660675303057,0.023077902876595946 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441805,65.11762869333806,0.12410069838424942 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441810,107.11546235811636,0.09205289134496697 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441806,83.117373270600865,0.018107465489504593 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441799,90.19488096041944,0.017382614319650047 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441794,99.46814423666518,0.05988474004731725 +967514 MM WT,MoneyMaker,0.6,m_109,fruit,2441795,47.63633465067956,0.259860937831498 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441805,899.3819343571662,0.0605048996724431 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441810,847.0938146511069,0.08651754883444562 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441806,1321.375754435894,0.10657727435853337 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441799,1036.5550321894598,0.0011433049216629243 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441794,1317.8475172686456,0.10541610329594953 +967514 MM WT,MoneyMaker,0.6,m_109,leaf,2441795,1031.1046294438866,0.0011463226830645823 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441805,889.4197159735006,0.09480810371539938 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441810,765.6133344887463,0.02971084021802639 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441806,664.3623221857061,0.03189365416754342 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441799,477.36323579123615,0.17544967991380833 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441794,512.1636831569325,0.1448898686286828 +967514 MM WT,MoneyMaker,0.6,m_11,fruit,2441795,1462.1027885494286,0.3106792567952188 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441805,2065.7510478656477,0.10540183515425738 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441810,2000.880477115234,0.0915450001943392 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441806,3.984728201281557,2.6092774431016514 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441799,5720.791419415796,0.5477799670643706 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441794,1240.3218513989762,0.11614175161280116 +967514 MM WT,MoneyMaker,0.6,m_11,leaf,2441795,5.633552638716408,2.458893789945738 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441805,306.91159310677386,0.03352969146280271 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441810,362.2135991975139,0.10548114966049837 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441806,237.0439731989167,0.07865468414062349 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441799,261.30458899625864,0.03633656525966389 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441794,170.76321840944422,0.22108927062926487 +967514 MM WT,MoneyMaker,0.6,m_110,fruit,2441795,341.486080004363,0.0798894031586328 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441805,4210.730907921645,0.013284707639741544 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441810,3957.0254841299993,0.013703933301053794 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441806,3702.790037203713,0.042543693991834886 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441799,4854.751664045947,0.07509423874145016 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441794,4942.183911586801,0.08284612207030939 +967514 MM WT,MoneyMaker,0.6,m_110,leaf,2441795,3687.803486146478,0.044305010001786105 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441805,106.55762784277393,0.03946550720879305 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441810,87.35766718546064,0.046818008539070366 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441806,88.04514863850491,0.04341360560565444 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441799,134.42625825530467,0.14036507366880402 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441794,86.43156179849886,0.05144667590553853 +967514 MM WT,MoneyMaker,0.6,m_111,fruit,2441795,227.95781221915513,0.36973544368662115 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441805,47715.31654019181,0.06174358664084778 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441810,35262.2445885517,0.06960426911851769 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441806,42018.89645488248,0.0065304197023223765 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441799,40764.68633077801,0.006630117674963465 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441794,69347.82239555728,0.2241186056459652 +967514 MM WT,MoneyMaker,0.6,m_111,leaf,2441795,27211.829817589303,0.18215647638677002 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441805,288.1830963930406,0.014882603677099038 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441810,316.01841189618494,0.02516127924734235 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441806,528.4011519552596,0.2484126487224385 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441799,235.21435364896908,0.10308728654978871 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441794,190.98166772000872,0.19355942558109485 +967514 MM WT,MoneyMaker,0.6,m_112,fruit,2441795,308.2765993981494,0.014389452617639797 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441805,282448.19842631405,0.10540003021147992 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441810,268341.63754437177,0.12765077346695808 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441806,437612.04814001534,0.0847504311128695 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441799,5250.216162894836,1.836161654550585 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441794,476585.42268940795,0.12180191527595419 +967514 MM WT,MoneyMaker,0.6,m_112,leaf,2441795,638873.9935659237,0.24907637062958177 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441805,164.38646428009153,0.06886577699864649 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441810,151.63301890423278,0.0337935040457813 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441806,128.92990128135153,0.036646627369307794 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441799,72.83313912633787,0.28467124894676954 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441794,93.74275481338852,0.17506256554343835 +967514 MM WT,MoneyMaker,0.6,m_12,fruit,2441795,254.88953308013055,0.25935172423078123 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441805,112.35099129705412,0.04780177925652618 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441810,88.93109490031938,0.05372149010162319 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441806,19.711887834425053,0.7080469101424374 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441799,322.586922606997,0.5058716281000821 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441794,44.45795408792581,0.35482565637895735 +967514 MM WT,MoneyMaker,0.6,m_12,leaf,2441795,203.59922860105848,0.30600099881873666 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441805,83.19274488913987,0.06216481804351481 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441810,70.27973968414395,0.011090491545896475 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441806,73.91540309949345,0.01081431393395138 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441799,51.050303037693936,0.1499223113182684 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441794,84.70689924222646,0.06999814861893605 +967514 MM WT,MoneyMaker,0.6,m_120,fruit,2441795,19.69608013674457,0.5635408331577916 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441805,350.9136945039746,0.38467601668481954 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441810,109.82239206657589,0.11983340137999976 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441806,118.8709997698477,0.08544838494896867 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441799,299.67113134249206,0.3161206071114582 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441794,170.56616543666092,0.07136858570212157 +967514 MM WT,MoneyMaker,0.6,m_120,leaf,2441795,101.22003634553116,0.1552578114067078 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441805,46.979085870291435,0.044918467335104406 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441810,70.7727656079177,0.22288007240030483 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441806,36.35651419835384,0.06640385746922983 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441799,180.82929058506713,0.6302826839248705 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441794,37.74679450956628,0.050106017720063845 +967514 MM WT,MoneyMaker,0.6,m_121,fruit,2441795,16.924483686573478,0.39847066600453274 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441805,201.9613032195095,0.04315263417364301 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441810,384.7332104257956,0.3230441462304885 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441806,163.75601457113112,0.04791827018565886 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441799,1108.2250775105929,0.7825124431011639 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441794,161.3516681814545,0.05434207043827932 +967514 MM WT,MoneyMaker,0.6,m_121,leaf,2441795,121.04623036785132,0.17916426112992623 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441805,240.0621334060983,0.005776170307491668 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441810,233.71869903243385,0.005854030804217647 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441806,288.9659641506682,0.0862992014032864 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441799,180.5430235271742,0.1179667797504278 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441794,179.4058412781371,0.12071091185975424 +967514 MM WT,MoneyMaker,0.6,m_122,fruit,2441795,312.3896461380483,0.12014914016017819 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441805,9234.784925253629,0.018711558594366462 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441810,9091.86996418024,0.02548512829796934 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441806,9524.1503839815,0.005312099740010012 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441799,10926.358375088,0.054337096965339615 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441794,9986.750437015333,0.015285853320218923 +967514 MM WT,MoneyMaker,0.6,m_122,leaf,2441795,9758.571595700509,0.005247908828881709 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441805,112.41214147990692,0.005044776342152613 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441810,140.08527173890474,0.1006240319372127 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441806,109.81568602652766,0.005104065983929651 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441799,229.57249677452907,0.3151514125597803 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441794,102.65444540612089,0.034390683923003706 +967514 MM WT,MoneyMaker,0.6,m_123,fruit,2441795,101.64183653438484,0.03869594139086985 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441805,258.9029127666071,0.033254185565818606 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441810,246.94712366133675,0.01272122115125729 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441806,232.68995213903355,0.013105120612550092 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441799,214.80696623856556,0.047834389367719776 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441794,418.9253988693541,0.24225394094308728 +967514 MM WT,MoneyMaker,0.6,m_123,leaf,2441795,194.7345911789508,0.09043964773462099 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441805,4684.927987237761,0.18858384937492323 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441810,3721.808044169967,0.08863489992504592 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441806,2347.638153021609,0.1114879113856535 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441799,2192.6215121055675,0.14115539957642476 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441794,1711.8143818991236,0.24866239948752078 +967514 MM WT,MoneyMaker,0.6,m_13,fruit,2441795,4799.140797592293,0.1990444211953557 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441805,81129.14219503629,0.14518556111526681 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441810,120322.52747385293,0.025984500877149763 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441806,106346.63547195944,0.02763869065962954 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441799,152631.56209678823,0.12928190382011184 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441794,85199.93776644331,0.12392316763957556 +967514 MM WT,MoneyMaker,0.6,m_13,leaf,2441795,153371.50770678435,0.13138224171462642 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441805,5.40500406010209,0.7334131887037194 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441810,62.66265004616789,0.33079954431944625 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441806,21.184753885748577,0.14018579028165856 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441799,8.59458826164997,0.5319841373176396 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441794,87.06480548767456,0.473633420871993 +967514 MM WT,MoneyMaker,0.6,m_14,fruit,2441795,37.32647356981897,0.10580774853413355 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441805,150.14968937720417,0.08196915757525458 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441810,195.2346733432033,0.1960016696236746 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441806,106.52738516788338,0.06709401359691824 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441799,8.841623375568574,1.1480232690823082 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441794,13.10371631897222,0.9771607979913057 +967514 MM WT,MoneyMaker,0.6,m_14,leaf,2441795,142.12078993640094,0.05810233220934746 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441805,64.90808920161132,0.0043852498051761835 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441810,56.80966899660408,0.062261815282023125 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441806,74.43425096948198,0.055088748293957934 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441799,20.982185090348658,0.49483336037981474 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441794,183.0712364417005,0.44593604058693215 +967514 MM WT,MoneyMaker,0.6,m_15,fruit,2441795,66.22553669805647,0.0043414124117326924 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441805,689.4112300148014,0.06882663309409809 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441810,537.55325066846,0.03923022793137765 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441806,511.02629974353704,0.0612084688970973 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441799,836.4389317400179,0.1527825183104694 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441794,510.7661323025992,0.061429627877861215 +967514 MM WT,MoneyMaker,0.6,m_15,leaf,2441795,639.19,0.035978251527298166 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441805,61.58608324857719,0.26074809338050753 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441810,549.0154277973523,1.21085005733376 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441806,31.15040139858171,0.03527084405627101 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441799,23.960454749815312,0.14923943498044556 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441794,36.421242861517705,0.03262027052158478 +967514 MM WT,MoneyMaker,0.6,m_16,fruit,2441795,3.877324865717096,0.9402023009808054 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441805,12.457788777816422,0.502587782636809 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441810,28.476441501175287,0.14354302810553432 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441806,46.96306213741477,0.07372766074962 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441799,57.17377516579608,0.1591681237232323 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441794,105.40734482165983,0.42484212796509735 +967514 MM WT,MoneyMaker,0.6,m_16,leaf,2441795,32.29779078115748,0.08885592882856685 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441805,15431.451734773576,0.42469857819866075 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441810,6983.5642047365445,0.08036892364087 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441806,4623.922697718996,0.09869764164838335 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441799,2600.453837831325,0.3486590578641615 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441794,3533.597677357125,0.21549110584193087 +967514 MM WT,MoneyMaker,0.6,m_17,fruit,2441795,13937.006367939994,0.3804612918451795 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441805,28827.29384479574,0.007214139061511915 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441810,33250.33323846872,0.06920626625640125 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441806,21831.467078161484,0.11350681460116174 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441799,29847.440260749707,0.022317355685030904 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441794,25961.99422555369,0.038251686964287934 +967514 MM WT,MoneyMaker,0.6,m_17,leaf,2441795,27877.49422237028,0.007336001471623277 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441805,73.74177644776904,0.016100528032007455 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441810,85.49932920673609,0.04814858381062548 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441806,32.18388093948574,0.37617571068712596 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441799,79.312024475893793,0.015524911953971099 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441794,14.516623278601523,0.7219485170482822 +967514 MM WT,MoneyMaker,0.6,m_18,fruit,2441795,122.60917996391775,0.20470886415626688 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441805,859.0078622015089,0.025402397536950172 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441810,550.0121046372637,0.21902728880401767 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441806,925.7122872051712,0.007076491930828599 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441799,2339.639218732923,0.40974935637864096 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441794,1376.3331075016083,0.17932402056167351 +967514 MM WT,MoneyMaker,0.6,m_18,leaf,2441795,895.7892076751405,0.007193710503542228 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441805,3.5015154409405316,0.007152360329109708 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441810,3.1549733418118273,0.03810799151442035 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441806,2.5961650349948475,0.12277138893766926 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441799,4.3630008032049865,0.10268160743241816 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441794,3.3871276050346135,0.007272127149075547 +967514 MM WT,MoneyMaker,0.6,m_19,fruit,2441795,5.007718045463307,0.16253618287028393 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441805,1725.0645008101735,0.0026451179063768926 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441810,1219.804737238023,0.1531601404006424 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441806,1746.142010044747,0.0026291050064028987 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441799,2144.9462025892153,0.09196594806118874 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441794,2003.785963462517,0.062400873990556605 +967514 MM WT,MoneyMaker,0.6,m_19,leaf,2441795,1568.5940087567196,0.04393990416330551 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441805,3.3222043848502856,0.4702537835770918 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441810,7.4429505940274705,0.11993499450756573 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441806,43.413075536973864,0.6459404232155871 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441799,211.34534760824636,1.3333125613683436 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441794,12.177551926691049,0.09387985945513722 +967514 MM WT,MoneyMaker,0.6,m_2,fruit,2441795,3.451926134868037,0.453618636675149 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441805,427.13275034893377,0.4009738348539078 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441810,1780.0595236924144,0.21889781796249386 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441806,94.53405763153016,1.0559484077626964 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441799,1723.502216708073,0.2048751392874517 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441794,5431.838098449186,0.7034101098380825 +967514 MM WT,MoneyMaker,0.6,m_2,leaf,2441795,121.40236755182102,0.9473095507312874 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441805,167.19333704235711,0.7407721658288464 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441810,64.4617024778105,0.32685497114673745 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441806,18.3044384997831,0.21989038903219127 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441799,12.003926045723354,0.4031234890545048 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441794,42.435842376678536,0.14528602740525698 +967514 MM WT,MoneyMaker,0.6,m_20,fruit,2441795,9.12829011923998,0.5220573656330285 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441805,43.73283670347153,0.01397993461918512 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441810,21.84545085232809,0.31542657089617476 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441806,38.88880801245523,0.0649629514047485 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441799,49.80258517560167,0.04246430378213062 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441794,46.594161713471586,0.013543919524273695 +967514 MM WT,MoneyMaker,0.6,m_20,leaf,2441795,50.69296143298772,0.05016007989999838 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441805,7809.37807342506,0.059810476139472435 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441810,7574.17390989136,0.046529300107683635 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441806,3145.3185140933965,0.33514134127580686 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441799,4731.316258336254,0.1578239937492385 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441794,7216.1151168180595,0.025497480190527 +967514 MM WT,MoneyMaker,0.6,m_21,fruit,2441795,6393.190542237761,0.027088324274735953 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441805,351868.8372140934,0.08525624174881141 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441810,359944.8176200595,0.09511136101222473 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441806,255302.0808398116,0.05407020955204889 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441799,275890.68968214846,0.020387519237518248 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441794,148313.69012651243,0.28994332356565966 +967514 MM WT,MoneyMaker,0.6,m_21,leaf,2441795,302411.1311947453,0.019473208612237336 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441805,26.323097920624857,0.0372217786001976 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441810,31.703641523962073,0.11799392801709274 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441806,95.50426894946052,0.5969075638370016 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441799,21.99893717102261,0.040713521356753324 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441794,16.419314404273255,0.16776020172444905 +967514 MM WT,MoneyMaker,0.6,m_22,fruit,2441795,9.752443278926044,0.39400178763250504 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441805,22.016581174994556,0.0012176522383040567 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441810,22.140212295385624,0.0012142477913941185 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441806,19.67730911730809,0.050001824931731775 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441799,111.93270099806544,0.7049894505717098 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441794,14.959832953809151,0.1690407889945913 +967514 MM WT,MoneyMaker,0.6,m_22,leaf,2441795,38.41420397776422,0.2405243050504482 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441805,1829.7137981780036,0.030711688460653086 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441810,1579.870798483306,0.033049902825360356 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441806,2025.647617645269,0.07489242286130127 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441799,2002.5410404513525,0.06990995064354033 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441794,1207.5499081668645,0.14976638548456256 +967514 MM WT,MoneyMaker,0.6,m_23,fruit,2441795,1184.4885565839584,0.1581406053828105 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441805,171719.2049044405,0.0072007457313478795 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441810,166071.82985603728,0.007322152258640635 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441806,157633.4540955169,0.02996973120044455 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441799,125892.64262235384,0.12761777325715595 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441794,268695.22015477356,0.2016418175882757 +967514 MM WT,MoneyMaker,0.6,m_23,leaf,2441795,174264.82472879798,0.013591610616308536 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441805,43.49709226809168,0.06617483447142658 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441810,49.644920257916105,0.008760242849287891 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441806,57.76816224385905,0.05705349142262439 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441799,74.50665877146116,0.16756002773317835 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441794,48.85885708384749,0.015691756643732235 +967514 MM WT,MoneyMaker,0.6,m_24,fruit,2441795,51.6680518491072,0.008587026425479483 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441805,109.08548841200616,0.02585267977536443 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441810,122.46710840904537,0.02439980353727167 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441806,101.54055856717392,0.05698011213106868 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441799,158.56166904154898,0.13657854837929229 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441794,86.90325899884431,0.12458359679838615 +967514 MM WT,MoneyMaker,0.6,m_24,leaf,2441795,168.36230669730196,0.16262520706767614 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441805,72.49258591744882,0.02900264237852057 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441810,68.72014971986167,0.005793147442319846 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441806,66.89897753160453,0.005871469411871333 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441799,72.08385979799903,0.02654708372501946 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441794,53.55353628919603,0.10250279578538923 +967514 MM WT,MoneyMaker,0.6,m_25,fruit,2441795,59.88578631641064,0.05396719324302368 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441805,3306.74944187056,0.014889269789027715 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441810,4500.021534635448,0.11892403337086144 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441806,3537.4168716148088,0.014395684139120846 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441799,3286.798696931888,0.017517452581339743 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441794,2568.1670754644074,0.1246672847938779 +967514 MM WT,MoneyMaker,0.6,m_25,leaf,2441795,4243.517207145935,0.09343540884329427 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441805,178.33687808848995,0.03063078523287066 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441810,194.2754928475902,0.06780764486160562 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441806,120.45239787163295,0.139794924498017 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441799,129.2407996537039,0.10921073804028492 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441794,154.04732108028492,0.032956224277687074 +967514 MM WT,MoneyMaker,0.6,m_26,fruit,2441795,240.89296559284685,0.1612137436735579 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441805,3708.974659929193,0.017359316658893675 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441810,3979.499795240337,0.013215303835925951 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441806,3632.739729735972,0.026378899220866003 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441799,3793.672047183498,0.007553398278806078 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441794,3926.787976011366,0.007424269640694092 +967514 MM WT,MoneyMaker,0.6,m_26,leaf,2441795,4990.875022672655,0.11156351190623237 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441805,67.25817786686461,0.008051857521437666 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441810,59.20400391489841,0.06344587624613429 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441806,96.421885489194,0.14837866475749273 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441799,121.81966817403335,0.24992045726992096 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441794,41.21739731177672,0.22071639029863288 +967514 MM WT,MoneyMaker,0.6,m_27,fruit,2441795,69.77538533747853,0.007905288659238341 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441805,505.1274290793284,0.16815256020432745 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441810,598.3117443475337,0.09462598435999814 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441806,795.642894598926,0.02916467659789701 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441799,735.54180495546575,0.004946150964829865 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441794,1194.1744971871865,0.2055142800290044 +967514 MM WT,MoneyMaker,0.6,m_27,leaf,2441795,752.3916470674499,0.004890453322009769 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441805,54.39425858733879,0.059888663206551396 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441810,70.47965429911758,0.052622040452514174 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441806,210.5582001769147,0.5279304349055993 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441799,134.6071295739149,0.3336263384970801 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441794,27.143256525704597,0.36177977360736846 +967514 MM WT,MoneyMaker,0.6,m_28,fruit,2441795,23.934702772739634,0.41641368608198825 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441805,228.0454089452201,0.09770823142250462 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441810,466.2991934411592,0.21293509946891653 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441806,236.8384836210836,0.08127729297520458 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441799,334.3238514564756,0.06843779651018256 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441794,655.162159339741,0.3606192408397826 +967514 MM WT,MoneyMaker,0.6,m_28,leaf,2441795,233.3240868858583,0.0877699898943467 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441805,409594.2546188641,0.14261906621012166 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441810,372260.10667570255,0.10111170751323595 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441806,127273.75969496928,0.36499591649462726 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441799,217621.4064643266,0.13203317717616425 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441794,379034.14784774225,0.10894354812931617 +967514 MM WT,MoneyMaker,0.6,m_29,fruit,2441795,198584.86181664895,0.17178865092596496 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441805,1402335.6098929537,0.07580842423527745 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441810,1219103.5632894528,0.014997062560370367 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441806,942960.4167027704,0.09655007565663531 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441799,1136344.506002633,0.015533521535469497 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441794,1047722.8053316608,0.050797140983885214 +967514 MM WT,MoneyMaker,0.6,m_29,leaf,2441795,1497561.2627681857,0.10434105959894868 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441805,40.74592388131196,0.005245190821889345 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441810,77.58954351637226,0.27447383643047774 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441806,30.454846315390515,0.1316729480962462 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441799,50.01488682995234,0.0837699300979664 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441794,21.03034052279638,0.29248305552478326 +967514 MM WT,MoneyMaker,0.6,m_3,fruit,2441795,41.73610896882743,0.0051825972610455295 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441805,7.3442645992862845,0.9013959030111675 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441810,83.8031024711511,0.15591587867075507 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441806,60.37,0.013476957598484551 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441799,63.51842499478039,0.03555550251549633 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441794,56.68075354295659,0.013908602907996448 +967514 MM WT,MoneyMaker,0.6,m_3,leaf,2441795,8.020102201239995,0.8631643156626244 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441805,133.85797990077228,0.002008780283860645 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441810,132.622549212368,0.0020181148639193403 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441806,134.510200063262,0.004119732299658008 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441799,186.02391436962324,0.14493329234865548 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441794,100.6146450498236,0.12197428691598633 +967514 MM WT,MoneyMaker,0.6,m_30,fruit,2441795,114.93945485227944,0.06416635335579546 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441805,9307.260722012825,0.10869703937496222 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441810,7488.024959215876,0.014242442837284042 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441806,6513.498899161333,0.046310496411689606 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441799,7004.859708165984,0.014725398741373574 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441794,10458.736888379764,0.1593543970466582 +967514 MM WT,MoneyMaker,0.6,m_30,leaf,2441795,6672.035421420376,0.03586649721499713 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441805,89.36873655853101,0.005372136248901871 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441810,76.23376850102515,0.06366609294348646 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441806,70.80077083582887,0.09577549588463175 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441799,101.49115465399392,0.06061471152262787 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441794,118.7401495182504,0.12878410952147124 +967514 MM WT,MoneyMaker,0.6,m_31,fruit,2441795,87.17140788974028,0.005439421680493162 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441805,543.0869475593206,0.044545691588399716 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441810,633.6335891425698,0.02242313453540179 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441806,550.6390229729814,0.03854807080623557 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441799,715.3401233561949,0.07509752850015072 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441794,569.8635227971597,0.023644198269873407 +967514 MM WT,MoneyMaker,0.6,m_31,leaf,2441795,678.4733349308633,0.052117727113321966 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441805,48.27078276182397,0.15178209265421616 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441810,46.18921669865746,0.17092583676280082 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441806,98.01695030452866,0.1558347516910663 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441799,127.14948999460717,0.2688481884554199 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441794,71.96939019446523,0.021681388797665013 +967514 MM WT,MoneyMaker,0.6,m_32,fruit,2441795,64.95992296732946,0.022820932848941933 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441805,2388.554902410637,0.05641653735781338 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441810,3302.352866879327,0.08427171153029311 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441806,2319.1946388666947,0.06921456720155161 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441799,3051.230424958153,0.049923240617012254 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441794,1683.1039211568689,0.2084408338430288 +967514 MM WT,MoneyMaker,0.6,m_32,leaf,2441795,3767.954161614226,0.1415538452006051 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441805,45.259337136129126,0.1361780832651085 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441810,33.83942085532377,0.009892815933624677 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441806,53.65878962169258,0.21011076632490622 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441799,32.315187306878414,0.010123428220206288 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441794,24.374803107937264,0.13258898947596176 +967514 MM WT,MoneyMaker,0.6,m_33,fruit,2441795,15.412114148682273,0.33166788884243603 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441805,4335.002182054602,0.20963823893395528 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441810,2109.0097826525025,0.10327248726228655 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441806,2106.774577738098,0.10373301235950505 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441799,2575.022867807286,0.0165699912836903 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441794,4773.3629582518115,0.25147337713842566 +967514 MM WT,MoneyMaker,0.6,m_33,leaf,2441795,2775.3133867872593,0.015960949026578408 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441805,523.5439861291931,0.04578617370652083 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441810,460.78270926199536,0.009670827628236456 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441806,437.4490425671307,0.03223953123491752 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441799,481.53422803130206,0.00946016115693471 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441794,432.08497580027705,0.037597836027800646 +967514 MM WT,MoneyMaker,0.6,m_34,fruit,2441795,493.29038543105656,0.019935649272208256 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441805,41877.24004231618,0.03419932231572265 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441810,32386.99354119714,0.07740809438988183 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441806,39646.47841653415,0.010425888263035255 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441799,37765.5994390378,0.010682346580964008 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441794,73515.68447466595,0.27860127606611584 +967514 MM WT,MoneyMaker,0.6,m_34,leaf,2441795,37414.30724333723,0.014741020746405376 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441805,476.80108428189527,0.30960466758083793 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441810,310.9894204493803,0.12401304824090786 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441806,156.49007047998904,0.17424578062384288 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441799,94.89937929517885,0.39146919490821075 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441794,806.1774483422399,0.5376980784506427 +967514 MM WT,MoneyMaker,0.6,m_35,fruit,2441795,134.08936868973723,0.24133822070484534 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441805,11151.22889487467,0.15071294113055167 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441810,6749.9415214842675,0.06730977897835944 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441806,9013.09148575105,0.058263990026379275 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441799,6264.638142444359,0.09971379892032362 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441794,34425.61919505008,0.6402719711300131 +967514 MM WT,MoneyMaker,0.6,m_35,leaf,2441795,5924.757059710493,0.12393924216726937 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441805,2712.610607197717,0.008550985900124708 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441810,2986.6458259792944,0.050347254709550704 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441806,2040.449221541476,0.11511067832956945 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441799,4550.797760356294,0.23325106592425815 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441794,2333.482264665795,0.05683196532116375 +967514 MM WT,MoneyMaker,0.6,m_36,fruit,2441795,2606.836138511421,0.008722736775047757 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441805,9406.95,0.11448290329244815 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441810,6583.841981590353,0.04048653351569076 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441806,7870.420201317652,0.037031987569135616 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441799,2633.4324694532243,0.438443746382561 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441794,25259.392556574163,0.543456969967393 +967514 MM WT,MoneyMaker,0.6,m_36,leaf,2441795,6276.488661865373,0.06124918373607269 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441805,676.5827524733746,0.0381121581022934 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441810,703.84410201167,0.05526771130841768 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441806,485.7035398343694,0.10583749575820178 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441799,1061.6063913031116,0.2337547600889458 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441794,537.8535168403818,0.061544751731388736 +967514 MM WT,MoneyMaker,0.6,m_37,fruit,2441795,562.8950687704055,0.04178132035524973 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441805,250.02989351066967,0.08019040196358018 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441810,168.4354383916865,0.09136806270907227 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441806,170.21284548084878,0.08680920199230346 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441799,245.5364573406146,0.07231445149523452 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441794,634.4848989894163,0.4846197562093968 +967514 MM WT,MoneyMaker,0.6,m_37,leaf,2441795,136.77025393021276,0.18180988070922321 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441805,82.81014568730579,0.3210201595422104 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441810,106.46074113668872,0.4301260960781952 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441806,19.254853328249155,0.3125231743714978 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441799,48.81440065004097,0.09148457220020512 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441794,2.368792919664622,1.2225362928773402 +967514 MM WT,MoneyMaker,0.6,m_38,fruit,2441795,30.270465662584645,0.11604428721956572 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441805,20.12013502592128,0.5099679708948115 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441810,68.28535845365967,0.020728731681795898 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441806,97.65273661892596,0.17608555662473324 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441799,61.92,0.021767914157332147 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441794,100.94852828081002,0.1905011299548478 +967514 MM WT,MoneyMaker,0.6,m_38,leaf,2441795,1.846290437140097,1.547298841563894 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441805,121.93941931274748,0.007452494058634684 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441810,114.50706934811537,0.034764316959826846 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441806,126.16049384779664,0.007326763746922538 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441799,536.9305583993629,0.6363215051281608 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441794,1901.3616411280889,1.185468111424889 +967514 MM WT,MoneyMaker,0.6,m_39,fruit,2441795,114.42182992940302,0.03508772751231737 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441805,2037.4934951270077,0.017392629935321757 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441810,1632.2739379306372,0.07891055453617701 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441806,1877.523003705225,0.018118334203809816 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441799,1533.2562811790003,0.10608884845081556 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441794,2063.966830304438,0.022999112574527913 +967514 MM WT,MoneyMaker,0.6,m_39,leaf,2441795,2556.4803692607675,0.11593886125200648 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441805,38.77718537992022,0.12719929118625384 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441810,27.57986107733684,0.020784917422634885 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441806,30.28394376519659,0.01983543938271337 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441799,89.28000463116078,0.489377212440407 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441794,18.571050396101707,0.19254052314152692 +967514 MM WT,MoneyMaker,0.6,m_4,fruit,2441795,11.994064682546012,0.3824106050750573 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441805,214.8864024632073,0.13687136929928645 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441810,140.40430232687103,0.047957150036939566 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441806,136.254741197621,0.060985942696392126 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441799,231.40547892181493,0.1690360715383088 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441794,173.1895653908398,0.04318415651659002 +967514 MM WT,MoneyMaker,0.6,m_4,leaf,2441795,45.852308942415895,0.5339763559430697 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441805,254.8533212831864,0.07220248746207192 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441810,227.8880092818544,0.023633664348743366 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441806,201.07114476772233,0.030738059763719683 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441799,203.7481365200538,0.02499416491042572 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441794,171.53248159701678,0.09974143959277759 +967514 MM WT,MoneyMaker,0.6,m_40,fruit,2441795,240.44031870086403,0.04691948466491702 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441805,7571.931375969845,4.474724301992694e-4 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441810,6957.752179423398,0.037185185724755154 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441806,7065.847806615062,0.030489862948600788 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441799,7785.716003676229,0.011644416340987895 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441794,7587.542795388736,4.47011854467938e-4 +967514 MM WT,MoneyMaker,0.6,m_40,leaf,2441795,8089.303850138744,0.028257006925366923 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441805,146.09982095781018,0.055083664984282965 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441810,125.1585152927657,0.012105616095149596 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441806,116.11795437270244,0.04466664238573115 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441799,298.18139234601875,0.3649145196018577 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441794,102.28385933007912,0.09975891245789592 +967514 MM WT,MoneyMaker,0.6,m_41,fruit,2441795,132.23405954930777,0.011777312130269113 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441805,1170.9946692741098,0.12483025358877464 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441810,1123.0437027927449,0.14298851463941986 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441806,2112.3766060492662,0.13138617753488369 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441799,1756.4908527590255,0.05126072084324518 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441794,2928.021581782548,0.27318910185988754 +967514 MM WT,MoneyMaker,0.6,m_41,leaf,2441795,1365.3816843742457,0.05813109882167966 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441805,50.45903801035416,0.03677922368673281 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441810,45.08967774457494,0.012082611432157497 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441806,44.45347024228166,0.018254073198257448 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441799,41.773887079676655,0.045254854402505984 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441794,53.81945652380048,0.06477956503308024 +967514 MM WT,MoneyMaker,0.6,m_42,fruit,2441795,47.633805622685486,0.011755537271996852 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441805,164.2549803150713,0.006298378645882341 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441810,141.62564907379877,0.07067501190298531 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441806,169.05392774117524,0.006208340307371607 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441799,190.0172802403675,0.056976172485255105 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441794,162.29868953874626,0.011501911979372448 +967514 MM WT,MoneyMaker,0.6,m_42,leaf,2441795,196.16276646523175,0.07079965253496656 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441805,891.365876299991,0.5804146249896718 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441810,255.0895048432223,0.03705121157657931 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441806,98.5812447803996,0.37584708153928936 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441799,314.0259985117287,0.12732422600869198 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441794,0.2381553612212898,2.9927810166531588 +967514 MM WT,MoneyMaker,0.6,m_43,fruit,2441795,213.3692663406447,0.04050951528971147 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441805,227.89296048359515,0.09443055267151301 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441810,219.67003334452193,0.11039064693557199 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441806,279.8722766869549,0.005201582207075894 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441799,467.4789322647589,0.21760058054049214 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441794,325.03407457073035,0.05976742923683798 +967514 MM WT,MoneyMaker,0.6,m_43,leaf,2441795,286.6166937512328,0.005140019031667276 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441805,115013.34082324736,0.21580847879745058 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441810,81736.31014323236,0.06747528837591865 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441806,34625.690672986595,0.30554129494308846 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441799,58212.66922912165,0.07992222642978586 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441794,84794.03012375973,0.08342553717008183 +967514 MM WT,MoneyMaker,0.6,m_44,fruit,2441795,44711.30384216751,0.19452240523506337 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441805,523209.2678104092,0.10829159520271592 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441810,451443.28050564195,0.044219360154156284 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441806,303831.55576587527,0.12775095557210392 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441799,342282.50684953696,0.07599912894291627 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441794,627411.4186707148,0.18716858543328563 +967514 MM WT,MoneyMaker,0.6,m_44,leaf,2441795,364037.68544053327,0.049237488559221276 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441805,130135.21229564887,0.21174383767423155 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441810,99671.2399277982,0.09591887377070574 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441806,36815.075399903006,0.33662529294403054 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441799,60167.108296023864,0.12329184794847503 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441794,101677.64269080586,0.10457448169273142 +967514 MM WT,MoneyMaker,0.6,m_45,fruit,2441795,51844.095005930416,0.1879516894183233 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441805,140627.5414703269,0.1762602592344722 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441810,119295.1720047218,0.10481274267834895 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441806,53751.810772838246,0.24141702581448232 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441799,66776.1293733632,0.14718888310979672 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441794,201577.72634575595,0.3326324173447599 +967514 MM WT,MoneyMaker,0.6,m_45,leaf,2441795,68135.26625618938,0.1384381676378954 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441805,7448.481258677789,0.09351703210629081 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441810,6844.890676699866,0.0568158189255068 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441806,2358.511175226397,0.40591275887299316 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441799,2749.769976315911,0.33925433149802897 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441794,7395.473599002919,0.09041529376618929 +967514 MM WT,MoneyMaker,0.6,m_46,fruit,2441795,5166.151525615741,0.0653835571751058 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441805,44158.33,0.011888905855074405 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441810,46609.41417932198,0.011572097902480927 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441806,22227.62546393796,0.3100084762368711 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441799,76594.95038690118,0.22729859265803132 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441794,25364.921552050462,0.2526680230574838 +967514 MM WT,MoneyMaker,0.6,m_46,leaf,2441795,58288.14330778033,0.10867867512102336 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441805,218.7023346820251,0.06561351330595677 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441810,193.61313360967824,0.012694908111223313 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441806,182.45791545614787,0.013077197087020931 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441799,106.84312563206356,0.2454933213569137 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441794,131.43932238581374,0.15551459442097748 +967514 MM WT,MoneyMaker,0.6,m_47,fruit,2441795,269.2157599710133,0.15586057410610143 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441805,452.87107848734706,0.018241283374777595 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441810,491.7244066200592,0.017505895145073946 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441806,309.1315578888079,0.18407252722913903 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441799,912.1593981092592,0.2858548673098795 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441794,253.29308241772117,0.270592540663825 +967514 MM WT,MoneyMaker,0.6,m_47,leaf,2441795,845.3682474043309,0.25283006162877264 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441805,117.07607330504312,0.2037559696241451 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441810,59.788447187279075,0.08809490411697629 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441806,86.96481108024533,0.07463137956642907 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441799,2.8283441445178887,1.4131799262773541 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441794,19.829941369233556,0.5673907481425731 +967514 MM WT,MoneyMaker,0.6,m_48,fruit,2441795,86.6793580733054,0.07320350809762277 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441805,2332.4879350054284,0.016711958932547955 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441810,2085.7641976369,0.031842238591071936 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441806,2162.7921166570763,0.016092669156236195 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441799,2326.0821680278304,0.015517604895767256 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441794,3461.643189961379,0.18817485372997522 +967514 MM WT,MoneyMaker,0.6,m_48,leaf,2441795,2115.9979443630273,0.025592205608659047 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441805,33.56111000021287,0.00795453663982415 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441810,30.788763099826618,0.02948953759658801 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441806,31.07738428487145,0.025437321555731973 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441799,35.96019695433488,0.03794028209178335 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441794,32.89649139641634,7.32199242405418e-4 +967514 MM WT,MoneyMaker,0.6,m_49,fruit,2441795,33.00750870411744,7.309668677482062e-4 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441805,32.18223372928155,0.0032503004809283365 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441810,31.446765904375205,0.013290497425069159 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441806,32.65307870061388,0.0030576499282697345 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441799,34.99945890981398,0.03319484509123982 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441794,32.19490553178928,0.003079330038963546 +967514 MM WT,MoneyMaker,0.6,m_49,leaf,2441795,34.335145211633495,0.02487240333428975 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441805,152.41678903113717,0.2693234803838913 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441810,314.71318359278354,0.045558647768903615 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441806,324.07154107793224,0.05828460588331952 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441799,355.03589995729055,0.09791598109979605 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441794,252.0299722218102,0.050904096915246555 +967514 MM WT,MoneyMaker,0.6,m_5,fruit,2441795,218.06900544132927,0.11376234560472165 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441805,18125.301711588323,0.012586173474595341 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441810,19314.050809968812,0.015001951588979878 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441806,16530.464575271875,0.05258635875500417 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441799,23912.937594006955,0.10776151247409871 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441794,18231.85269440437,0.010040614719145857 +967514 MM WT,MoneyMaker,0.6,m_5,leaf,2441795,19084.69113952587,0.009813717869026739 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441805,79.04369640607588,0.0020889309245732957 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441810,66.37344621065404,0.07796180490280347 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441806,92.99057120055602,0.0684827430388828 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441799,79.80591912480114,0.0020789313677338495 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441794,47.828707186245026,0.2202675303464967 +967514 MM WT,MoneyMaker,0.6,m_50,fruit,2441795,129.16871525315497,0.21120116762637364 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441805,4148.561233474663,0.12292308974514743 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441810,5922.847539681001,0.03170995910775165 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441806,3572.363879183047,0.18786490499424335 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441799,5448.273146179954,0.004561721915067984 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441794,5563.330987398387,0.004514304346362685 +967514 MM WT,MoneyMaker,0.6,m_50,leaf,2441795,9038.579637260487,0.21527959438338184 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441805,40.922464253305506,0.020551302639135738 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441810,37.7681508759346,0.01428475302438259 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441806,35.38739550541614,0.04256187541009959 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441799,57.63365443639441,0.16926568284378507 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441794,40.29399238627256,0.013829824669880031 +967514 MM WT,MoneyMaker,0.6,m_51,fruit,2441795,34.65120220504233,0.051692168542064154 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441805,249.8260752105776,0.03349880920282322 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441810,245.54521131530157,0.04100510559257087 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441806,273.5122716574102,0.005840242146872843 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441799,288.705130884766,0.02931792783452325 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441794,293.6467139142901,0.03668857076404963 +967514 MM WT,MoneyMaker,0.6,m_51,leaf,2441795,266.2053154187741,0.005919851480364002 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441805,157.00515942572846,6.098986756266633e-4 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441810,182.3702295999453,0.06443012198189946 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441806,157.44644759452663,6.090433693293207e-4 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441799,212.84273980526,0.1315350178286847 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441794,146.94345390149584,0.029373579182203624 +967514 MM WT,MoneyMaker,0.6,m_52,fruit,2441795,149.6073345494591,0.021570937407212387 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441805,1518.7963326906677,0.0037564810365164902 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441810,1357.8052495185436,0.044905575376322115 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441806,1482.943554952672,0.006618437917869979 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441799,1492.6356219837871,0.0037892568641311186 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441794,1601.2515376267204,0.02671650101270684 +967514 MM WT,MoneyMaker,0.6,m_52,leaf,2441795,2233.0709131640497,0.17115945592184234 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441805,63.17747468461756,0.04331906830677279 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441810,53.09234235824259,0.11884944448891921 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441806,52.35750837203107,0.12490235986208797 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441799,76.4308534802022,0.039387378542635965 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441794,89.32512222264485,0.1070922884111345 +967514 MM WT,MoneyMaker,0.6,m_53,fruit,2441795,134.902655348537,0.2861391674616871 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441805,316.69323527040837,0.0706303211067767 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441810,441.0357336677798,0.07320467054504265 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441806,337.5128662414694,0.042978774714113044 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441799,787.5799259278972,0.3250255303544791 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441794,407.73218960498417,0.03910589162279754 +967514 MM WT,MoneyMaker,0.6,m_53,leaf,2441795,196.82400117555196,0.27719105162364155 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441805,358.3769263007732,0.02920547565144682 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441810,381.71588493145225,0.0566056686185501 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441806,311.76155998702785,0.03131199876706958 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441799,293.2705505361033,0.05786611022153565 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441794,296.0043005851903,0.05383654379287961 +967514 MM WT,MoneyMaker,0.6,m_54,fruit,2441795,415.3680166124732,0.0932984880865857 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441805,8788.95965742532,0.07972471679786164 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441810,8333.603634341122,0.10282934724896631 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441806,6419.728012118192,0.21614555931779877 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441799,15767.2398347067,0.17409348590355656 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441794,14045.297608563184,0.12386875818474863 +967514 MM WT,MoneyMaker,0.6,m_54,leaf,2441795,12330.95619252369,0.06733456706177954 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441805,61.79535566779268,0.062392097418522585 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441810,95.87929577497052,0.2531610967420177 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441806,4.340165705447098,1.0910574277921017 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441799,60.052819365958754,0.04996966274331527 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441794,46.99892157245976,0.05647584595775501 +967514 MM WT,MoneyMaker,0.6,m_55,fruit,2441795,15.75539923469796,0.5311343263009862 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441805,61.66647823861971,0.34732310674542477 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441810,262.71627479844244,0.28211472397682646 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441806,87.27278485555523,0.19649341897074035 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441799,133.5686860237129,0.011667599760783798 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441794,140.8427768828243,0.011362325713800914 +967514 MM WT,MoneyMaker,0.6,m_55,leaf,2441795,205.43581237064876,0.17530390036493237 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441805,101.2034487570311,0.0918963936313637 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441810,79.43698088809282,0.19706897620170527 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441806,71.53010172095348,0.2426028633996471 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441799,148.901164042711,0.07580638684295637 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441794,189.0140430160281,0.17940236573815138 +967514 MM WT,MoneyMaker,0.6,m_56,fruit,2441795,195.3567566150383,0.1937367303008828 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441805,4296.121473338203,0.11830256425891106 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441810,704.8632161151512,0.666669141200289 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441806,3566.7671701866775,0.037500772251371384 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441799,1470.2663441041054,0.3473779724310555 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441794,2976.6405791832835,0.04104759033481287 +967514 MM WT,MoneyMaker,0.6,m_56,leaf,2441795,7240.4517091052785,0.34499167298129985 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441805,129.8003458397481,0.012284458089235617 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441810,134.04013045364104,0.001674534149212814 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441806,133.00846820976187,0.001681015746125336 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441799,198.60517721991545,0.17243025776372045 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441794,109.1460234754178,0.0875523900357158 +967514 MM WT,MoneyMaker,0.6,m_57,fruit,2441795,169.4436011274732,0.10346486508667896 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441805,87118.79110756244,0.11602304754417503 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441810,72121.82,0.19806821025823318 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441806,117881.2925945618,0.015310001435980602 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441799,182319.14901399988,0.20469739717697344 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441794,180224.42666182568,0.19967876469687074 +967514 MM WT,MoneyMaker,0.6,m_57,leaf,2441795,109714.8428765844,0.015869502413214498 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441805,278857.85429478297,0.40251348631504946 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441810,202187.68806249043,0.2628853113038918 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441806,123475.97614928574,0.04871307319822815 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441799,97273.35209497868,0.05487551283102832 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441794,87431.37657782233,0.10120207873518794 +967514 MM WT,MoneyMaker,0.6,m_58,fruit,2441795,62534.10330706525,0.24675246823501062 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441805,402289.9416564174,0.08959765813226817 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441810,325995.5787378898,0.001729805971053544 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441806,233405.68785587593,0.14683008088363803 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441799,255875.13623358405,0.10691342913191626 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441794,416772.9121310749,0.10495796850687533 +967514 MM WT,MoneyMaker,0.6,m_58,leaf,2441795,328597.654733941,0.0017229434344798733 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441805,986.6147927480124,0.18530310385051907 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441810,737.2177733195448,0.05875127803160396 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441806,550.6596041428019,0.06796130066623807 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441799,546.5015298328223,0.07125313687515478 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441794,504.1223793478306,0.10630854152611624 +967514 MM WT,MoneyMaker,0.6,m_59,fruit,2441795,885.5037957473714,0.1383459082587839 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441805,1570.6486112378695,0.026376211904861613 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441810,1216.2566666908565,0.08467758895102229 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441806,1495.9588909215615,0.005216836502284217 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441799,1460.2343412966425,0.005280264925182632 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441794,2718.002113443254,0.26454696735140315 +967514 MM WT,MoneyMaker,0.6,m_59,leaf,2441795,1301.548508842474,0.0552424637951181 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441805,20.18790940585949,0.25157577304544243 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441810,49.98823456285803,0.1422006788264083 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441806,52.76699526400317,0.16569524444920747 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441799,33.730977019735704,0.02863819945904922 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441794,32.5507009115081,0.04410677556418885 +967514 MM WT,MoneyMaker,0.6,m_6,fruit,2441795,38.329497205552755,0.02686600215582624 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441805,117.84631517365526,0.020717913524052722 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441810,213.13435750781665,0.23661954308797428 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441806,123.70863454925065,3.660922932779975e-4 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441799,52.04538033180414,0.3756517344724677 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441794,176.64675240905206,0.1550717364384968 +967514 MM WT,MoneyMaker,0.6,m_6,leaf,2441795,123.50015990043268,3.664011543209611e-4 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441805,49.13010771043094,0.04095631181531245 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441810,28.82265393341759,0.27257006077418655 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441806,49.05616913046629,0.04161039758740559 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441799,297.87874197540026,0.7417354829520422 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441794,58.84758017675633,0.03742458120117109 +967514 MM WT,MoneyMaker,0.6,m_60,fruit,2441795,101.28901571617358,0.27325832278662565 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441805,68.59,0.02347372620343302 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441810,66.80159570646646,0.0349476923612837 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441806,48.727350592884584,0.1719617305304273 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441799,76.2086539675539,0.02226976192274588 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441794,81.28858804880683,0.05029505103022025 +967514 MM WT,MoneyMaker,0.6,m_60,leaf,2441795,80.6717069220219,0.04698671715800584 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441805,77.84038065029638,0.1367461267964507 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441810,64.91118887119013,0.057860739230215286 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441806,45.03894909550501,0.1008705757642756 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441799,51.69837120355597,0.0409819636974762 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441794,13.500204370181558,0.6241184812033664 +967514 MM WT,MoneyMaker,0.6,m_61,fruit,2441795,61.93053335997565,0.03744599603998533 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441805,461.74746298321503,0.12338008517290655 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441810,498.24839635784537,0.09033869354000634 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441806,929.2517486026328,0.18034878388218978 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441799,509.204166219694,0.08089265479423746 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441794,1071.8321093612467,0.2423421601473832 +967514 MM WT,MoneyMaker,0.6,m_61,leaf,2441795,717.7111803918534,0.06816510854401336 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441805,6280.179576910279,0.3030407916302549 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441810,3822.0562594522858,0.0873658048411059 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441806,2540.1108524989945,0.09007860060440809 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441799,2299.6895545910347,0.13326205798741242 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441794,2451.769147501006,0.10545169492088746 +967514 MM WT,MoneyMaker,0.6,m_62,fruit,2441795,3711.058522853582,0.07456653256209433 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441805,1069512.1071889407,0.01084536017200044 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441810,852378.7014733823,0.10939847605737008 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441806,1161981.7722222104,0.025168249968715806 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441799,970564.64,0.053006600570718376 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441794,1123601.154712916,0.010581111402016674 +967514 MM WT,MoneyMaker,0.6,m_62,leaf,2441795,1444499.0955714085,0.11968620881263803 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441805,1779.0141186508756,0.08506841761220274 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441810,1424.0338385090477,0.011590667825699619 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441806,1403.5791417936064,0.017874071483186427 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441799,1048.7152750802577,0.14445338336868607 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441794,1714.265900612355,0.0689672092963125 +967514 MM WT,MoneyMaker,0.6,m_63,fruit,2441795,1501.0678787738252,0.011289354481134328 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441805,9271.972715021158,0.015041673044412729 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441810,9921.846232424628,0.044462020210370934 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441806,4584.497763016979,0.2908387067446787 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441799,10145.010529988083,0.05412203024597195 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441794,7201.828577390143,0.09468769210003858 +967514 MM WT,MoneyMaker,0.6,m_63,leaf,2441795,8640.703161237136,0.015581386060878888 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441805,850.7992529255824,0.00814567239415398 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441810,1081.9157318410485,0.0962206635194045 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441806,883.0157951256639,0.00799569990107285 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441799,664.3210178052099,0.11559477939861695 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441794,606.2273004496035,0.15533728206752473 +967514 MM WT,MoneyMaker,0.6,m_64,fruit,2441795,982.5084589905764,0.05436352588167104 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441805,5289.999861688679,0.002526299106810015 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441810,5228.634460714937,0.002541080662374462 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441806,5089.810766939209,0.014227725484535991 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441799,5930.942230459539,0.052194332293891144 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441794,5692.370731987832,0.03436381543503009 +967514 MM WT,MoneyMaker,0.6,m_64,leaf,2441795,5109.476057652976,0.012552993128774226 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441805,63.00612705472673,0.06908286194102975 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441810,45.698267322134456,0.2085659127398134 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441806,105.57595064101392,0.15509935406680175 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441799,88.94816741540468,0.0806713582338181 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441794,58.15514617486078,0.10387749490223586 +967514 MM WT,MoneyMaker,0.6,m_65,fruit,2441795,84.73303866659383,0.05958713462307652 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441805,1457.2635910292497,0.05984525892305781 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441810,1435.8681318072056,0.06626881662116046 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441806,1424.0976522234002,0.06984360288137959 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441799,2190.069521552906,0.11707452796089779 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441794,1887.8692497655748,0.052588539254289746 +967514 MM WT,MoneyMaker,0.6,m_65,leaf,2441795,3121.639257366085,0.27099934038152274 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441805,629.9523173182947,0.054143129741956564 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441810,797.234426753963,0.04813523685845844 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441806,811.2601619528783,0.05570934227950319 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441799,513.9964125277767,0.1424907197749703 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441794,515.2407265150193,0.14144062365776255 +967514 MM WT,MoneyMaker,0.6,m_66,fruit,2441795,905.0814187741744,0.10323684137284195 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441805,4247.91587326986,0.013813523404914818 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441810,3656.332425979168,0.051316709894246415 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441806,4214.764247093125,0.010410903488125456 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441799,4015.094467211244,0.010666616060179379 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441794,5119.732466643741,0.09488488348024715 +967514 MM WT,MoneyMaker,0.6,m_66,leaf,2441795,3654.603828955072,0.05152207898428118 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441805,614.806640883566,0.15493529303696763 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441810,386.45071065924105,0.04670914660730885 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441806,474.2125262570692,0.042169764738253956 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441799,362.4885863734122,0.07450892032930323 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441794,367.6932054027372,0.06831765226123032 +967514 MM WT,MoneyMaker,0.6,m_67,fruit,2441795,613.310798220686,0.15387735425220983 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441805,616.3818537360474,0.07047930728467655 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441810,431.7128659219849,0.08417554562438667 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441806,637.0217826111541,0.08478374571842107 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441799,320.94635240129685,0.21293809310009593 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441794,2144.7369746967793,0.6120035016391219 +967514 MM WT,MoneyMaker,0.6,m_67,leaf,2441795,276.2126135926237,0.2781270300396459 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441805,135.35970141574097,0.08704116323438793 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441810,192.6701364129889,0.06628385392903757 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441806,164.76778636752564,0.0016582438828911528 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441799,179.1084044944918,0.03458541425135753 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441794,166.02844000446166,0.0016519363730900238 +967514 MM WT,MoneyMaker,0.6,m_68,fruit,2441795,159.01698759520804,0.017087028977960994 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441805,1730.7836114377217,0.2236125286629318 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441810,1087.0226308163735,0.021608340188159048 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441806,930.6353389694688,0.045850705652774604 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441799,981.4998313118392,0.02274001631110112 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441794,2041.843506505348,0.29539220768580643 +967514 MM WT,MoneyMaker,0.6,m_68,leaf,2441795,897.4163416835487,0.0616362719640553 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441805,57.84969252652973,0.024634583688493583 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441810,64.60223741677622,0.02331192080604061 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441806,72.94842312559764,0.07608026980512661 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441799,92.30137336915006,0.17827252433209573 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441794,9.77812292862898,0.7966801458630164 +967514 MM WT,MoneyMaker,0.6,m_69,fruit,2441795,53.7495267955676,0.05656099356197042 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441805,125.52179161078432,0.06397808387559989 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441810,165.36714831979748,0.05575202394080181 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441806,99.4891328610042,0.16492156770864352 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441799,208.89381195520963,0.15722836178372157 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441794,98.97364751468996,0.1671776375312235 +967514 MM WT,MoneyMaker,0.6,m_69,leaf,2441795,185.0162738970251,0.10451271699401765 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441805,68.3719918673407,0.08063474003228976 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441810,61.9867545240793,0.12321407398697515 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441806,75.02930728709123,0.040282035512571035 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441799,89.61357788902194,0.03686084487198604 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441794,130.44185271365,0.1999039862926293 +967514 MM WT,MoneyMaker,0.6,m_7,fruit,2441795,147.26497840102115,0.2525865057040795 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441805,215.76988043904103,0.27526912582328755 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441810,378.2769269407202,0.03145009450257952 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441806,214.95771016072743,0.2769069196213074 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441799,671.414681247043,0.21773088661500362 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441794,465.8992383734256,0.05903205374343745 +967514 MM WT,MoneyMaker,0.6,m_7,leaf,2441795,435.0964299337605,0.029325573076749656 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441805,1466.7178323274045,0.15121779159196125 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441810,1232.4815037534702,0.07565162983347573 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441806,642.3297671588612,0.20737073180082222 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441799,1034.4695552233725,4.110668061660938e-4 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441794,910.2005750763798,0.05599167500437874 +967514 MM WT,MoneyMaker,0.6,m_70,fruit,2441795,1036.4287668819452,4.106780926282916e-4 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441805,575597.9629522582,0.02592497661049009 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441810,579033.8003920583,0.028509644194539163 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441806,461745.3683261228,0.06979172386917387 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441799,508888.82967676385,0.02757135365178165 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441794,325218.56294212386,0.22201894523750987 +967514 MM WT,MoneyMaker,0.6,m_70,leaf,2441795,633030.458160407,0.06723033484672314 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441805,307.6847134056798,0.3320634389298607 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441810,149.0615400363826,0.01732312290202387 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441806,175.04300071278527,0.0871022687554901 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441799,137.40405936727026,0.018042917550793458 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441794,131.71459596831212,0.036408576927255076 +967514 MM WT,MoneyMaker,0.6,m_71,fruit,2441795,108.54451546138294,0.12043459664158718 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441805,2203.2664918363566,0.01996314039961078 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441810,2005.2970132163944,0.02092518222205353 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441806,1885.427227273816,0.04769411478146468 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441799,1532.49313238105,0.13770535220246316 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441794,2835.347163370796,0.12950235285447143 +967514 MM WT,MoneyMaker,0.6,m_71,leaf,2441795,2423.8616508722444,0.06140393837262037 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441805,256.249687631798,0.2908286900285959 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441810,80.73394115285348,0.21077850086961303 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441806,147.77342089167195,0.05176167253947739 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441799,271.12340080806405,0.3153323487601192 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441794,114.5666613131383,0.058776397507214195 +967514 MM WT,MoneyMaker,0.6,m_72,fruit,2441795,55.369959056732846,0.37456045225746526 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441805,318.2157385470853,0.07152752369035964 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441810,224.47994828738655,0.08001657816851271 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441806,234.9624552021959,0.0601956601775564 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441799,228.96136974908632,0.07143191723913445 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441794,537.3752122813257,0.2990834978800603 +967514 MM WT,MoneyMaker,0.6,m_72,leaf,2441795,304.8266658036754,0.052858823987680825 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441805,115.73213504736952,0.052588745114003466 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441810,104.86132907173132,0.00975013788010548 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441806,95.96558856478111,0.02874968881521811 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441799,100.20540540822998,0.009974070594211515 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441794,85.49174935624158,0.07894101619801086 +967514 MM WT,MoneyMaker,0.6,m_73,fruit,2441795,107.8056937118428,0.021776478508596764 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441805,1674.922696671203,0.0011409537679685222 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441810,1470.6604705013276,0.05762330215983713 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441806,1683.734790256675,0.0011379641714888145 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441799,1709.8549888492462,0.007823558409232767 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441794,1586.22221514923,0.02477169354120612 +967514 MM WT,MoneyMaker,0.6,m_73,leaf,2441795,1978.1037269841445,0.07111333976350398 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441805,158.3501379324222,0.0065876241195095275 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441810,201.83880784104116,0.11197385047594999 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441806,153.58249971075674,0.006689089991910091 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441799,144.0197964277634,0.03460862917570395 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441794,146.28461458675565,0.027832170068913253 +967514 MM WT,MoneyMaker,0.6,m_74,fruit,2441795,223.5535933104391,0.1563508330497725 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441805,1119.656437620121,0.0653923091274744 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441810,945.29,0.00812740873144957 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441806,948.5295481091808,0.0066416079946760576 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441799,1326.1791370963329,0.13890971913741268 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441794,806.8599754624069,0.076894299661177 +967514 MM WT,MoneyMaker,0.6,m_74,leaf,2441795,977.7639911003974,0.0065415667602186645 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441805,109.9692622561485,0.0312210794419574 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441810,102.24999201207306,3.8694934642879986e-4 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441806,100.87174870367473,0.006280682313990038 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441799,102.4322793797772,3.8660488771569135e-4 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441794,80.3420451500154,0.10510734936183175 +967514 MM WT,MoneyMaker,0.6,m_75,fruit,2441795,164.28709159699048,0.20555320919195852 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441805,8075.096491442677,0.03260644669239188 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441810,8934.632536810557,0.011322528338824078 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441806,8474.78185828721,0.011625638988429277 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441799,9607.538114071704,0.04285794880473581 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441794,7869.308474354525,0.04381759737769775 +967514 MM WT,MoneyMaker,0.6,m_75,leaf,2441795,8960.412970904923,0.01257385882683737 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441805,68.05478076827933,0.15554712946016003 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441810,38.29022380935787,0.09422360498685256 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441806,62.20627290929082,0.11652267152800366 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441799,13.52709260214147,0.5461070467499574 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441794,16.32573531621393,0.4644387586805838 +967514 MM WT,MoneyMaker,0.6,m_76,fruit,2441795,56.84503532951592,0.07738103090896442 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441805,97.03903282948843,0.13868952780603716 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441810,199.89586904855665,0.17516783213946008 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441806,141.41465576641127,0.02485843354455053 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441799,125.6804824143114,0.026368148112303924 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441794,182.29,0.13512685778469624 +967514 MM WT,MoneyMaker,0.6,m_76,leaf,2441795,69.4214799601535,0.28414211922090526 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441805,638.3058475324963,0.04783043500763462 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441810,585.1718250662095,0.010085019465272627 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441806,525.444768206401,0.03667131584643224 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441799,733.2507382241248,0.10805412087222699 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441794,558.3076764859401,0.010324788770404325 +967514 MM WT,MoneyMaker,0.6,m_77,fruit,2441795,543.5302867116576,0.021974639073537805 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441805,12361.890861170104,0.0972916152888681 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441810,12250.411141512055,0.10122585583089538 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441806,17479.62824354982,0.053155671501757595 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441799,18115.48152998573,0.06867336223560994 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441794,13452.26595294809,0.060581075544189567 +967514 MM WT,MoneyMaker,0.6,m_77,leaf,2441795,17674.614120162852,0.05797342054020582 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441805,67.1370245326135,0.029905936440287384 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441810,61.46390613760508,0.008435996298035153 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441806,61.803721926875504,0.006041523421234984 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441799,65.75382084952854,0.020864840792497175 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441794,63.53525599680776,0.00595863086329862 +967514 MM WT,MoneyMaker,0.6,m_78,fruit,2441795,60.38808772828883,0.016104875966370003 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441805,102.15625277471364,0.0028231251535228985 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441810,96.15001389414462,0.029138727877893178 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441806,103.48870945089578,0.002804891929310216 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441799,108.06132817677822,0.021582221919276723 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441794,94.48829770817852,0.03671005435652508 +967514 MM WT,MoneyMaker,0.6,m_78,leaf,2441795,112.42708734809284,0.03878288031960597 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441805,122.0935246437483,0.02490619051196541 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441810,115.65386316172504,0.0013737032093401602 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441806,111.6704268257835,0.013848264689006573 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441799,107.17443543214353,0.03169523635198468 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441794,114.92337686952204,0.0013780621179062535 +967514 MM WT,MoneyMaker,0.6,m_79,fruit,2441795,118.99079378256242,0.013726920907191964 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441805,259.48849838557555,9.172543228550545e-4 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441810,240.85508780384157,0.03144503379258179 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441806,258.39354654496736,9.19195716526211e-4 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441799,284.5225268750531,0.04091579851652938 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441794,236.5120686890369,0.03934755181377625 +967514 MM WT,MoneyMaker,0.6,m_79,leaf,2441795,294.9539162603785,0.05655330836054784 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441805,115.97588707178213,0.21578831706338786 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441810,77.69158660062021,0.041794604651197664 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441806,63.5299996839007,0.045600532780194714 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441799,35.46461943120599,0.2987840821341692 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441794,42.108884400851885,0.2242056502330123 +967514 MM WT,MoneyMaker,0.6,m_8,fruit,2441795,77.59676374118006,0.04126422294979126 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441805,480.6628335060826,0.023966599718232118 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441810,399.66120141748934,0.05618195300352946 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441806,373.50315252589365,0.08557967077671069 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441799,612.1552076708005,0.12898760586073 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441794,479.5219928429838,0.022934587913286286 +967514 MM WT,MoneyMaker,0.6,m_8,leaf,2441795,430.1900379833002,0.024213593470667316 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441805,51.81993375208193,0.04436747561065424 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441810,48.81426201622131,0.01841735011937251 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441806,46.61427630263303,0.001610431738996665 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441799,46.9606240890776,0.0016044820622331812 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441794,46.55180927317544,0.0021928129798103324 +967514 MM WT,MoneyMaker,0.6,m_80,fruit,2441795,44.28806244682238,0.023842697023709558 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441805,138.15,0.01747826780268369 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441810,115.26594825490584,0.061171594026594445 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441806,127.25103801790809,0.018211287780060204 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441799,142.40945305613286,0.030666197021322894 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441794,122.56479917648464,0.03450686349014731 +967514 MM WT,MoneyMaker,0.6,m_80,leaf,2441795,151.6670770924733,0.05801869573214358 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441805,529.5472239325211,0.06960026551576215 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441810,504.8239402073427,0.048835512077831655 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441806,397.4417141047014,0.055030982934106465 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441799,250.8650288937453,0.2548643061626992 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441794,269.08446187293043,0.22441580974022068 +967514 MM WT,MoneyMaker,0.6,m_81,fruit,2441795,535.2169206878153,0.07422540489490714 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441805,7830.832616660473,0.027961255860809775 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441810,9206.449719009865,0.042322988681836815 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441806,7524.437274683897,0.045295170747705615 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441799,9865.617891069222,0.07235509370792004 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441794,7900.866378305842,0.024094479975163896 +967514 MM WT,MoneyMaker,0.6,m_81,leaf,2441795,8802.314826278889,0.022827700691538944 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441805,7115.770106263366,0.07406155786972857 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441810,6430.472193567858,0.030082513869571947 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441806,5833.293550723575,0.012246518617136548 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441799,5483.028366737157,0.03913985800441511 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441794,4382.234763919215,0.1364647109823962 +967514 MM WT,MoneyMaker,0.6,m_82,fruit,2441795,6166.9579040267345,0.011910633180678865 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441805,66150.1186687098,0.07974047641649129 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441810,58435.73698792257,0.13359257832885785 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441806,115384.20608345406,0.16187526214861236 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441799,92814.7295444207,0.06734579947116881 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441794,135575.0515179406,0.23190867410278315 +967514 MM WT,MoneyMaker,0.6,m_82,leaf,2441795,55531.661217556255,0.1557304385430136 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441805,160.93686881310666,0.06644255824545642 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441810,165.7666173048661,0.07928408599238335 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441806,107.25858915564125,0.1097809090992472 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441799,115.27541251085084,0.07847630418777385 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441794,111.90715292762408,0.09135514236682996 +967514 MM WT,MoneyMaker,0.6,m_83,fruit,2441795,297.2606338493422,0.3329244103078417 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441805,2816.698709756952,0.11805874709776365 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441810,2231.965979749555,0.017005922933265083 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441806,2060.5472604309803,0.01769906785076847 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441799,1950.007006906708,0.04164547584084799 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441794,4249.357370938032,0.296641609045023 +967514 MM WT,MoneyMaker,0.6,m_83,leaf,2441795,1820.916486994144,0.07139161961544094 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441805,559.1259887708587,0.015291068567422794 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441810,755.2987271571067,0.11531800505211809 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441806,599.1998477900648,0.014770946606222246 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441799,787.9078020954192,0.13367465324775285 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441794,279.9019297248655,0.315794855136593 +967514 MM WT,MoneyMaker,0.6,m_84,fruit,2441795,392.32118138070314,0.16915899148740055 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441805,204761.58830777783,0.22645933213384328 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441810,736974.4076739665,0.3297445849323939 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441806,76740.63940635265,0.6526824083503904 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441799,913850.2641818536,0.4231672199336307 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441794,71734.81597298455,0.6819778332743391 +967514 MM WT,MoneyMaker,0.6,m_84,leaf,2441795,485061.6451554524,0.1480891136171989 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441805,45.74767797679235,0.03918374954906789 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441810,41.97324433666095,0.0017872336045652304 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441806,41.62849278052542,0.0017946189339785867 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441799,42.963790728034056,0.011917286666644378 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441794,37.63233063187282,0.04562419012749119 +967514 MM WT,MoneyMaker,0.6,m_85,fruit,2441795,38.3583191386874,0.037325737714836826 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441805,570.7594381120933,0.04715513890380629 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441810,701.6832671340359,0.042532879495144726 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441806,463.07344039359054,0.13795836792413319 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441799,996.3433232757787,0.19480077419642639 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441794,488.7044837503308,0.11456191704726981 +967514 MM WT,MoneyMaker,0.6,m_85,leaf,2441795,764.655740769161,0.07985771276359488 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441805,828.4235273369137,0.02200772301533238 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441810,914.547399738324,0.020946071851361214 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441806,687.6892667134844,0.10286790139972135 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441799,725.6507651396074,0.0795324899060521 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441794,1181.8198495832996,0.1322911325862295 +967514 MM WT,MoneyMaker,0.6,m_86,fruit,2441795,1059.1833783629456,0.08471100938597154 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441805,16348.375400593111,0.05490977638721617 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441810,17188.1580883713,0.03315503859449542 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441806,15102.811867930788,0.08932656552797713 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441799,19915.298755485976,0.030802447723041304 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441794,25141.5197475064,0.13200714819847903 +967514 MM WT,MoneyMaker,0.6,m_86,leaf,2441795,26798.188713336727,0.1597210630484298 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441805,247.08434146604208,0.013014794376795535 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441810,232.49495352379765,0.01341689860827655 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441806,262.36796898858137,0.039080384148187264 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441799,284.3077830203079,0.07395831955812726 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441794,194.52748693475235,0.09084945299483183 +967514 MM WT,MoneyMaker,0.6,m_87,fruit,2441795,180.5048631787999,0.12334152204962745 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441805,34495.02236820998,0.020687031904600417 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441810,42763.08763101762,0.07262559230809185 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441806,37860.79576145974,0.019746274957994636 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441799,32674.715672232705,0.04423164566489213 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441794,43424.88421784921,0.0792952063730219 +967514 MM WT,MoneyMaker,0.6,m_87,leaf,2441795,32675.95475641877,0.044215176746634555 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441805,58.270837532972834,0.07778802668340656 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441810,68.52098484201808,0.007415690590476753 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441806,78.12905745906662,0.04957329807770661 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441799,70.88110439674261,0.007291188683941741 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441794,78.513861713097,0.051707051728294706 +967514 MM WT,MoneyMaker,0.6,m_88,fruit,2441795,41.48047015903892,0.2253956167378297 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441805,1594.5734949872317,0.045306900706251874 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441810,1518.88,0.06642797814804258 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441806,1827.7359944446016,0.013962023004764124 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441799,1712.0861137221411,0.014425836842228978 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441794,2294.8750734745554,0.11280760707284543 +967514 MM WT,MoneyMaker,0.6,m_88,leaf,2441795,1881.987210294774,0.026665226023145916 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441805,16956.67395866947,0.21249380529859252 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441810,14954.457845227107,0.15792380848488996 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441806,3834.459377388549,0.4331427232012053 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441799,6715.892791266491,0.1897431096873663 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441794,8388.32834515739,0.09317144261854571 +967514 MM WT,MoneyMaker,0.6,m_89,fruit,2441795,12402.742584885587,0.07667086576859905 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441805,125835.75625701176,0.03746979869265665 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441810,72737.66477522238,0.2005749107971111 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441806,71760.27950024784,0.2064501432426713 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441799,105032.52006631912,0.041010479098140706 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441794,133079.851085788,0.061778041406070905 +967514 MM WT,MoneyMaker,0.6,m_89,leaf,2441795,158388.305068545,0.1373888465743116 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441805,28.094083863828224,0.23319090248289398 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441810,23.774101013848593,0.3057016733365301 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441806,96.01212678751828,0.3005203129735914 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441799,9.44663255514952,0.7065287540158799 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441794,111.15927445966314,0.3641399264741736 +967514 MM WT,MoneyMaker,0.6,m_9,fruit,2441795,68.03078772600409,0.15089972268394303 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441805,139.1732829517174,0.0021015008076021857 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441810,133.35872105477682,0.016432949261225183 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441806,137.82964955223912,0.0021117191927646495 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441799,146.37528649235466,0.024013386999327757 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441794,128.5736378186559,0.03230243924499687 +967514 MM WT,MoneyMaker,0.6,m_9,leaf,2441795,157.35608923590783,0.05542918244059836 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441805,37.081069371306405,0.09664680590055386 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441810,42.03888605279021,0.042147856493966795 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441806,72.62830889579692,0.19530687594787732 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441799,12.150500289940558,0.5812048959282905 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441794,50.607621315008885,0.03841686880067985 +967514 MM WT,MoneyMaker,0.6,m_90,fruit,2441795,61.933575460464816,0.12612709674113987 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441805,2593.717088760384,0.018586158224722205 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441810,2820.5385472854073,0.017823277822119454 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441806,2511.666277273118,0.032546827025659475 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441799,2250.821348560389,0.0801677359342472 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441794,3510.459753360325,0.11285523668340769 +967514 MM WT,MoneyMaker,0.6,m_90,leaf,2441795,3007.610913232929,0.04571289038457005 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441805,316.6875046541953,0.10755854966258438 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441810,213.5966330960508,0.06347797568799862 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441806,232.1194712412044,0.027360805766464935 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441799,455.9888897988716,0.2658818828232108 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441794,262.3077508122582,0.025738745195027057 +967514 MM WT,MoneyMaker,0.6,m_91,fruit,2441795,221.3697777792933,0.047954049253812414 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441805,551953.1817865652,0.08126654190971205 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441810,298178.3428655113,0.18615960249723162 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441806,597345.4556110908,0.11558986477716804 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441799,272926.10887372924,0.2245906158283546 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441794,662962.9394180258,0.16085355208857077 +967514 MM WT,MoneyMaker,0.6,m_91,leaf,2441795,363562.3045404207,0.10005685165283484 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441805,56.56463867467759,0.10347584403558563 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441810,51.80672196245411,0.14163474785825403 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441806,89.7082834384163,0.09681168525515327 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441799,66.26083195273222,0.034763976844306876 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441794,85.93074225012033,0.07812770183897366 +967514 MM WT,MoneyMaker,0.6,m_92,fruit,2441795,77.30492230726247,0.03218628672364132 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441805,36967.64886751068,0.1237475626339446 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441810,18636.1243615281,0.1737186679104914 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441806,49507.94464218304,0.25060062885330225 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441799,14918.291321707688,0.27035518408246073 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441794,122644.78490934455,0.6445748180979685 +967514 MM WT,MoneyMaker,0.6,m_92,leaf,2441795,14006.34198519741,0.2977495417332081 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441805,11.105279448692771,0.34345882092726066 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441810,21.134200403760303,0.06400249107959044 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441806,4.734105239488568,0.7137504042604003 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441799,236.3497261348457,0.9845667910525502 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441794,83.50444489347117,0.5327212809865369 +967514 MM WT,MoneyMaker,0.6,m_93,fruit,2441795,27.8457462772674,0.05577054929229419 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441805,6.980478542597093,0.9803428518834987 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441810,83.6844019860008,0.09841646865168685 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441806,92.13573897858886,0.14020007514064692 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441799,49.746998384058315,0.12746116675691566 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441794,38.40958406451251,0.23978844409261368 +967514 MM WT,MoneyMaker,0.6,m_93,leaf,2441795,127.69855521683222,0.2819579353478401 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441805,247.9010977042895,0.044372290880170695 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441810,319.7940332826932,0.06621961571393475 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441806,301.23593970368375,0.04025604449902698 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441799,456.3815867296722,0.2206773732553171 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441794,208.94582606594085,0.11861704067239387 +967514 MM WT,MoneyMaker,0.6,m_94,fruit,2441795,234.4536261358033,0.06859378663902405 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441805,4246.555572710762,0.042293869440721554 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441810,4180.714281909302,0.03550754561219893 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441806,2857.8353468739524,0.12970573896862447 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441799,3540.0784351862944,0.03673005791929551 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441794,3182.387424135935,0.08298989284946501 +967514 MM WT,MoneyMaker,0.6,m_94,leaf,2441795,4164.926799208423,0.03386443042615772 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441805,52.14010785747968,0.13503843829573503 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441810,84.09517826952415,0.07256073203424984 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441806,56.58104701319683,0.09953938384602923 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441799,115.83205379478484,0.21161839328554022 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441794,64.55918403555903,0.04225233081971247 +967514 MM WT,MoneyMaker,0.6,m_97,fruit,2441795,77.75243488957777,0.038503634731830605 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441805,122.72492342686922,0.09539489738164564 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441810,111.42981701412047,0.053463544920785644 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441806,81.2214126474427,0.08386733370814903 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441799,179.53570538983226,0.26061295995069234 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441794,42.76022272823224,0.3624979137327642 +967514 MM WT,MoneyMaker,0.6,m_97,leaf,2441795,85.61629409735998,0.060981446954516905 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441805,2072.540264208439,0.032766176987884865 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441810,2118.76473264022,0.042345935827041714 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441806,1832.2765652723183,0.02074577252645149 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441799,992.634790976982,0.28694730679033187 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441794,1316.210446241707,0.16441146625709768 +967514 MM WT,MoneyMaker,0.6,m_98,fruit,2441795,2011.576652270716,0.019799786702185518 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441805,56442.62169942732,0.01411132212034083 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441810,60170.78849078049,0.01366720243051045 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441806,34313.092642194155,0.23025863736364283 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441799,109836.59978392988,0.2750285797794394 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441794,39449.33205046093,0.16967884597983574 +967514 MM WT,MoneyMaker,0.6,m_98,leaf,2441795,100811.79593065174,0.2377928514464962 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441805,18799.32983509997,0.19296240966867284 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441810,15146.061977344412,0.09911977162182595 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441806,6305.809640631612,0.2814391018372424 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441799,8964.645480395206,0.1286468385463535 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441794,15404.38847394646,0.10646450430475252 +967514 MM WT,MoneyMaker,0.6,m_99,fruit,2441795,7476.577422934939,0.20747712303023036 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441805,106549.62816112746,0.007415001154500445 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441810,104249.98737097878,0.002060926254785933 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441806,87165.21671304543,0.07979372303630505 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441799,101030.47300984398,0.015684550992413726 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441794,116531.96662088863,0.04630813848229387 +967514 MM WT,MoneyMaker,0.6,m_99,leaf,2441795,105241.76662137444,0.0020511923891257666 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441804,96.198426995727,0.17786901878473604 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441792,87.59663580824369,0.1371884753217376 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441790,57.753376796973974,0.043721569692251494 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441811,63.87029938554627,0 +967514 MM WT,MoneyMaker,1,m_1,fruit,2441808,59.92400911283848,0.02769809048475791 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441804,1212.2396010235989,0.08948939343330986 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441792,2026.8274620204377,0.312717706174904 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441790,760.7694135181531,0.11284603023939654 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441811,63.29788037033262,1.1927099066311722 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441808,634.9827762676126,0.1913371285203045 +967514 MM WT,MoneyMaker,1,m_1,leaf,2441813,1247.421984989466,0.10191432008207046 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441804,58.67010995010348,0.09182358698272597 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441792,47.48903177645221,0 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441790,55.074510023033326,0.06435732696780017 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441811,46.691274945829086,0.00735758223851013 +967514 MM WT,MoneyMaker,1,m_10,fruit,2441808,45.67069494857004,0.01695569501593064 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441804,320.25951603395265,0.004318667759572126 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441792,350.16022795756834,0.04308344107311113 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441790,309.33562105843646,0.010753441878814662 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441811,321.1546528570498,0.005530843149684106 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441808,300.6545694998451,0.023115566403447918 +967514 MM WT,MoneyMaker,1,m_10,leaf,2441813,313.92169491388324,0.004362044729622205 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441804,71.16677488581401,0.05565833336987458 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441792,9.772497375239762,0.8066133892195024 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441790,62.606431717838454,0 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441811,8.857101034457807,0.8493273529011267 +967514 MM WT,MoneyMaker,1,m_100,fruit,2441808,70.5055395446971,0.05160428870584699 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441804,1822.172282702579,0.0963590974430879 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441792,1446.9682188552451,0.0037713464003692465 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441790,1472.2081484407286,0.0037388783542455784 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441811,1407.1613634482485,0.015886436647925883 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441808,1267.6792074432983,0.06122097173929841 +967514 MM WT,MoneyMaker,1,m_100,leaf,2441813,1843.5144165915317,0.10141619941127855 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441804,34.36241435281728,0.050028307704646835 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441792,29.396612660178427,0.017758072670956082 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441790,30.623537893712253,0 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441811,21.67560923297386,0.15008404971639622 +967514 MM WT,MoneyMaker,1,m_101,fruit,2441808,40.32199694018489,0.11948666964841581 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441804,31.75394941719091,0.5148859656800675 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441792,300.8839780908953,0.46171534809598525 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441790,42.12871194646653,0.39210553320929864 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441811,26.092926387603917,0.6001609252586182 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441808,165.70390685088688,0.20264903371825005 +967514 MM WT,MoneyMaker,1,m_101,leaf,2441813,216.24705952456443,0.31826649643171434 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441804,101.95036178892376,0.05799777670529038 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441792,84.52159700810338,0.023423300271649516 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441790,89.20536911400563,0 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441811,70.05401224362448,0.10495798065144335 +967514 MM WT,MoneyMaker,1,m_102,fruit,2441808,131.40182122202827,0.16821038998062643 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441804,581.5291604885876,0.006697326823609906 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441792,563.7310329705846,0.00680222720245327 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441790,541.7395112981764,0.024083658635100313 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441811,593.5598620865461,0.015590354983677557 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441808,467.7666843194319,0.08784488338624818 +967514 MM WT,MoneyMaker,1,m_102,leaf,2441813,667.9948589113645,0.06689894976168054 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441804,3466.731067599049,0 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441792,2652.348497010391,0.11628956623323772 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441790,3386.6667838503513,0.010147684220697784 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441811,3723.9635205810328,0.03108526556676816 +967514 MM WT,MoneyMaker,1,m_103,fruit,2441808,13413.46321895052,0.5876207702447127 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441804,717961.8304456825,0.03643170027031761 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441792,645689.1750560913,0.009646150312256019 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441790,607848.1736500401,0.03587453970821297 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441811,674692.9961282703,0.00943654598676158 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441808,601506.9782726427,0.04042898576306175 +967514 MM WT,MoneyMaker,1,m_103,leaf,2441813,690620.4944420784,0.01956980621305071 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441804,3398.551718947703,0 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441792,2600.1854104033346,0.11628956623323772 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441790,3320.0620398077226,0.010147684220697784 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441811,3650.725244440269,0.03108526556676816 +967514 MM WT,MoneyMaker,1,m_104,fruit,2441808,13149.663931496649,0.5876207702447127 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441804,717961.8304456825,0.03643170027031761 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441792,645689.1750560913,0.009646150312256019 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441790,607848.1736500401,0.03587453970821297 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441811,674692.9961282703,0.00943654598676158 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441808,601506.9782726427,0.04042898576306175 +967514 MM WT,MoneyMaker,1,m_104,leaf,2441813,690620.4944420784,0.01956980621305071 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441804,56.20554267791818,0.039862042336758385 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441792,51.276349974663965,0 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441790,44.65377555871236,0.06005891787686046 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441811,29.386079310944886,0.24177545665751543 +967514 MM WT,MoneyMaker,1,m_105,fruit,2441808,72.46441931811223,0.15020771335789762 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441804,82.19047337369847,0.15573326663387088 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441792,96.79185672677276,0.08471592752689894 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441790,138.4879983871969,0.07085738991450397 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441811,195.58310584903344,0.22077659002453176 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441808,50.84372669643722,0.36431737283153365 +967514 MM WT,MoneyMaker,1,m_105,leaf,2441813,185.20615301852655,0.19710066255539838 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441804,157.0149211179481,0.017433706794239612 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441792,130.29234185339777,0.06358832846249962 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441790,150.83676814131007,0 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441811,149.2762483628371,0.0045165067794536995 +967514 MM WT,MoneyMaker,1,m_106,fruit,2441808,161.66504042871722,0.030108896650873795 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441804,2829.3554333052102,0.016513808529861507 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441792,2618.2255553030104,0.017166642417192346 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441790,2597.6448079246316,0.020593932892033262 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441811,2609.516486909339,0.018613654842213556 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441808,3010.88176783557,0.04352000193568406 +967514 MM WT,MoneyMaker,1,m_106,leaf,2441813,3081.233607815739,0.05355092626551805 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441804,376.8576331127515,0.17408581489918173 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441792,85.8036116186544,0.46858593285242844 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441790,75.82009438576536,0.5223071805440529 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441811,319.176448361718,0.1019393365315917 +967514 MM WT,MoneyMaker,1,m_107,fruit,2441808,252.4012499310995,0 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441804,4735.383789996041,0.040686462295436154 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441792,4666.509459651724,0.03432342968085811 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441790,3758.6622760285304,0.059635415694530014 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441811,4399.58945519651,0.00874343161362967 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441808,4224.21135022766,0.008923081706596392 +967514 MM WT,MoneyMaker,1,m_107,leaf,2441813,4198.366373067556,0.011588385978896998 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441804,127.06952131900653,0.11904788664872212 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441792,71.18180941451661,0.1326244838458548 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441790,74.90917648609036,0.11045848457293816 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441811,132.5682959185001,0.1374461664827593 +967514 MM WT,MoneyMaker,1,m_108,fruit,2441808,96.60364365415194,0 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441804,77.8579252764202,0.3204442706836581 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441792,603.6712971012431,0.5690534295116167 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441790,53.511152072054294,0.4833027960845633 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441811,141.1159675241527,0.0621709396003407 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441808,184.55353668077817,0.05437527485542759 +967514 MM WT,MoneyMaker,1,m_108,leaf,2441813,258.4524145402558,0.20063349649984685 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441804,167.83958012440192,0.14845584969331993 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441792,91.80647568693226,0.11356521890823745 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441790,68.56837492829195,0.2403146779050951 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441811,119.24454882105748,0 +967514 MM WT,MoneyMaker,1,m_109,fruit,2441808,128.8800283910611,0.03374708837669704 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441804,1052.963191743557,0.2226368382863364 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441792,1865.6908165558643,0.02578964564305597 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441790,1264.03843948886,0.1432897471084833 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441811,1650.5614396789506,0.027418333249086935 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441808,2134.7023828515435,0.0842873066885601 +967514 MM WT,MoneyMaker,1,m_109,leaf,2441813,2596.0863083651197,0.16926909855696026 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441804,810.8270446117269,0.2959517529799207 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441792,248.2338661669409,0.2181154415570914 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441790,199.92838984943103,0.31210200454144665 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441811,923.82913008984,0.3526151793633625 +967514 MM WT,MoneyMaker,1,m_11,fruit,2441808,410.1818815347686,0 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441804,1043.2838343127469,0.08641912560296205 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441792,1113.825816666216,0.11483392747184817 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441790,869.7724804578071,0.007422310062312754 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441811,584.3307856379682,0.165324584591926 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441808,840.2953929953919,0.007551369950209441 +967514 MM WT,MoneyMaker,1,m_11,leaf,2441813,599.8500896934593,0.15394062430875577 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441804,330.3157058403648,0.08750591850739609 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441792,163.37701022764975,0.2182323612158541 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441790,133.24965622350626,0.30675720824964126 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441811,337.72112597367595,0.09713492306134652 +967514 MM WT,MoneyMaker,1,m_110,fruit,2441808,270.0370192654832,0 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441804,3128.274391563435,0.3113299024133154 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441792,5171.650176801321,0.09300560146492654 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441790,7641.760259075368,0.0765586667590239 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441811,9665.844048113771,0.17860504189554316 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441808,8353.201436059622,0.11521821255637699 +967514 MM WT,MoneyMaker,1,m_110,leaf,2441813,4470.941533862407,0.15623575124310118 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441804,259.69809764579264,0.16500195400313578 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441792,169.28781591516636,0.020841112391749572 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441790,177.60975464279304,0 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441811,182.47803643141827,0.01174378471446147 +967514 MM WT,MoneyMaker,1,m_111,fruit,2441808,135.14376509241376,0.11867080016059228 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441804,42836.48163998956,0.15121367666393581 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441792,111714.672823678,0.26508274829136624 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441790,53044.64312414638,0.058385937764831475 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441811,49354.10952135168,0.08970414916358393 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441808,74874.15220417148,0.09130444827574724 +967514 MM WT,MoneyMaker,1,m_111,leaf,2441813,68310.29839934835,0.05145871280679071 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441804,772.9178407689079,0.3532868193387029 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441792,286.4580415503158,0.07778549419374725 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441790,142.69811108497066,0.3804282882817085 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441811,342.6466677271985,0 +967514 MM WT,MoneyMaker,1,m_112,fruit,2441808,588.236469419282,0.2347054337297103 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441804,3770.0262450846935,0.24354111708604798 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441792,6374.128314662084,0.01546468883949803 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441790,6836.257036642191,0.014932892758684257 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441811,4470.698861251997,0.16951007314067912 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441808,7821.410066520716,0.07339956534000613 +967514 MM WT,MoneyMaker,1,m_112,leaf,2441813,7243.709868434463,0.04007555658938555 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441804,152.43070158968692,0.1479788202166441 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441792,38.1447695135887,0.4536586332831354 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441790,30.537242923513215,0.5502638044291126 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441811,262.40568936058406,0.38387961864447595 +967514 MM WT,MoneyMaker,1,m_12,fruit,2441808,108.41606199930746,0 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441804,43.20007518251199,0.04406497758212824 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441792,70.8544184403411,0.2589474127289233 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441790,29.222317276254536,0.1257048733293693 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441811,52.95167233234266,0.13246015560157498 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441808,34.86369472943411,0.04904611486458088 +967514 MM WT,MoneyMaker,1,m_12,leaf,2441813,26.93057249937019,0.16117393915934364 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441804,78.57228409831863,0.10011378259453729 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441792,50.776775584048494,0.08949047674768629 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441790,62.39583424361941,0 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441811,22.287326019589784,0.44709762969971845 +967514 MM WT,MoneyMaker,1,m_120,fruit,2441808,69.85537761635581,0.04904424896948023 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441804,235.61559066525123,0.020556108093863212 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441792,305.1663552603102,0.13288873453940475 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441790,228.64899173880815,0.007521374431850081 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441811,206.8884476787128,0.0359116751731543 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441808,200.5131474565729,0.04950506203761407 +967514 MM WT,MoneyMaker,1,m_120,leaf,2441813,220.7974141867788,0.007653933247328659 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441804,66.11164109296529,0.026926282386075195 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441792,73.42178762323735,0.07247329877542308 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441790,47.97982148782418,0.11229302761213367 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441811,29.77789857213102,0.3194576091118235 +967514 MM WT,MoneyMaker,1,m_121,fruit,2441808,62.137196574430895,0 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441804,269.2790589786773,0.07703635199353176 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441792,345.745984922484,0.18559091648007175 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441790,257.84460666751556,0.058191822747940325 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441811,193.17583365311057,0.06721343383218858 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441808,182.02019479255992,0.09304665415686442 +967514 MM WT,MoneyMaker,1,m_121,leaf,2441813,110.46117930637703,0.3099565534273867 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441804,384.0119458210284,0.22369478923135722 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441792,92.51684618731811,0.39442912569494815 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441790,63.14745530012714,0.5602940911966101 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441811,294.4842069851501,0.10841206343644316 +967514 MM WT,MoneyMaker,1,m_122,fruit,2441808,229.4298627701906,0 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441804,9111.809315752364,0.0908804770154763 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441792,9873.19453182168,0.05602740561921449 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441790,13385.886074433787,0.07616202482476453 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441811,12592.254073243384,0.049618378206552904 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441808,12726.72273531072,0.05423148302935665 +967514 MM WT,MoneyMaker,1,m_122,leaf,2441813,8291.950542890656,0.13182839654145573 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441804,159.57647851350106,0 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441792,205.67237752430518,0.1102070914753499 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441790,169.26165889501712,0.025589716020577136 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441811,77.23510250769701,0.3151541496746497 +967514 MM WT,MoneyMaker,1,m_123,fruit,2441808,127.5294104652742,0.09735852489778862 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441804,51.11900602075665,0.2664710317401351 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441792,57.80113032162867,0.21311710108341297 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441790,90.44501593900756,0.018668792736430184 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441811,99.3459019986275,0.02209652487282443 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441808,98.39039079597444,0.017899253174715968 +967514 MM WT,MoneyMaker,1,m_123,leaf,2441813,156.09347269105737,0.21833131032410846 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441804,1575.279915501381,0.20990158366118905 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441792,453.7124947039784,0.33067541282885227 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441790,533.107277015022,0.26064154144735996 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441811,2615.3554808814847,0.4300745745998271 +967514 MM WT,MoneyMaker,1,m_13,fruit,2441808,971.5298578062713,0 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441804,78345.93573063108,0.25720285465479176 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441792,45804.454117880865,0.024094094434321534 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441790,40834.5000992286,0.025786374025232206 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441811,34128.57419942569,0.10369547230255094 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441808,40860.52026105829,0.025509725264190486 +967514 MM WT,MoneyMaker,1,m_13,leaf,2441813,60524.42680139772,0.1451170678349003 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441804,61.221803639121525,0.3857804646381291 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441792,25.18405478542685,0 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441790,60.91627400516008,0.3836076760464162 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441811,8.036052734895833,0.4960828773935878 +967514 MM WT,MoneyMaker,1,m_14,fruit,2441808,23.036348710104683,0.03871201145392278 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441804,79.44692053276782,0.03852440041778338 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441792,26.93449152773339,0.4312438863251895 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441790,65.95919188592781,0.042277341478737185 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441811,126.88994366913738,0.2418745369583859 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441808,85.92857835799909,0.0725849590578711 +967514 MM WT,MoneyMaker,1,m_14,leaf,2441813,21.082454660193772,0.5376314926170676 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441804,74.0117675227234,0.003953719387718824 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441792,43.93668367671994,0.22251978316390209 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441790,73.34103873437998,0 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441811,99.70403999578204,0.13336569961671385 +967514 MM WT,MoneyMaker,1,m_15,fruit,2441808,29.072526447869286,0.4018642823340792 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441804,781.7077974870645,9.712396192895767e-5 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441792,2523.744376163654,0.5089037961826408 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441790,669.500023563587,0.06739097136795413 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441811,782.0574728878591,9.710224635250952e-5 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441808,689.5529923171538,0.054573920569114254 +967514 MM WT,MoneyMaker,1,m_15,leaf,2441813,916.0039420539964,0.06875577467156502 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441804,84.93364143802405,0.06573022058278144 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441792,28.543663237276782,0.40783981495718136 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441790,73.00448200237366,0 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441811,1.5636290546248195,1.669215792114971 +967514 MM WT,MoneyMaker,1,m_16,fruit,2441808,97.43427026153392,0.1253622130273524 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441804,2.8379755180477133,1.0262277863480929 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441792,32.83017807038122,0.03703680732190939 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441790,27.462757107572596,0.04049229518825648 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441811,2.9915898389603077,1.0033343815629325 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441808,118.36890218769403,0.594001188746375 +967514 MM WT,MoneyMaker,1,m_16,leaf,2441813,116.7436683632302,0.5879969047318498 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441804,1902.3774175462588,0.3603891322793151 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441792,298.1102970497528,0.4445305723792998 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441790,257.0736591788679,0.5088499703394667 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441811,4247.1540239674005,0.709190461391684 +967514 MM WT,MoneyMaker,1,m_17,fruit,2441808,829.6741320372079,0 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441804,19296.32336932095,0.08368334783905951 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441792,17698.890726413476,0.046154827292383516 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441790,12118.599923660457,0.11833877245580915 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441811,12725.897566691649,0.0971027974327674 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441808,21003.07935217817,0.1204917525684408 +967514 MM WT,MoneyMaker,1,m_17,leaf,2441813,14129.978971032297,0.05164970511396927 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441804,16.60154718156142,0.12193282986931409 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441792,43.48948818190947,0.2963029027010329 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441790,23.545220653823844,0.029821370905201983 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441811,19.35758264957638,0.05523027166629335 +967514 MM WT,MoneyMaker,1,m_18,fruit,2441808,21.98271826225866,0 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441804,138.3193520949672,0.33845384080439 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441792,1729.4286813562426,0.7585658703816347 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441790,224.2463735959832,0.1286113582133317 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441811,360.10765476073203,0.07709556642399651 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441808,242.96103663865435,0.0938001548729952 +967514 MM WT,MoneyMaker,1,m_18,leaf,2441813,441.43078361939894,0.16552582905822 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441804,2.908509142465322,0.008015920186061343 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441792,2.8553181968875814,0 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441790,2.7059620439794054,0.0233328125531731 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441811,2.3042550183460446,0.09312397109471549 +967514 MM WT,MoneyMaker,1,m_19,fruit,2441808,3.441297473543449,0.08106770255120971 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441804,1056.605049212581,0.12167067592002079 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441792,3416.2860957378416,0.38797087574154077 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441790,1151.2747055827092,0.0844043946716222 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441811,1401.110683220018,8.890868580477829e-4 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441808,1395.3798489129388,8.909107294794438e-4 +967514 MM WT,MoneyMaker,1,m_19,leaf,2441813,2209.87,0.19878336855476864 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441804,92.62425346387042,0 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441792,93.23987168023623,0.002876946498712396 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441790,51.9731739944706,0.2509454807239051 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441811,7.508692844080213,1.0911603815270894 +967514 MM WT,MoneyMaker,1,m_2,fruit,2441808,122.79508549794932,0.12245626516936681 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441804,403.30113067877096,0.6166114787615431 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441792,4052.896376441422,0.3855245815969903 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441790,3054.3393016093455,0.26267636213004364 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441811,2632.1142726216567,0.1980638218025872 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441808,693.1226338840717,0.3814308373986557 +967514 MM WT,MoneyMaker,1,m_2,leaf,2441813,704.230426341783,0.37452613346790287 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441804,59.06172703954648,0.15697998020324766 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441792,17.794985371144108,0.36402852661472274 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441790,111.4736279073508,0.43284597353389986 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441811,41.145861693741416,0 +967514 MM WT,MoneyMaker,1,m_20,fruit,2441808,27.564464858943563,0.17397659649844344 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441804,60.893751379532226,0.11999233704927748 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441792,134.49920427164824,0.2241546481775838 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441790,74.49933074876621,0.03241269542193903 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441811,72.26396479211303,0.04564328115116245 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441808,106.66955364181489,0.1234754110095817 +967514 MM WT,MoneyMaker,1,m_20,leaf,2441813,86.04503266988719,0.030160737035258345 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441804,5112.233287421837,0 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441792,3018.9630621212846,0.22875286449932197 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441790,5281.250279450198,0.014126085436459324 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441811,2488.0256822544434,0.3127558048588961 +967514 MM WT,MoneyMaker,1,m_21,fruit,2441808,7957.808847736395,0.1921828390339857 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441804,256893.59675944905,0.07585725157829692 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441792,223067.84431519156,0.01454094261060046 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441790,56405.137144454304,0.5825773682362723 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441811,155524.52002339877,0.14209715804356637 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441808,359041.07440239046,0.22124810708476073 +967514 MM WT,MoneyMaker,1,m_21,leaf,2441813,208377.7349412387,0.015044714795483749 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441804,38.22354259381819,0.34437604362568597 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441792,11.966364765034333,0.1599926546780619 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441790,46.7178804404891,0.4315282391172408 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441811,0.3137707302843673,1.7413424632638228 +967514 MM WT,MoneyMaker,1,m_22,fruit,2441808,17.296367002746994,0 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441804,73.16590828157976,0.045479986949488405 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441792,111.14443672046288,0.13609897393699266 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441790,64.57355489102862,0.0997340594866567 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441811,34.25752782364689,0.37503273611863297 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441808,89.3211405605812,0.04116550478550374 +967514 MM WT,MoneyMaker,1,m_22,leaf,2441813,128.927174066024,0.20055570828986258 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441804,2300.518181888749,0.20669667200831476 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441792,1429.3184443240082,0 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441790,3094.1664112726453,0.33541466932761344 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441811,981.4457176335656,0.16326271361374456 +967514 MM WT,MoneyMaker,1,m_23,fruit,2441808,1342.79949079726,0.027117830116763386 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441804,70369.60876722557,0.11764509765007691 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441792,146517.6506278924,0.20085971210601716 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441790,91121.54563775276,0.005409156345157484 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441811,71643.27049540982,0.10985483109212701 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441808,93405.58551408704,0.0053426130218481305 +967514 MM WT,MoneyMaker,1,m_23,leaf,2441813,104347.51127984333,0.05345186132417634 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441804,90.39337724295144,0.08053480642766653 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441792,59.597756341084455,0.10037189592012585 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441790,75.0934065552675,0 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441811,104.93753695798765,0.14532906022288694 +967514 MM WT,MoneyMaker,1,m_24,fruit,2441808,59.93355542995274,0.09793176416188887 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441804,127.88824832498958,0.04983694883161416 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441792,178.66381484018376,0.19504291275339902 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441790,100.15839584407364,0.056306329900473795 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441811,94.46710945240442,0.08171306326011107 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441808,31.28659274530327,0.5616354210363823 +967514 MM WT,MoneyMaker,1,m_24,leaf,2441813,129.56268425940283,0.055486246996943045 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441804,71.22032965620265,0.03977571242830624 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441792,60.32974846918265,0.03229675249468089 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441790,64.98726606693829,0 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441811,55.9450551451668,0.06506656085560714 +967514 MM WT,MoneyMaker,1,m_25,fruit,2441808,84.0709593732274,0.11181773625857927 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441804,2788.0224735948755,0.056152335884469995 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441792,2123.478034587819,0.06209616132547957 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441790,1823.416102959837,0.12825814847776273 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441811,2372.8533493255795,0.01387303617972524 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441808,2618.5107437757315,0.028910425854245414 +967514 MM WT,MoneyMaker,1,m_25,leaf,2441813,2526.8967452632455,0.013443561722644493 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441804,191.7902632686757,0 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441792,157.83858704809646,0.08461337079588871 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441790,258.0460724656925,0.1288706980654042 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441811,253.53404258985935,0.1212097259820677 +967514 MM WT,MoneyMaker,1,m_26,fruit,2441808,111.90988932014884,0.23395808908671922 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441804,3085.599739664849,0.07808993617859095 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441792,4370.151779842597,0.07306699532934546 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441790,3959.5277579818335,0.030213866507434517 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441811,3566.7709776726783,0.015154301205277942 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441808,3643.6989788184624,0.0058870344916917006 +967514 MM WT,MoneyMaker,1,m_26,leaf,2441813,3743.1551183798742,0.005808299491690594 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441804,83.04017136800873,0.06599778361705799 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441792,99.71453014319738,0.14546799405919186 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441790,71.33299407385407,0 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441811,60.004114539990574,0.07510942173526192 +967514 MM WT,MoneyMaker,1,m_27,fruit,2441808,29.837306429267866,0.3785308386104136 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441804,281.559855668617,0.3706244802705436 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441792,1128.614147384529,0.23235027575222 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441790,566.8164148869114,0.06675279534009437 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441811,879.3931780013158,0.12398787802831412 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441808,589.4019579501892,0.04978363996579427 +967514 MM WT,MoneyMaker,1,m_27,leaf,2441813,732.5790313565245,0.044659269498800835 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441804,79.84543834467918,0 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441792,101.70081204106485,0.10507431113273547 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441790,154.81715424798512,0.2875689707899054 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441811,57.1236296768908,0.14543431444335542 +967514 MM WT,MoneyMaker,1,m_28,fruit,2441808,12.70956009306308,0.7981195905857672 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441804,215.0090929063996,0.21268930921514562 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441792,344.2934831854631,0.008217333758066658 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441790,330.92433746913866,0.025417428131949915 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441811,950.6354355163232,0.43286786267255195 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441808,1064.6147159656146,0.48204632886788135 +967514 MM WT,MoneyMaker,1,m_28,leaf,2441813,357.44635412863227,0.008064735540055601 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441804,261136.7459921541,0 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441792,234850.51693210047,0.046076467644727614 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441790,364296.9991527764,0.14458760571914553 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441811,149116.61006002646,0.24334196599973978 +967514 MM WT,MoneyMaker,1,m_29,fruit,2441808,523179.4501691865,0.30178268901468197 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441804,717263.8456485727,0.4340557557619604 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441792,267189.9709553461,0.005196968145972036 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441790,227709.82120014948,0.06424142232356811 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441811,311109.2942371919,0.0712898010288292 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441808,231436.81277651983,0.057190744797017246 +967514 MM WT,MoneyMaker,1,m_29,leaf,2441813,260833.44244617,0.005259911433202369 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441804,44.54414435386128,0.009722105297674144 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441792,43.55805868791294,0 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441790,5.8517628695958654,0.8717817967760042 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441811,22.04122595390885,0.29583276899092703 +967514 MM WT,MoneyMaker,1,m_3,fruit,2441808,53.66158560337315,0.09059498543281341 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441804,75.62710464668777,0.006735527280660625 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441792,163.78606507454526,0.3423350025589855 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441790,83.8662718129735,0.0516453906975336 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441811,22.26802352596008,0.5242602751807566 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441808,39.15273912570767,0.2791797959443454 +967514 MM WT,MoneyMaker,1,m_3,leaf,2441813,73.29938138469714,0.006841637246326249 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441804,155.99729234084424,0 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441792,157.0589025652132,0.0029454982025840515 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441790,158.65551513618038,0.0073381131842467084 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441811,60.563033061549355,0.41090944336177704 +967514 MM WT,MoneyMaker,1,m_30,fruit,2441808,121.09659698138006,0.10998512142406014 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441804,6959.749745470899,0.12231309707198568 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441792,5984.314800945994,0.0567339045155828 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441790,4761.115067543276,0.04257184900366129 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441811,4632.376015970598,0.054476722320770055 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441808,4585.912682906878,0.05885474533633728 +967514 MM WT,MoneyMaker,1,m_30,leaf,2441813,5741.816174926805,0.03876875766510901 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441804,71.09974259982943,0.049707439023490174 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441792,79.7215010866364,0 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441790,74.82568550654474,0.02752476322612596 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441811,145.91963908643845,0.26253827932042606 +967514 MM WT,MoneyMaker,1,m_31,fruit,2441808,131.81381786765866,0.21838547166539257 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441804,577.8607697388837,0.004862608665991086 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441792,567.5261288238203,0.012699959228932745 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441790,698.9811447699321,0.07777964026550599 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441811,618.271358781359,0.024493308003144865 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441808,541.1469094164789,0.03337063795265616 +967514 MM WT,MoneyMaker,1,m_31,leaf,2441813,590.8736007129885,0.004808766418820998 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441804,97.95049007303687,0 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441792,61.29716459881987,0.2035662272526555 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441790,71.12407381498144,0.13898998921756944 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441811,125.44027446572817,0.10743038235604252 +967514 MM WT,MoneyMaker,1,m_32,fruit,2441808,215.68893928858097,0.3428212614548152 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441804,2115.549589586031,0.07591843526730946 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441792,2075.0329189704275,0.06752021627754923 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441790,1430.876747075511,0.09390254851495428 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441811,1839.4982135217508,0.015194595782023868 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441808,1384.2108323559758,0.10830253105186038 +967514 MM WT,MoneyMaker,1,m_32,leaf,2441813,1713.0073788824695,0.015745540889359422 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441804,17.667387062931336,0 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441792,83.7186410871051,0.6756498464877598 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441790,15.980080195804234,0.04359336932592761 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441811,13.192535170695116,0.12684406315010244 +967514 MM WT,MoneyMaker,1,m_33,fruit,2441808,63.316290446565894,0.5543431388272413 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441804,1077.441282997427,0.2938870219362584 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441792,3920.254464659909,0.2670336243001481 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441790,1611.4727717137482,0.11905766195072909 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441811,2143.880715806693,0.004919984022824675 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441808,2860.615355668523,0.1301788317908925 +967514 MM WT,MoneyMaker,1,m_33,leaf,2441813,2095.5801381279352,0.004976360234631105 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441804,353.2391534277451,0.05926746026564178 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441792,336.70996219216283,0.03845459099030535 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441790,250.82624842183588,0.08942839248939594 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441811,283.52053841648967,0.03621685005024711 +967514 MM WT,MoneyMaker,1,m_34,fruit,2441808,308.17781736740005,0 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441804,40184.48284695527,0.04223048222459891 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441792,89254.4274868242,0.30434090281416015 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441790,41388.516476119396,0.02940900589174511 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441811,40392.79970630936,0.0399849097455558 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441808,47188.05405448705,0.027543202450463156 +967514 MM WT,MoneyMaker,1,m_34,leaf,2441813,64825.06633751269,0.16545410408458316 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441804,369.57257552246153,0 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441792,537.4443276187013,0.16263374702857103 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441790,133.7618340735191,0.44136752155830283 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441811,37.16870400262146,0.9975223181254651 +967514 MM WT,MoneyMaker,1,m_35,fruit,2441808,523.5354204711622,0.15124633325124126 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441804,3992.2799507855657,0.010922219103622233 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441792,14718.685560945773,0.5557258206189659 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441790,2699.6301355413107,0.18083893937724582 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441811,2069.6428328014067,0.29624780298422193 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441808,4195.632729523559,0.010654257787276578 +967514 MM WT,MoneyMaker,1,m_35,leaf,2441813,10121.25549652478,0.39309118130171194 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441804,2584.508637942818,0.13882015206735243 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441792,1877.4044197438238,0 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441790,1697.1030736997022,0.043849615906420336 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441811,1922.8308107885043,0.010383236562315545 +967514 MM WT,MoneyMaker,1,m_36,fruit,2441808,1747.0667682467542,0.031248333056986155 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441804,4694.234531701417,0.03129571850492763 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441792,13006.506437386834,0.4113001578487063 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441790,2925.964442852711,0.23659145822633 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441811,2279.7796666641057,0.34496762650764534 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441808,5395.749944089764,0.029191312524728286 +967514 MM WT,MoneyMaker,1,m_36,leaf,2441813,9160.548326636936,0.25906096780757704 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441804,630.5732461043939,0.1391511347758474 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441792,471.70666353935616,0.013087605501024058 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441790,397.215574459102,0.06155813737984417 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441811,457.7036816840933,0 +967514 MM WT,MoneyMaker,1,m_37,fruit,2441808,428.5433378641309,0.02858965787841905 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441804,174.29083804829372,0.06639783961050405 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441792,231.87406534488693,0.057579778626892786 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441790,148.36240232541823,0.13634854081852854 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441811,54.824986368578834,0.5686938653807931 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441808,281.47393330876565,0.1417657842288773 +967514 MM WT,MoneyMaker,1,m_37,leaf,2441813,339.99720998652566,0.22380295549152285 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441804,52.969082036362195,0 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441792,67.34692402198112,0.10429531810954029 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441790,53.35293141834068,0.0031358396503611274 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441811,37.9739590029011,0.14453656941059356 +967514 MM WT,MoneyMaker,1,m_38,fruit,2441808,9.961355600584016,0.7257040027754361 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441804,201.66286758896504,0.5171006882582367 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441792,97.29598123516656,0.20056965212554956 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441790,64.93596318866007,0.02496003657976731 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441811,12.764569187903865,0.6815190885030031 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441808,3.808235334717095,1.2068014718652686 +967514 MM WT,MoneyMaker,1,m_38,leaf,2441813,57.68232414665818,0.026482499447662233 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441804,151.03253415694155,0 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441792,196.05853561416777,0.11331524508238866 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441790,66.35606904689634,0.35718985905047496 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441811,23.70078525037829,0.8043077742123677 +967514 MM WT,MoneyMaker,1,m_39,fruit,2441808,1797.4588834845745,1.0755884553367991 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441804,2345.9392518021423,0.031819032316334095 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441792,2279.0530061391105,0.04438136806268389 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441790,2732.3487481711218,0.03440033632549566 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441811,2148.341266337401,0.07003252351072708 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441808,2702.600611848015,0.029646076582912517 +967514 MM WT,MoneyMaker,1,m_39,leaf,2441813,3577.7172498369387,0.15147022074283933 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441804,21.22559126666845,0.3578869698390361 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441792,54.637064951385824,0.052740594668217344 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441790,48.389013329210776,0 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441811,43.1670667871357,0.04959422752423448 +967514 MM WT,MoneyMaker,1,m_4,fruit,2441808,77.03793111608098,0.20195784435845687 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441804,297.4853420289319,0.03808234377226993 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441792,500.2388338382569,0.26379417537939487 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441790,244.92429166186992,0.046351367149966904 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441811,247.53564202022076,0.0417454871457128 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441808,326.96732058386596,0.07912112051822495 +967514 MM WT,MoneyMaker,1,m_4,leaf,2441813,229.08751116032315,0.07538181384578246 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441804,185.23102603947197,0.017716500668460977 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441792,109.07664653421973,0.21226545425501797 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441790,177.82680749950882,0 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441811,188.68476469184913,0.02573960284491461 +967514 MM WT,MoneyMaker,1,m_40,fruit,2441808,110.13840937712378,0.20805843163311177 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441804,6525.4656922724,0.005608516256561558 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441792,6640.965338267096,0.002011186536911236 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441790,6752.584988384559,0.009250031987559026 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441811,6579.5998709576315,0.00202054354567327 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441808,6169.379021919591,0.029978574583300777 +967514 MM WT,MoneyMaker,1,m_40,leaf,2441813,6895.748684737594,0.01836139830229211 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441804,162.2069390743401,0.1857421869354594 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441792,105.76141241956837,0 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441790,81.58550797654244,0.11271422015346078 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441811,78.52732291585623,0.12930644996341534 +967514 MM WT,MoneyMaker,1,m_41,fruit,2441808,211.746553459332,0.3014891080837554 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441804,1287.5089685498588,0.06610996886277487 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441792,2603.7063676235134,0.23973177339731144 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441790,1465.8519392077278,0.009770125911664262 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441811,1532.5526054561017,0.009555158969254407 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441808,1352.556477176888,0.0447048232991647 +967514 MM WT,MoneyMaker,1,m_41,leaf,2441813,1849.4388638673645,0.09117974779457372 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441804,46.999004547507326,0.014031557392553795 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441792,38.94157858807799,0.06764354947332496 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441790,45.50478870860701,0 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441811,39.14962006942073,0.06532955038867572 +967514 MM WT,MoneyMaker,1,m_42,fruit,2441808,56.421779670253414,0.09338967850539603 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441804,160.41918701335803,0.03440090300452647 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441792,189.64064697712092,0.03827421422850419 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441790,182.31111885282073,0.021155942305073783 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441811,183.4244184561534,0.023799936768174934 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441808,149.60324810788697,0.06471619125127193 +967514 MM WT,MoneyMaker,1,m_42,leaf,2441813,164.97482804683844,0.022239529688386828 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441804,1497.3250065458224,1.0152822302471405 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441792,241.0028686504336,0.2219883645303593 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441790,144.55524279139226,0 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441811,44.7935555711911,0.508818310730974 +967514 MM WT,MoneyMaker,1,m_43,fruit,2441808,0.2664061793236135,2.734489553342167 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441804,467.3509827077694,0.0535680882940186 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441792,583.992260270432,0.1503320194542539 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441790,434.8247253872757,0.022239159420589516 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441811,342.63732966435674,0.08124039519363224 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441808,360.55457198847273,0.05910406495752163 +967514 MM WT,MoneyMaker,1,m_43,leaf,2441813,391.4130893144933,0.023439727048348846 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441804,53790.09671168416,0 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441792,34694.77113001537,0.19043829818252345 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441790,54886.90720791044,0.008766434530081746 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441811,37745.50458974697,0.15383708963536513 +967514 MM WT,MoneyMaker,1,m_44,fruit,2441808,92362.35908515305,0.2347926918550085 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441804,209842.91998823915,0.3924423526473184 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441792,113643.56279005676,0.1260928724078756 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441790,30697.63626589537,0.44234703237287665 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441811,59078.575052811815,0.1580219564449541 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441808,64028.57255948496,0.12307814837885545 +967514 MM WT,MoneyMaker,1,m_44,leaf,2441813,105984.36207899376,0.0957898219000155 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441804,66220.00137435179,0.14576469185477858 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441792,47339.59014331685,0 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441790,47005.85410154791,0.0030725453054936125 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441811,44989.52065557531,0.022113127609631356 +967514 MM WT,MoneyMaker,1,m_45,fruit,2441808,109152.89385871855,0.36281076062717776 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441804,30605.97879230046,0.3570619289785659 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441792,16582.617912351612,0.09090875007330812 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441790,5106.9094301989735,0.4205861881856756 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441811,9173.525672781798,0.16620806329871884 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441808,10932.991200997158,0.09000534542266614 +967514 MM WT,MoneyMaker,1,m_45,leaf,2441813,15968.375199105609,0.07451638441178243 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441804,4919.280995002424,0.06374546038785933 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441792,1468.7839057514166,0.46119826519458096 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441790,1743.9243333253064,0.38662853276539844 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441811,4247.722826290698,0 +967514 MM WT,MoneyMaker,1,m_46,fruit,2441808,5499.9641855350865,0.11220369119901896 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441804,24285.90974789409,0.3051065177037726 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441792,11176.479005044424,0.03194285240624062 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441790,7040.583483170614,0.23263920657151704 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441811,5336.846088764616,0.35296318083194667 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441808,12882.536647798064,0.02975352756047478 +967514 MM WT,MoneyMaker,1,m_46,leaf,2441813,17075.66295735751,0.1521297149900276 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441804,151.6386456365754,0.17829069949251597 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441792,55.24430173131879,0.26023170875514334 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441790,43.74071927463278,0.36163327704875603 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441811,165.52359074159682,0.21634070164082297 +967514 MM WT,MoneyMaker,1,m_47,fruit,2441808,100.58175227520373,0 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441804,324.0663185875527,0.18426271727456411 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441792,235.90927888837197,0.046373844815152054 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441790,162.80347663161095,0.11470750335639046 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441811,89.79479694553248,0.37312000555891256 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441808,188.12520269499808,0.0519241974019371 +967514 MM WT,MoneyMaker,1,m_47,leaf,2441813,270.19374663630947,0.1053041152219083 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441804,50.52346332718478,0.1362183919994724 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441792,83.6007569334935,0.08249870431604811 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441790,69.13715515737715,0 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441811,110.65157817192264,0.20424610714077351 +967514 MM WT,MoneyMaker,1,m_48,fruit,2441808,66.61687818978733,0.016127228448223674 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441804,1129.0656369168512,0.06077311722782319 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441792,2317.8794536765813,0.25159853870208915 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441790,1138.4543841713405,0.057176673193441996 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441811,1458.8467355844475,0.05051736082285263 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441808,670.3193166169855,0.2872105724364826 +967514 MM WT,MoneyMaker,1,m_48,leaf,2441813,1581.5564711974832,0.08559239639541927 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441804,32.18165068818108,0.012343439228814868 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441792,31.27986552367971,0 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441790,30.32983381908052,0.013394846537955862 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441811,26.09723728585628,0.07867034295259079 +967514 MM WT,MoneyMaker,1,m_49,fruit,2441808,34.609064283803235,0.04392498024498592 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441804,31.195174813371462,0.006926098551613968 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441792,30.588575638318535,0.015454267783160391 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441790,32.19814823959854,0.006817373282808514 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441811,32.71334888009885,0.013711483070369734 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441808,30.771569990536765,0.012863867379451221 +967514 MM WT,MoneyMaker,1,m_49,leaf,2441813,32.62419336877616,0.012526260324071448 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441804,1246.3584432701225,0.38845524454202973 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441792,251.42262961841305,0.3067833512111333 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441790,223.5119662786187,0.35788693641164704 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441811,910.108968139922,0.25190567833514477 +967514 MM WT,MoneyMaker,1,m_5,fruit,2441808,509.55106725407944,0 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441804,12919.478347311577,0.11224190401940959 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441792,12893.286985291106,0.11136057512991737 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441790,9134.576403375464,0.03831466171833142 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441811,9421.307929203069,0.024891875734210256 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441808,8405.633923882227,0.07443260238688065 +967514 MM WT,MoneyMaker,1,m_5,leaf,2441813,10532.834602898174,0.023542190124797635 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441804,82.16699617495628,0.1339486157639065 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441792,122.30545802067948,0.038799812075407836 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441790,123.97735474505518,0.04469633946740359 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441811,70.39980249713737,0.2010745855263616 +967514 MM WT,MoneyMaker,1,m_50,fruit,2441808,111.852585218757,0 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441804,2544.644714889646,0.035836948748321884 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441792,2796.654562807272,0.005174723347758814 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441790,2730.4044145231237,0.005237125709081525 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441811,3481.4499311506165,0.10029605055497859 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441808,2535.034044073225,0.03748030711064443 +967514 MM WT,MoneyMaker,1,m_50,leaf,2441813,3883.5019735871433,0.14775942704972023 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441804,38.0123194121712,0.002760040366807326 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441792,37.77150847760366,0 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441790,34.05625702170565,0.04496741476574706 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441811,21.257123821203713,0.24965982727531144 +967514 MM WT,MoneyMaker,1,m_51,fruit,2441808,47.59312945951949,0.10037993297100312 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441804,256.0962758256378,0.02165008254531875 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441792,278.59931385065767,0.014926696974040254 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441790,265.82642908508626,0.005455188185372162 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441811,349.00566757110533,0.11277913409777707 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441808,207.894176826176,0.11221102071908629 +967514 MM WT,MoneyMaker,1,m_51,leaf,2441813,272.54665739395074,0.005387514547852135 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441804,167.18234472778195,0 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441792,181.1876465734067,0.034938172119809874 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441790,155.9449164401673,0.030219189901349086 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441811,146.74116537936618,0.05663844810201235 +967514 MM WT,MoneyMaker,1,m_52,fruit,2441808,179.07969246276082,0.029855927983296393 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441804,1499.5377827100697,0.06974412379333916 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441792,1799.8240324624533,0.00952850989728704 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441790,2203.7293490957068,0.09745671898718955 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441811,1908.162904760793,0.034913912170894346 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441808,1721.7071008655012,0.009742265975304587 +967514 MM WT,MoneyMaker,1,m_52,leaf,2441813,1630.813815793534,0.033297154597884404 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441804,79.32116777394621,0.05213429627664867 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441792,23.826525251261693,0.47019409153616576 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441790,45.11703826452219,0.19291422064426023 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441811,70.34849374217848,0 +967514 MM WT,MoneyMaker,1,m_53,fruit,2441808,77.07556298489398,0.039661902608511435 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441804,326.6404584320485,0.16145496455689123 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441792,150.82421318169625,0.17414394350928708 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441790,191.82932569511644,0.06970001168379403 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441811,313.0435570873299,0.14298975789157797 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441808,249.505239330723,0.04446465787275544 +967514 MM WT,MoneyMaker,1,m_53,leaf,2441813,200.9431180487954,0.04954187492590112 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441804,637.2488661748853,0.2673135377759106 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441792,203.0417735910961,0.22941013527272647 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441790,192.45891792990471,0.2526574939352595 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441811,556.97630356212,0.20884118495321013 +967514 MM WT,MoneyMaker,1,m_54,fruit,2441808,344.34638943296693,0 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441804,5655.819641564055,0.014183276389827526 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441792,6845.084449129284,0.09706653507515162 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441790,4959.253382083525,0.0428959772287949 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441811,5292.3689798530195,0.014662160157995707 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441808,4322.296954823524,0.1025976744912076 +967514 MM WT,MoneyMaker,1,m_54,leaf,2441813,6257.414393334188,0.05808264140608843 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441804,73.73217263184539,4.8656127626411916e-4 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441792,74.97943293122945,0.006798559010089411 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441790,73.81482466957348,0 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441811,160.08849948419945,0.33621654145818725 +967514 MM WT,MoneyMaker,1,m_55,fruit,2441808,40.09272451217641,0.2650780226677407 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441804,30.2088289142141,0.5534977463333146 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441792,118.90507210713746,0.04156874469205185 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441790,306.00489789587004,0.4520967419037851 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441811,133.9792089806338,0.09340577344359202 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441808,45.71567222866066,0.37356652566623016 +967514 MM WT,MoneyMaker,1,m_55,leaf,2441813,97.19834371924873,0.0459727714069722 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441804,149.33120016689,0.023464877627710656 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441792,141.4769465092102,0 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441790,78.24520606191304,0.2572279392656265 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441811,119.40628811052687,0.0736584799040112 +967514 MM WT,MoneyMaker,1,m_56,fruit,2441808,230.76315159850577,0.2124807837258995 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441804,2796.63,0.08811130933077216 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441792,13444.359790249508,0.5937938048586098 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441790,2450.309944103973,0.1455252989063638 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441811,7536.76160924988,0.34243845714852617 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441808,1725.8051924020206,0.29775455012444674 +967514 MM WT,MoneyMaker,1,m_56,leaf,2441813,4054.722573913221,0.07321482349009756 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441804,196.36957560953303,0.09551984009276726 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441792,186.55746465609224,0.07325826955039094 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441790,109.68802719083187,0.15739513595184773 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441811,157.59932803845666,0 +967514 MM WT,MoneyMaker,1,m_57,fruit,2441808,148.3222781043278,0.026347974195173318 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441804,75673.06367743466,0.056710990960044505 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441792,178664.84099054665,0.4298087711009604 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441790,57145.97169242251,0.06524470435910956 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441811,56305.373762892676,0.07168048035709251 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441808,45524.55626786828,0.1639846047038951 +967514 MM WT,MoneyMaker,1,m_57,leaf,2441813,79151.69024811985,0.07622986737497595 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441804,289406.8614299397,0.356887447095227 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441792,316548.871193763,0.39581939285414247 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441790,127239.33080001466,0 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441811,41901.45859782851,0.48239223521781227 +967514 MM WT,MoneyMaker,1,m_58,fruit,2441808,79711.91510304598,0.2030981330091155 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441804,150021.75497342538,0.6166069374386307 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441792,39862.37221405305,0.04101583589549129 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441790,20966.72629553088,0.23801667829889972 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441811,32493.6037683589,0.047749423831740856 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441808,32677.5857895368,0.04529734065281499 +967514 MM WT,MoneyMaker,1,m_58,leaf,2441813,55150.38288739944,0.18200122777301075 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441804,863.4183604603871,0.23144019705340169 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441792,300.1322965289528,0.2274683512263418 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441790,256.2758929674239,0.2960733271229947 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441811,804.0433837480501,0.20049840002550567 +967514 MM WT,MoneyMaker,1,m_59,fruit,2441808,506.7352108228812,0 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441804,708.4296469912756,0.24899884595706823 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441792,1644.951674065617,0.11685757003094865 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441790,1342.0014562953554,0.02845741351964337 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441811,1362.574981721036,0.035064836987424464 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441808,1142.6614856241663,0.04137798423257344 +967514 MM WT,MoneyMaker,1,m_59,leaf,2441813,1171.7687191847083,0.030453673427003558 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441804,188.6653876546159,0.6353737546862082 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441792,36.98071470295894,0.07234317735648355 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441790,38.9841919966654,0.04942994032292103 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441811,43.68360562003678,0 +967514 MM WT,MoneyMaker,1,m_6,fruit,2441808,75.10453796631893,0.2353477011413223 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441804,58.79571185945509,0.02803254267434241 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441792,66.63624311891991,0.02633230846572343 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441790,172.8900983374811,0.44039192576321295 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441811,100.35622334939865,0.2041661138259927 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441808,42.49638190468315,0.16902623928985228 +967514 MM WT,MoneyMaker,1,m_6,leaf,2441813,45.23387926889375,0.14191436101114818 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441804,45.37606733862865,0.03892613338712869 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441792,41.48591949789376,0 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441790,46.376794605126975,0.048400008210320866 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441811,27.068013704963885,0.18544433257686865 +967514 MM WT,MoneyMaker,1,m_60,fruit,2441808,10.965327506610748,0.5778791127930551 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441804,66.80462263950137,0.0032128913196249886 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441792,78.98207162181927,0.0695091142153641 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441790,67.79672314456369,0.003189296935496966 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441811,67.99360590776291,0.004448667292029418 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441808,26.78208425181559,0.4001750345271802 +967514 MM WT,MoneyMaker,1,m_60,leaf,2441813,56.905180219347095,0.07286760335450615 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441804,83.85610989052016,0.008778385673850142 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441792,82.17814349896081,0 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441790,57.16559307372353,0.15762161230306782 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441811,102.35264231533854,0.0953427329898322 +967514 MM WT,MoneyMaker,1,m_61,fruit,2441808,81.29912299700399,0.004670465084937403 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441804,402.9452249022638,0.11926183560873627 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441792,1009.6382564131724,0.27965794900872076 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441790,665.0588625365343,0.09835223607246713 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441811,415.8090978962258,0.10561386169012676 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441808,570.8888844799102,0.03204373799128524 +967514 MM WT,MoneyMaker,1,m_61,leaf,2441813,489.6774685665207,0.03459772777467318 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441804,2563.430945917313,0.22106226863742862 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441792,785.2338131906139,0.29276036159084473 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441790,757.6478862551378,0.30829193826617596 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441811,1898.9629766450685,0.09075714333868001 +967514 MM WT,MoneyMaker,1,m_62,fruit,2441808,1540.8464219317814,0 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441804,977081.2766033668,0.022874864898237313 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441792,776595.5258217262,0.07686094213546912 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441790,977690.0030033332,0.023145348230786844 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441811,876816.6636368138,0.02414703140929486 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441808,871045.9255999066,0.027014772623900285 +967514 MM WT,MoneyMaker,1,m_62,leaf,2441813,988556.4488108376,0.027945647291764963 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441804,272.31368588105477,0.48705515003637334 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441792,882.1274056827839,0.023406696223653878 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441790,289.8348006586263,0.45997408830563336 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441811,835.8428246871816,0 +967514 MM WT,MoneyMaker,1,m_63,fruit,2441808,1467.934437187975,0.24458204038282938 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441804,3357.143972535194,0.16707360078870215 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441792,2125.028195798092,0.03153166892813486 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441790,1026.9561604273515,0.3473444612976815 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441811,1208.2480539628332,0.2767402614357364 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441808,2445.0787314986,0.02939648219989799 +967514 MM WT,MoneyMaker,1,m_63,leaf,2441813,2670.3111393338572,0.06766550167995522 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441804,1169.7154658700078,0.2193460651145438 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441792,183.27574033864596,0.585629184527209 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441790,119.41172913217648,0.7716871798774805 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441811,891.2039335583802,0.10124292767192244 +967514 MM WT,MoneyMaker,1,m_64,fruit,2441808,705.8853474404251,0 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441804,4444.594948928721,0.12647921968726328 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441792,5422.887301344456,0.040080829057610234 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441790,9085.242196117768,0.18402510124145666 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441811,7930.217611081234,0.12497369678338277 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441808,6471.481594577154,0.03669231228020964 +967514 MM WT,MoneyMaker,1,m_64,leaf,2441813,4840.163256660964,0.08945139760119147 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441804,62.40515514372578,0 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441792,38.1225581270881,0.21403843193223882 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441790,54.46696642425,0.059087279602343834 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441811,109.70014611253148,0.2449867388089837 +967514 MM WT,MoneyMaker,1,m_65,fruit,2441808,86.36964373515974,0.1411406609722421 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441804,1692.6785620867386,0.07652537711196183 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441792,2387.835916077289,0.07290460927386988 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441790,2111.0088873472823,0.019390190714879907 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441811,1980.021889331393,0.008429879521254957 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441808,1793.4889836964574,0.05140115756099828 +967514 MM WT,MoneyMaker,1,m_65,leaf,2441813,2057.639237571487,0.008269362002939928 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441804,1256.128406557134,0.22410540893868003 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441792,239.8150536649161,0.49505218693943887 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441790,169.87498589711248,0.6447991943951861 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441811,1088.339490554118,0.16183575981456366 +967514 MM WT,MoneyMaker,1,m_66,fruit,2441808,749.7709819063119,0 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441804,3315.174404009777,0.14929462057216725 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441792,4889.684120274266,0.019479802873394014 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441790,6376.829471876925,0.1348038021227751 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441811,5971.6461326850185,0.10629306324052523 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441808,4460.733253106631,0.020394747497786803 +967514 MM WT,MoneyMaker,1,m_66,leaf,2441813,3117.2934204221087,0.1760233182978137 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441804,730.6604414352491,0.2774330902806783 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441792,180.04633648538208,0.33089821569843325 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441790,131.34127558970738,0.4678812747853436 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441811,495.4796552395931,0.10874332209924908 +967514 MM WT,MoneyMaker,1,m_67,fruit,2441808,385.7291894272375,0 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441804,135.70643321476527,0.4542203495464374 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441792,1039.6332585647444,0.4300593788345042 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441790,55.70925123536669,0.8408934642592052 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441811,2631.854160242105,0.833441034324427 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441808,141.57557031955056,0.43583246578494617 +967514 MM WT,MoneyMaker,1,m_67,leaf,2441813,630.8395759350706,0.21309814553510753 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441804,162.3737322195662,0.14704789257592488 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441792,253.25866765913122,0.0460006520226659 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441790,227.8052170480967,0 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441811,186.0435129798409,0.08794913427569195 +967514 MM WT,MoneyMaker,1,m_68,fruit,2441808,253.9371757265683,0.04716261929523213 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441804,887.2673194712125,0.20392079674062513 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441792,515.1184052594854,0.03222662123032771 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441790,481.04400422438994,0.06194888286397804 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441811,594.4745338953046,0.029999566246336595 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441808,778.2306350085867,0.14697463398751776 +967514 MM WT,MoneyMaker,1,m_68,leaf,2441813,438.8806136779656,0.10178729127031438 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441804,57.40948728994969,0.19847490631935094 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441792,71.49115142455199,0.1032062828299074 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441790,90.6689475478319,0 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441811,195.87680919539665,0.3345244461833541 +967514 MM WT,MoneyMaker,1,m_69,fruit,2441808,93.21054602554682,0.01200647744383887 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441804,147.47357677624103,0.14371771478411555 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441792,60.36478026585334,0.24421287473642894 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441790,9.98724360961306,1.0255508554801493 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441811,127.521642588416,0.08058739934442372 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441808,131.51943634481117,0.09399344010634314 +967514 MM WT,MoneyMaker,1,m_69,leaf,2441813,84.3273945679239,0.09902781653036263 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441804,51.16977497252381,0.06987371459133862 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441792,72.45263861523611,0.22091441393792133 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441790,21.946744651007737,0.2977696818186435 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441811,22.405939390087305,0.28877663566829215 +967514 MM WT,MoneyMaker,1,m_7,fruit,2441808,43.56520806124309,0 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441804,115.17053345030098,0.216078908984366 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441792,183.67112284297897,0.013379406415588324 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441790,195.16404033347547,0.012979512999202747 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441811,165.1318271801388,0.05958950101858562 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441808,369.48224364711103,0.29017328476814086 +967514 MM WT,MoneyMaker,1,m_7,leaf,2441813,203.22681314478737,0.030560719517733315 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441804,860.8773813968163,0.008851463639677704 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441792,489.1697026420882,0.23663028311278955 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441790,1028.030646276388,0.08591622773937235 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441811,584.3098884701291,0.15944659763774327 +967514 MM WT,MoneyMaker,1,m_70,fruit,2441808,843.5092194199185,0 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441804,316276.7989198534,0.106440520165485 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441792,366948.8054690205,0.17097866384693727 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441790,126160.70901064837,0.29270269340964816 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441811,244009.12105928708,0.0062207538622551795 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441808,248377.33848677695,0.0014851546151968265 +967514 MM WT,MoneyMaker,1,m_70,leaf,2441813,246681.490356666,0.0014902508232861322 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441804,196.67920548388503,0.24003779368717204 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441792,101.44335953522395,0.04749702807656586 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441790,113.16722107911814,0 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441811,149.94914424371018,0.1222233400594126 +967514 MM WT,MoneyMaker,1,m_71,fruit,2441808,96.14787576881496,0.07078095788552252 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441804,3247.7174599924315,0.03855661245072284 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441792,2360.45629176313,0.10002566459588014 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441790,2896.4031090548597,0.011162622678985379 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441811,2707.3691865258415,0.04047414591338594 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441808,3766.043944552592,0.10286375566161654 +967514 MM WT,MoneyMaker,1,m_71,leaf,2441813,3047.2249370266823,0.010882886057255181 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441804,142.872265687391,0.17332417684965962 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441792,63.11310896103792,0.18150418092310816 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441790,106.03978171737263,0.0438450700329327 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441811,72.773924535996,0.11964795894584257 +967514 MM WT,MoneyMaker,1,m_72,fruit,2441808,95.85698280939287,0 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441804,458.85542481704647,0.03060395838990182 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441792,475.53058608145824,0.015101372954944292 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441790,592.0533890287913,0.08008104253844772 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441811,509.1827611385909,0.014593862876272734 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441808,543.4382840279534,0.042870401341555286 +967514 MM WT,MoneyMaker,1,m_72,leaf,2441813,365.7846950286656,0.12905429890732734 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441804,88.12363302740688,0.012381558153103489 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441792,60.57925136989235,0.15038693305036732 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441790,85.64673964619313,0 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441811,97.04840864205056,0.05427758328063392 +967514 MM WT,MoneyMaker,1,m_73,fruit,2441808,61.80800911197028,0.14166608030244032 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441804,1679.699844637448,0.009501678744695763 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441792,1654.3641403821653,0.016102252941361694 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441790,1777.1862406359398,0.014999581389500971 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441811,1754.0081248549109,0.009298239968738464 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441808,1545.325985576319,0.045713253207732674 +967514 MM WT,MoneyMaker,1,m_73,leaf,2441813,1854.7364874487128,0.03354885495323323 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441804,183.24441454230848,0.035022211767033795 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441792,110.40733463300415,0.18501060844319772 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441790,84.24773467417408,0.30245030203866174 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441811,244.13694348616292,0.15962496899354628 +967514 MM WT,MoneyMaker,1,m_74,fruit,2441808,169.04741497858578,0 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441804,868.3743299327565,0.0579122512793373 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441792,1292.0059152209014,0.11464527395875423 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441790,1017.0065532704228,0.01070452334338734 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441811,1406.012622138119,0.15136999142948815 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441808,967.4848582560452,0.010975051281945092 +967514 MM WT,MoneyMaker,1,m_74,leaf,2441813,859.7839268324741,0.06222990607489276 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441804,104.36009201878024,0.004881916153234744 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441792,99.72085589166039,0.014866539868167106 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441790,93.31653357627994,0.04369393950116418 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441811,103.19354623941776,0 +967514 MM WT,MoneyMaker,1,m_75,fruit,2441808,105.37605931890668,0.009089416296233388 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441804,8552.808966852097,0.017224248697006672 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441792,9298.878703355713,0.05354605955431202 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441790,8255.89822538413,0.0018798073888866007 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441811,8007.07351339792,0.01141070735257399 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441808,6874.987288682486,0.07761262363414145 +967514 MM WT,MoneyMaker,1,m_75,leaf,2441813,8184.582746544062,0.001887979362671377 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441804,3.527539325996642,1.2089601238645433 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441792,112.80377104425587,0.29589163045469946 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441790,38.441869431587214,0.1716274886644822 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441811,57.07316905800331,0 +967514 MM WT,MoneyMaker,1,m_76,fruit,2441808,60.5765228435207,0.025872352795227593 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441804,169.69401051965193,0.01559378598172767 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441792,157.72411929028576,0.016174616805042508 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441790,241.339727403574,0.16855609000642646 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441811,83.64753100432178,0.29161960128406994 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441808,323.652757778818,0.296006584054604 +967514 MM WT,MoneyMaker,1,m_76,leaf,2441813,114.89759622500542,0.15376178494992487 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441804,612.0057583645283,0 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441792,654.5556844161819,0.02919109035183798 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441790,511.49036965102187,0.07791804722162698 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441811,501.6708484270581,0.08633664308440725 +967514 MM WT,MoneyMaker,1,m_77,fruit,2441808,712.7902562524694,0.06620624587864476 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441804,14972.234140973978,0.013588121052565683 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441792,16691.692743497224,0.0336256505337964 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441790,15923.941607140465,0.013175845168190037 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441811,16351.920207899242,0.024694028047364647 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441808,12150.413117506829,0.1042836868738668 +967514 MM WT,MoneyMaker,1,m_77,leaf,2441813,14310.920135707487,0.03320717311594379 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441804,65.55813436159181,0.02141835306669071 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441792,59.90279374073866,0.017761155508530413 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441790,59.75889441403838,0.018805678858056618 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441811,62.40339718877016,0 +967514 MM WT,MoneyMaker,1,m_78,fruit,2441808,66.7292637059665,0.02910809989568275 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441804,99.5854445559406,0.0051669173371762245 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441792,98.68224490860406,0.009123763128512818 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441790,102.78018077768094,0.008546593457248619 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441811,104.65968932565526,0.01641665747226151 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441808,95.26418288142956,0.024433137067878308 +967514 MM WT,MoneyMaker,1,m_78,leaf,2441813,101.96918565474664,0.005106167195393141 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441804,120.832627558624,0.013431800511127356 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441792,95.74094928432197,0.0876546897455448 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441790,97.59866927196576,0.07930852276621936 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441811,117.15273151678048,0 +967514 MM WT,MoneyMaker,1,m_79,fruit,2441808,118.45859997345566,0.004814176538752601 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441804,243.95605274215788,0.0012276769823831302 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441792,240.62427444746083,0.007199837423397248 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441790,247.0038512641296,0.004164450043885992 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441811,245.3372489541229,0.0012242163277638163 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441808,233.61998758202228,0.020029278242395865 +967514 MM WT,MoneyMaker,1,m_79,leaf,2441813,250.7549229939804,0.01071019339251622 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441804,81.17936942014636,0.36901291626040633 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441792,24.576871493266538,0.14990615858847378 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441790,34.70825321906942,0 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441811,76.77680404570756,0.34479727272265426 +967514 MM WT,MoneyMaker,1,m_8,fruit,2441808,31.09486057526427,0.04774414340741928 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441804,318.75467809503067,0.00407702900817819 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441792,443.2194012275004,0.14723922443333404 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441790,315.7967083048582,2.806058721027682e-5 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441811,217.64150519917536,0.16163781745043426 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441808,302.4055463605655,0.01878978604464754 +967514 MM WT,MoneyMaker,1,m_8,leaf,2441813,315.7559011789456,2.806240037545038e-5 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441804,51.68171957479672,0 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441792,43.907397743917514,0.07079925667448816 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441790,46.78061026801564,0.04327107222628945 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441811,54.56059176139333,0.023542116763021204 +967514 MM WT,MoneyMaker,1,m_80,fruit,2441808,67.34525030830196,0.11497001619112779 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441804,132.65912059841028,0.02895882487739465 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441792,134.31083239422887,0.023584898236465257 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441790,145.13324549086403,0.010070968229879629 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441811,138.47962441668827,0.010310061918193725 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441808,170.04106028301254,0.07885786542912498 +967514 MM WT,MoneyMaker,1,m_80,leaf,2441813,154.88601841784805,0.038316276808882055 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441804,399.1525982208073,0.15175636141511273 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441792,110.57566293627232,0.4057230473894977 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441790,97.29054561756855,0.4613119601951796 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441811,418.28310758427864,0.17208772672519101 +967514 MM WT,MoneyMaker,1,m_81,fruit,2441808,281.43791141459815,0 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441804,8136.262874743144,0.02004871218317561 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441792,6583.1400070239315,0.07194316803628498 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441790,8816.115949911491,0.05490103381309508 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441811,7944.33222973816,0.009681138349449725 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441808,6171.3505797917105,0.09999604123586447 +967514 MM WT,MoneyMaker,1,m_81,leaf,2441813,7594.066271014911,0.00990187681974275 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441804,5953.346604618188,0.09311454725871293 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441792,3819.411716433342,0.09965014470511369 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441790,4476.916475167717,0.030667628786931633 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441811,6483.625994140124,0.13017133405220083 +967514 MM WT,MoneyMaker,1,m_82,fruit,2441808,4804.482553945456,0 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441804,110353.57746983696,0.0916188487449503 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441792,377661.4625872657,0.44269740517906353 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441790,142368.53975446057,0.019008765051390597 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441811,207603.6739176029,0.18282976932271744 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441808,130174.60403264772,0.019879000232519317 +967514 MM WT,MoneyMaker,1,m_82,leaf,2441813,113822.0626036348,0.07817881421402895 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441804,174.2597031064356,0.2608090256558562 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441792,56.218625116891104,0.2305077238248534 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441790,46.909776335869786,0.30912458186551817 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441811,95.5846037520756,0 +967514 MM WT,MoneyMaker,1,m_83,fruit,2441808,117.11886436641824,0.08823890851635863 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441804,1050.4033606469563,0.1356798367698464 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441792,3340.647781580274,0.36679474924479205 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441790,1766.6524339672865,0.09011517675466152 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441811,923.5097735537756,0.19159444336713083 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441808,1104.5640257319317,0.11384504463946632 +967514 MM WT,MoneyMaker,1,m_83,leaf,2441813,2689.0988491411404,0.27257082750781736 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441804,684.0369846989539,0.22647389469079648 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441792,153.1137301711669,0.42359155227318324 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441790,119.63303927250396,0.5307545531082685 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441811,809.9670481064392,0.2998616616163252 +967514 MM WT,MoneyMaker,1,m_84,fruit,2441808,406.07447286840136,0 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441804,13024.368798395775,0.17601866361531382 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441792,12849.110126542566,0.17013502976392036 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441790,7874.93911325411,0.042490816963165035 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441811,9272.427805515652,0.02845543902810954 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441808,7883.868186120314,0.04199866709222322 +967514 MM WT,MoneyMaker,1,m_84,leaf,2441813,8096.300323964841,0.030451412095438446 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441804,51.31604013982633,0.10011802836471895 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441792,44.281918567151905,0.03609132113572211 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441790,40.750703239256104,0 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441811,35.44448120155348,0.06058648381116383 +967514 MM WT,MoneyMaker,1,m_85,fruit,2441808,40.25088704416267,0.00535965206869049 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441804,370.4855099445133,0.00885962075693536 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441792,404.3801262942872,0.02915895584702044 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441790,385.0585229318969,0.0078958928432602 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441811,441.2864270997008,0.06708972209077846 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441808,342.83495115325064,0.04254575698831653 +967514 MM WT,MoneyMaker,1,m_85,leaf,2441813,371.1835640189888,0.008042110272070246 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441804,981.8249089055272,0.047389990228519974 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441792,1095.025004347932,0 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441790,468.90415527755215,0.3683399548528201 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441811,1367.9993965454391,0.09666186962081147 +967514 MM WT,MoneyMaker,1,m_86,fruit,2441808,1099.4690469246518,0.0017589710991727792 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441804,9236.179099863966,0.21495840002678746 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441792,6286.987338628085,0.04790863996811856 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441790,4592.574142335108,0.08847776948937103 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441811,4758.879392542876,0.07302924743346084 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441808,4973.675141946821,0.05385653005548141 +967514 MM WT,MoneyMaker,1,m_86,leaf,2441813,7622.219420554086,0.13154750087887113 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441804,318.4434239503949,0.05028771573264246 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441792,245.07689150957327,0.0634422059189208 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441790,395.5998928474226,0.1445115961542176 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441811,206.2607929128464,0.13832788619503367 +967514 MM WT,MoneyMaker,1,m_87,fruit,2441808,283.62503934393084,0 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441804,10771.717821450116,0.22795949449870445 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441792,32245.711157481473,0.24822749694889978 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441790,19714.61374949541,0.03454381025271491 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441811,17138.39531676401,0.026274306391782964 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441808,15587.079719724028,0.06747970590343044 +967514 MM WT,MoneyMaker,1,m_87,leaf,2441813,19276.113658586622,0.024775015883234275 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441804,92.5953252350946,0.08616168963838322 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441792,112.91476918331692,0 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441790,104.45020111300276,0.03384147056835429 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441811,117.21820078781884,0.016244299904394133 +967514 MM WT,MoneyMaker,1,m_88,fruit,2441808,127.9055820182615,0.05413874715073863 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441804,522.0190498909325,0.2853611093787931 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441792,1774.6160822099623,0.24605695167997288 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441790,1078.239065254478,0.02966760127605328 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441811,901.0743663236073,0.048286826155719 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441808,957.838389079936,0.021755222166431665 +967514 MM WT,MoneyMaker,1,m_88,leaf,2441813,1056.245042835729,0.02071722247994634 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441804,7195.286312472285,0.02939639790540971 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441792,2478.3192354885923,0.4334944343404037 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441790,3108.617647397573,0.335084373878459 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441811,7761.418574452769,0.0622894236189091 +967514 MM WT,MoneyMaker,1,m_89,fruit,2441808,6724.371239947096,0 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441804,57431.494908858454,0.00973548416075598 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441792,54885.28202759948,0.009958736536827217 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441790,82519.30443515621,0.16714092189398588 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441811,102690.94964438165,0.26211753335217747 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441808,50233.11615798094,0.048424516711807364 +967514 MM WT,MoneyMaker,1,m_89,leaf,2441813,37280.0196289725,0.17793850435351466 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441804,58.08801997775296,0.10525090391588954 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441792,45.586439076541026,0 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441790,37.54199461922188,0.08431832608165646 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441811,32.046873841276806,0.1530499985151048 +967514 MM WT,MoneyMaker,1,m_9,fruit,2441808,49.780655673386995,0.038224943314055126 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441804,138.25001298058004,0.001220930628954342 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441792,133.16134084585005,0.015066090562296353 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441790,140.88025443778497,0.0094058771959733 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441811,139.78381076995757,0.006012625860151832 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441808,128.1956179588441,0.03157106994038417 +967514 MM WT,MoneyMaker,1,m_9,leaf,2441813,137.47378099992707,0.0012243727061345133 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441804,53.284843159388565,0.09253097576228586 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441792,120.51251433078507,0.26189747995442225 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441790,65.93783258956822,0 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441811,59.539666487054234,0.04432826995300898 +967514 MM WT,MoneyMaker,1,m_90,fruit,2441808,114.59222553997122,0.24002048655033725 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441804,1579.8384113167526,0.12774081945288307 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441792,3254.1526843596303,0.18608443784472284 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441790,1959.7749272102892,0.03414729113636339 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441811,2280.397171290907,0.03165700534703264 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441808,1445.6812366241943,0.1662809438809223 +967514 MM WT,MoneyMaker,1,m_90,leaf,2441813,2328.3495231247725,0.04069468726890779 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441804,381.6876677210229,0.022343579916354273 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441792,362.5471940717664,0 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441790,384.7790174618413,0.025846833064652408 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441811,0.19443278699097383,3.270595046885779 +967514 MM WT,MoneyMaker,1,m_91,fruit,2441808,296.13022187262055,0.08788181624251168 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441804,792759.3276474783,0.02347636359872851 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441792,709327.3446320647,0.02481829479987052 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441790,543102.8138389656,0.1407829441651316 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441811,448005.5631688685,0.22438159012060588 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441808,937704.072763968,0.09640080523710726 +967514 MM WT,MoneyMaker,1,m_91,leaf,2441813,914880.808224307,0.08569952028071892 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441804,153.9022899152112,0 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441792,187.76322075201085,0.08636544446641015 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441790,179.67324933689983,0.0672383402047938 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441811,63.96836419967811,0.3812798366835697 +967514 MM WT,MoneyMaker,1,m_92,fruit,2441808,49.436729988341675,0.4931953453017073 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441804,39731.239159025696,0.40831234415587225 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441792,123698.678340836,0.08492060500245824 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441790,83567.90551924804,0.0854049369441432 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441811,54067.68938626444,0.27450664428156113 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441808,119889.94411890605,0.0713383033411068 +967514 MM WT,MoneyMaker,1,m_92,leaf,2441813,146607.8047174745,0.15871263630848986 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441804,19.120532323206888,0.524841577586847 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441792,142.2049442114955,1.3962562948461499 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441790,5.710293113270017,0 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441811,1.010536237714047,0.7521065095711735 +967514 MM WT,MoneyMaker,1,m_93,fruit,2441808,3.2751791071580567,0.24142334655239128 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441804,45.54475161032173,0.25762457348429346 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441792,17.179057718995086,0.6810635725172207 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441790,86.35371239250625,0.020218101489554163 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441811,78.49778906779693,0.021205486587245748 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441808,98.7979825616286,0.07868516508863332 +967514 MM WT,MoneyMaker,1,m_93,leaf,2441813,121.59187978564212,0.1688416612488468 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441804,379.2185371986456,0.01942700568381639 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441792,396.5669930722006,0 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441790,418.8057819624752,0.02369610452077131 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441811,120.26634398343955,0.5181724554157348 +967514 MM WT,MoneyMaker,1,m_94,fruit,2441808,423.63539635578616,0.028675675590299488 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441804,2246.669005086905,0.05906482880868902 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441792,2374.8948320672857,0.03495954021597525 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441790,2637.075477259789,0.010518637509314033 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441811,2721.3434884976105,0.02417943931730493 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441808,2548.6548590705406,0.004292895718608136 +967514 MM WT,MoneyMaker,1,m_94,leaf,2441813,2599.290378117872,0.004250876495703881 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441804,80.7873704587917,0.029995093919506166 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441792,63.37849397656673,0.075406463518495 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441790,75.39601264964546,0 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441811,134.20023665798388,0.25040490307080643 +967514 MM WT,MoneyMaker,1,m_97,fruit,2441808,43.48646432589267,0.2389942799110789 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441804,31.619594981548076,0.014934268163815156 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441792,33.83205007378549,0.014437744049748957 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441790,37.88471124264895,0.06357341052899379 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441811,13.947212476888916,0.37040315372292887 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441808,13.134707703467404,0.39647015832781585 +967514 MM WT,MoneyMaker,1,m_97,leaf,2441813,123.81242990488728,0.5778736761358236 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441804,2436.3167267305525,0.29790773807283744 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441792,387.6931621692539,0.5003378675051571 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441790,386.3456764605969,0.5018499523507107 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441811,2169.171426815552,0.24746786627101258 +967514 MM WT,MoneyMaker,1,m_98,fruit,2441808,1226.9475813193878,0 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441804,19835.41703266022,0.0666149362894366 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441792,29428.894553476533,0.10471767678600052 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441790,23737.553194572967,0.01137967889242475 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441811,22509.734540184625,0.011685898736833344 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441808,26420.88472910813,0.05789108421235145 +967514 MM WT,MoneyMaker,1,m_98,leaf,2441813,18191.675923064173,0.10418356144229701 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441804,11957.53344672836,0 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441792,10446.697204544413,0.05866259737387303 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441790,14210.175693865782,0.07495784323271337 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441811,8546.528473658966,0.14585186045855458 +967514 MM WT,MoneyMaker,1,m_99,fruit,2441808,22206.77095199103,0.2688438088105878 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441804,72063.45449331448,0.20330706495975193 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441792,50792.342290911285,0.05139022877289712 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441790,32393.680608445593,0.1439477161567302 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441811,26982.86981527294,0.22331987400359843 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441808,39455.74529265617,0.058297760696958356 +967514 MM WT,MoneyMaker,1,m_99,leaf,2441813,75986.80330595649,0.2263301625051115 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441797,86.38725136535811,0.10936948590883988 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441802,296.9729206843674,0.645636680104982 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441791,67.15528091250818,0 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441803,46.94507554736545,0.15549012781559668 +967514 MM WT,MoneyMaker,0.4,m_1,fruit,2441807,39.11149419361536,0.23477576229729502 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441797,3090.667308582087,0.2240511820428055 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441802,2211.267518247845,0.07864021013372424 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441791,18.77002471975493,1.992536231814722 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441803,14787.087898919412,0.9038815780659402 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441807,1478.7724658205198,0.09609972081508378 +967514 MM WT,MoneyMaker,0.4,m_1,leaf,2441796,6.035028040657453,2.4853217840855883 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441797,55.80130208431012,0.058133352731301935 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441802,48.81024418021904,0 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441791,40.96533050560953,0.07609451721309113 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441803,116.87279113985376,0.3792024356426016 +967514 MM WT,MoneyMaker,0.4,m_10,fruit,2441807,41.767518926731334,0.06767230220237797 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441797,328.7348293844026,0.0015171342405779775 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441802,320.4394503573762,0.012616876037301328 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441791,313.6366222786502,0.021936086108094166 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441803,362.1496987084632,0.04052527405748574 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441807,331.03560466345124,0.0015118528333304404 +967514 MM WT,MoneyMaker,0.4,m_10,leaf,2441796,331.80506230463914,0.0025201535438497125 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441797,223.42483936129696,0.8066222440073412 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441802,34.87459801264007,0 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441791,29.349297802208817,0.07491149537104058 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441803,9.331526866134077,0.5725564995840201 +967514 MM WT,MoneyMaker,0.4,m_100,fruit,2441807,92.62160305058951,0.42420308293587405 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441797,4843.017502213456,0.09194240776882268 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441802,3707.247149888469,0.024122090810936303 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441791,4201.033246163962,0.03018248769376397 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441803,3683.4720292059906,0.02691625443318646 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441807,4130.723383788819,0.02285248239614157 +967514 MM WT,MoneyMaker,0.4,m_100,leaf,2441796,3162.8887829948126,0.09308970974058983 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441797,36.137670384411024,0.11433979683438933 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441802,67.67868495919129,0.15815196232920403 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441791,54.64329082370257,0.06523689714205627 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441803,13.679061089484872,0.5362436600834894 +967514 MM WT,MoneyMaker,0.4,m_101,fruit,2441807,47.02187570462818,0 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441797,144.4727832830917,0.14535927780210844 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441802,38.20903433551938,0.4322606999770007 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441791,62.28256732951133,0.22006025561671771 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441803,245.00845165519223,0.37475430397444054 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441807,25.258853556198865,0.6120131267983684 +967514 MM WT,MoneyMaker,0.4,m_101,leaf,2441796,156.2960363138835,0.17952120260521331 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441797,84.30718270993552,0.16499585913038817 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441802,154.211606116562,0.09725662450173544 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441791,123.27086284434844,0 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441803,128.0434931797351,0.016497077835505358 +967514 MM WT,MoneyMaker,0.4,m_102,fruit,2441807,97.97919284788438,0.09972657845222033 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441797,571.3309408648989,0.004842372384463722 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441802,558.6610557684186,0.00489697409261991 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441791,583.378121192396,0.013904765600404545 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441803,593.4745801028605,0.021356749982394785 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441807,555.245272587799,0.007560502252588641 +967514 MM WT,MoneyMaker,0.4,m_102,leaf,2441796,556.9229890390836,0.006250226505983392 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441797,106095.48143909372,0.5124737797644867 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441802,43261.972962814405,0.1228832134443616 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441791,32600.413460220458,0 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441803,331.6788539443591,1.9925053239883983 +967514 MM WT,MoneyMaker,0.4,m_103,fruit,2441807,8630.263450591041,0.5771990547652064 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441797,875521.2236130465,0.02846247121214418 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441802,805464.9421411564,0.007757564617826063 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441791,826724.5300707578,0.0035566168238352347 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441803,813239.0475020146,0.003585984093644079 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441807,1130040.996837764,0.13928999245106777 +967514 MM WT,MoneyMaker,0.4,m_103,leaf,2441796,672659.9290045891,0.08600865000293911 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441797,104008.92765735544,0.5124737797644858 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441802,42411.1503635236,0.1228832134443616 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441791,31959.269133723355,0 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441803,325.1558073675121,1.9925053239883983 +967514 MM WT,MoneyMaker,0.4,m_104,fruit,2441807,8460.534178467744,0.5771990547652064 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441797,875521.2236130465,0.028475951814097122 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441802,805464.9421411564,0.0077440840158731206 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441791,826724.5300707578,0.003570097425788177 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441803,813188.1434403278,0.0035996886657061467 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441807,1130040.996837764,0.1393034730530207 +967514 MM WT,MoneyMaker,0.4,m_104,leaf,2441796,672659.9290045891,0.08599516940098617 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441797,52.25325720482072,0.01286995811573477 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441802,52.00252878455197,0.010781053825658526 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441791,48.01366029786801,0.023878593783063895 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441803,19.447463013971134,0.4163804550395793 +967514 MM WT,MoneyMaker,0.4,m_105,fruit,2441807,50.727494125034866,0 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441797,46.227442221866696,0.15186999924209998 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441802,62.02169359924022,0.02422624254947836 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441791,69.13783870400184,0.022945935374810267 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441803,43.42756648076844,0.1790043699047268 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441807,216.69934374655904,0.519087732400068 +967514 MM WT,MoneyMaker,0.4,m_105,leaf,2441796,102.22538004048288,0.19278887009199064 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441797,296.28968064351665,0.1899534868839834 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441802,353.7678403871529,0.2669553114136596 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441791,186.1023718810926,0.012011130724105534 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441803,184.3730215008512,0.01606566603676507 +967514 MM WT,MoneyMaker,0.4,m_106,fruit,2441807,191.32117480537693,0 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441797,3490.691405045201,0.018061102992960265 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441802,3206.309372065524,0.01884492919277747 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441791,3726.054311687696,0.04639882729952172 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441803,3755.5556788790536,0.04982385143239254 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441807,2950.7551289022585,0.054917182994357994 +967514 MM WT,MoneyMaker,0.4,m_106,leaf,2441796,3191.9894973870923,0.02078889994656663 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441797,750.5290655705924,0.012196179010491637 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441802,480.4646199778105,0.18150992372441177 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441791,729.7453506926178,0 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441803,622.1419046927903,0.06928188225993637 +967514 MM WT,MoneyMaker,0.4,m_107,fruit,2441807,965.7808170913072,0.12170723821727503 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441797,19324.054520308073,0.0422022645447937 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441802,18162.31084467225,0.015275114698654058 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441791,23480.886659920063,0.12681850266824313 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441803,15918.2891492685,0.04199960035604189 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441807,15014.809022983376,0.06737617690411568 +967514 MM WT,MoneyMaker,0.4,m_107,leaf,2441796,16906.899361258587,0.01583202205995171 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441797,513.0124702330126,0.2101960499207962 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441802,441.32167844827376,0.14482338914511628 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441791,181.13410077076168,0.24193165268157557 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441803,316.17816315757574,0 +967514 MM WT,MoneyMaker,0.4,m_108,fruit,2441807,72.20014428793294,0.6413938066032181 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441797,303.45489412551854,0.03746419422716052 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441802,426.9140965496897,0.11078215486939236 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441791,358.1341977863145,0.03448745280985399 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441803,500.2668629575786,0.17964339630186021 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441807,90.92497268645944,0.560875161152429 +967514 MM WT,MoneyMaker,0.4,m_108,leaf,2441796,225.9680499164938,0.16551130271320202 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441797,34.70379930609792,0.1843469204831114 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441802,22.700221905328704,0 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441791,19.578072200916093,0.06426017686071184 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441803,5.297717733607774,0.6319412876059336 +967514 MM WT,MoneyMaker,0.4,m_109,fruit,2441807,61.18885667718039,0.43064223576958716 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441797,805.0279608116714,0.03263580788529774 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441802,1265.0079569410032,0.16364648450251718 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441791,866.9209152489798,4.6729192033678757e-4 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441803,1284.9377771258366,0.1704353248022885 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441807,868.7874973804097,4.667896642214231e-4 +967514 MM WT,MoneyMaker,0.4,m_109,leaf,2441796,650.7443714444639,0.12503635233822052 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441797,4045.8855453635897,0.13062318046284416 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441802,2994.955765080098,0 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441791,2357.8794872372346,0.10386880807555166 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441803,2553.7035841507163,0.06921992630568052 +967514 MM WT,MoneyMaker,0.4,m_11,fruit,2441807,5171.772092782581,0.23724896601845913 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441797,7610.048712816869,0.03189591927495261 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441802,37561.78093493465,0.6614628194726397 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441791,8849.728046529835,0.03364656894383611 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441803,8769.930704031827,0.029712805759404937 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441807,2180.206559047714,0.5747857141607464 +967514 MM WT,MoneyMaker,0.4,m_11,leaf,2441796,4227.135150728352,0.28723722263188733 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441797,1048.6521174549018,0.1704631261692806 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441802,1279.7308817768717,0.2569503382851366 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441791,449.49550491473684,0.19744295893023045 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441803,708.2202037778204,0 +967514 MM WT,MoneyMaker,0.4,m_110,fruit,2441807,528.9401913017925,0.12676174399109597 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441797,3568.9042117958784,0.02684546790059006 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441802,6466.8305695367535,0.28500205872237805 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441791,3141.0478828281416,0.028614866961755858 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441803,4597.775576221991,0.13685834504514904 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441807,2422.2793668262193,0.14146519405490476 +967514 MM WT,MoneyMaker,0.4,m_110,leaf,2441796,2824.848866970863,0.07469420642531288 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441797,93.6334766233467,0.004931681155590395 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441802,882.046729905152,0.9691287639533723 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441791,107.61843904104836,0.055523858250974056 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441803,53.74622810610623,0.24601483924858125 +967514 MM WT,MoneyMaker,0.4,m_111,fruit,2441807,94.70280231790892,0 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441797,18198.39204385411,0.09941933122198598 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441802,23675.98111027716,0.014855636875898526 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441791,20300.718849326084,0.051940931353369635 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441803,28278.981482842923,0.09201141560332893 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441807,23308.877678069304,0.008069014829446886 +967514 MM WT,MoneyMaker,0.4,m_111,leaf,2441796,22450.73539789719,0.008221776571613049 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441797,763.9732028573285,0 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441802,1359.370318935914,0.250259657602109 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441791,629.1754007398664,0.08430639111605265 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441803,537.61744046958745,0.1526047766026304 +967514 MM WT,MoneyMaker,0.4,m_112,fruit,2441807,974.0633066642026,0.10550905809621725 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441797,267654.29739250743,0.013030976329367228 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441802,21636.27487441227,1.0793607541467525 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441791,145659.4152280414,0.2512046822927161 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441803,646047.2395764196,0.3957210308005621 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441807,371572.2209456142,0.15549999393843628 +967514 MM WT,MoneyMaker,0.4,m_112,leaf,2441796,251830.9754605316,0.013434096662224171 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441797,512.6370147245732,0.09428039088822704 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441802,359.33202336355805,0.06003364724611915 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441791,307.69914385609457,0.12740328226383157 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441803,412.6003291839858,0 +967514 MM WT,MoneyMaker,0.4,m_12,fruit,2441807,757.7112022175687,0.2639741379003788 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441797,1419.12130574649,0.11408283498486416 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441802,2679.4522570062686,0.39010933778192136 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441791,763.441153787737,0.1551611181561392 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441803,1847.256277057914,0.22859046566066787 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441807,147.79924401139283,0.868264472662843 +967514 MM WT,MoneyMaker,0.4,m_12,leaf,2441796,446.7408827999092,0.38788098724705034 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441797,65.11517912444901,0 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441802,77.92882202737611,0.07801587189961423 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441791,22.87168295641822,0.4543841173191647 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441803,224.50387445385152,0.5375416008016565 +967514 MM WT,MoneyMaker,0.4,m_120,fruit,2441807,39.022871503332446,0.2223630157375689 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441797,195.18329666457865,0.03914986723042446 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441802,129.98558363218677,0.21569732774313133 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441791,195.4240842477699,0.038614430692115675 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441803,247.65265104693245,0.06425046510152255 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441807,438.16115536819177,0.3120413568612941 +967514 MM WT,MoneyMaker,0.4,m_120,leaf,2441796,231.76732636022896,0.035459694593472424 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441797,55.9266563872575,0 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441802,40.75732520224075,0.13741318087002052 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441791,112.55351493674272,0.3037402066254966 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441803,18.466325882937507,0.4812383600491845 +967514 MM WT,MoneyMaker,0.4,m_121,fruit,2441807,98.38727196668584,0.2453200633192576 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441797,797.3586693977884,0.054819985821925155 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441802,1222.5769264995756,0.1308024888191417 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441791,1011.9126633478636,0.04866932448000716 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441803,627.8652186442188,0.1586072808862924 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441807,4914.651491899347,0.7350190201991231 +967514 MM WT,MoneyMaker,0.4,m_121,leaf,2441796,624.2972248097414,0.16108230197602458 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441797,209.5862717399116,0.23029737923535665 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441802,356.17235795970566,0 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441791,502.8750091640712,0.14979984204801866 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441803,231.23240528270276,0.1876115147019588 +967514 MM WT,MoneyMaker,0.4,m_122,fruit,2441807,712.3651881371787,0.30104247676091767 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441797,10105.18223677906,0.03438450823394845 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441802,20978.108488164347,0.28283766881340267 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441791,12486.981537758924,0.057528811385974876 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441803,10648.983777213873,0.011620492792483894 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441807,8896.928635964916,0.08968855119948183 +967514 MM WT,MoneyMaker,0.4,m_122,leaf,2441796,11226.549747772227,0.0113176469526719 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441797,122.69567929827409,0 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441802,149.78664777104146,0.08664383195173908 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441791,53.98484503158192,0.3565574103818363 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441803,1889.3475846226147,1.1874825933273798 +967514 MM WT,MoneyMaker,0.4,m_123,fruit,2441807,30.17340966455704,0.6092048801888561 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441797,212.9948749864744,0.16255286252641055 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441802,302.02477590749595,0.010879445471100091 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441791,317.34785676904,0.01061355338365022 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441803,340.4617377854029,0.04114629530481784 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441807,420.1889684863319,0.1325226301460125 +967514 MM WT,MoneyMaker,0.4,m_123,leaf,2441796,236.1769222541795,0.11768455745386186 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441797,15030.920368405246,0.07026731321607738 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441802,27909.653975429163,0.3390361913655813 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441791,5707.382932625418,0.35028124857012344 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441803,12785.51602111496,0 +967514 MM WT,MoneyMaker,0.4,m_13,fruit,2441807,9265.300942251351,0.1398587307467265 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441797,237944.4253672356,0.08080906938220256 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441802,160444.33918509673,0.09034206621554564 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441791,248349.8886475352,0.09939750451549934 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441803,234646.0458369973,0.07474677495867077 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441807,124138.15998379784,0.2017611612485215 +967514 MM WT,MoneyMaker,0.4,m_13,leaf,2441796,153009.19524653346,0.11094893411157791 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441797,1122.0798547800343,1.2011222526370504 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441802,39.108025164805085,0.25663562674318663 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441791,70.61573970035849,0 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441803,109.61886208488328,0.19098377678914846 +967514 MM WT,MoneyMaker,0.4,m_14,fruit,2441807,15.88460081784876,0.647925207289459 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441797,110.20356463262004,0.13667969830128213 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441802,50.69269189097978,0.20057059027726543 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441791,11.289846682616622,0.8528278998868977 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441803,156.43224642809844,0.2888103379022553 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441807,352.89993711779977,0.6421356368901527 +967514 MM WT,MoneyMaker,0.4,m_14,leaf,2441796,5.871068303876143,1.1367988111049134 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441797,51.59976743263616,0.03429721158412291 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441802,37.33598718677046,0.10622289378871219 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441791,50.914279110119644,0.028489066396038654 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441803,16.656676237582793,0.45676218835322535 +967514 MM WT,MoneyMaker,0.4,m_15,fruit,2441807,47.681568434409435,0 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441797,600.9005704735414,0.009095998300229002 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441802,527.9759843760048,0.06528444604220462 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441791,674.4416294683828,0.04104575436948865 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441803,626.3369096993131,0.008909390579775245 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441807,1014.3074158838676,0.21827098612755513 +967514 MM WT,MoneyMaker,0.4,m_15,leaf,2441796,437.9418290850911,0.1464821867276518 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441797,8.099708309379078,0.26619659804835516 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441802,34.74196186290444,0.36618836203164085 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441791,19.914403583884692,0.12450132707720596 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441803,4.7465304204435235,0.498289708579958 +967514 MM WT,MoneyMaker,0.4,m_16,fruit,2441807,14.95085319808198,0 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441797,28.55879485069506,0.1069550030965789 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441802,315.56380165001576,0.9363922995938545 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441791,60.895045689081634,0.2218870808111666 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441803,11.06940024751878,0.518570788888834 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441807,13.418717880415375,0.43498385760764013 +967514 MM WT,MoneyMaker,0.4,m_16,leaf,2441796,44.50881068351905,0.08575110984395984 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441797,34606.661242310605,0 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441802,7724.277530738085,0.651301832305653 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441791,34418.23759793035,0.0023710734431485747 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441803,35525.27199659606,0.0113777100050525 +967514 MM WT,MoneyMaker,0.4,m_17,fruit,2441807,52209.0508445382,0.17858609610058007 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441797,80939.52403482923,0.23375165389537056 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441802,42878.23388627209,0.0421721034214908 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441791,37011.718692284405,0.10606973964635014 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441803,60406.409398404096,0.10667402941447257 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441807,46570.467180848245,0.00629839763184048 +967514 MM WT,MoneyMaker,0.4,m_17,leaf,2441796,47931.09503985503,0.006208358754372867 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441797,125.27215551361222,0.015923842694197443 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441802,120.76211416388506,0 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441791,40.008378502873306,0.4797797573036031 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441803,131.9408998414258,0.03844873411291028 +967514 MM WT,MoneyMaker,0.4,m_18,fruit,2441807,67.74793459987573,0.25103464793263774 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441797,321.24147552233586,0.3677102327915782 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441802,1304.1899945926016,0.24079901926287883 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441791,1461.393903920137,0.2902254465639249 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441803,939.5149238085552,0.09836183825403566 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441807,558.692140418487,0.12736928300098382 +967514 MM WT,MoneyMaker,0.4,m_18,leaf,2441796,237.18283595272595,0.4994585872876476 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441797,3.807844814306266,0.07243181250021802 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441802,5.089497208102285,0.19842745221812708 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441791,3.2229044362381325,0 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441803,2.9456349720316117,0.03906850089699404 +967514 MM WT,MoneyMaker,0.4,m_19,fruit,2441807,2.949545733183361,0.03849229388237635 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441797,1018.426519492788,0.11893138231846745 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441802,1615.1013176564068,0.08133868944935863 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441791,1712.106373771659,0.10666966205114603 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441803,1637.3957079900108,0.08729256566692323 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441807,1063.3951480895594,0.1001664075526354 +967514 MM WT,MoneyMaker,0.4,m_19,leaf,2441796,959.7137502890292,0.14471936479914937 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441797,0.47520812004297247,0.9999134625911513 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441802,3.518270332889889,0.1304681093320268 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441791,437.5138387621405,1.9641944789426087 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441803,4.751134396262259,0 +967514 MM WT,MoneyMaker,0.4,m_2,fruit,2441807,30.728523157820135,0.8107443725848354 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441797,968.3227317360156,0.43200525408452295 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441802,100.36122145159098,0.5524489348339214 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441791,315.8709025471065,0.05450525178266785 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441803,473.3196549385896,0.12113966611992133 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441807,400.3464992546123,0.048421162150660724 +967514 MM WT,MoneyMaker,0.4,m_2,leaf,2441796,208.8435871894199,0.2341937288767708 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441797,22.25905318797211,0 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441802,14.653103976519226,0.18157705590594908 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441791,58.43266263078503,0.4191489892550553 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441803,102.55914925906572,0.6634677224396768 +967514 MM WT,MoneyMaker,0.4,m_20,fruit,2441807,20.74949331021947,0.03049919124789313 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441797,61.071491890191915,0.3732482519241529 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441802,9.864809821055005,0.41850156028785024 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441791,8.730259380590363,0.47156313038704667 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441803,51.461460845470455,0.2988918330411692 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441807,19.08575891306551,0.13188084378415366 +967514 MM WT,MoneyMaker,0.4,m_20,leaf,2441796,32.62968692299035,0.10102262941528295 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441797,21500.588636417237,0.17814558448098072 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441802,14266.083629425695,0 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441791,17942.4241386481,0.09957635311581203 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441803,10526.681468522913,0.1320132839499557 +967514 MM WT,MoneyMaker,0.4,m_21,fruit,2441807,10119.164951392831,0.14916009022335164 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441797,635346.8376465363,0.06901575907463897 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441802,483856.05832026375,0.04927893036222741 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441791,513819.3108517335,0.023184691236229682 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441803,693473.0720623676,0.10703448829872642 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441807,570170.2734008934,0.02200945748652927 +967514 MM WT,MoneyMaker,0.4,m_21,leaf,2441796,436482.98429858807,0.09402779556038343 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441797,118.72463565945984,0.4947521506114374 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441802,42.431640949689395,0.04790113258043016 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441791,24.016906013215593,0.19927163636431855 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441803,38.00044609231445,0 +967514 MM WT,MoneyMaker,0.4,m_22,fruit,2441807,24.135591004790353,0.1971307570954537 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441797,69.31491846207679,0.19209059418630936 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441802,20.137923879629433,0.3447214275984327 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441791,44.82210826828292,0.0027561577955350636 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441803,22.382452365780612,0.29882845360766996 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441807,44.255001679895635,0.0027737609403590824 +967514 MM WT,MoneyMaker,0.4,m_22,leaf,2441796,56.82756521560385,0.10582292652964709 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441797,2564.89128482401,0.2856348448600152 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441802,2992.3612531120652,0.3525799055785064 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441791,1140.6737163676917,0.06627268246173879 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441803,1162.327334305821,0.058105665851259314 +967514 MM WT,MoneyMaker,0.4,m_23,fruit,2441807,1328.7219731737207,0 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441797,182920.6602965181,0.015029021197295656 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441802,164486.92172359678,0.03110236609319017 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441791,235389.97710253455,0.12455422745086775 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441803,170477.0528744064,0.015567810309351948 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441807,184384.83423999156,0.0184914580069675 +967514 MM WT,MoneyMaker,0.4,m_23,leaf,2441796,159695.29913103284,0.04394160698375238 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441797,119.88654878538082,0.06107851854839064 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441802,262.40721277435614,0.40128382865267476 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441791,52.83980571495984,0.2947307275448794 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441803,104.15783391364396,0 +967514 MM WT,MoneyMaker,0.4,m_24,fruit,2441807,94.97108180329454,0.040100554622184426 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441797,156.7563889080992,0.022785758258089928 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441802,61.0778794630657,0.4321270580677814 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441791,173.64434572970077,0.0216496375938533 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441803,87.89599976098596,0.27404189830163395 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441807,388.0157908873808,0.37083839159391996 +967514 MM WT,MoneyMaker,0.4,m_24,leaf,2441796,186.87065068448433,0.053530089183469354 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441797,59.39739747948158,0.12922949663576455 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441802,79.98285701996537,0 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441791,84.67088623704265,0.024737192239548733 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441803,30.425578228979106,0.4197580726321577 +967514 MM WT,MoneyMaker,0.4,m_25,fruit,2441807,99.32128582324032,0.09404542008953554 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441797,6037.415396619602,0.10952262830315851 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441802,4692.1648025762815,4.4827753197917986e-5 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441791,4691.196204727151,4.483238078334395e-5 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441803,4053.633396581192,0.06348396034305415 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441807,6206.98488464021,0.12155225813215287 +967514 MM WT,MoneyMaker,0.4,m_25,leaf,2441796,4355.748455464534,0.03226563835751728 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441797,315.5522259834861,0 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441802,683.1026000206766,0.33541469020444303 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441791,171.57958234434537,0.2646056418019054 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441803,336.02246250870974,0.02729706203771398 +967514 MM WT,MoneyMaker,0.4,m_26,fruit,2441807,204.66509940206976,0.18802745740636917 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441797,5245.784501018256,0.07869988530666738 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441802,4418.567409604636,0.004170924652342034 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441791,3637.270747010924,0.08033493054322749 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441803,5893.730641873132,0.1292797233126648 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441807,4124.731531936969,0.02571487361253011 +967514 MM WT,MoneyMaker,0.4,m_26,leaf,2441796,4334.1026169175075,0.004211370585803564 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441797,113.08636202774666,0 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441802,198.74096851411625,0.2448771688120721 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441791,109.17244841932589,0.01529718272950742 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441803,199.69458882125068,0.2469560637320134 +967514 MM WT,MoneyMaker,0.4,m_27,fruit,2441807,50.03499426855038,0.3541363787291658 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441797,522.92585861332,0.02844796999115351 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441802,628.0675331377134,0.10801419571079895 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441791,372.1178383261103,0.11931165874582428 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441803,587.0968275841295,0.07871758547236185 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441807,123.04742679320007,0.5999196121432893 +967514 MM WT,MoneyMaker,0.4,m_27,leaf,2441796,456.61407037193226,0.030442858209636547 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441797,72.73298180997115,0.06005491276467456 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441802,224.7647859517203,0.5500517912228045 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441791,63.33976967541679,0 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441803,18.330499320424337,0.5385021845500895 +967514 MM WT,MoneyMaker,0.4,m_28,fruit,2441807,23.761834565781133,0.42579651188030776 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441797,211.8083086466914,0.008946961061440994 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441802,305.60725765452435,0.15027371046100413 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441791,168.11028331129722,0.10929567326407508 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441803,317.8252393414477,0.16729842938921058 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441807,220.6258069395996,0.008766357845109152 +967514 MM WT,MoneyMaker,0.4,m_28,leaf,2441796,103.6120619184362,0.3194796369130519 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441797,1287683.7280268571,0.12027013908036466 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441802,1112218.1573581763,0.05665091217780027 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441791,976200.5963659228,0 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441803,586841.169347521,0.22101849483002667 +967514 MM WT,MoneyMaker,0.4,m_29,fruit,2441807,241203.24059826063,0.6071559303207037 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441797,1623432.650724286,0.025318832940654623 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441802,1695467.0989181604,0.04417392319750224 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441791,1399784.0745015258,0.03905439518584153 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441803,1439556.3626432992,0.026886769988690773 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441807,2259933.7059972216,0.1689802561521878 +967514 MM WT,MoneyMaker,0.4,m_29,leaf,2441796,1089554.460376358,0.14786650044035454 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441797,103.16162383226158,0 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441802,47.62772890829937,0.33565829659613566 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441791,110.0452313094096,0.028053058014997134 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441803,17.93993223001948,0.7596973714842934 +967514 MM WT,MoneyMaker,0.4,m_3,fruit,2441807,109.95754050257489,0.02770684750841923 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441797,14.081772065286012,0.02334102605450661 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441802,148.9039061341052,1.0009077541851368 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441791,82.325493428622,0.7435360060099787 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441803,12.372363788478884,0.0795456551673468 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441807,9.506071357000078,0.19399726639492187 +967514 MM WT,MoneyMaker,0.4,m_3,leaf,2441796,15.636826939557617,0.02215029325880269 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441797,209.29658101919043,0 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441802,435.4066318528226,0.3181329057238109 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441791,193.9558997070492,0.03305913953574047 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441803,658.427190903345,0.49774562358049756 +967514 MM WT,MoneyMaker,0.4,m_30,fruit,2441807,189.8600164606083,0.04232861975469815 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441797,7535.909713492771,0.030459451473473287 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441802,8488.998142475666,0.021261300473568223 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441791,8108.490201407502,0.0013448581505470791 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441803,8058.349557785197,0.0013490356455725383 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441807,9149.768092503746,0.05381494861990177 +967514 MM WT,MoneyMaker,0.4,m_30,leaf,2441796,6884.93649438376,0.0696951993333994 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441797,211.0421915209963,0.04977988951604795 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441802,188.18690448713505,0 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441791,114.68449520984532,0.2150846911924087 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441803,45.00388686568356,0.6213393742933748 +967514 MM WT,MoneyMaker,0.4,m_31,fruit,2441807,259.1476617864572,0.13895789613643972 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441797,737.7805216804719,6.296409078752063e-4 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441802,1370.2895226692735,0.2695147928711217 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441791,1105.0315466152597,0.17607713228356436 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441803,735.6428006806929,6.305550879170951e-4 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441807,512.6376041994014,0.1574870838149267 +967514 MM WT,MoneyMaker,0.4,m_31,leaf,2441796,710.0474397472425,0.016010178415411414 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441797,46.356454079850366,0.17548953109917664 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441802,94.05057743845413,0.13176172691538812 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441791,69.43840545717566,0 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441803,35.503235993148714,0.2913318001491423 +967514 MM WT,MoneyMaker,0.4,m_32,fruit,2441807,81.88587970231058,0.07160927962542107 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441797,4025.844616463388,0.0055596862715980855 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441802,3001.2124131353603,0.13311996085675082 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441791,4129.582118727159,0.0054894117915362806 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441803,4503.228637027297,0.043107302537576775 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441807,4841.497295268084,0.07456299867003979 +967514 MM WT,MoneyMaker,0.4,m_32,leaf,2441796,2467.0063820397368,0.21824642190566035 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441797,86.16584667308494,0.12294974744176246 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441802,481.19253390412536,0.8699334679424524 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441791,50.549344523418384,0.10866988390417998 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441803,64.92103162435141,0 +967514 MM WT,MoneyMaker,0.4,m_33,fruit,2441807,5.2780190314129865,1.0899144604831057 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441797,919.12384920998,0.04598108254711564 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441802,1069.1866852678827,0.01969842401955857 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441791,974.3625866745008,0.020634518087906173 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441803,2062.130305722515,0.30496098705314134 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441807,1467.0382374251192,0.15708631583381516 +967514 MM WT,MoneyMaker,0.4,m_33,leaf,2441796,833.2925190100658,0.08855763485935242 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441797,526.2984940035761,0 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441802,626.7096710350685,0.07583426925163339 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441791,521.0287724249928,0.004370420574181466 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441803,545.0326596957673,0.015190399757586626 +967514 MM WT,MoneyMaker,0.4,m_34,fruit,2441807,463.7092487652764,0.05498636922634592 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441797,19227.09756823012,0.09476797098550716 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441802,24356.98005233404,0.00794173932105302 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441791,25304.907213275128,0.024523048069699627 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441803,30732.91566998147,0.10892206313979091 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441807,23474.26621626761,0.008089675620797543 +967514 MM WT,MoneyMaker,0.4,m_34,leaf,2441796,19862.107325822537,0.0806563768379851 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441797,485.4960710869964,0.37179229079276244 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441802,974.5270359069948,0.674400463170715 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441791,69.34381809221475,0.47338567853703317 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441803,90.76325146987456,0.35648338340520946 +967514 MM WT,MoneyMaker,0.4,m_35,fruit,2441807,206.24974909817468,0 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441797,2018.2827103551165,0.3759002415721113 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441802,6070.238819064762,0.1023235362862489 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441791,6520.846247808823,0.1334217188824698 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441803,11335.512035114803,0.3735589009664442 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441807,3521.828919679488,0.13411398603872948 +967514 MM WT,MoneyMaker,0.4,m_35,leaf,2441796,2775.927432007811,0.23747413275320461 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441797,3542.275400103297,0.18128692636267907 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441802,3314.210864196953,0.152384739873074 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441791,1259.7144625645662,0.26772328130584233 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441803,1210.296186920869,0.28510373172128034 +967514 MM WT,MoneyMaker,0.4,m_36,fruit,2441807,2333.4333292269257,0 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441797,2211.016206791114,0.3562601058550423 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441802,5373.233041552259,0.029383644855039304 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441791,6332.05787137304,0.10069284357835873 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441803,10194.890314797703,0.30753052580179663 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441807,4670.19627615003,0.03151689862000451 +967514 MM WT,MoneyMaker,0.4,m_36,leaf,2441796,3205.5021152209483,0.19495596403369397 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441797,875.4717437038321,0.20960372925093385 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441802,983.5985510448854,0.26017947598158697 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441791,377.46823300881897,0.15575799619376607 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441803,377.8242496119153,0.155348575840196 +967514 MM WT,MoneyMaker,0.4,m_37,fruit,2441807,540.3042756693734,0 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441797,116.6159617284424,0.3640993216502535 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441802,358.85331200581464,0.12405963897429562 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441791,277.8931290021022,0.013020488941812847 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441803,338.9706041988615,0.09930471757605774 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441807,261.47752727240754,0.013422950597166583 +967514 MM WT,MoneyMaker,0.4,m_37,leaf,2441796,147.65737245275406,0.26160218396507817 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441797,169.3651668805152,0.1974888649716151 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441802,112.34735762076664,0.01922763297669894 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441791,107.48187386214862,0 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441803,58.7011142556483,0.2626888843728641 +967514 MM WT,MoneyMaker,0.4,m_38,fruit,2441807,6.14824830788437,1.2425838304778742 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441797,16.261662196498488,0.4499912115457545 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441802,41.63509759942282,0.041696559716645654 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441791,50.0262298453784,0.03804162737088146 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441803,67.03786207067374,0.1651640088277755 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441807,168.72224184090325,0.5660161905449737 +967514 MM WT,MoneyMaker,0.4,m_38,leaf,2441796,18.132570207968907,0.40269677907576407 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441797,155.60529972724856,1.3325158061617457 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441802,799.160124790341,0.6219063845798471 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441791,90481.67492031475,1.4320204406751644 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441803,10278.7820695529,0.48740146764853076 +967514 MM WT,MoneyMaker,0.4,m_39,fruit,2441807,3346.109820895748,0 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441797,2131.4493932232135,0.02367788435175422 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441802,2818.0111352779227,0.14494556353102572 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441791,1562.8691858712573,0.11107451280334457 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441803,3825.683195287372,0.2777118619210328 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441807,1905.2567632654257,0.025043629389445154 +967514 MM WT,MoneyMaker,0.4,m_39,leaf,2441796,1523.2285189522215,0.12223207906372346 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441797,28.560935720157865,0.16929885474823636 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441802,24.887416333027463,0.22909147352562753 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441791,129.31787762804285,0.4865872817892358 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441803,205.5050318828836,0.6877511736930717 +967514 MM WT,MoneyMaker,0.4,m_4,fruit,2441807,42.17657277799863,0 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441797,115.1626145799954,0.11111584082080839 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441802,211.0981378655132,0.15205704524598218 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441791,96.16710900369624,0.18940079670088616 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441803,173.96051981664232,0.0680233396344394 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441807,428.0258296152044,0.45904262061765433 +967514 MM WT,MoneyMaker,0.4,m_4,leaf,2441796,123.51919245214972,0.08069291343299856 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441797,268.8358524788721,0.09288422217944481 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441802,332.94416554203775,0 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441791,383.0218269671235,0.0608521146846126 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441803,646.3883535172758,0.2881221140236163 +967514 MM WT,MoneyMaker,0.4,m_40,fruit,2441807,144.0218790965019,0.36394293579950654 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441797,7664.563488345172,1.5048729552669116e-4 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441802,8027.7096788097715,0.02025471919799715 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441791,7836.267681794439,0.009772324100567609 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441803,7559.20629051588,0.005860741305096617 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441807,7659.2527157412605,1.5053945892518072e-4 +967514 MM WT,MoneyMaker,0.4,m_40,leaf,2441796,7042.548136668167,0.03660711456858268 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441797,232.11869726398737,0.07641566695358204 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441802,240.01905134536193,0.09095125737795762 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441791,194.6679509276906,0 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441803,164.6223833874541,0.07280557245160457 +967514 MM WT,MoneyMaker,0.4,m_41,fruit,2441807,116.72495108240189,0.222130756927561 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441797,791.0450766227807,0.16780480096057637 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441802,1441.1655092009007,0.09270782694940571 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441791,1255.7189688482058,0.03288642189860225 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441803,1245.7013469245016,0.029407901192064934 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441807,760.8382549168432,0.18471369205358723 +967514 MM WT,MoneyMaker,0.4,m_41,leaf,2441796,1082.5830541725825,0.031544808106408695 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441797,46.905131339619096,0 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441802,38.51477921214966,0.08559294378343085 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441791,40.90888609456776,0.05940270209067822 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441803,47.28837207287629,0.003534007082917734 +967514 MM WT,MoneyMaker,0.4,m_42,fruit,2441807,49.4406743852793,0.02286402965160672 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441797,164.2615760494951,0.013223926863812796 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441802,161.94540180365345,0.007056562785602516 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441791,141.6455237043175,0.051109204139748954 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441803,172.48517835832726,0.034439723515804044 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441807,136.3665544622656,0.06760419116141625 +967514 MM WT,MoneyMaker,0.4,m_42,leaf,2441796,156.7252394328688,0.0071731166029120885 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441797,9732.76081256171,1.2150773880276047 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441802,1699.291699483999,0.45710927354575315 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441791,181.11429061626384,0.5152059432998288 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441803,419.2313404929717,0.1507049207179172 +967514 MM WT,MoneyMaker,0.4,m_43,fruit,2441807,593.141979846147,0 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441797,263.0664163881822,0.008147882926106131 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441802,248.1457969641907,0.03350636798713058 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441791,309.84524290639115,0.06293154115438648 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441803,273.0304729453075,0.007997829771847265 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441807,479.6177430278622,0.2526819494546828 +967514 MM WT,MoneyMaker,0.4,m_43,leaf,2441796,219.8143699014508,0.0861572115012752 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441797,232283.64270452037,0.04078867529041119 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441802,277231.6026738611,0.1176127828333664 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441791,187764.7792253701,0.05161582185026781 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441803,211460.8398732934,0 +967514 MM WT,MoneyMaker,0.4,m_44,fruit,2441807,51560.29732337546,0.612914539735514 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441797,382459.5012458952,0.13354975987070805 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441802,700625.4962960399,0.12935072335773512 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441791,547922.2342558529,0.02258370990393832 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441803,492393.6026632952,0.023822812417090056 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441807,656656.6047206533,0.10120310258178744 +967514 MM WT,MoneyMaker,0.4,m_44,leaf,2441796,344494.04515684274,0.17895349502274804 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441797,341603.7409762625,0.13018472788898094 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441802,253126.6608994771,0 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441791,261380.4207431377,0.013935162503576848 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441803,209084.54045982883,0.08301596758115615 +967514 MM WT,MoneyMaker,0.4,m_45,fruit,2441807,67790.28970546885,0.5721704003122303 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441797,88313.51688143938,0.20861638902715374 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441802,209649.8044640108,0.1668508927723824 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441791,158981.06718308022,0.04670183901111091 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441803,126563.27839374448,0.0523358529944602 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441807,162970.51487664937,0.05746546871676994 +967514 MM WT,MoneyMaker,0.4,m_45,leaf,2441796,84879.24679722366,0.22584205184873518 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441797,36463.060260507635,0.1912200423017545 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441802,23476.484992954087,0 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441791,30663.599717931676,0.11599006413054092 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441803,11940.342360299464,0.29361629356984675 +967514 MM WT,MoneyMaker,0.4,m_46,fruit,2441807,17945.916633212004,0.11666742695250498 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441797,175061.69490772896,0.028578865737610926 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441802,309172.4032072249,0.2755884586056867 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441791,237387.0570841371,0.16084477332453595 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441803,152763.44771102868,0.030592811771630757 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441807,75234.71531441968,0.33819398119960553 +967514 MM WT,MoneyMaker,0.4,m_46,leaf,2441796,131623.8859938314,0.09527755462184384 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441797,500.2374559390145,0 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441802,399.6143920042281,0.0975350861499793 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441791,465.1775380799713,0.03155747109821938 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441803,505.1729434385804,0.00426387514093074 +967514 MM WT,MoneyMaker,0.4,m_47,fruit,2441807,985.5236485716644,0.29449084306330686 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441797,1986.2784452309515,0.05546108681430395 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441802,3262.639424490355,0.27099003681165224 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441791,2122.122188352742,0.08419134333742218 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441803,1510.0243594690858,0.06359508960139193 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441807,1157.9525332471126,0.1788882857486147 +967514 MM WT,MoneyMaker,0.4,m_47,leaf,2441796,704.4827762327127,0.3947086633286867 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441797,313.0985963880113,0.30538763051988393 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441802,240.13176052106627,0.19015611472836014 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441791,70.1528416350712,0.34424822276978606 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441803,125.6273974383888,0.09120912737272713 +967514 MM WT,MoneyMaker,0.4,m_48,fruit,2441807,154.98636413880791,0 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441797,5542.420671881831,0.25127228317715566 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441802,3595.812869603968,0.06336987980582709 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441791,2394.867037151749,0.11314579621891063 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441803,4826.964175389428,0.19124687295760978 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441807,2619.417038565842,0.0742225544899271 +967514 MM WT,MoneyMaker,0.4,m_48,leaf,2441796,1932.100681079722,0.20639744903972534 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441797,30.762937040772012,0 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441802,30.27050005080588,0.007008201355070742 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441791,34.26419722808618,0.046812764577845334 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441803,23.314373268505907,0.12040405131418197 +967514 MM WT,MoneyMaker,0.4,m_49,fruit,2441807,32.94382291173078,0.029746198087157394 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441797,31.23393217207173,0.0038851895622256105 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441802,32.80073219222194,0.025142065047842443 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441791,29.78740698588401,0.016708774053232123 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441803,30.677588165333063,0.003920260367384243 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441807,30.193915338567123,0.010822040296478708 +967514 MM WT,MoneyMaker,0.4,m_49,leaf,2441796,32.01962923675006,0.01467482552607291 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441797,581.6774221295932,0.19530387448130915 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441802,1038.4352661086384,0.4470010962434334 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441791,209.08087753550782,0.24906401824676028 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441803,248.95775043134623,0.1732526813920745 +967514 MM WT,MoneyMaker,0.4,m_5,fruit,2441807,371.0037782730722,0 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441797,38346.53001528359,0.00331014047289635 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441802,42247.0581174799,0.04538054195296404 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441791,47261.52454178647,0.09409179660486622 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441803,37764.2067247963,0.0033355638647893926 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441807,29502.43708225277,0.11055803735280811 +967514 MM WT,MoneyMaker,0.4,m_5,leaf,2441796,29810.507873762577,0.10604655514447892 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441797,49.049340851615376,0 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441802,110.73696479795368,0.35365944021300466 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441791,155.17319214776987,0.5001835188203256 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441803,24.746575779999542,0.29711806203709346 +967514 MM WT,MoneyMaker,0.4,m_50,fruit,2441807,46.8693909583013,0.019743865357913837 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441797,9883.916110381546,0.03520798837906858 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441802,7127.0054341878795,0.10681397236020063 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441791,9829.24361138269,0.032799036608774035 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441803,8909.389736572877,0.009873104962673906 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441807,9319.1155257419,0.009653633262798333 +967514 MM WT,MoneyMaker,0.4,m_50,leaf,2441796,6088.888552488429,0.17518303724641981 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441797,54.072823027468104,0 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441802,54.66700850922644,0.0047462652956140605 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441791,55.36152960201561,0.010229037118570927 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441803,15.37952332563312,0.5460361686510995 +967514 MM WT,MoneyMaker,0.4,m_51,fruit,2441807,36.61211990576992,0.1693541677422421 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441797,250.99698905508063,0.003386941767651752 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441802,275.79339647883415,0.04430229336287983 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441791,228.04017653437745,0.03827020143818993 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441803,265.67290583553824,0.028065695967760096 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441807,247.09730380709703,0.0034135633338290283 +967514 MM WT,MoneyMaker,0.4,m_51,leaf,2441796,234.546649786238,0.026052336015153443 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441797,152.07438190185903,0.013854253433262187 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441802,165.8351299987608,0.02376622214870494 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441791,194.66442858573396,0.09337628587898283 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441803,153.87388444677728,0.00874539599791202 +967514 MM WT,MoneyMaker,0.4,m_52,fruit,2441807,157.00385405983735,0 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441797,1776.6522950761337,0.00587551013876686 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441802,2144.5438097959486,0.08760799153389254 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441791,1302.6234693711474,0.12890803251954708 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441803,2499.046676941582,0.1540474367975544 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441807,1728.9038467880653,0.005956090511607837 +967514 MM WT,MoneyMaker,0.4,m_52,leaf,2441796,1431.4274187691378,0.08795759931242797 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441797,81.7682450686091,0.08208658419483816 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441802,98.7805093241184,0 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441791,173.30178392584904,0.24413177215169513 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441803,51.529845248948995,0.28261242288725086 +967514 MM WT,MoneyMaker,0.4,m_53,fruit,2441807,120.97530877249584,0.08802547815219985 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441797,417.2983078048359,0.010968910642741303 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441802,646.2071057320969,0.17895619499474247 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441791,975.6664452739388,0.357885834925173 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441803,365.6324437070507,0.06837080916585458 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441807,374.9498826352133,0.057442312245744365 +967514 MM WT,MoneyMaker,0.4,m_53,leaf,2441796,438.6460429062893,0.010698681633333429 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441797,615.2751473733824,0 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441802,736.2927222085942,0.07798113465550172 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441791,611.6356996018511,0.002576546982648864 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441803,314.4241982834877,0.29155341088478126 +967514 MM WT,MoneyMaker,0.4,m_54,fruit,2441807,780.8208079172191,0.10348200511427219 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441797,14459.94531499146,0.023989450293723458 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441802,21800.223653982383,0.154304848335042 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441791,29530.481198070695,0.28611442300600665 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441803,16102.359051138325,0.022733405503645443 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441807,12845.714310689067,0.07539784177374642 +967514 MM WT,MoneyMaker,0.4,m_54,leaf,2441796,13285.248755178196,0.060786410205247776 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441797,70.82609301866422,0.033192274720971415 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441802,23.613302476942295,0.44384428045225155 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441791,33.57431391790261,0.29099386400184746 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441803,65.61467933644101,0 +967514 MM WT,MoneyMaker,0.4,m_55,fruit,2441807,158.4464922273099,0.3828816182485395 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441797,31.17878153260044,0.38998625556032973 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441802,38.9604428689011,0.29322150958598603 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441791,78.19099923835479,0.009311368704279177 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441803,199.3146142202652,0.41569374886164256 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441807,130.87770925671697,0.23302029046035777 +967514 MM WT,MoneyMaker,0.4,m_55,leaf,2441796,74.873822545558,0.009515388706291095 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441797,76.40518806674471,0.12604092579874782 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441802,102.13245582310356,0 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441791,119.8010366190544,0.06929680110062897 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441803,25.491047744813596,0.6027760884406153 +967514 MM WT,MoneyMaker,0.4,m_56,fruit,2441807,114.28893622269044,0.048840415563737416 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441797,2545.4674279891005,0.036552286388811694 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441802,2097.5279153447,0.1206120811007767 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441791,3568.4895741111177,0.11016460170719311 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441803,2840.46206706609,0.011069163339151089 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441807,3100.8070451344174,0.04915491157321705 +967514 MM WT,MoneyMaker,0.4,m_56,leaf,2441796,2697.498081211992,0.011358686097641346 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441797,283.5599970037744,0 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441802,701.2455403854477,0.39322514925924024 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441791,225.74667550059903,0.09902359977493536 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441803,277.29308934714106,0.009705916794104041 +967514 MM WT,MoneyMaker,0.4,m_57,fruit,2441807,318.0295114240771,0.04982245894985171 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441797,66875.20042705238,0.00491160263067858 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441802,110269.36678542108,0.22210138667940704 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441791,65371.08724497482,0.004967785828957183 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441803,148795.53393928436,0.3522364021706821 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441807,41713.77674564881,0.2000739815513093 +967514 MM WT,MoneyMaker,0.4,m_57,leaf,2441796,49436.40072359317,0.1263066500931398 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441797,58064.73483284235,0.1814457449191993 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441802,38289.98705235856,0.3622729724914482 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441791,139566.236401301,0.19942217531388895 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441803,88177.5833249477,0 +967514 MM WT,MoneyMaker,0.4,m_58,fruit,2441807,88408.0432144728,0.001133586205255277 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441797,367751.32037397806,0.02053666509848906 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441802,449695.68215154216,0.0668278118260579 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441791,403366.7872125971,0.01960923021700456 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441803,340003.3450891551,0.05460771596491831 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441807,555227.9579029658,0.1583804206347148 +967514 MM WT,MoneyMaker,0.4,m_58,leaf,2441796,316104.86099759146,0.086259731406364 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441797,2243.3807567796234,0.05319643649351269 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441802,3093.400647529573,0.19272961832339153 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441791,1249.25291387187,0.20105618267499237 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441803,1791.888668975069,0.04439553056885215 +967514 MM WT,MoneyMaker,0.4,m_59,fruit,2441807,1984.7533962973616,0 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441797,2468.8763722560057,0.049797915657825875 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441802,6081.130825312661,0.44128291888870264 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441791,2151.9254281823355,0.009874210323393307 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441803,2250.8995677116977,0.009654690022412815 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441807,1308.325890478342,0.22598549200321116 +967514 MM WT,MoneyMaker,0.4,m_59,leaf,2441796,1603.2999262377691,0.1376866551519491 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441797,68.98111700193802,0 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441802,114.5059960343702,0.22009800626802134 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441791,26.093124266761745,0.4222041399883256 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441803,467.0258364297834,0.8306106843622993 +967514 MM WT,MoneyMaker,0.4,m_6,fruit,2441807,48.36653278322346,0.15418526701158153 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441797,291.7914937575178,0.08750359559607546 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441802,316.28700808830945,0.12251232136852375 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441791,226.46861394787825,0.022561009593208947 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441803,250.61997298572237,0.02144664714911393 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441807,176.23442190434417,0.13147829342788508 +967514 MM WT,MoneyMaker,0.4,m_6,leaf,2441796,218.12157776420864,0.03887040122814156 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441797,43.61954902302856,0.3156681225054816 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441802,98.5066924745295,0.0381164435018031 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441791,78.14654627356676,0.062439504742537455 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441803,90.2296543441676,0 +967514 MM WT,MoneyMaker,0.4,m_60,fruit,2441807,185.58174623957177,0.31318596326306003 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441797,86.28196297721618,0.021229321660719558 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441802,92.85591804275802,0.010660249394539134 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441791,205.15235807487807,0.3549271745080509 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441803,88.35290281511053,0.01092851599149025 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441807,114.50067612123364,0.10165871245447744 +967514 MM WT,MoneyMaker,0.4,m_60,leaf,2441796,74.09121102597818,0.08738264530414575 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441797,133.20635618546635,0.2615107504677201 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441802,133.67825498831394,0.2630465697026583 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441791,72.94813581753098,0 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441803,64.86499902166317,0.051003782144787735 +967514 MM WT,MoneyMaker,0.4,m_61,fruit,2441807,62.48559546615739,0.06723428516334184 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441797,519.0750816184806,0.011631919825374037 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441802,491.6388610042051,0.011952057237078595 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441791,628.6073456480502,0.09478119060389067 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441803,671.6610718739311,0.12355191709779278 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441807,351.71828033919314,0.15740332000527335 +967514 MM WT,MoneyMaker,0.4,m_61,leaf,2441796,470.92576201676025,0.030645811901424125 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441797,6832.888808743169,0.026500948351553255 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441802,7912.772417478464,0.09022526980752676 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441791,5726.719454220669,0.05019749715784183 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441803,6026.791630413911,0.028017228695260687 +967514 MM WT,MoneyMaker,0.4,m_62,fruit,2441807,6428.407589784535,0 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441797,897000.5043065822,0.05421229134572325 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441802,1135520.1812036645,0.048189878632031835 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441791,664184.0561372131,0.18471653248944975 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441803,1438492.5647219568,0.1509026428950433 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441807,1400958.9888469167,0.13942044354001393 +967514 MM WT,MoneyMaker,0.4,m_62,leaf,2441796,828351.5169065611,0.08879030667902654 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441797,2540.4762706185575,0.09339872665309157 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441802,3150.0240485432437,0 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441791,3057.6066540696697,0.012932254541317523 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441803,5904.4257496969785,0.27286379618254575 +967514 MM WT,MoneyMaker,0.4,m_63,fruit,2441807,5942.678641551894,0.2756683764470762 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441797,25442.131797497408,0.010523365608657187 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441802,46327.26540176178,0.27080653304741276 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441791,36339.16571063104,0.16534481992811312 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441803,24223.976148960912,0.010784702236901644 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441807,15722.22013418082,0.19851625970565934 +967514 MM WT,MoneyMaker,0.4,m_63,leaf,2441796,18575.646752947607,0.12608618881307887 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441797,1670.775738588262,0 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441802,2348.0303591889706,0.14778554765487906 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441791,1664.5065057701177,0.0016326632805196972 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441803,1234.925146884664,0.1312775259366985 +967514 MM WT,MoneyMaker,0.4,m_64,fruit,2441807,2004.5119155235625,0.07909048196467872 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441797,4611.026923360722,0.07237019446503012 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441802,12395.344750051963,0.35709075774843146 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441791,6587.102334666821,0.08252655802729159 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441803,5214.852200421305,0.018925848354267583 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441807,4687.568115750517,0.06522026091781274 +967514 MM WT,MoneyMaker,0.4,m_64,leaf,2441796,5679.410617231343,0.018135416494554413 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441797,117.28587907638844,0.12319085618082837 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441802,88.31914805776539,0 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441791,81.50809109012117,0.03485414899227801 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441803,89.01356844493502,0.003401340595953428 +967514 MM WT,MoneyMaker,0.4,m_65,fruit,2441807,63.017991819297016,0.14659031163314484 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441797,1759.7775689233404,0.04356912460161766 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441802,1047.2223168209275,0.2689880135791225 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441791,939.6734701255124,0.3160499366903404 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441803,2784.6904375819104,0.1557500212386218 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441807,2328.246954751788,0.07800214133983685 +967514 MM WT,MoneyMaker,0.4,m_65,leaf,2441796,2131.1836113459053,0.03959396555987471 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441797,1357.1326874721487,0 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441802,1988.3948542483456,0.16588031965901617 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441791,1094.1113991825857,0.0935607680753674 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441803,1179.3304453673147,0.060986800555017595 +967514 MM WT,MoneyMaker,0.4,m_66,fruit,2441807,1442.3541152146731,0.026449587070428215 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441797,4313.45320087043,0.0435899728254201 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441802,9203.68796690427,0.28554682302377055 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441791,4694.898846916231,0.006788823624114038 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441803,5101.184610711674,0.02925597751941167 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441807,3167.259646566765,0.1777313957594071 +967514 MM WT,MoneyMaker,0.4,m_66,leaf,2441796,4842.8319214160865,0.006684333076753646 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441797,1190.4777391712726,0.05399876472754972 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441802,1204.13926900059,0.05895420551080921 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441791,555.0406534812383,0.27739772036745114 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441803,576.8350178004533,0.260670897051384 +967514 MM WT,MoneyMaker,0.4,m_67,fruit,2441807,1051.2899535585973,0 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441797,166.58444371492988,0.2141972293813752 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441802,494.70010030805906,0.2585103261388384 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441791,348.4319367305937,0.10628628263304307 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441803,827.505006286845,0.4819389575899158 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441807,134.48782888861632,0.3071486896991509 +967514 MM WT,MoneyMaker,0.4,m_67,leaf,2441796,197.1521165296716,0.14103022847567992 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441797,153.1290236084039,0 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441802,177.94562946993406,0.06522981239338854 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441791,85.12765338823498,0.2549868514694211 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441803,366.1154365737413,0.37856052713096044 +967514 MM WT,MoneyMaker,0.4,m_68,fruit,2441807,97.12718261088848,0.19771672210758973 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441797,1230.431380549324,0.06528304023795117 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441802,1835.49732936913,0.10841331799469112 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441791,1429.377431515306,1.9351822129420881e-4 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441803,1430.6515541511765,1.9343202949428928e-4 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441807,1612.7819799863,0.052235223360907135 +967514 MM WT,MoneyMaker,0.4,m_68,leaf,2441796,1018.7780125200068,0.14726087559305734 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441797,69.35452324088615,0 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441802,78.84174380636698,0.055681430718213853 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441791,25.19187958876064,0.4398142188280538 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441803,203.98613950801345,0.4685258682616382 +967514 MM WT,MoneyMaker,0.4,m_69,fruit,2441807,17.472516096818165,0.5987193413900009 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441797,272.94926389797166,0.09070621302871906 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441802,123.55157576521924,0.2535274256651223 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441791,196.9866410367004,0.050938939602525934 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441803,154.59289281829192,0.15618619040081327 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441807,344.8302111040432,0.19222959363599879 +967514 MM WT,MoneyMaker,0.4,m_69,leaf,2441796,246.01538256477303,0.045586548624837686 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441797,82.32776579446617,0.22526909666152073 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441802,97.23133307183004,0.15300918627249205 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441791,138.29784930763918,0 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441803,154.4671776508644,0.04802078502420182 +967514 MM WT,MoneyMaker,0.4,m_7,fruit,2441807,270.2305440493244,0.29091900921276714 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441797,977.9969920213482,0.004555364125712114 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441802,2715.193038177723,0.43890782825664143 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441791,1114.605472016212,0.052228287663310446 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441803,998.6216128812732,0.004508077955203582 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441807,213.8497191063509,0.664784199033313 +967514 MM WT,MoneyMaker,0.4,m_7,leaf,2441796,497.562869786913,0.29804491914716946 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441797,867.3061488860181,0.1267293145376227 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441802,770.3789612103681,0.17819732608662697 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441791,2305.1264345840746,0.29779301120047785 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441803,1161.1858632912658,0 +967514 MM WT,MoneyMaker,0.4,m_70,fruit,2441807,1335.096506923628,0.06061091971111843 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441797,860656.2334132496,0.046060025094806 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441802,663925.0572069297,0.06665063376741909 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441791,687446.1850604982,0.051530987221953595 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441803,885334.0620349904,0.058337479996895425 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441807,986456.2040167176,0.10530811507855731 +967514 MM WT,MoneyMaker,0.4,m_70,leaf,2441796,612223.2761091976,0.10185985642735229 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441797,1103.3315569213205,0.4794969511990903 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441802,365.77084753700774,0 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441791,331.08178067199424,0.04327380630585065 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441803,507.4044448292359,0.1421451786687533 +967514 MM WT,MoneyMaker,0.4,m_71,fruit,2441807,188.522392122656,0.2878461468266851 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441797,2743.8157912993006,0.05232422606489129 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441802,1848.1270663120597,0.11929889773597457 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441791,2511.2964167417326,0.01386725180065218 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441803,2353.455757431689,0.014324686746610915 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441807,2569.629460640722,0.023839777613567925 +967514 MM WT,MoneyMaker,0.4,m_71,leaf,2441796,2219.312779350305,0.039812211235641826 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441797,317.0982401480314,0.2427914116394132 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441802,181.301927009404,0 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441791,386.59034129892973,0.3288485791517233 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441803,154.5582030534051,0.06931036027483817 +967514 MM WT,MoneyMaker,0.4,m_72,fruit,2441807,81.44175750067542,0.3475552830169142 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441797,321.2196377423184,0.0513067917119332 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441802,235.1695127174712,0.08411427698356899 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441791,179.0085169726634,0.20262160168197418 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441803,350.2073050540205,0.08882990461740459 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441807,339.6656792469278,0.07555637050757635 +967514 MM WT,MoneyMaker,0.4,m_72,leaf,2441796,249.6346822103961,0.05819037373036107 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441797,122.14925637582076,0.1381533379061608 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441802,159.42531388145284,0.022486884599277612 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441791,167.89747517516034,0 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441803,259.1257234660429,0.18846636232033198 +967514 MM WT,MoneyMaker,0.4,m_73,fruit,2441807,265.2054972585544,0.1985383566997161 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441797,1735.6841351814376,0.04345366834616726 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441802,2398.390880181941,0.09699560190263812 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441791,1667.7832916448365,0.060784743581817846 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441803,2123.6463668050337,0.044157836765005065 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441807,1550.7120559048758,0.09239319891815345 +967514 MM WT,MoneyMaker,0.4,m_73,leaf,2441796,2100.9850842777255,0.03949860697758023 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441797,249.4233303330013,0 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441802,232.02640500708668,0.031399662517219706 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441791,208.87695288452198,0.07704655035066743 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441803,276.9780762049154,0.045508320794033 +967514 MM WT,MoneyMaker,0.4,m_74,fruit,2441807,276.4020941215922,0.04460425540026547 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441797,1009.9279759172484,0.01564771629586703 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441802,2135.5480879772635,0.30957123624406035 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441791,1299.382244605937,0.09379880904570737 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441803,1079.7041268782027,0.013366642337298451 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441807,954.0879894309272,0.04034969025962587 +967514 MM WT,MoneyMaker,0.4,m_74,leaf,2441796,1014.2545876620594,0.013791138236638023 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441797,153.38966074076808,0.033378239508759844 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441802,175.3377442564173,0.09145756760886137 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441791,142.04234953383852,0 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441803,136.86086665002838,0.016138561617805358 +967514 MM WT,MoneyMaker,0.4,m_75,fruit,2441807,134.01265529020583,0.02527203511949283 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441797,8517.32467287618,0.0623095664593496 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441802,9492.367531283637,0.015238223791735894 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441791,10405.88117221585,0.024666093311731974 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441803,10170.314879675472,0.014721630233728522 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441807,11412.591881647108,0.0647715180767201 +967514 MM WT,MoneyMaker,0.4,m_75,leaf,2441796,8525.14817331282,0.061910832855589515 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441797,52.23531944354825,0.039748310108755236 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441802,26.278206972746023,0.25862021594728657 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441791,53.59769381093034,0.050930158517066726 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441803,15.611173241423408,0.4847804016187922 +967514 MM WT,MoneyMaker,0.4,m_76,fruit,2441807,47.66679421609808,0 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441797,135.1100244556339,0.08914174117078666 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441802,351.43754856403837,0.3260188471048173 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441791,86.22918847883402,0.2841750148799753 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441803,235.16347283962008,0.15154055136213485 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441807,18.95148342874477,0.9421861036956398 +967514 MM WT,MoneyMaker,0.4,m_76,leaf,2441796,196.67693263130917,0.0739241126622514 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441797,479.5841412327396,0.11819625641134035 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441802,629.5947094367032,0 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441791,646.9785395732122,0.011828805324531455 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441803,703.8370094091265,0.0484110293918687 +967514 MM WT,MoneyMaker,0.4,m_77,fruit,2441807,575.9519611752231,0.03867480850269267 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441797,16750.982854241865,0.0031169577563687767 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441802,14492.737460120536,0.05977291142710417 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441791,19344.897798325543,0.0656431032857423 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441803,15582.29,0.02829205365488452 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441807,20409.319376274583,0.08890518547081516 +967514 MM WT,MoneyMaker,0.4,m_77,leaf,2441796,16511.3980065357,0.003139490164530301 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441797,62.79472359760744,0.0021717330502619703 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441802,63.22320500326724,7.816217504612588e-4 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441791,896.6811584656532,1.152543158028765 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441803,63.10952133451059,0 +967514 MM WT,MoneyMaker,0.4,m_78,fruit,2441807,61.94540089846534,0.00808581824399024 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441797,99.19987358614227,0.0032346157191127656 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441802,107.43513352746594,0.031400593499544716 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441791,97.17386944890396,0.012196237821762601 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441803,100.683067065473,0.003210702368981355 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441807,97.26512303623714,0.011788593945029513 +967514 MM WT,MoneyMaker,0.4,m_78,leaf,2441796,101.10892608648004,0.0050437631814919115 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441797,140.38361867424112,0.02523080787599108 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441802,132.46026671097448,0 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441791,119.40262977683885,0.04507173317669855 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441803,131.4999790899998,0.0031599414029979123 +967514 MM WT,MoneyMaker,0.4,m_79,fruit,2441807,156.74816554085027,0.07311684171518795 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441797,264.5780964941253,0.003055212337848001 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441802,286.54456121552744,0.037693494443905795 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441791,260.86860601695753,0.0030768577726019153 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441803,269.40518853868804,0.010907280385233253 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441807,251.98437486084035,0.01812506353755916 +967514 MM WT,MoneyMaker,0.4,m_79,leaf,2441796,257.5921480760448,0.008566054538166501 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441797,228.59871696807704,0.04255431259826503 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441802,219.29802572613977,0.06059337927237474 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441791,252.1320768292534,0 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441803,255.10855066481363,0.005096914282433751 +967514 MM WT,MoneyMaker,0.4,m_8,fruit,2441807,346.96798225251916,0.13866129937272165 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441797,500.7357805215887,0.0022087387486280363 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441802,615.9871640860807,0.08775429829336101 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441791,488.6444029498371,0.01282443553402901 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441803,505.8420472589054,0.002197562342502568 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441807,348.8639161245557,0.1591613125591489 +967514 MM WT,MoneyMaker,0.4,m_8,leaf,2441796,614.9362184304721,0.08701270866008803 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441797,50.93400203615255,0 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441802,73.34065398326939,0.15833697694628945 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441791,44.08640351361986,0.06270312998761107 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441803,56.11486330924136,0.04207010802585032 +967514 MM WT,MoneyMaker,0.4,m_80,fruit,2441807,46.6347072033895,0.03829854694310941 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441797,127.23353646333516,0.00396779505495104 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441802,137.15930494194512,0.02865588200906899 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441791,114.35906820717705,0.05029878555434664 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441803,129.56904749363926,0.00393187248994753 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441807,133.92517930096938,0.018292842843277146 +967514 MM WT,MoneyMaker,0.4,m_80,leaf,2441796,112.97215099486291,0.05559799582095337 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441797,1638.8202683049988,0.040386587930234086 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441802,1906.921575694311,0.10618809398885176 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441791,1160.3063389551216,0.10957207369613764 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441803,1095.2463223027582,0.13463293502558482 +967514 MM WT,MoneyMaker,0.4,m_81,fruit,2441807,1493.2920003836284,0 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441797,8832.427934135794,0.0025978052546093977 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441802,13950.387853385631,0.19590837431428465 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441791,10498.081498026442,0.07243203206724047 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441803,8938.409889502871,0.0025823583991195775 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441807,6261.274505480102,0.15201516341491583 +967514 MM WT,MoneyMaker,0.4,m_81,leaf,2441796,8190.973216931258,0.03534240199782168 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441797,8424.797552289228,0.09030077278896886 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441802,13415.832604855565,0.29235892995941004 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441791,4544.337988929236,0.1777880758737358 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441803,5609.355869403705,0.08634570734809488 +967514 MM WT,MoneyMaker,0.4,m_82,fruit,2441807,6843.191615358009,0 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441797,74385.27568434596,0.020141085422085148 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441802,132678.95580757724,0.23117398259345645 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441791,81447.23147477373,0.019248264172105678 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441803,116772.75090829778,0.17571344900792685 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441807,45737.32350296683,0.2313573157534634 +967514 MM WT,MoneyMaker,0.4,m_82,leaf,2441796,51330.06893554121,0.18125621482790244 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441797,323.6342309432382,0 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441802,425.22286546477153,0.11856215885181909 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441791,247.2152713236366,0.11697915581440776 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441803,176.76509425072734,0.26265794175470614 +967514 MM WT,MoneyMaker,0.4,m_83,fruit,2441807,425.6857910657972,0.11903470323681065 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441797,1598.1201775726902,0.017107014682316457 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441802,1726.533750999667,0.016458622993551053 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441791,2020.43,0.084727358889507 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441803,3329.666046973834,0.3016842280375518 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441807,1522.5200223948325,0.03815343687068973 +967514 MM WT,MoneyMaker,0.4,m_83,leaf,2441796,1374.6560343275078,0.08252240670948874 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441797,17958.653828440234,0.6866740893798577 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441802,24704.93788755669,0.825184076658172 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441791,1530.9283083146927,0.3826448360354333 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441803,3694.874482392026,0 +967514 MM WT,MoneyMaker,0.4,m_84,fruit,2441807,1147.707285511193,0.5077685511778083 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441797,2471619.5674535297,0.08269921101831468 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441802,1984081.632323034,0.012722877146471134 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441791,2599070.1682663155,0.1045355907185046 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441803,2094589.255751987,0.010816457694879489 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441807,1409941.3916490015,0.1610813534781137 +967514 MM WT,MoneyMaker,0.4,m_84,leaf,2441796,1991542.9070842275,0.011092746217816085 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441797,52.23546882999613,0.011317726139516315 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441802,66.22560144332991,0.11437814028323778 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441791,46.77520974077643,0.03663202729142001 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441803,35.16263447072856,0.16056636482372544 +967514 MM WT,MoneyMaker,0.4,m_85,fruit,2441807,50.891795204533715,0 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441797,1189.012011028525,5.779414785784809e-4 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441802,1185.8495378410223,5.787116046191976e-4 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441791,1739.0914906611442,0.1657141298319882 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441803,1412.9716694512615,0.0755251539183388 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441807,1151.014938313174,0.013527340163022039 +967514 MM WT,MoneyMaker,0.4,m_85,leaf,2441796,1065.0823134947568,0.04722512731639217 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441797,1845.846536984228,0.08721459065404646 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441802,1510.014092501029,0 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441791,1065.4916271390468,0.15143095916527827 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441803,1328.0290443085646,0.055773427191379454 +967514 MM WT,MoneyMaker,0.4,m_86,fruit,2441807,1937.0218968368267,0.1081535297278502 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441797,21779.945721650103,0.03685725313364241 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441802,26620.32315075659,0.0502992769413666 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441791,25638.14267156286,0.033972513738164345 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441803,30410.53111523152,0.1081099588578942 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441807,20319.65472684693,0.06699772212958521 +967514 MM WT,MoneyMaker,0.4,m_86,leaf,2441796,17637.628221189225,0.12847386225134727 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441797,365.5741872417371,0.09464164000169495 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441802,360.2144696095059,0.08822727106901906 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441791,216.0549608471757,0.13376964051031415 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441803,293.99089686598387,0 +967514 MM WT,MoneyMaker,0.4,m_87,fruit,2441807,186.6559751701082,0.1972919861482314 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441797,34984.77573371662,0.006447491336299294 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441802,29217.617591475177,0.08468178498290424 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441791,47019.29228072035,0.12194950238355506 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441803,33337.43584224783,0.027394392692691838 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441807,36031.28548593817,0.006353171102709609 +967514 MM WT,MoneyMaker,0.4,m_87,leaf,2441796,39002.21661047941,0.04076270436482865 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441797,100.70022129866292,0.07821873831388682 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441802,165.14288659076118,0.29304818486695017 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441791,84.10303854687021,0 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441803,76.20194991151779,0.04284560211743238 +967514 MM WT,MoneyMaker,0.4,m_88,fruit,2441807,50.693426834860304,0.21986003647248742 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441797,1906.3078456566464,0.028000074118100127 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441802,1433.9765467583295,0.09565091281741234 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441791,2145.685072364337,0.07937301865273616 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441803,1645.555485531802,0.03588043055162826 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441807,2016.054696982856,0.052309349495418545 +967514 MM WT,MoneyMaker,0.4,m_88,leaf,2441796,1668.2551634816166,0.029930483426188204 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441797,32979.30822480784,0.06672639025788829 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441802,68684.59519130191,0.2518914110902193 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441791,51707.612591117126,0.12858655439938982 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441803,38456.33850042446,0 +967514 MM WT,MoneyMaker,0.4,m_89,fruit,2441807,29890.286937088746,0.10943784773889753 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441797,290056.6701963597,0.09848370822993768 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441802,552376.7031386528,0.3782362048250718 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441791,204613.8646090761,0.05306409069275375 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441803,257798.18712012225,0.04728071019281188 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441807,155724.74082809617,0.17164153205137556 +967514 MM WT,MoneyMaker,0.4,m_89,leaf,2441796,105813.31839072658,0.33945881437923475 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441797,29.62412224736773,0 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441802,9.66977309884625,0.4862292077257292 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441791,28.813842043228114,0.012044320160390809 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441803,133.00644854514252,0.6522272061441545 +967514 MM WT,MoneyMaker,0.4,m_9,fruit,2441807,33.75781264589066,0.056728807328737973 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441797,140.74205333858637,0.002689789590656577 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441802,152.41593766955378,0.03729628899497861 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441791,139.004077738099,0.0027065525952929548 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441803,145.95013092295426,0.018470395671307482 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441807,134.71758539346646,0.01630980307054264 +967514 MM WT,MoneyMaker,0.4,m_9,leaf,2441796,135.2675118875777,0.014540591550777915 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441797,43.34658896436272,0.3474569680340358 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441802,104.16721834512616,0.03331917139628238 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441791,96.47435765382325,0 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441803,31.61985790222966,0.48445198172392856 +967514 MM WT,MoneyMaker,0.4,m_90,fruit,2441807,246.31906374342387,0.4070861295180046 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441797,4224.113437395399,0.03064112244045525 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441802,4027.888065576123,0.009982942968922881 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441791,3844.8254103132,0.010217826393866147 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441803,5257.875313557441,0.12571583283521237 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441807,3816.053594829397,0.013479984545961443 +967514 MM WT,MoneyMaker,0.4,m_90,leaf,2441796,2733.8384022083865,0.15832161035205772 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441797,340.66772276678614,0.09503638565328654 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441802,170.75822286453686,0.20491297546540554 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441791,273.71248134533914,0 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441803,328.76214221199484,0.0795871998654949 +967514 MM WT,MoneyMaker,0.4,m_91,fruit,2441807,238.69164991639775,0.059457375309778904 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441797,126280.59404456764,0.17020889462917577 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441802,158303.9618224902,0.07205372689933132 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441791,215441.1372960035,0.06178312216784132 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441803,488325.0061822702,0.4171634533903994 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441807,274764.88690834696,0.16741572119358228 +967514 MM WT,MoneyMaker,0.4,m_91,leaf,2441796,112366.81115092212,0.22090745461728645 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441797,66.99192048467529,0.16309142571214275 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441802,86.08382322832622,0.2719905446540871 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441791,45.2628785731587,0.007188832128270484 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441803,25.736732959875273,0.25237758595332327 +967514 MM WT,MoneyMaker,0.4,m_92,fruit,2441807,46.01834570697704,0 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441797,5708.909233655078,0.32927095322205435 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441802,11263.739417863237,0.0341414967215119 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441791,13106.1796594158,0.031652025561077934 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441803,26477.9534098339,0.33706032224870963 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441807,13460.453524191376,0.043235601449480576 +967514 MM WT,MoneyMaker,0.4,m_92,leaf,2441796,9023.7266914618,0.1304381583773937 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441797,5.98739560454023,0.20016530063019955 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441802,3.430203593481006,0.0417527559906804 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441791,394.04654803485073,2.0184748737536773 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441803,3.706447880463413,0.008114756041492699 +967514 MM WT,MoneyMaker,0.4,m_93,fruit,2441807,3.776353606363725,0 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441797,135.60163363930866,0.4583008015399235 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441802,42.879688733845846,0.04171249598970195 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441791,24.935923736323968,0.27713865908623636 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441803,19.640312466551674,0.3808157272251058 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441807,114.43388673655276,0.38459052884590217 +967514 MM WT,MoneyMaker,0.4,m_93,leaf,2441796,51.52511980334605,0.03805489013286856 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441797,422.8337519723459,0 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441802,1043.116831570759,0.3921633063432446 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441791,367.35694654928454,0.06108139025930681 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441803,1547.5518747851715,0.5634755689003494 +967514 MM WT,MoneyMaker,0.4,m_94,fruit,2441807,331.5232430072976,0.10565566474434052 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441797,6933.9411207429175,0.0870598866779142 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441802,5383.907095717351,0.02282270573683176 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441791,5897.775871073933,0.016768001483592698 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441803,5451.032387163277,0.01744150048114257 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441807,6385.427084546094,0.05126968716905722 +967514 MM WT,MoneyMaker,0.4,m_94,leaf,2441796,4679.248199991572,0.08374418090742797 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441797,233.92261657701377,0 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441802,474.8876749182016,0.30751868501721535 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441791,86.85977104187731,0.43025353292329793 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441803,297.18386042097313,0.10395300671996788 +967514 MM WT,MoneyMaker,0.4,m_97,fruit,2441807,126.55699212897008,0.2667860687417325 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441797,125.35227461805542,0.020425137381900882 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441802,61.61875259159144,0.32884445414721775 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441791,137.42472649565312,0.019507524929468723 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441803,98.71056373725791,0.1241937241947737 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441807,303.05999157631544,0.36297125045354095 +967514 MM WT,MoneyMaker,0.4,m_97,leaf,2441796,225.07538960409508,0.233770654207194 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441797,2134.4150441959964,0.0031441608301405743 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441802,1316.960429929088,0.21285030803327132 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441791,3531.4183326392863,0.2155261330805831 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441803,2149.923635237173,0 +967514 MM WT,MoneyMaker,0.4,m_98,fruit,2441807,4189.87777274591,0.2897783197424215 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441797,94652.55978966528,3.887086501297432e-4 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441802,94483.20093289229,3.890568695688046e-4 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441791,114855.72767238604,0.08440900275059793 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441803,109835.43982749344,0.06499883857170907 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441807,71971.87344185029,0.11858084729088425 +967514 MM WT,MoneyMaker,0.4,m_98,leaf,2441796,92361.7624488999,0.010251443355527634 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441797,45857.61315120557,0.07675253287235773 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441802,39255.93088261692,0.00924636685657898 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441791,38428.984963263916,0 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441803,31670.567683168072,0.08400306545153402 +967514 MM WT,MoneyMaker,0.4,m_99,fruit,2441807,9335.62160281896,0.6145156731587043 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441797,112416.81527799384,0.014870187302788551 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441802,110689.20515270822,0.021596196215153185 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441791,120248.40105780357,0.014377845222949936 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441803,120564.1447790542,0.015516704778109514 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441807,135778.6181917452,0.06712991952983138 +967514 MM WT,MoneyMaker,0.4,m_99,leaf,2441796,96343.62820284566,0.08187846767650786 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441099,405.2143143173143,0.41950757014668216 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441079,162.0649679530624,0.02151193927895889 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441080,143.68709256446576,0.030759451255001125 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441096,200.09326880658105,0.11305527069883414 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441089,146.4009626007255,0.022633276134819358 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,fruit,2441091,138.5352305461552,0.04661697661151809 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441099,17.493768369369146,0.27588975447408015 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441079,423.892377817063,1.108482481094575 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441080,23.86968468122738,0.1409264443062015 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441096,3.564385848436262,0.9667884155821932 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441089,42.1697157974402,0.10622754778312227 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_1,leaf,2441091,339.52134763714685,1.0120939597214422 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441099,55.54302866085092,0.0036584651488469344 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441079,54.611178218995114,0.0036895457998480374 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441080,55.59697133914909,0.004080041707485993 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441096,78.25751797528352,0.15255497744448876 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441089,52.84058701468865,0.018003458585898358 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,fruit,2441091,47.33356194266294,0.06580190500055827 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441099,313.8239856739958,0.015859974166097413 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441079,328.52016332369254,0.004015922104114278 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441080,319.9817176432805,0.007420942620237625 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441096,322.4725142705353,0.004053404212049472 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441089,363.4790560524887,0.047933283567676455 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_10,leaf,2441091,334.4809918859546,0.011825334461350145 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441099,53.73441195227974,0.012491393626419711 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441079,37.50891195527855,0.14362664039020223 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441080,66.06988837835137,0.10224246622189259 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441096,50.687370572810984,0.012861344257557361 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441089,36.73845417473456,0.1526402281030288 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,fruit,2441091,246.3947178084123,0.6738702863504147 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441099,1941.6593522075368,0.03020794165714058 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441079,2775.4637916574197,0.12495458535482351 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441080,2221.384410186265,0.028242739036384634 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441096,1754.271859855638,0.07428408365331274 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441089,2878.1998361727015,0.14073996352924745 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_100,leaf,2441091,1406.6261692409316,0.17020228771961854 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441099,34.497585647182724,0.012146393686063295 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441079,31.50679447557741,0.051530875247150165 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441080,36.45448770788538,0.011815904278264178 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441096,24.900893311038484,0.15372016768765628 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441089,47.000763683496984,0.12216981932021165 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,fruit,2441091,43.68999415315836,0.09044689136083472 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441099,60.867293288515306,0.5296458001592876 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441079,244.68208822116804,0.07457238862256244 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441080,243.3395413523741,0.07218289548392232 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441096,168.8147113347329,0.08661949920160739 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441089,39.365370295582565,0.7189154486271616 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_101,leaf,2441091,307.71608484990844,0.174120408488474 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441099,112.92341214948496,0.01507786315579418 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441079,117.60631696578088,0.03272452017020422 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441080,93.59183064134062,0.06646818728309722 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441096,87.91525773895992,0.09364187572407201 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441089,130.71127307691094,0.07860691516169105 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,fruit,2441091,105.21699783572868,0.015620223491692453 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441099,650.1894030543315,0.004506773132930242 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441079,519.8217759017327,0.09267864523125979 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441080,639.6494046231675,0.0025911138597627392 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441096,647.3048486022362,0.002575746242291288 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441089,562.4489892782861,0.058449973160878965 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_102,leaf,2441091,770.1155205728371,0.0780227622138332 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441099,1819.0848086026851,0.10914045814051176 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441079,2139.058002694864,0.03877084410970211 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441080,2538.5454439371506,0.03559153719158603 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441096,7917.4704683647715,0.5295930469879297 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441089,10224.187545074072,0.6406354021004157 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,fruit,2441091,520.1805359419822,0.6528393073889052 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441099,833706.4508590208,0.009683698918580674 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441079,824032.6283538535,0.004614945365850609 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441080,709413.5336469379,0.06042999362207535 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441096,716721.7571738436,0.0559788746378036 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441089,811378.82995326,0.002105790828635712 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_103,leaf,2441091,819266.3033460755,0.0020956295984655426 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441099,1783.3093143478095,0.10914045814051221 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441079,2096.989674201132,0.03877084410970211 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441080,2488.6204940305684,0.03559153719158603 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441096,7761.759520796743,0.5295930469879297 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441089,10023.11095917232,0.6406354021004157 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,fruit,2441091,509.9502730718385,0.6528393073889052 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441099,833706.4508590208,0.009683698918580674 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441079,824032.6283538535,0.004614945365850609 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441080,709413.5336469379,0.06042999362207535 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441096,716721.7571738436,0.0559788746378036 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441089,811378.82995326,0.002105790828635712 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_104,leaf,2441091,819266.3033460755,0.0020956295984655426 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441099,47.97355700477776,0.012454577853503013 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441079,45.26109158889608,0.012822318733855198 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441080,51.59285742534955,0.04404223894058923 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441096,60.75554074961963,0.11503854800085334 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441089,38.70492586574369,0.08078110266056093 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,fruit,2441091,24.978850229851112,0.2709748985862215 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441099,182.34873815567508,0.3128378252791362 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441079,72.61353211801044,0.08704737455883005 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441080,104.84420234768504,0.0724794828572648 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441096,70.5998612232694,0.09926108971585301 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441089,52.52108558326989,0.2277312429353595 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_105,leaf,2441091,192.48130184972584,0.33632361027739144 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441099,231.95271279157032,0.10389540123397012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441079,182.92669011709916,7.730213866707913e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441080,161.2046851030755,0.05412639533681762 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441096,182.2760695067607,7.743997780007561e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441089,187.09673484719897,0.010562153476449954 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,fruit,2441091,171.88690159967052,0.026261271774411288 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441099,3525.699803983189,0.02812931230369431 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441079,3166.898428798904,0.018481884623518408 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441080,3229.8144927040007,0.009938440238468793 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441096,3371.41,0.008695551456857853 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441089,3237.746181756152,0.008873219303449531 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_106,leaf,2441091,3455.817215086712,0.019434744539760018 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441099,316.0457778685168,0.07834945293321693 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441079,483.1591519706168,0.1059907645409397 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441080,257.39102118734,0.16750605286099152 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441096,321.71352678032144,0.07063012414171066 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441089,435.3449758785002,0.060734091034809534 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,fruit,2441091,453.155001898502,0.07814733228117943 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441099,6267.6927581557175,0.0353141903557308 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441079,6751.659794411639,0.0030113388415591302 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441080,7057.850405148468,0.016250559431468137 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441096,6845.615336031081,0.0029906023294392625 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441089,7447.5965151792125,0.03959425045923748 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_107,leaf,2441091,5631.230066362312,0.08181861859597106 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441099,76.91996799794822,0.03308433520447207 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441079,91.28920285354118,0.04129598470593021 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441080,89.09736229967152,0.03074141698549937 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441096,44.34126195182026,0.27231538111509734 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441089,112.74437255513878,0.13297144393013394 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,fruit,2441091,41.24706954646457,0.3037303311392161 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441099,285.76234901419184,0.042986494050594626 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441079,72.46544182181758,0.5528875687017976 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441080,231.90230060301127,0.04771345603746324 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441096,505.7492118766514,0.2909167015243148 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441089,615.9739402580274,0.3765438258994034 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_108,leaf,2441091,166.37697345227193,0.19192529332196706 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441099,194.78116850364717,0.08363331364589843 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441079,117.63047703708015,0.1353937949620816 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441080,173.65946357389922,0.03378480195542233 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441096,170.39060064672202,0.025531980641166463 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441089,117.52269288556008,0.13579191900638277 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,fruit,2441091,150.93375763404936,0.02712726887896899 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441099,1901.6449362625644,0.04184641036296499 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441079,1797.338819420036,0.017346933476737547 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441080,1269.89031994999,0.13351680825648282 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441096,1262.032947763867,0.13621232780938985 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441089,1656.5870850888864,0.01806874971185879 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_109,leaf,2441091,3282.6114102276656,0.27893645380750076 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441099,1731.7198428082386,0.12625605713160049 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441079,1727.8393551584015,0.12528178556475877 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441080,592.721516220204,0.3393708834532938 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441096,478.4499146511378,0.4323850947366483 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441089,886.9925119312488,0.16430162268759885 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,fruit,2441091,1702.7201002065754,0.1189216866206304 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441099,546.2057544039865,0.2136336861682362 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441079,805.440021684037,0.04495675182855807 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441080,1507.197413037668,0.22718018263499618 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441096,981.129632727822,0.040736435372235924 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441089,1722.4054903566605,0.28514544379010154 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_11,leaf,2441091,452.07376113829497,0.29578065655575747 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441099,630.2404710443806,0.12641181530056933 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441079,529.4079804858984,0.050696010967416605 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441080,361.9740220224232,0.11441706934416684 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441096,421.6847170445678,0.04810661142429984 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441089,520.4748629069896,0.043305286709152124 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,fruit,2441091,385.2069944191269,0.08740030850592406 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441099,5434.025229896751,0.15067208298678825 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441079,2471.519904735165,0.19148545504355097 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441080,3589.6797436833963,0.029393863149667965 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441096,3872.780771273523,0.003573345818122853 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441089,3809.312276619721,0.0036029911559123384 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_110,leaf,2441091,9102.115559346592,0.3746927774485589 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441099,405.4531928528713,0.17536887317363448 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441079,210.69799583049544,0.10891144696810917 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441080,266.9832655336906,0.006087810853419029 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441096,274.52095665097585,0.0060036520854431785 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441089,363.88108078662,0.12838762440085905 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,fruit,2441091,139.70821272957377,0.28734991475512617 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441099,62488.335545504495,0.1802412148223862 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441079,30828.68155422159,0.1266027903115141 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441080,37309.17046548214,0.04374214900921913 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441096,41418.02461944584,0.0016316398969706825 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441089,41107.3943181436,0.0016377930759583492 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_111,leaf,2441091,68527.65206583778,0.22030810999717332 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441099,3178.269467291179,0.21348414621723588 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441079,2011.1671061071795,0.014741587682274737 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441080,1494.5518944778803,0.1141955701623627 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441096,1876.9251855373548,0.015259607624185989 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441089,2573.1577328928697,0.12175983943469504 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,fruit,2441091,556.6911949471281,0.5430922173322497 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441099,379461.2194788013,0.13830719964090843 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441079,276433.44779778225,7.303920557379939e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441080,275504.4232900411,7.316224913154201e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441096,269231.7056690999,0.010733995834200982 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441089,204192.5351946903,0.13082033719536312 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_112,leaf,2441091,402117.9151846655,0.16349322381331888 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441099,280.2958869104941,0.12467770163373881 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441079,280.9599201435672,0.12570534749453133 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441080,129.70109006382907,0.20999539719590432 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441096,80.35015164842892,0.4179523225297146 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441089,140.40072938465156,0.17556965932488433 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,fruit,2441091,332.3828204405753,0.19869954542694446 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441099,42.41645043768952,0.15852635986153873 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441079,23.124140127802725,0.4219950897749758 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441080,96.3502104204802,0.19779198522755848 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441096,153.2607537167943,0.3993702748043342 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441089,79.78902863206629,0.11588249568919995 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_12,leaf,2441091,19.556097894473897,0.4947784796253556 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441099,87.23155657778024,0.26700685247533684 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441079,80.19583588069605,0.23048504868714126 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441080,38.66684725783167,0.08632800685138142 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441096,8.187979550406377,0.7604900203741418 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441089,55.67334682580662,0.07198056017107946 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,fruit,2441091,17.941651236034748,0.41980435944629546 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441099,139.09280683774426,0.016196102465769524 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441079,169.17876736936827,0.06884508281175128 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441080,99.36409625767264,0.1622712866961762 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441096,70.69795464709446,0.31009392410479153 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441089,149.66302835419825,0.015613755131922424 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_120,leaf,2441091,168.776825548518,0.06781204059670332 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441099,57.707789424721426,0.14862867714188988 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441079,52.26133591891968,0.10557474584527782 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441080,49.62041044691211,0.08305459107492608 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441096,32.128510168056344,0.10571517390700502 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441089,9.905617509376574,0.6167242069077055 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,fruit,2441091,32.345969888185124,0.10278558333025889 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441099,74.4494290472428,0.27213230866931815 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441079,197.13716236043945,0.15077482075917814 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441080,130.99919199018953,0.026725063252265535 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441096,147.62811399681206,0.025175391352824317 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441089,248.12,0.25066809232752707 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_121,leaf,2441091,130.27186434780612,0.029143051697043454 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441099,326.60996928631073,0.01328381661369038 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441079,346.8987912179663,0.012889533115586715 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441080,257.0150872328388,0.1173546354920969 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441096,352.1218392400694,0.01937970822961388 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441089,602.7619259478074,0.2528325584557427 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,fruit,2441091,303.8578805266771,0.04464274919592359 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441099,11480.383390211042,0.037249112072898605 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441079,9448.27028306456,0.047354971121897904 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441080,8778.385801380398,0.07929261586000846 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441096,12712.687829946795,0.08153010307696196 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441089,9593.145903861794,0.040746229819469626 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_122,leaf,2441091,14548.15891408745,0.14010075674129663 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441099,214.64203409502375,0.10654390764368316 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441079,176.8103249597791,0.022336754628823563 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441080,159.08260552797148,0.023548172265195788 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441096,130.64854231156022,0.10906629918680677 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441089,181.25583424384513,0.03312112678153589 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,fruit,2441091,121.137432870509,0.14189250180199364 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441099,196.88995896398225,0.014560300730452003 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441079,183.9068175639408,0.015065438570686318 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441080,250.76402387871303,0.11960196238848964 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441096,262.0528654919926,0.13872564525175868 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441089,155.61049142606385,0.08762439348993611 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_123,leaf,2441091,139.26868868020549,0.1358097813270711 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441099,3319.8981064836917,0.10657996918252977 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441079,3450.658645420761,0.12335721360072283 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441080,1278.2952559952923,0.30791360829298764 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441096,1444.6221366921352,0.25479051996977375 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441089,1874.9730559790496,0.14154975431955874 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,fruit,2441091,4160.843593303177,0.20463660544502638 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441099,85470.32079939006,0.024988087366485168 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441079,78816.75842630565,0.010208677407509192 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441080,77270.81045726273,0.018811779271766582 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441096,82566.04011994104,0.009974209613163865 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441089,94773.72072189696,0.06986068427671555 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_13,leaf,2441091,72607.19829428353,0.04584756776263976 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441099,10.187190546914948,0.3924235413019368 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441079,28.77327657394944,0.0585113494249756 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441080,59.66498260111094,0.37524154749216976 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441096,8.766349538258886,0.45765918765503244 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441089,21.51977255393621,0.06764029393554849 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,fruit,2441091,77.61066369057217,0.4894434265146581 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441099,175.63014132856642,0.39626933170047884 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441079,62.22921363355031,0.0543354060946748 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441080,73.6174064691689,0.01865079414409565 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441096,106.09462822907687,0.1773636762073072 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441089,67.42824943487693,0.0194878343874878 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_14,leaf,2441091,16.146624185277137,0.640247981968546 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441099,90.21727633338028,0.05822004006135284 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441079,79.79645465638966,0.004913924631663624 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441080,55.31683579590988,0.1542123416471124 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441096,21.7190385766572,0.5602290748187448 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441089,143.71459637761825,0.26043120799349917 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,fruit,2441091,78.00088140972959,0.004970161269347351 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441099,536.7004414708266,0.04595711086693388 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441079,705.3920104925237,0.07274147300434386 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441080,571.8793129252382,0.01838467666074095 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441096,418.9810331709747,0.15349470003082288 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441089,621.3366618225605,0.017637916422776012 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_15,leaf,2441091,678.7475791239423,0.056019230220394345 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441099,25.24284121568514,0.061382123429758906 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441079,295.082725200298,1.0064234267774717 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441080,0.4788148100136213,1.7833527839840388 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441096,69.25250415741105,0.3769151231257015 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441089,22.046128540379037,0.12018802365341674 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,fruit,2441091,32.90724387489506,0.05377115086095885 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441099,317.03969018483315,0.46403575238139627 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441079,41.01416310674544,0.4241440283405504 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441080,2.726591262548468,1.6014578438808098 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441096,176.81091488834437,0.21043118881713552 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441089,235.29506242464024,0.33453493122394873 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_16,leaf,2441091,27.640449860092115,0.5955327754596043 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441099,2188.243019472895,0.003400082121075343 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441079,2580.2495235281635,0.06816607266870056 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441080,829.8698138389057,0.42448566625927064 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441096,1048.1116828821257,0.3230880719391771 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441089,3921.7832714048745,0.24998795582305267 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,fruit,2441091,2222.6409086405015,0.0033736696007591327 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441099,33539.53512765797,0.0943500916072475 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441079,27546.463794887874,0.008858908153051459 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441080,26434.041167423387,0.009043385179249519 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441096,31449.008282612675,0.06640000769806509 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441089,23428.371255501617,0.06146484977926381 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_17,leaf,2441091,25217.54287020676,0.029504179388604612 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441099,217.03079607156147,0.29968446409524985 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441079,128.35524352116354,0.07157671569272628 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441080,46.53190962584124,0.36908602337906005 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441096,169.95521078786476,0.19349758517716964 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441089,89.3490002646021,0.08574720181341755 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,fruit,2441091,16.485250376264194,0.8197413517668735 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441099,2256.2159890542544,0.030556205400393832 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441079,556.8974949033809,0.6381616136971839 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441080,3373.3897911681015,0.1441296482973562 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441096,4214.36963582228,0.24079574623698718 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441089,2585.138392561005,0.028546919532294268 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_18,leaf,2441091,1390.1897343080911,0.24086280081171862 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441099,4.5503288892818965,0.12295464778946197 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441079,4.468756437217828,0.11509854474736347 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441080,3.1002122752878916,0.043696708475589985 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441096,2.2086519736674117,0.19096085229368237 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441089,3.756534890201619,0.03969928686755919 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,fruit,2441091,2.5249186835909887,0.13284074401211193 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441099,2755.8150352946004,0.009315189765355392 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441079,1338.9005433497384,0.32281693721128324 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441080,3630.6252857520935,0.11041617298593565 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441096,4071.387715264654,0.16017720687762393 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441089,2875.3110375355895,0.00911957647189432 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_19,leaf,2441091,2217.571583117211,0.10368760727836168 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441099,487.7917909367267,1.0761999739238832 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441079,108.05674749130571,0.42161737777367714 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441080,0.5470894805125003,1.873976149156944 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441096,26.53408070195826,0.18823046767238516 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441089,55.32455628719598,0.13088342613415982 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,fruit,2441091,4.591488182402659,0.9500810424949908 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441099,881.2265527033918,0.0030213913539531845 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441079,687.0382349922344,0.1050852762277592 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441080,869.0077002317381,0.0030425585523041754 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441096,853.340906772405,0.010943618286264556 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441089,931.7604259226408,0.02723807770752007 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_2,leaf,2441091,1317.302252835235,0.1776192512714485 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441099,67.88428114426594,0.16894854472297904 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441079,19.372659751947467,0.37563142782501036 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441080,65.33159494005915,0.15230258204022973 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441096,58.53933381848278,0.10462709711669693 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441089,11.322284628260846,0.6088866103960271 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,fruit,2441091,33.47398052269377,0.1381133196153368 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441099,4.651881347907398,0.7486866067063052 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441079,27.73159040136493,0.026659541320675162 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441080,29.394130265052933,0.05194537881733896 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441096,1.4490565923575685,1.2552298886670021 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441089,24.429328227260104,0.02840371103622652 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_20,leaf,2441091,38.72088661574392,0.17163005737944448 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441099,5208.978126613742,0.005905399078997231 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441079,5896.007027654586,0.04790005966287669 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441080,4334.67550209179,0.08570134150564535 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441096,5351.605707265429,0.005826175383560006 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441089,9929.279119242658,0.27425978636132475 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,fruit,2441091,3191.012394150975,0.2187294418072505 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441099,392637.3433457541,0.06338228778295107 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441079,321105.25540181104,0.023961901210565628 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441080,237474.90983320543,0.1549915833111406 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441096,370564.1537841184,0.0382540911383904 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441089,357534.5202525932,0.02270866489161172 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_21,leaf,2441091,316773.17173728213,0.0298609217031629 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441099,81.06520454648792,0.2804671424864391 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441079,71.86578042961932,0.22815480580040615 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441080,38.95618966152977,0.03779086881267513 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441096,18.05977947924894,0.3716548973656766 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441089,11.551276272233904,0.5657373693659631 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,fruit,2441091,46.03958491882552,0.03476405910778846 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441099,61.28961654418591,0.3723527179482855 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441079,11.253296625678155,0.36375441967707056 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441080,13.384462474769707,0.28843325183034363 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441096,198.53246649469065,0.8827973518666832 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441089,5.61915598683323,0.6653630980631908 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_22,leaf,2441091,38.6228224739765,0.171809821655176 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441099,2415.1557837981945,0.08853988225231202 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441079,1828.153239365564,0.032392670523671896 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441080,2476.1576467039563,0.09937302410289917 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441096,2111.293765337982,0.030143398373769337 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441089,1478.5773497358016,0.12456121788313856 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,fruit,2441091,832.1670883873832,0.37419473109599144 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441099,130839.0907806742,0.054268176025444426 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441079,82878.86420226836,0.14402555072899048 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441080,105048.43469047436,0.04107975602505931 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441096,115060.90138256818,0.0015415695156093534 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441089,115879.19202093214,0.0015361169169976208 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_23,leaf,2441091,158792.93510842454,0.138361834764833 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441099,173.40389519205834,0.12288776770822185 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441079,103.85596169523014,0.0997396495414633 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441080,86.97109263678439,0.1767961549043573 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441096,154.31263729908122,0.07223041253855778 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441089,128.20352336466104,0.008271120266190923 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,fruit,2441091,133.13358222693455,0.008116536581035838 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441099,85.03197104217436,0.023805237903991916 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441079,146.2705868065637,0.2593799954520175 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441080,75.96103290662643,0.025186146665118647 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441096,39.703601084274105,0.30694710953560644 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441089,40.944841626917494,0.29357781262250016 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_24,leaf,2441091,90.9812192950038,0.05317474453822313 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441099,81.4009037886649,0.08376178314657756 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441079,67.18734360024848,4.200269280654201e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441080,67.0574462498666,4.2043354945553446e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441096,81.80497510284876,0.08591227308973037 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441089,60.9949339689902,0.04157367821986324 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,fruit,2441091,44.806559486826266,0.1755258462220861 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441099,3857.02050910029,0.06275005507213338 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441079,3336.701445864016,1.845435593756939e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441080,2918.9664777001954,0.0582727856461025 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441096,3082.9587567550307,0.034534178237579205 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441089,3941.7444112929375,0.0721865674484592 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_25,leaf,2441091,3339.5377591658375,1.8446517509529414e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441099,125.13752057486786,0.16558239598843594 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441079,166.70676157230986,0.04101672674790047 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441080,186.15977465791505,0.00691590279879728 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441096,180.27774720535652,0.00702781939359598 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441089,283.6118909417959,0.18975449369806618 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,fruit,2441091,286.9574228792066,0.19484752157619623 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441099,3816.80829290202,0.03439029255842607 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441079,3820.374140091147,0.03398474302921972 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441080,4055.0833534158032,0.008090854027789973 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441096,4641.250881922882,0.050544405042252105 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441089,4717.381749771251,0.057610382832681495 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_26,leaf,2441091,4207.590973334569,0.007942875018734252 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441099,121.73020836997584,0.03985533360858984 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441079,108.20284378013338,0.011304356786504766 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441080,77.51389920878596,0.15616344790083758 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441096,86.62226212560405,0.10791351073824695 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441089,113.90967008062984,0.01101756219702521 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,fruit,2441091,288.9418223053141,0.41526737567237015 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441099,412.3746357807081,0.1255101418507536 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441079,548.1925409535573,0.0018689648602823183 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441080,552.920946954806,0.0018609563143581198 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441096,603.8144105361074,0.040101386787048554 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441089,825.2709315962425,0.17579446145944777 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_27,leaf,2441091,467.4845749856082,0.07103480126159889 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441099,93.77140075036648,0.004931915975138423 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441079,111.45135469688908,0.07008303222886214 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441080,61.60018384054486,0.187420311209457 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441096,95.91330498000626,0.004876536674460752 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441089,66.49033637913159,0.15424378940875516 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,fruit,2441091,226.9146434301011,0.37886020352343097 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441099,205.048177395644,0.11201398091326853 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441079,141.73179729252786,0.04837463800780206 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441080,135.89285786560046,0.06664530035549898 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441096,136.93282458234447,0.063334365769534 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441089,393.8783880846506,0.3955202195064813 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_28,leaf,2441091,175.13149336914285,0.04352231854573052 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441099,155869.52202514265,0.1389912988430284 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441079,208333.1742298165,0.01299407152908394 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441080,220988.187454276,0.012616557352512103 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441096,283260.27319360216,0.12043316719133923 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441089,453271.14568349806,0.3246055711537785 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,fruit,2441091,68563.8575916152,0.49565725827685636 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441099,338516.0796120542,0.13151732928097282 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441079,660229.2884779134,0.15859815428363078 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441080,491060.6652569214,0.030038515937553356 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441096,425427.0069146092,0.03227157562545635 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441089,646182.658590784,0.14925866690185696 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_29,leaf,2441091,272302.07500139443,0.22604568113450885 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441099,68.10624379598913,0.06141619254313535 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441079,34.72496830805585,0.2311288780883387 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441080,50.14364249717864,0.0715548576720022 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441096,110.74215642489632,0.2725422399139201 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441089,587.0396787961238,0.9968967206471373 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,fruit,2441091,14.121219340444222,0.6218985372989869 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441099,57.13114437001603,0.2696298012538423 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441079,85.16384644940634,0.09624745632896681 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441080,214.8010944075108,0.3055337651829979 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441096,127.4212038665348,0.07873897937667484 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441089,68.48492001441514,0.1909077717005816 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_3,leaf,2441091,134.1221998621828,0.10099794350813784 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441099,189.5815359670513,0.06793938160827784 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441079,161.96817298804476,4.2697259226498474e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441080,162.28680460662272,4.265532303788788e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441096,129.94941378263812,0.09608233125259247 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441089,293.2783104478479,0.25742328975102025 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,fruit,2441091,28.516058453254978,0.754767159665138 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441099,7344.95006576198,0.01095791475945962 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441079,6092.460320744539,0.07023822347684439 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441080,7098.857434552099,0.0038424784686794666 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441096,7225.030959755134,0.003808779564566489 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441089,7742.290807492781,0.03383854693574051 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_30,leaf,2441091,6645.044922390712,0.0325330116070619 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441099,74.48644483428542,0.10137806141786387 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441079,82.1665425710316,0.05876029475092137 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441080,60.291023535768474,0.19320265096694023 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441096,105.97526119060724,0.05174918788740279 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441089,161.35867882525037,0.23433702156443714 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,fruit,2441091,163.6766203704163,0.24053134132340115 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441099,506.9285547333607,0.033022750484050345 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441079,526.6781367950628,0.01642421521985238 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441080,1204.6083296369432,0.3428763561768666 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441096,509.6930612265754,0.030660784427634535 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441089,572.0410937161932,0.019457722594860893 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_31,leaf,2441091,567.2769735293674,0.015825649643246287 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441099,157.63264320674745,0.03571021662299634 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441079,132.63895082970052,0.039264863342848955 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441080,98.23709927162922,0.1696604110929596 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441096,205.59952309165757,0.15108616162985467 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441089,299.05269878572034,0.3138117847283275 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,fruit,2441091,132.7468460045451,0.038911730038808656 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441099,2812.77651017051,0.11238440637107283 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441079,2119.6827692149386,0.010479950721152598 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441080,2115.194803783786,0.011400449279989733 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441096,2223.2270955240665,0.010233006561459312 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441089,2086.8794796185716,0.017253451553163934 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_32,leaf,2441091,2684.626780068133,0.09213309791572888 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441099,218.39962330561903,0.29109627787601067 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441079,142.2897450726894,0.10501799419839841 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441080,44.4356861860012,0.4004237160582602 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441096,166.112799011385,0.17224748909452492 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441089,81.1629529225321,0.13879776766005003 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,fruit,2441091,40.24053909675661,0.44349181682076844 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441099,2031.6202069515564,0.06969177856450948 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441079,1366.8088815253964,0.24182651015131018 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441080,2412.151888599616,0.004870348690434234 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441096,2358.3524811632747,0.004925586737850374 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441089,2518.950863229076,0.02368539353470478 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_33,leaf,2441091,2536.9537815354547,0.026778252942594172 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441099,372.46525073017045,0.06411447234914114 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441079,290.26332428705797,0.04417912419545367 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441080,340.2828593001459,0.02486878442475815 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441096,378.60679314740827,0.07121711304418987 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441089,270.7436988824262,0.07441293105658797 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,fruit,2441091,302.4067590861517,0.0263797951334257 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441099,54958.250910384006,0.017105659021267705 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441079,37907.66765258976,0.1442001791012606 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441080,54727.57843775634,0.015278988606787891 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441096,46886.339002159155,0.05188092017869028 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441089,55217.71913378836,0.019151219880581216 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_34,leaf,2441091,50943.76751832652,0.015836183661266823 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441099,88.88810063404419,0.07907070050563747 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441079,113.32376436475688,0.026406665614476132 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441080,523.1499571206676,0.6907118672834902 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441096,89.55850896879892,0.07580747223933182 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441089,99.95338257189448,0.028116830898116785 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,fruit,2441091,415.8429360807859,0.5910150017511779 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441099,11471.011626771988,0.0040816639828040735 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441079,6164.014948208847,0.27381970069230244 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441080,25432.84778524021,0.3417116080971683 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441096,12253.413313128023,0.024573698768960206 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441089,11687.64585878104,0.0040436598592163975 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_35,leaf,2441091,10671.798624802685,0.03544576235760566 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441099,4776.330156693779,0.3844045411283852 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441079,2033.0027473727175,0.013448167549760193 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441080,1909.026059823905,0.013877941066488209 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441096,1750.9407458602277,0.05141834875327467 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441089,1483.7157378263353,0.12333909469958915 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,fruit,2441091,2058.523449755097,0.01886602065682519 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441099,4987.3767202648005,0.2074808189707693 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441079,5803.087419294185,0.1416938798096843 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441080,18571.9406329334,0.36350429397637773 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441096,10280.502388258634,0.10666134555458884 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441089,5271.581591648518,0.183412059994005 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_36,leaf,2441091,10316.704666678595,0.10818800554285568 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441099,1065.7889415326154,0.34169117906991087 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441079,477.31892442809055,0.007171377352710451 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441080,451.2689974082868,0.03154453256549461 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441096,493.21344877204217,0.007054879591912755 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441089,374.3437851477071,0.11270940331280732 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,fruit,2441091,663.0234149540943,0.13554883528660078 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441099,517.4080892565157,0.09291941173493434 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441079,166.29324776341105,0.40003918722806064 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441080,454.0217442044413,0.03616285023187471 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441096,381.4731461256846,0.03944983141655767 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441089,533.6765852087188,0.10636434622877289 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_37,leaf,2441091,58.7380402953506,0.8519943496822149 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441099,126.92870238420534,0.35523478081121307 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441079,14.602626135794464,0.5838940930755574 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441080,62.73272052358622,0.04916906256192077 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441096,161.8029065219412,0.4606612593403401 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441089,49.30262426911097,0.05545502296646965 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,fruit,2441091,41.913616826566944,0.1259699206251379 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441099,77.96735743491023,0.08525014144123455 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441079,29.676511324716667,0.3342498280445554 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441080,50.17498808200066,0.10617539538670506 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441096,32.24598450986902,0.2981870323643132 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441089,133.11894217084344,0.3175771844521085 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_38,leaf,2441091,83.51059820628137,0.11507892126158992 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441099,90.18184926625996,0.10210340706386911 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441079,83.3321336442595,0.1364100420679435 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441080,126.6861603658507,0.045506629888854455 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441096,101.4806858045116,0.05083915024185881 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441089,7706.353049676649,1.8296263576275114 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,fruit,2441091,233.92272941144856,0.3118498789021018 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441099,2655.4962043875826,0.040062112560164564 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441079,2484.6385271489175,0.011179642728518235 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441080,1744.0876880717876,0.14251525612772076 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441096,2038.6237362201991,0.07474649593235405 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441089,2358.351426073724,0.011475051141276893 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_39,leaf,2441091,2818.743540322059,0.06597199151609079 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441099,54.20607538471354,0.037197066664983014 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441079,45.30717086948725,0.040683953835549014 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441080,21.471558430687267,0.36498733088986746 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441096,24.596073915661595,0.3059851085605585 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441089,105.62380226298784,0.32691089916920135 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,fruit,2441091,66.15826420407133,0.12373320403067645 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441099,114.41801657308476,0.10491379427372616 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441079,338.14498548648413,0.36569474213931663 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441080,101.47586831295637,0.15704543311505192 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441096,176.94753604318225,0.08443631024784448 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441089,349.40169047810946,0.37991679254963007 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_4,leaf,2441091,111.54703109420036,0.11595019360099723 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441099,107.8305338834295,0.04960278472455304 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441079,126.103396886002,0.0183822452651623 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441080,146.0734520360638,0.08222675252843104 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441096,115.65108591241528,0.01919482523117777 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441089,80.79324834251568,0.17496947062914248 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,fruit,2441091,127.51651590985723,0.023221897945004066 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441099,7708.703798666533,0.007763817372512083 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441079,6995.350282256925,0.03440807511640731 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441080,7435.538059749191,0.007905140211593942 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441096,7410.537468076053,0.009367833736359188 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441089,7858.631312060263,0.01612937314199181 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_40,leaf,2441091,7730.357192179076,0.008982020408111246 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441099,196.05276479889227,0.01946109963111553 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441079,175.30817214871044,0.029109710013171863 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441080,178.87004858731055,0.02037424664873244 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441096,260.85510223424586,0.14348746418090963 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441089,267.74935658354383,0.1548165642633781 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,fruit,2441091,131.86426487508308,0.15278475362262123 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441099,1243.4286839622944,0.07753713815528362 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441079,990.93633281602,0.17611226763046872 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441080,2075.0361542745104,0.144867648219277 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441096,1544.8048628900144,0.01671560808876782 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441089,1780.5596550418609,0.07839850885420674 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_41,leaf,2441091,1428.1479457913942,0.017384820264107148 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441099,45.24646860087115,0.028275295339946993 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441079,43.51650673753922,0.011344631668616767 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441080,46.12497251926659,0.03662672673762346 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441096,39.46502579877634,0.031097002636702786 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441089,41.27246907540426,0.01164894288663465 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,fruit,2441091,35.16468895561254,0.08120261340715862 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441099,146.26160301872127,0.0547287242299217 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441079,148.6863595898066,0.047587924789800784 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441080,169.73832228982417,0.00992085206604898 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441096,176.23632230802895,0.026236368212086525 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441089,175.9821881355484,0.025609660162103864 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_42,leaf,2441091,162.07135553461293,0.010152788693021275 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441099,24.915774746663743,0.7288217194725863 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441079,240.27001093925716,0.255403452742192 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441080,33.31932841300122,0.6025998762642224 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441096,231.1652727208532,0.2386264764521786 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441089,83.30145520722202,0.20464352717664958 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,fruit,2441091,183.5847404675874,0.13854046446837254 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441099,376.88924906793847,0.03164078932746772 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441079,471.0999555843833,0.06525852478054883 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441080,439.5270782822381,0.03513109763555056 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441096,325.1775867003697,0.09573393488592208 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441089,390.9963287638656,0.015681858878600963 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_43,leaf,2441091,419.7491476264668,0.015135284388506864 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441099,18941.79473368785,0.3020613364258349 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441079,34493.24743048063,0.04174837866530101 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441080,41454.073413473794,0.03808474977246945 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441096,48553.89018257642,0.10674156929993384 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441089,64973.5709573127,0.23325427389832676 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,fruit,2441091,20325.537632698233,0.27144042043154304 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441099,138480.4072375889,0.06875036582815586 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441079,171740.18461551433,0.0247332275633676 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441080,312218.57581976097,0.2843200405146904 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441096,152725.4408244914,0.026227310505911205 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441089,224175.4281278905,0.14044930998979233 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_44,leaf,2441091,126234.39570635304,0.10896099246799817 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441099,27601.954176093288,0.2443807457101661 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441079,45136.9621655377,0.030788249666417578 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441080,51769.016501656064,0.028749338164558935 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441096,75407.67557520342,0.19209497771568707 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441089,93405.55638856118,0.2850521354970317 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,fruit,2441091,24764.25664011533,0.291495280147851 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441099,23530.07202847525,0.033842845755116535 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441079,25197.38379385723,0.004110651377625452 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441080,62099.898554883854,0.38762478836006853 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441096,25676.641084476447,0.004072108082250558 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441089,35792.32579048997,0.14832381746241197 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_45,leaf,2441091,20952.56197145767,0.08422896851898365 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441099,5853.991279002978,0.004281490553687206 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441079,7009.592429631104,0.08252218624238994 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441080,3611.3891564431183,0.2054962908555571 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441096,7833.123478290037,0.13076439209129198 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441089,5739.135260041511,0.004324120225740469 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,fruit,2441091,2203.2083836190222,0.42011500506582466 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441099,11779.206272719051,0.04969899452887283 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441079,14497.6929560108,0.04048387610208959 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441080,13398.650506038392,0.006246037446406838 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441096,9474.561190998838,0.1442559165681616 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441089,16845.760266665082,0.1056755943526051 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_46,leaf,2441091,13016.00902292196,0.0063371805787415525 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441099,132.27206566978424,0.06579378920675438 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441079,211.8497790726548,0.13876609032675624 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441080,105.64225411096552,0.16342426584056025 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441096,97.54619973403432,0.1980515705633108 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441089,175.54445205389015,0.05712518337146344 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,fruit,2441091,265.6591875412515,0.2370629150126473 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441099,279.9580288589238,0.057976479510446044 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441079,263.74977571295847,0.08387730757109857 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441080,373.53917860253506,0.06726675289161488 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441096,51.52701274300369,0.7930344414123922 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441089,426.1769050172596,0.12452050457045338 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_47,leaf,2441091,359.92324722479464,0.051140491814218425 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441099,51.79995432343589,0.08919016605050278 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441079,35.9940986169511,0.0689079085327462 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441080,60.75166760085406,0.15841899284637018 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441096,48.37224090725434,0.05945699637438495 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441089,32.73278943281227,0.11015619401496357 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,fruit,2441091,7.914530237490863,0.7267140680817258 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441099,3055.35,0.030656808590714846 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441079,1898.3738174316984,0.17602242322710104 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441080,2958.089389548887,0.016607135020785257 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441096,4093.081178932611,0.1576461995405003 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441089,2736.129455520718,0.017267517171066782 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_48,leaf,2441091,2170.4210206242674,0.1178601717079042 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441099,31.365105088880476,0.00508245030865373 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441079,30.66819698513407,0.004676052558713284 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441080,31.33217459782916,0.004626241301292744 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441096,29.63599891672905,0.019544726436318216 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441089,32.53438722145809,0.020978334626868378 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,fruit,2441091,23.60956926193851,0.11827623288309352 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441099,30.470651732295348,0.013295228686828642 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441079,31.26862013554697,0.0020682555450757256 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441080,31.70973707623555,0.004015668985619003 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441096,29.822706876511496,0.022629912155338383 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441089,31.56715367938945,0.002058452487571305 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_49,leaf,2441091,33.400402698130726,0.026574730925107426 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441099,1225.3351375240063,0.027745328293973692 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441079,1372.4518551212311,0.021496902824033715 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441080,901.857699342274,0.1608621984549865 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441096,1272.4021023508617,0.011375837739274086 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441089,2040.284830081261,0.19369058476640255 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,fruit,2441091,1339.940971659033,0.011085451090278475 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441099,15909.10378664142,0.02024530457461804 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441079,15779.937242607995,0.023785747968815052 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441080,17427.474048831988,0.019343425062706032 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441096,22367.901193525584,0.1277342160058641 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441089,13408.990827747426,0.09449492593749387 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_5,leaf,2441091,17488.324780604187,0.020857190445150664 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441099,142.81300149233675,0.008394193798199723 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441079,245.70039288322073,0.2272439103426458 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441080,148.38737775832368,0.00823501963212303 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441096,104.1082476424956,0.1456768041266514 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441089,244.3940593268395,0.2249287043814454 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,fruit,2441091,5.565083768545704,1.4176902346423648 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441099,5290.846200803002,0.11082604628147319 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441079,3419.2404444499407,0.07876944906340322 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441080,3721.7791860798616,0.041948488182852905 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441096,4775.8321178313845,0.06634996091587375 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441089,3371.7289577714887,0.08484643511419998 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_50,leaf,2441091,4476.620491056846,0.03825118733391886 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441099,38.193542397956854,0.002470033137901062 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441079,37.76032691138961,0.002484161750476055 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441080,38.78545352355425,0.009148966761119981 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441096,33.95983649807513,0.0485543166760416 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441089,42.09856610596,0.04474739653050852 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,fruit,2441091,14.786212999319137,0.40966294927916125 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441099,232.77756667435904,0.04850191682119087 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441079,271.27323631091,0.01796390775962564 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441080,278.02720950401164,0.02864425997978115 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441096,269.84991866611455,0.015679250675630474 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441089,250.71276959530033,0.016266586312640552 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_51,leaf,2441091,221.7654519827708,0.06954915087136548 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441099,181.08021044683684,0.01137391496681861 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441079,166.9795717769556,0.023833732622055237 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441080,171.71856679241282,0.011679820494326254 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441096,192.4010180201143,0.03771029003666282 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441089,250.147585090491,0.1516992390045182 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,fruit,2441091,166.5479814199656,0.024957702221009903 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441099,1859.3788409028284,0.01312077840579029 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441079,1774.6505102461206,0.007134267838697639 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441080,1710.6303326790703,0.02309093750635416 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441096,1667.263655668098,0.034242822942225803 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441089,1833.437327724807,0.007018962966689912 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_52,leaf,2441091,1966.7076316583912,0.037492696911136214 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441099,103.29611436678827,0.09811030025936818 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441079,116.1484586434475,0.047180834631154855 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441080,81.68721752006647,0.2000401823617306 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441096,142.806529537376,0.04255377965458029 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441089,436.2598916493012,0.5275510016957585 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,fruit,2441091,201.899903217144,0.19294182529083193 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441099,357.3318858808304,0.08591848335469043 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441079,374.7160698947373,0.1065490303599943 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441080,278.8902998366032,0.021719878871325538 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441096,307.4952826705182,0.020685169508957824 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441089,177.93712773021699,0.2168867121931517 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_53,leaf,2441091,243.5412554694864,0.08058074755901723 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441099,797.8908699421187,0.05527275770618889 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441079,626.4511684245381,0.04978351427857142 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441080,448.14406573565566,0.19525308794929064 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441096,778.6278011013186,0.04465916837617545 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441089,1068.9354381171263,0.18228073747621654 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,fruit,2441091,553.5522290875635,0.10351213391841796 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441099,5837.314040845077,0.01233575336927295 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441079,5162.948024516905,0.040979552098245 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441080,5940.254450458154,0.019927743241071383 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441096,5712.520774529731,0.0029504873469816673 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441089,4426.058426453983,0.10786016255789432 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_54,leaf,2441091,5635.1649846818445,0.0029706694050077864 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441099,38.320706720308,0.02373965528922195 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441079,98.5099574400617,0.4337862768773537 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441080,31.02224965481445,0.06802056600821937 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441096,8.37971224707656,0.6364647490161763 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441089,34.243733644983124,0.02511274420430376 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,fruit,2441091,151.89926686517714,0.6218618232040747 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441099,39.85938411631546,0.488218486002024 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441079,69.65906032189656,0.2457714582860553 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441080,280.887111844584,0.35978274264087906 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441096,98.94899533063754,0.0933376809598252 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441089,148.6665182161363,0.08346410037291774 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_55,leaf,2441091,146.39705199259862,0.0767832614366264 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441099,185.9840814478423,0.2512569111407359 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441079,87.48617444302971,0.07627943668753567 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441080,97.84127214320488,0.027696772184839125 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441096,167.59325771181005,0.2060376799536705 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441089,104.41301074277884,5.357558023679765e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,fruit,2441091,104.15555692517952,5.364175396405102e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441099,2490.342508602609,0.061513115814767705 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441079,5409.805157333695,0.3984356576210897 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441080,606.4624363268865,0.5519420596939364 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441096,1832.565179250228,0.07168653573075456 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441089,1681.309267348841,0.10909835916027877 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_56,leaf,2441091,4864.498871331107,0.35229214099663553 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441099,175.70349390957472,0.017615063714334855 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441079,262.3490891585946,0.19171422679855787 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441080,135.99660645275154,0.09363726244649984 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441096,231.28155665006344,0.13697566778406856 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441089,161.73554822076483,0.0183598489640171 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,fruit,2441091,100.95215000068762,0.22304976127970777 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441099,69641.930730605993,0.0074057329488956825 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441079,57454.91805459599,0.07613786033446779 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441080,111651.60525163678,0.21239990154154942 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441096,50048.979202322065,0.13606984585785398 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441089,68603.01513383466,8.781336623977509e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_57,leaf,2441091,68325.86791755715,8.799128269263434e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441099,702078.8264544925,0.6731935951808579 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441079,189705.92750394024,0.10488862051508896 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441080,168423.6146084221,0.05321070324820365 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441096,55234.06684592651,0.43098525924068554 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441089,65810.84695742946,0.35489480042224564 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,fruit,2441091,129580.5106969151,0.060652593207610295 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441099,100031.37219442002,0.1611615423247823 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441079,160257.28801814115,0.04352002037669589 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441080,190154.36145323789,0.11780852233983197 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441096,129695.81733118604,0.048371798282334844 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441089,178872.19828411218,0.09124507570142804 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_58,leaf,2441091,64989.28835209987,0.34845598729951455 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441099,983.4549288711175,0.008139531106133191 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441079,1100.4501356909634,0.05695543814367454 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441080,816.7585723505603,0.0725212288172381 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441096,842.2860580960345,0.05915531804859642 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441089,946.9344785902464,0.008295000333067737 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,fruit,2441091,1109.2949199353286,0.06043209396412896 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441099,1122.8116897673117,0.03732183158667102 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441079,656.1382544459933,0.27063339816672594 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441080,996.124515796165,0.0893151283519047 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441096,1324.3279543999934,0.03436678931466419 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441089,1402.2981313505622,0.0592115982309811 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_59,leaf,2441091,1541.61024595472,0.10034583101439498 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441099,137.76019291621952,0.1363621254938594 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441079,154.7182712752535,0.0859442635475296 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441080,135.98540909868146,0.14199355564407146 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441096,251.19292643184784,0.12452153776745511 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441089,222.43324967153737,0.07171383900399242 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,fruit,2441091,243.11116022921877,0.1103190281868951 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441099,109.05289049619564,0.09255665050791162 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441079,119.36314939840685,0.05332356260100157 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441080,150.5498662232931,0.047486542193470704 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441096,249.1822294852675,0.2663232354871252 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441089,82.28991003433228,0.2148472442266216 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_6,leaf,2441091,181.49892108343283,0.1286802159783802 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441099,164.57978171643063,0.41839104030605756 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441079,74.35237685643072,0.07330941469616192 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441080,31.47706821139872,0.2999911664909882 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441096,82.24638651690923,0.11713138470191264 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441089,32.20768884904231,0.29002587972670435 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,fruit,2441091,51.25508424943089,0.08824848995687162 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441099,59.09875963557898,0.07730267209101505 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441079,78.63832058888838,0.20135853615280364 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441080,39.82615623084492,0.09410730084540297 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441096,157.04745367521167,0.5017552053429042 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441089,12.6397884084849,0.592535890048326 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_60,leaf,2441091,36.82185248070922,0.12817006015762966 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441099,167.86857143640202,0.04111518059943098 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441079,137.54210131641585,0.04541855894957347 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441080,117.10473457895516,0.11527975991246198 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441096,64.93230741414807,0.37139337789405147 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441089,168.5196968623045,0.04279645524132292 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,fruit,2441091,287.61612109544456,0.27495901092492003 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441099,477.5910087668822,0.10787828943768485 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441079,325.69741926513063,0.2741201141617404 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441080,1078.945163686421,0.24606494114645283 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441096,932.4542625247482,0.18269310706955721 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441089,632.2778893187751,0.013973563340562212 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_61,leaf,2441091,592.2380064117538,0.0144381570557921 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441099,321.83066149594384,0.4511383121261736 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441079,742.4992279837122,0.08806972359492216 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441080,998.1581734447982,0.04043363732554228 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441096,1738.3499152942488,0.2813714707328727 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441089,820.6869737812694,0.04458818981476531 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,fruit,2441091,1044.748610768594,0.06024607229741452 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441099,772818.6044101922,0.061825935918156105 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441079,1071906.6426601703,0.08025345785748694 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441080,892791.0621634065,8.46329423976222e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441096,889314.8052763619,8.479819254736398e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441089,747390.4221155606,0.07635597639679581 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_62,leaf,2441091,1186591.6073618962,0.12439776787491041 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441099,1203.363640934948,0.10667466151945781 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441079,642.3298610285474,0.16596411159703983 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441080,747.5027249689434,0.10010944364186702 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441096,1135.071981992002,0.08130117989215524 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441089,1431.3904362487633,0.18203588734310916 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,fruit,2441091,716.3197220191929,0.11861531532781822 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441099,3393.4544367349745,0.030091823058307376 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441079,3880.387192790816,0.02814121709208184 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441080,4250.4048789243625,0.06769645598098828 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441096,3357.3769789225366,0.03473373723101458 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441089,4425.826376743837,0.08526052730474065 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_63,leaf,2441091,3025.722006094062,0.07990482153893508 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441099,577.3857571115047,0.1985567150617964 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441079,963.2745909509846,0.023727323101239595 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441080,720.1310343206651,0.10261125420002415 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441096,1157.500811085881,0.10349852239963431 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441089,1565.8153339631258,0.23471776016694346 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,fruit,2441091,860.8427722380267,0.02509894419212877 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441099,6409.390047157787,0.02598488299996493 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441079,5396.398507900515,0.048727805097978916 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441080,5099.848059140984,0.07327458136879983 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441096,6735.3599483409425,0.04752899143507161 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441089,5664.905840729304,0.027639123000773314 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_64,leaf,2441091,8368.52064582778,0.14181687327601322 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441099,40.34804804802789,0.24404267847222982 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441079,49.39896359333688,0.15614737042678373 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441080,129.70096301370307,0.26307799287564193 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441096,39.06242564907457,0.2581059997452091 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441089,92.14625500468703,0.11461248157413295 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,fruit,2441091,173.5126852670908,0.38946602313955725 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441099,756.5035379216408,0.24535695528203183 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441079,1825.635882258184,0.13724624436935207 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441080,1625.551583808636,0.0868328368653648 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441096,574.3403891780026,0.3649985605763555 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441089,1863.557256130025,0.14617482190399356 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_65,leaf,2441091,1036.386283745882,0.10864626210263939 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441099,741.8548709717157,0.16241604055167125 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441079,1147.6273910079349,0.027065912091372546 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441080,855.8306807220639,0.10034714165984404 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441096,1460.1219972867343,0.13165415068800357 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441089,2160.465403809287,0.3018123230790133 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,fruit,2441091,1008.9497066770124,0.02886547472374268 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441099,6316.768165032841,0.060967548985444875 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441079,4198.500431070943,0.1164331868235986 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441080,4662.0953111961035,0.07094624100726854 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441096,6462.332899411841,0.07086193748724678 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441089,4244.293733635142,0.11172195657090489 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_66,leaf,2441091,7694.603582280165,0.1466588614225568 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441099,484.0465903841001,0.09286390654665633 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441079,804.5969557243728,0.1278273131862364 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441080,607.1875058489438,0.005571754609250856 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441096,591.7072692913338,0.0056441671136595595 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441089,696.2804574094766,0.06503313409507827 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,fruit,2441091,379.91736073081165,0.1980619322943329 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441099,659.1214174923699,0.0073557642538455426 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441079,304.70179833430234,0.34244617067499794 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441080,1657.1246671909958,0.3930339939795173 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441096,801.0135519998936,0.07731867569696771 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441089,642.8219523773988,0.018230488582542836 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_67,leaf,2441091,681.639011442779,0.007233249845675083 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441099,287.41407634616235,0.09521642366634486 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441079,234.09418753049596,0.006099019873627043 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441080,227.56513110012423,0.006185892985587138 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441096,212.38088671509615,0.03617618089119512 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441089,303.6129311725018,0.11902865405495211 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,fruit,2441091,186.32782206924813,0.09301390293506628 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441099,722.8494522718199,0.014534039701541435 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441079,605.7906989585683,0.09125929489514784 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441080,876.4363870649923,0.06913850391596288 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441096,772.0496863404023,0.01406335488712962 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441089,788.6572054715579,0.023306379573266423 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_68,leaf,2441091,476.00361916487697,0.1959716412047463 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441099,216.66106632567053,0.5516829865679382 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441079,63.555075843387336,0.019052351637197207 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441080,58.09934214641826,0.0199266747435356 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441096,35.3305211157763,0.23594784647465383 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441089,47.74020160985236,0.10521364095735297 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,fruit,2441091,274.1664128606811,0.6539163601753992 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441099,139.11146816607516,0.06256456232753971 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441079,175.84055939114808,0.16432068487190188 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441080,101.78385441644394,0.07311947881363867 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441096,204.81906675571057,0.23057201116948445 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441089,61.41985297547177,0.2924895992944634 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_69,leaf,2441091,99.8546980561852,0.0814298690291444 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441099,97.22841748877296,0.18710199052308285 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441079,99.43207972385736,0.19683529661065569 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441080,57.75083404213737,0.03913296588835946 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441096,44.025053304627306,0.1569913361388322 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441089,68.64164213736954,0.03589643812637444 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,fruit,2441091,42.22809251856965,0.17508976222292105 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441099,154.0163170937301,0.18086713684655908 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441079,156.53821401784356,0.1738134964422744 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441080,310.6198679298397,0.12379535972694278 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441096,154.64562901544892,0.17909622159675864 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441089,327.59872748853917,0.14690833515131052 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_7,leaf,2441091,319.7748564237248,0.13641044162893845 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441099,556.766664294639,0.06734770796189338 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441079,743.5553889419773,0.05829239303000078 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441080,877.2441490913361,0.13009954780059996 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441096,350.3733913674191,0.26848981566344277 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441089,1784.7054575661157,0.4385456191981252 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,fruit,2441091,263.9850794500227,0.3914415514526821 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441099,589114.11774750706,0.09561277221728393 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441079,404618.9741791703,0.06754041354313944 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441080,408217.8651083087,0.06369465112371309 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441096,547084.4483281181,0.06346771126384798 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441089,507280.024196552,0.030661102657949968 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_70,leaf,2441091,438122.27442933945,0.03299132467491894 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441099,79.61552900314784,0.25420602886222965 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441079,108.56549941795171,0.11951197944317293 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441080,144.8909564552563,0.005837465331010705 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441096,146.56896896427003,0.01083821885897951 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441089,142.43973330491053,0.0015726621117337913 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,fruit,2441091,143.47320557575915,0.0015669877478021732 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441099,3048.0538129863353,0.0756626737066739 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441079,2597.9390179242773,0.006268996112966274 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441080,2385.601719737556,0.03076201725598038 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441096,2044.124090331444,0.09785269995279489 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441089,2523.4757812042967,0.006360815446429413 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_71,leaf,2441091,2724.3438730506346,0.026901967925000658 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441099,80.33152343959546,0.11283780729375459 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441079,95.45935554488575,0.037905312394868496 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441080,117.33191260444364,0.05169233960649944 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441096,112.87160014859154,0.034860871485747236 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441089,213.32645859531183,0.31132091328180334 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,fruit,2441091,65.5459834059929,0.20117772677324552 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441099,546.9585256453634,0.06934707192531153 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441079,196.46716040392144,0.3753173560938676 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441080,248.75047884252808,0.27284339887359144 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441096,473.4147739229372,0.006634482589608304 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441089,655.7956274598547,0.14816119236414904 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_72,leaf,2441091,459.06049001688336,0.00673740837664516 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441099,57.65323478342387,0.0698017676216971 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441079,64.7387871632906,0.019460888214017258 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441080,70.67267974439424,0.01862611192023178 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441096,60.10480997651197,0.051716218694828564 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441089,81.65688294336229,0.08136735059997813 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,fruit,2441091,148.6244608491658,0.34146484503280505 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441099,1736.2506317321167,0.01021950920634751 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441079,1758.6657568632756,0.01579039992619702 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441080,1626.0970306257718,0.018246450795568858 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441096,1658.939823543884,0.0095622748637898 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441089,1680.0275885731337,0.004076494005453402 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_73,leaf,2441091,1711.7151447980264,0.004038585649193571 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441099,233.3892474609553,0.00758463073263016 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441079,310.77997834003844,0.1319568191441629 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441080,193.9126258537079,0.07289012557237795 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441096,186.2436384105446,0.09041476561493766 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441089,225.3080787568608,0.007719448660516992 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,fruit,2441091,259.339668629136,0.05337273865107983 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441099,849.2021178252443,0.013689256367562574 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441079,873.6126026753769,0.0013814344417188984 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441080,879.1791480662348,0.0013770542071358527 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441096,1196.8931995024036,0.13535507446558004 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441089,916.0187921248048,0.01920405836027328 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_74,leaf,2441091,873.1579343734018,0.0016075201638159342 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441099,157.60558256243888,0.018018399123921114 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441079,162.8581397655064,0.03225627230153494 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441080,135.59080771768626,0.047322949644821755 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441096,144.79539666451623,0.018798442498783263 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441089,190.8258574920506,0.1010840251083076 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,fruit,2441091,101.64475563685966,0.1724682213686477 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441099,9951.725670022128,0.02921269553202377 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441079,8210.12810114569,0.054335766796480556 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441080,11238.69533845703,0.0820301982171392 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441096,9440.22295324019,0.006296551125606786 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441089,8141.454558095422,0.05798369700303141 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_75,leaf,2441091,9168.46253774567,0.0063891853845552404 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441099,33.31269557578638,0.015478646941678331 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441079,65.45494676673663,0.30881134485357165 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441080,30.979924523363053,0.01605077379023334 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441096,79.45676327463097,0.3929997406585515 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441089,18.50259805075013,0.23989841479691054 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,fruit,2441091,16.60825009988205,0.2868072529796162 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441099,222.2234070273527,0.17813699424808505 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441079,182.31000553953385,0.0921576967982376 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441080,69.33349517922669,0.3277097134425113 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441096,152.44924184152586,0.014472461414536841 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441089,111.65307998593433,0.12078209973995291 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_76,leaf,2441091,142.45621123046027,0.01497141781141842 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441099,718.4799520177205,0.03282173946678091 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441079,613.8841120369915,0.03550652138060473 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441080,606.7192331300519,0.040605152520185595 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441096,912.8507527084976,0.1368068630905701 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441089,728.8687645506235,0.03905642415850741 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,fruit,2441091,587.0646168982211,0.054907009203472246 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441099,19347.52536542675,0.0501459926389094 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441079,15127.88368158586,0.05670125551548999 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441080,13506.58542833838,0.10593386225492551 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441096,26129.1297949299,0.18064551414421803 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441089,13761.329311854235,0.097819044326374 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_77,leaf,2441091,23480.20360647527,0.13422242646577764 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441099,61.37451709688121,0.011705669251873108 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441079,61.12963785917773,0.013441934333755734 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441080,63.446043618475315,0.0027107881420622704 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441096,64.35259023254359,0.008872274912582467 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441089,62.6564727473179,0.002727814727208955 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,fruit,2441091,64.82848336293902,0.012072104264092554 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441099,98.11109490432378,0.0016261442483271882 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441079,96.8877884994723,0.007075223563467681 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441080,98.84719385725415,0.001620078125220914 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441096,96.25959449068516,0.009900238837762698 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441089,100.20421100411232,0.007541706156610317 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_78,leaf,2441091,103.29767062150913,0.020746261575839586 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441099,102.92703692206632,0.023962101762205368 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441079,112.06376689029642,0.012973644481886204 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441080,110.2480871670826,0.005879490895583039 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441096,108.81078598228363,1.8037520029290377e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441089,108.72042014568105,1.8045014651768554e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,fruit,2441091,108.5288451776079,9.463903484032699e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441099,247.65018764901583,0.0010619917219014674 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441079,235.39051617057933,0.020987708433737762 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441080,246.4404962589509,0.0010645950053751463 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441096,240.0484647086409,0.012477736996845401 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441089,249.3429900468992,0.004020493433367633 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_79,leaf,2441091,259.77668547190143,0.021823501604668838 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441099,66.11513356557279,0.013109419405408662 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441079,70.16743011366134,0.012725271719955744 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441080,43.74820864903211,0.19245002430360936 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441096,44.38859739938789,0.18613887672855456 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441089,95.51306438013864,0.14665247987651564 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,fruit,2441091,85.75425056799502,0.09984535681869411 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441099,330.5312261370463,0.013866249776089301 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441079,251.5620953157714,0.10470104149766346 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441080,391.2225573532213,0.08707764275543539 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441096,318.5897831831809,0.002114400551302964 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441089,271.9582662599919,0.070843981029169 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_8,leaf,2441091,321.6995113064812,0.0021041562629382504 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441099,45.524119872420975,0.015056819933008336 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441079,45.56397309472931,0.014676791433669178 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441080,48.69623058023232,0.014196966993415217 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441096,61.388071773090786,0.11478561403706711 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441089,60.47777199265117,0.10829740516170228 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,fruit,2441091,40.967195594068016,0.06086214279431146 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441099,150.52594001604703,0.024902289844094927 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441079,130.81295553516173,0.03605830011301636 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441080,148.62031578115278,0.01936912157868953 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441096,135.20997244294858,0.021700333881982115 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441089,135.65493663246858,0.020273455319925304 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_80,leaf,2441091,156.71779937417736,0.042409266522295486 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441099,573.0228266678373,0.023993783947863 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441079,548.2038607090976,0.004763951005136491 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441080,373.8022430746084,0.1615362355939225 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441096,414.6315476257146,0.1165157960015728 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441089,536.2426466586944,0.0048167888366661415 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,fruit,2441091,566.9980871157842,0.019403454999105563 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441099,6137.317529366839,0.006840507148628383 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441079,6132.269992521882,0.006483181766871127 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441080,5150.544635540776,0.06928493082308673 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441096,5950.54377309192,0.006581431743452271 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441089,6604.434844758047,0.038697574037054316 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_81,leaf,2441091,5869.891629957144,0.01250800265110108 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441099,6342.021783947773,0.08450376151487582 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441079,5302.146382877491,0.00672774574571644 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441080,3421.1426292886863,0.18355278738426417 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441096,4420.4724404015615,0.07225528062978759 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441089,5139.1389387458985,0.006833608744110542 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,fruit,2441091,8553.885695327022,0.21443947460930746 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441099,81718.92405293966,0.11998415898292425 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441079,54116.8415812831,0.29897435691357455 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441080,137771.64919133397,0.10685305827683145 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441096,183802.04063418417,0.23204352989518284 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441089,116052.37141883098,0.03234722040347204 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_82,leaf,2441091,99392.81461299032,0.034951809711421866 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441099,484.0811507587535,0.25532177785999455 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441079,257.3757148817936,0.01902882855568855 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441080,160.56240522863598,0.2239525292015907 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441096,202.26937410573444,0.12366626386947299 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441089,280.4312102128272,0.018229951730948102 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,fruit,2441091,465.5098121651649,0.2383324451408786 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441099,1512.853895561823,0.003513569247776349 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441079,799.1068749248188,0.2736785516151503 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441080,2298.624826586574,0.18518467439780428 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441096,3164.455271408552,0.32401554279003886 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441089,1488.4737895702142,0.0035422270571983105 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_83,leaf,2441091,1197.1983460516778,0.09811731046250882 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441099,311.2413949576673,0.15623258052353783 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441079,421.6902426955313,0.024336381459669543 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441080,317.7105193114613,0.14729833920149016 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441096,470.29964173199386,0.023044714264059074 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441089,1048.9230454290264,0.37141369356787735 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,fruit,2441091,851.2909986466036,0.2807481076452252 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441099,21991.81915527112,0.21610409287334154 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441079,28683.671848900965,0.10073050302198805 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441080,53118.30988158499,0.16687899979628718 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441096,65571.37716806862,0.2583490566653035 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441089,43659.1165099936,0.08170969463644884 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_84,leaf,2441091,13795.280088590638,0.41863472592079987 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441099,42.25891386286413,0.013271401030766627 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441079,40.56032273494699,0.0045455276249806165 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441080,39.87198579138734,0.011979063727551198 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441096,41.413827861356786,0.004498444392654344 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441089,36.33275068803488,0.05234865083587348 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,fruit,2441091,46.13600726588852,0.05139307719192732 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441099,421.1762113285891,0.012876927337715838 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441079,399.1617263306315,0.0361918686987841 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441080,508.9614218910772,0.06934410412557757 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441096,459.2099886593337,0.024670565261394994 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441089,435.6506119531405,0.001797567486085505 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_85,leaf,2441091,432.051703966905,0.0018050386457879597 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441099,1117.786757799982,0.08795814824129611 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441079,967.7086797645442,0.025343824360013034 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441080,857.9971726996882,0.026914955318000366 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441096,710.932877568996,0.1085722131346829 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441089,992.020630045534,0.03611989176165542 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,fruit,2441091,735.2501832443085,0.0939656706506029 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441099,13019.467218340227,0.02543062441707189 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441079,15339.019221372366,0.045773754815599865 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441080,14589.73340087346,0.024023519228565604 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441096,10792.404790226006,0.10690561081437089 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441089,15342.021568843187,0.04585875212402968 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_86,leaf,2441091,10086.640500300442,0.13627729450740045 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441099,322.0580470345069,0.02848396189804303 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441079,281.1681429106388,0.030484080706346006 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441080,331.2363555598407,0.04068780451982201 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441096,258.05347607305913,0.06774047958752183 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441089,329.57116260467336,0.038499010891968055 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,fruit,2441091,239.51554064612105,0.10011649585313975 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441099,24157.510218374584,0.009925707812068474 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441079,26952.65829765484,0.03762372568102812 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441080,25274.454859300207,0.00970391740987342 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441096,22007.870591293653,0.05039985603584718 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441089,22698.348350573713,0.0369836228993039 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_87,leaf,2441091,27497.52089517347,0.04631566101094098 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441099,109.82635175158948,0.08071622672225098 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441079,78.5111253176873,0.06505912833446148 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441080,103.88698147581064,0.056570797079142476 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441096,63.44217669333892,0.15761225542365254 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441089,171.62696470286903,0.2745951912879323 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,fruit,2441091,71.84980202868898,0.10356475474065063 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441099,1340.1843257634018,0.007434079658033443 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441079,1294.6933040116444,0.007563552752647418 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441080,1286.9091707251605,0.010182558901682182 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441096,1148.3367928831349,0.05966117473641486 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441089,1445.2159153096509,0.04020228090650857 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_88,leaf,2441091,1740.1714143933732,0.1208615756257001 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441099,9325.623998211056,0.019707866140544983 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441079,11680.877174478224,0.11750542238751738 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441080,4640.8096474352915,0.28337627963756695 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441096,6740.952244959432,0.12124878445062492 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441089,9194.479292018998,0.01355710409049804 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,fruit,2441091,8629.309637679838,0.013993982257477722 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441099,109856.17824560216,0.06365811087310114 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441079,77153.08433192573,0.08981308309011915 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441080,76668.53404809837,0.09254921618699274 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441096,114792.1506857821,0.08274581714366924 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441089,199914.7427325567,0.3236784468572429 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_89,leaf,2441091,79900.19498561011,0.0746185363793721 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441099,137.0597777748018,0.5414884344865685 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441079,60.17844731475481,0.18401938932275064 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441080,27.251672978580057,0.16002842009805152 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441096,30.892699042066347,0.10556573531928382 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441089,9.726940981438872,0.6074453080552495 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,fruit,2441091,47.89376043625375,0.08485734869390704 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441099,133.50358875659515,0.0019716842115045097 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441079,132.29413152862008,0.0019806764399712407 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441080,131.73613955617148,0.0038163234994055273 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441096,131.4929235756401,0.004618874608751877 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441089,134.33751322709247,0.0046760485787569195 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_9,leaf,2441091,138.4227704830655,0.017686281175381957 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441099,79.82407236597317,0.041250611515946556 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441079,54.80833990400701,0.12203662092010914 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441080,65.3580913021163,0.04558390809177948 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441096,112.62645051826516,0.1907571285133418 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441089,194.71021862376804,0.42850547561194086 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,fruit,2441091,29.620311224354367,0.38929365140076255 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441099,2721.896949186694,0.02705653590156576 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441079,2240.197021339585,0.11164199928344365 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441080,3161.69036796266,0.037991121438638586 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441096,3580.240264018892,0.09198395768442413 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441089,2127.9247327540797,0.13397195234497827 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_90,leaf,2441091,3071.832491636648,0.025469315014166494 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441099,472.0725429447641,0.059300565071219946 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441079,383.3343002830073,0.031130495186128204 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441080,440.307107019575,0.02904751916886994 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441096,478.644215206212,0.06530463817199816 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441089,305.28065919538216,0.13000888551556633 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,fruit,2441091,240.499804691575,0.2335934482946227 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441099,932500.330693286,0.0714467193206696 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441079,887429.6939882278,0.04993168123183267 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441080,782123.7978131202,0.004926774733547745 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441096,694753.7540472695,0.05637137304243112 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441089,799970.1560491864,0.004871510186537975 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_91,leaf,2441091,617985.9292448624,0.10722368830693085 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441099,20.82781610681413,0.6915345283748153 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441079,17.533457392246195,0.7663107005990064 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441080,84.70672431753769,0.08226037539593034 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441096,171.1378012673923,0.22316768507227724 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441089,126.8510861480958,0.09311592725338969 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,fruit,2441091,120.03589668312613,0.06913287813087443 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441099,106920.61291600384,0.1072815102800524 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441079,49693.50488116005,0.22548030077827974 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441080,72635.04241807788,0.06063373488913726 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441096,90811.12627404532,0.036359132615924494 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441089,76224.81357880897,0.03968355848350491 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_92,leaf,2441091,205634.47667092143,0.3913160008505878 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441099,241.3988736103385,1.074337721912935 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441079,6.453248101995178,0.4986191550526361 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441080,12.34984819987024,0.21673589796599124 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441096,17.914640643106097,0.05518941649060838 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441089,600.3593619518417,1.4700137699785056 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,fruit,2441091,22.769721651956996,0.048960204228136295 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441099,42.21920451182049,0.22550952158065818 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441079,216.20250259935875,0.4838411490010639 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441080,75.87686956347628,0.02908983727219372 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441096,66.04507836717747,0.031179107878448242 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441089,194.83986828726347,0.438658259599348 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_93,leaf,2441091,27.43264625307284,0.41275186446085543 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441099,388.7518039655293,0.009900709155165721 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441079,382.4524379191656,0.0028057254637996465 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441080,377.5267580323225,0.002823969561700057 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441096,293.7852654023794,0.11174169792651512 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441089,1089.522548842611,0.4574645146809724 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,fruit,2441091,52.120467591721145,0.8627634049141781 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441099,4267.915351387143,0.017111409189660254 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441079,4248.0105953094335,0.015081203308420665 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441080,3723.066332687166,0.04220361400180739 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441096,3958.0436526172207,0.015623808315880172 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441089,4366.170678819622,0.026996320818657438 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_94,leaf,2441091,3798.158345092396,0.033531321474983056 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441099,284.1499133832279,0.4103301018339023 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441079,120.20436355599222,0.03670280717783081 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441080,100.72193778045197,0.04009335362856303 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441096,92.1010842546637,0.07895268322836624 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441089,94.88335764442068,0.06602738145868092 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,fruit,2441091,236.8054664407111,0.3311742973013243 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441099,46.902101768767075,0.11549408376196224 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441079,102.65344028582837,0.22468712027856164 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441080,57.75989867795918,0.02505996571566671 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441096,76.7884623433272,0.09860958267029263 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441089,39.29540406673164,0.19234462954625053 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_97,leaf,2441091,64.62177382823096,0.02369248652222744 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441099,1281.8078428471215,0.09191213571957979 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441079,1721.7537099527117,0.03623596721298261 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441080,1284.172271104357,0.09111177220154865 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441096,1446.0995481067052,0.03953686983899063 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441089,1871.2235041426773,0.07239060369729833 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,fruit,2441091,2334.4106099861842,0.16844218819661583 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441099,19013.36200484751,0.13696512578095899 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441079,27756.94386361172,0.02734760426979399 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441080,33302.20845144119,0.10644899209470537 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441096,24369.01278121291,0.029186107071592637 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441089,28632.500184879613,0.040835229387997884 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_98,leaf,2441091,17889.57275135895,0.1634240741762243 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441099,6072.510344375129,0.1638163073310448 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441079,8007.96394075336,0.043662461738068536 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441080,9701.873152551818,0.03967102151115531 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441096,13396.88386897556,0.1798192220824646 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441089,17702.919675357512,0.3008603281906739 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,fruit,2441091,4887.343247772307,0.2581117291602184 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441099,66950.41912195092,0.03532785595102972 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441079,77487.16922324296,0.028148639378953177 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441080,80162.278829558,0.04288889862277667 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441096,62440.64824441893,0.06561375291198779 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441089,70781.12552970195,0.011163691758580896 +1017363 Sl10g007190 #19.2,transp1-1,0.8,m_99,leaf,2441091,74467.20579691629,0.010883902220517605 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441095,118.74130957350948,0.0865018029904645 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441083,137.07168933722474,0.024155872089749675 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441084,97.26664800399882,0.1731396878423601 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441094,165.39680411435782,0.057423476275458185 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441078,152.75183481512968,0.022882798226231404 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,fruit,2441088,236.61681674616895,0.21294197006009297 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441095,550.4169920378397,0.7522422311429346 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441083,75.80759285930314,0.10873689490841998 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441084,60.88023525791238,0.2039732794884166 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441094,74.08480481276212,0.11872046048056761 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441078,319.19595366342196,0.5156077758257547 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_1,leaf,2441088,118.94336265726562,0.08689061082359051 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441095,54.66672442787479,0.005023905445261212 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441083,56.19486051140433,0.006949639881562719 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441084,56.24990213553984,0.0073748135398741255 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441094,52.82892958631748,0.019875146500497598 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441078,55.938834138389005,0.004966453033275364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,fruit,2441088,54.22543312300458,0.008543928045751104 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441095,304.1700857531193,0.02365494930781553 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441083,397.4206126860121,0.09247893902982174 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441084,321.3256019426714,1.738802620487867e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441094,347.30912992842315,0.033944750506008425 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441078,298.24544633787644,0.03219762800951553 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_10,leaf,2441088,321.06835254714713,1.7394990708741176e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441095,46.19425790951066,0.07269607264834055 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441083,17.02043125719476,0.5063135075234007 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441084,34.522995883863764,0.19917559091885484 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441094,126.25272914288898,0.3639567074221819 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441078,63.028732545061374,0.06225450651640818 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,fruit,2441088,125.53351434167314,0.3614756197767639 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441095,2104.523392639562,0.1661770417184658 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441083,3223.350519595532,0.018976735750689144 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441084,4937.875052594706,0.20420929720843484 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441094,2819.473544807173,0.03916277524320755 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441078,3628.720772499552,0.07042275164222733 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_100,leaf,2441088,2947.724057264753,0.019843973333208087 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441095,32.087304269244264,0.004964183439163383 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441083,31.77770113759473,0.009174939677774052 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441084,33.58946935320923,0.014905726952287424 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441094,31.571462972893084,0.012002709059905081 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441078,43.00225145741766,0.12219377846051849 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,fruit,2441088,32.82505762614341,0.004908081234595407 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441095,202.94656302024768,0.5691202582672179 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441083,28.91785747413932,0.27709532959151884 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441084,69.74617064819692,0.1052589255450902 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441094,94.51641733777195,0.23724580875915646 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441078,39.72290178051888,0.13922047606018606 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_101,leaf,2441088,25.382019143892116,0.3337352751687448 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441095,87.56479132907451,0.03629983703874218 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441083,85.05947124165988,0.04890667544050453 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441084,105.10870514236072,0.04300933184353983 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441094,101.66496735711722,0.028541971436550462 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441078,88.73170324766114,0.03055053601591129 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,fruit,2441088,117.4840318847198,0.09134948836882462 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441095,538.8294701466687,0.025815073862003768 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441083,576.6663234593476,0.003658175548093112 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441084,570.1120160932887,0.0013062197821955834 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441094,543.6346666860053,0.02195927120120178 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441078,573.5466101118668,0.0013023028661036662 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_102,leaf,2441088,584.7100038390456,0.009674109884098225 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441095,5502.942944212807,0.11248590772568079 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441083,8963.626881020666,0.324374668100321 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441084,2355.6136390238435,0.2560050420192175 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441094,3396.143478211324,0.09712307247347418 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441078,895.6234599610432,0.6759836412773179 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,fruit,2441088,5098.381503459982,0.0793232276443181 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441095,827914.5609605005,0.047557621542267725 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441083,974159.832512834,0.023087075997258566 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441084,1127380.6865777457,0.08652744818409008 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441094,951100.4611469556,0.01268324988150038 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441078,896351.4305320926,0.01306482643189888 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_103,leaf,2441088,516532.9582324,0.25244510475213744 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441095,5394.7179165755215,0.11248590772568123 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441083,8787.341432168434,0.324374668100321 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441084,2309.2863640056225,0.2560050420192175 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441094,3329.3523583476976,0.09712307247347418 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441078,878.009453294152,0.6759836412773179 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,fruit,2441088,4998.112886338001,0.0793232276443181 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441095,827914.5609605005,0.047557621542267725 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441083,974159.832512834,0.023087075997258566 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441084,1127380.6865777457,0.08652744818409008 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441094,951100.4611469556,0.01268324988150038 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441078,896351.4305320926,0.01306482643189888 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_104,leaf,2441088,516532.9582324,0.25244510475213744 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441095,53.081218855271906,0.00730578989405406 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441083,54.49796556930732,0.01874519347568593 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441084,43.773867554080766,0.07642017717394789 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441094,44.36662960261433,0.07057865877422342 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441078,51.31027017913623,0.007430795237566956 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,fruit,2441088,73.67397464041048,0.1496790035403881 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441095,90.62160980424832,0.006422023381556841 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441083,87.96123831662543,0.006518414625586555 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441084,194.47169403585272,0.3380466479928994 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441094,79.63543967202766,0.049703367177480695 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441078,48.754552371419805,0.2627945759279664 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_105,leaf,2441088,248.2144517705026,0.4440173144455499 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441095,159.744591232462,0.052436182937224185 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441083,171.09449261920523,0.022626315096741845 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441084,166.2479058592225,0.03510616188486537 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441094,201.3116062498791,0.04800646875236669 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441078,195.01046132670064,0.034195564387222266 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,fruit,2441088,189.3947761708928,0.0215056509475966 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441095,2963.5338091453477,0.00947281393082422 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441083,3094.2350147170373,0.009270596209810744 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441084,3440.434679836603,0.055330616602400795 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441094,3182.311248127692,0.021459953722348768 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441078,2847.4533303228477,0.02682608539878295 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_106,leaf,2441088,2953.014793458277,0.011017077516977114 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441095,309.2759637907012,0.11132375117189808 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441083,473.1043242214572,0.07328699743373024 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441084,246.49360295540137,0.2098642672545208 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441094,475.91796246247145,0.07586217645654658 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441078,326.1774606640322,0.0882159727665166 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,fruit,2441088,616.8498999352747,0.18850957849082928 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441095,9753.669724761136,0.016606570147276845 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441083,10514.03700012534,0.015994885289122074 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441084,9606.941846786378,0.02318945391215843 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441094,10608.052948932069,0.019861063070324647 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441078,13390.878477143591,0.12103445308741723 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_107,leaf,2441088,9714.344865729325,0.018361098574232404 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441095,161.5862004145185,0.04468768602107698 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441083,189.77167150851085,0.11451479995735436 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441084,66.66039148013493,0.33984872308217096 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441094,129.9863116672565,0.04981896199984881 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441078,107.81339922791828,0.13104384387624224 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,fruit,2441088,190.49241218509215,0.11616109834298527 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441095,392.91831718273806,0.10215610273302689 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441083,228.20261897982573,0.13382554830463045 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441084,151.31047296261715,0.31227718384006176 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441094,429.3680157277019,0.14068351743313023 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441078,109.48682613537964,0.45278430623727184 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_108,leaf,2441088,565.5890656953301,0.2603548322106417 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441095,147.11427388351785,0.07089451489107512 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441083,81.37286424026766,0.18628069468125052 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441084,117.65963418712091,0.026132803861921072 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441094,143.43418769870044,0.05989238058415136 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441078,132.25419758429365,0.024649167234088942 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,fruit,2441088,64.87468372713145,0.2846850440431379 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441095,1640.9262170791706,0.014255435501486335 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441083,1086.6309155360905,0.16475156138451075 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441084,1978.3049501802857,0.09545961941196213 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441094,1303.519058146316,0.085716233121782 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441078,1553.373662633341,0.009557680848897299 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_109,leaf,2441088,1622.5028976095143,0.009351862784365395 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441095,675.0642777312344,0.11517371753647776 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441083,628.0144127576671,0.14654923385124885 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441084,724.6329765946904,0.08440075062162888 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441094,1343.2703033163043,0.18364456894067294 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441078,2059.111903574139,0.3691611045915022 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,fruit,2441088,1035.513620331334,0.07063697099344912 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441095,1819.8002829239545,0.03042922574837048 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441083,2245.1312628029655,0.06078878337899951 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441084,1419.1577221979896,0.13842228924922928 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441094,2085.8243720905452,0.028824783760458494 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441078,2083.958277831915,0.028436065900857344 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_11,leaf,2441088,1723.353272143417,0.054078640869443806 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441095,511.935132503033,0.004339324114509324 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441083,518.0558882474511,0.00950100355132566 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441084,422.2329180443433,0.07932352204980297 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441094,560.0290236049243,0.043334924252035556 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441078,435.6696470318944,0.0657183068981575 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,fruit,2441088,501.75590423387536,0.0043831191318757234 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441095,2500.2871673841487,0.03814385805407028 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441083,1961.5673540651471,0.06724280880643896 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441084,3798.966046630687,0.21981937821534459 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441094,2079.824108366949,0.04181942579541742 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441078,2862.213095247046,0.09685593054280872 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_110,leaf,2441088,2073.4148335540035,0.043159832611785465 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441095,171.59574402814292,0.0020139302236414913 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441083,173.1909029977972,0.0020046342255941596 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441084,798.0272171203958,0.6654972610745258 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441094,102.43584397049406,0.2260684924132117 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441078,483.8263799212252,0.44816910157785994 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,fruit,2441088,129.04787656291572,0.12576957958409318 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441095,51955.173637487846,0.14112232595606233 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441083,21110.94396505279,0.24999882164703102 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441084,38749.387684295485,0.013758369554597749 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441094,36332.72255737112,0.01420853212590334 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441078,33272.658076539636,0.05241897759689351 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_111,leaf,2441088,43841.645481200816,0.06738037124246876 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441095,933.4598096956504,0.02516181012638352 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441083,884.1345192241606,0.0487390871351705 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441084,1074.9428313051951,0.03612793360258726 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441094,1044.8186845956127,0.023783496355862965 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441078,410.9361279283556,0.38148310973003685 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,fruit,2441088,1487.1415373594518,0.17709486990042844 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441095,100258.68673841497,0.5398267616119741 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441083,314659.4448245514,0.04310800114809421 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441084,766602.4655180854,0.3436214384625975 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441094,380330.89632168354,0.03921283369866568 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441078,482222.7556874647,0.1422989272978148 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_112,leaf,2441088,108320.22677563391,0.5062392126530559 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441095,132.64428778656867,0.08245191132982654 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441083,128.57390784558464,0.09598761957785662 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441084,117.50854947702231,0.13507099814941714 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441094,188.1085144075832,0.06926799005782547 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441078,282.41785108216413,0.24575168062707764 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,fruit,2441088,199.3002555963592,0.0943673921415682 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441095,174.6151493858673,0.2278277605866732 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441083,72.60935083114853,0.15326160531322808 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441084,35.38918592082457,0.4653835868385938 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441094,88.63861878525475,0.06663117922203199 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441078,208.3534954598913,0.30454663158385786 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_12,leaf,2441088,118.03457695146771,0.05775508856231548 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441095,93.22096063675905,0.08706452063023584 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441083,73.24153762418209,0.017691600117236916 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441084,79.33194132340428,0.016999028620159784 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441094,80.15118460476982,0.021460892079289584 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441078,39.77857196134883,0.28279986534133483 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,fruit,2441088,37.23456333722795,0.31150278828393607 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441095,203.2174386382098,0.08920510103862211 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441083,89.92234307474456,0.26488825752645195 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441084,168.5619461949539,0.008003664781409459 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441094,211.5705937561756,0.10669943271430693 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441078,130.04826038077496,0.10465132502198404 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_120,leaf,2441088,162.4059488269467,0.008153939028791246 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441095,94.1162892875144,0.16670514935768765 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441083,64.34198266855095,0.0015347927529760774 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441084,40.31335397844536,0.20151071464407733 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441094,63.88801733144904,0.001540235938473078 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441078,64.82118436554654,0.004757315278133056 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,fruit,2441088,25.730316660086633,0.3965145155474006 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441095,466.5360376920567,0.282848176560873 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441083,687.9229685389384,0.4515027900187145 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441084,203.91196259002356,0.07659431538940131 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441094,203.74325146256123,0.07695378738117276 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441078,273.47235648412766,0.05087641292234535 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_121,leaf,2441088,213.009912141691,0.057637206759599824 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441095,297.60236431478467,0.007799507633059477 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441083,390.1416973039861,0.12538549950254563 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441084,237.98112262273824,0.0892943606453338 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441094,287.00847743110853,0.007942144752743019 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441078,163.90395862971243,0.2512474266917364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,fruit,2441088,380.63972143327067,0.11467723733428903 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441095,9385.324882255927,0.006072496172590203 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441083,8142.6466580841,0.05561122514387229 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441084,11973.252731024217,0.11183533509823684 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441094,6174.316483544112,0.17578792776240526 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441078,11732.232220727508,0.10300383598077412 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_122,leaf,2441088,9124.691803255784,0.0061586099849222364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441095,167.7785124804303,0.025004815915661727 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441083,172.58646779814728,0.012734415104151076 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441084,182.85750241715135,0.012371628054411499 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441094,185.25281475935077,0.018023659887071553 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441078,159.52753517754653,0.046905500486120744 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,fruit,2441088,236.0829252223399,0.12332342216819692 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441095,235.2267883089149,0.04336107423654756 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441083,284.62297292367873,0.039422097429511194 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441084,441.0407695622087,0.22963088409027588 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441094,200.80410906370184,0.11207525762052928 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441078,73.5532486339421,0.54824599415588815 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_123,leaf,2441088,290.03169614650034,0.047597609241476935 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441095,2889.07941429962,0.1425491428915353 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441083,3836.567576477112,0.019365770505166857 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441084,2211.6128801111245,0.2585995121371578 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441094,5687.565307134761,0.15161777377569718 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441078,4186.466159056042,0.018538962296911876 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,fruit,2441088,5085.598847725692,0.10303347734273771 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441095,113167.26109055211,0.0017101625138602472 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441083,93730.81865853368,0.08354855736409483 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441084,133753.74077404378,0.07087496944918659 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441094,125400.33017974664,0.042867712398143354 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441078,92486.37241448618,0.08935322211492647 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_13,leaf,2441088,114060.2770777899,0.0017034546505128034 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441095,60.83746454103083,0.05306765920970502 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441083,76.41780093177512,0.1520910889642908 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441084,6.808176778061174,0.8980726229959978 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441094,141.95074648454715,0.4210342338027857 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441078,13.888048328597574,0.5884622277912188 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,fruit,2441088,46.84213768540475,0.060466740621052395 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441095,142.76226086020296,0.00607010906009009 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441083,166.4986193763349,0.07286732864301726 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441084,138.799260827158,0.006156154701836503 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441094,380.1991809090215,0.43146786889820943 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441078,39.17084207694582,0.5555804000863196 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_14,leaf,2441088,87.61971053312915,0.20594149392219196 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441095,58.74638510744472,0.022514499715359237 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441083,58.24247618011278,0.026255816923528297 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441084,85.37225411033799,0.13982110072600284 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441094,69.01202394966873,0.04742911670112204 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441078,18.509249735408112,0.5241068324931955 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,fruit,2441088,64.99804027578844,0.02140461497899082 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441095,571.1479732135243,0.04282189465491637 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441083,567.9842609499588,0.04523423322263831 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441084,713.092488813897,0.053575327294097086 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441094,475.2610612656076,0.12263830118152974 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441078,912.0413528881433,0.1604439954883663 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_15,leaf,2441088,689.5194496809163,0.03897598644203537 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441095,68.27882943768564,0.4140620518491376 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441083,18.9955573626083,0.14157197414474365 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441084,33.63694405603536,0.10659251773208678 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441094,11.778481538306584,0.34913470961801507 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441078,53.876166306859666,0.31117266966612944 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,fruit,2441088,9.698320286521607,0.4335274926070364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441095,9.11591872913221,0.9062832012971236 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441083,143.94693102607116,0.29211876410735615 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441084,22.96866568187965,0.504947879501221 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441094,120.88259320289932,0.21628012205156444 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441078,160.511373084798,0.33942216393528724 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_16,leaf,2441088,26.048476916274193,0.45030131127920736 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441095,2183.5157702405622,0.028560260186645703 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441083,5003.8864945899595,0.38871137710212356 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441084,1453.386135346712,0.14821505983173378 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441094,1905.568571147346,0.030571491425559483 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441078,1782.210645107473,0.05963703936210596 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,fruit,2441088,5423.121066534232,0.42365322706237585 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441095,45914.911995733826,0.033055977752845855 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441083,37379.52254140335,0.12237598428326546 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441084,56711.27051919306,0.058659643018961205 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441094,53177.34713169137,0.030716933803102364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441078,39093.47866505785,0.10290541691321664 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_17,leaf,2441088,55745.838471388546,0.051202718051929885 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441095,126.44242437539457,0.07581513585718858 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441083,100.15538035548332,0.02540339385138779 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441084,112.22171371496198,0.023999217996895084 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441094,77.1126534052985,0.13895203122025634 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441078,18.615760041081916,0.7561969062263092 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,fruit,2441088,259.7651341619039,0.3885031809288826 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441095,2012.4032825096845,0.014157581671291997 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441083,3085.03391228176,0.17138734366384334 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441084,2145.7701030888124,0.013710591272962258 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441094,1811.8235382114003,0.05975670124755439 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441078,650.2850944942263,0.5047687992765892 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_18,leaf,2441088,2207.7851573786934,0.026084210597475455 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441095,4.199678456059826,0.019304287266533326 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441083,4.321690225176891,0.031741880723091365 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441084,4.393156926106009,0.03886496368599757 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441094,3.8345050812374897,0.020202435501533222 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441078,2.311927364583823,0.2399375676728253 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,fruit,2441088,2.3041225827491507,0.24140617262812247 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441095,2717.2212513472095,0.01972229314495877 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441083,2793.759345018886,0.031786283779255076 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441084,2693.6835182414607,0.01594385958561828 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441094,2309.1489240926894,0.050950766594878516 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441078,1427.8074737142497,0.259733058498532 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_19,leaf,2441088,2499.4884604255226,0.01655157334416435 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441095,1.246740356101673,1.4661906798262767 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441083,322.90172305454854,0.9471036651513665 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441084,105.1009686182662,0.45964002120074565 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441094,0.7003939480988391,1.716624312521023 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441078,63.49483908705565,0.24077172957657433 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,fruit,2441088,9.45035648420738,0.586518506159504 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441095,721.4069791767499,0.016413655207367484 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441083,687.0741755342777,0.037590369352066055 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441084,818.0163430074531,0.03816798570575264 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441094,776.98,0.01581584515909018 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441078,450.52831698759263,0.2208719019290224 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_2,leaf,2441088,845.8972054676198,0.052723595466427575 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441095,32.013663944586874,0.12070115190471342 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441083,52.52717033698677,0.09434747215252015 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441084,12.036983969566718,0.5455188514863538 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441094,9.707979358862202,0.6389076893731743 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441078,67.93846289696597,0.2060791831267934 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,fruit,2441088,54.107900327569254,0.10722414770322941 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441095,8.329526553436944,0.7675314290841967 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441083,35.63730509154544,0.1362468910188388 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441084,193.87547685967627,0.5993711329332081 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441094,61.902468180220296,0.10355621950163418 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441078,127.66845372373018,0.41793185230091456 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_20,leaf,2441088,6.649503693148433,0.8653625145252769 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441095,5530.930816340935,0.0642231650639915 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441083,8893.08671814453,0.27047746615691004 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441084,3835.893139825942,0.09470856095878144 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441094,2416.661409671771,0.29535925393982065 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441078,6742.768820764724,0.1502632088604221 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,fruit,2441088,4010.314379802637,0.07539664154738857 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441095,272051.3553969438,0.24384086457741905 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441083,528657.7822817625,0.04468287122647574 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441084,639995.7401155793,0.12768532474099992 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441094,446767.03693532664,0.028410635736475065 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441078,507174.488502476,0.026665641340043678 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_21,leaf,2441088,270180.77899200516,0.2468373090219167 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441095,71.81978972213118,0.31347599001955695 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441083,57.33282487395732,0.21563520141851034 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441084,1.9538592523092144,1.251874863434931 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441094,413.18531805025367,1.0733767418665785 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441078,3.570843974232875,0.9899972648365944 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,fruit,2441088,12.457968422900034,0.44732091348424197 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441095,88.29463011631222,0.32275416632814324 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441083,26.81138149897708,0.1948609329530968 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441084,57.175241835728045,0.1340278850053973 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441094,108.55865683688845,0.4124843360670585 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441078,13.707795582587831,0.48621250583236386 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_22,leaf,2441088,22.066199843738843,0.27945257815282787 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441095,1810.395100174742,0.013148162981653222 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441083,2415.9428045293535,0.11216511998993273 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441084,2075.215096811932,0.04614158965068871 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441094,1728.8624669690057,0.03316108249994043 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441078,738.3750512098673,0.4026445145278261 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,fruit,2441088,1921.689880308214,0.012761774621887323 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441095,100572.6291061177,0.18257072143054476 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441083,196161.84935951463,0.1075640225063701 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441084,154828.95188692535,0.004801649088134852 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441094,193247.14883184189,0.10106257029827947 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441078,96460.52836399087,0.20070088831226762 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_23,leaf,2441088,151424.1671168694,0.004855331180936062 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441095,71.34991730194886,0.1189134898705837 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441083,90.64318172833757,0.01497182236230854 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441084,68.87566672024774,0.13424114807825505 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441094,97.00180226380056,0.014472839446821428 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441078,99.51908905529385,0.025599428111740208 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,fruit,2441088,133.23125023674356,0.15229913936162265 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441095,227.5504712963809,0.114970355859358 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441083,204.27054682403408,0.06809836800544522 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441084,79.54104564688984,0.3415160875585619 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441094,240.98414153638092,0.13988108037882574 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441078,57.15318598075319,0.4850669385102988 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_24,leaf,2441088,144.98022869435948,0.08079860300246722 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441095,57.74660493137316,0.013867822979119149 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441083,60.849043749807,0.0365951245615217 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441084,66.54107012811691,0.0754311479412042 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441094,51.138916781365054,0.03890710845495193 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441078,51.752538543761545,0.03372697558531712 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,fruit,2441088,54.11695309081136,0.014325296233482332 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441095,3715.478269933489,0.04450133854895233 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441083,4348.781790735811,0.023851552357966543 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441084,5424.065911127271,0.11980889405185202 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441094,3883.989673515562,0.025237997650661814 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441078,4364.452602421921,0.02541371723800223 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_25,leaf,2441088,3678.688059347972,0.04882310156757219 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441095,181.76711216330065,0.07561890394037984 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441083,194.37433180101516,0.04649529792679763 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441084,226.54356776720047,0.020017524473083803 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441094,263.8852863951224,0.0862809643561091 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441078,312.51542383848357,0.1597372449827148 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,fruit,2441088,206.13382791650045,0.020984943122010602 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441095,3983.243316785376,0.018982009286897306 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441083,3078.694263525241,0.13085228294488616 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441084,8764.048260894491,0.32348591499521184 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441094,3471.9307361711217,0.07864779286027179 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441078,4908.828945023691,0.07175905334289956 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_26,leaf,2441088,4339.161581464354,0.018186977239764257 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441095,78.54049312503459,0.057022429385067186 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441083,82.59900994705283,0.03514121130682146 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441084,101.4468814259139,0.054122647853943606 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441094,96.52180181162048,0.032509367370447295 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441078,26.24310180329559,0.5331008879215111 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,fruit,2441088,192.55198619407057,0.3324319496820951 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441095,626.9168187026017,0.00983803801018368 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441083,340.21566311346146,0.2556175789596078 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441084,1001.7512589680396,0.21338801382833728 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441094,598.8331159012158,0.010066073952021526 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441078,411.87653501170576,0.1726048325821088 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_27,leaf,2441088,885.7629626365757,0.15994563362039615 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441095,61.63891440861557,0.10210008478832155 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441083,72.52701819002884,0.031455243419775236 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441084,83.42286784634545,0.02933004954416263 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441094,92.99083964845175,0.0764851030742617 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441078,21.37049001655774,0.5621405855872488 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,fruit,2441088,209.72823805043896,0.42970184224962216 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441095,282.01471864397536,0.031096860365326773 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441083,156.08442661137573,0.22581534151876426 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441084,420.7493664683312,0.20484855589141215 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441094,215.0996552988352,0.08653520040698837 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441078,243.0404167066174,0.03349641368815215 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_28,leaf,2441088,951.3700793044712,0.5591745738584808 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441095,297545.29598994885,0.08017919273587282 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441083,541919.0829940803,0.34056054842398353 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441084,148843.624411102,0.22064365923798235 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441094,197225.31124164705,0.09841124589384709 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441078,127832.6586902695,0.2867320744265873 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,fruit,2441088,307806.14788437675,0.09490339385986868 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441095,933172.7885423092,0.07061333472983566 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441083,1581215.6235010915,0.1584156958768661 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441084,1524275.3722538657,0.14248803183812608 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441094,1160876.8203046042,0.024210738604656612 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441078,902737.0124078676,0.08501415195420758 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_29,leaf,2441088,1034986.9666315044,0.025640520094054153 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441095,7.63389825941864,0.8302543545284753 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441083,88.89154586289477,0.2358597367048738 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441084,39.11295231877163,0.12068012358276503 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441094,59.11780985979436,0.058717614225595405 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441078,44.16563573105106,0.06791623597188656 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,fruit,2441088,231.02721766584375,0.6506624256642224 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441095,27.553599628939985,0.03317516764219741 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441083,23.500799772946177,0.03592053358656555 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441084,19.221562856426186,0.12321447975495436 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441094,8.803050647158411,0.46236997538581825 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441078,37.63828129850274,0.16862660783083783 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_3,leaf,2441088,88.47813656402957,0.5398327914872811 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441095,156.73676915428618,0.010511255514675799 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441083,164.41634786381476,0.01026285126791393 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441084,169.70052418590714,0.02400103796509878 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441094,169.7177404382565,0.024045095248869774 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441078,93.93678742913694,0.23284644230073814 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,fruit,2441088,119.48364461519022,0.1283736844026535 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441095,8286.259042554884,0.0041765071273234256 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441083,8466.7584018364,0.005182154309630427 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441084,8446.401815514524,0.004136724920280166 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441094,7860.729302761373,0.02707217220306113 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441078,5825.915708579293,0.15717081627611407 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_30,leaf,2441088,9123.25566260131,0.03761483225895068 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441095,61.59443050906406,0.11112350924432546 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441083,73.16068557070662,0.03638718692335319 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441084,55.05623337855889,0.15985845719598846 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441094,85.94838875313336,0.033572786107002095 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441078,116.06595680432326,0.16403990250060008 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,fruit,2441088,112.0014021419009,0.1485585062095931 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441095,562.1626566252044,0.00744454643720216 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441083,581.6016383250931,0.007319081898574886 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441084,548.0105522769139,0.018517618157185556 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441094,1109.0493080531246,0.28764431587497175 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441078,587.917124327247,0.012009570790026736 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_31,leaf,2441088,547.1402384475094,0.019207883966067207 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441095,70.24784697762563,0.2629353068260454 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441083,77.69906528470308,0.219152530644954 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441084,132.75253695918116,0.01347450445116305 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441094,134.4405139652519,0.018961839166130368 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441078,124.6414047027961,0.013905990105046673 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,fruit,2441088,143.93292125237278,0.048591814952593015 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441095,2692.1020670913476,0.041005276937326585 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441083,3225.2416158950823,0.037465456508205985 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441084,4638.753172004643,0.19530446589177508 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441094,2362.4305707275284,0.09773774451308581 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441078,3824.101134166508,0.11143257089547909 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_32,leaf,2441088,2482.284480933805,0.07624524632780805 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441095,62.90699679116564,0.04488657331654888 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441083,89.74087165727144,0.10940475796109328 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441084,61.69882707196368,0.05330861764002148 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441094,123.37859911721698,0.2476543092289687 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441078,37.75902996281197,0.2665646969235602 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,fruit,2441088,76.60627421785625,0.04067881515809435 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441095,2617.6599550724295,0.06855104217830066 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441083,1379.5256125069484,0.2096324189637766 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441084,2786.8872451164634,0.0957572108762097 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441094,1794.929467696429,0.09531479952412969 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441078,1853.2114931851272,0.0814372021065064 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_33,leaf,2441088,2657.6058581094226,0.0751283853763538 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441095,502.4001282276186,0.0724273410405849 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441083,433.6439744684003,0.008510915664212249 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441084,358.64834895455726,0.07395356464157521 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441094,416.8130961841663,0.008681044581926312 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441078,358.21033889365305,0.07448428395729545 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,fruit,2441088,487.1454507024406,0.059036250632146015 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441095,40365.2093136856,0.04992732039879577 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441083,28003.406676547107,0.10886902101606655 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441084,51715.12554190374,0.15753769484068325 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441094,33546.38201812988,0.030434200147780643 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441078,30989.334428683356,0.06486763965002851 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_34,leaf,2441088,38416.72140668505,0.028440409709673098 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441095,322.6108432893859,0.4497027875375008 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441083,34.97466113201737,0.5152226575308227 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441084,93.73938783239949,0.08705405983295167 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441094,135.35063131026274,0.07248411291817769 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441078,986.5045516183576,0.9351229205229656 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,fruit,2441088,80.014211409526,0.15580904350510005 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441095,20925.991836038454,0.06769777150912226 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441083,8178.8780078823565,0.3402945495242746 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441084,25129.154923817405,0.14718960377289747 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441094,15413.180931525378,0.0650960035256043 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441078,4300.163889454376,0.6195032721520399 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_35,leaf,2441088,20397.969729144224,0.0565986629092059 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441095,3430.210206777156,0.07239142017566635 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441083,3022.2733051168666,0.01740442047317181 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441084,2784.8267694463525,0.01813112969240116 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441094,3214.229342226961,0.044147546694015105 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441078,1702.635698355482,0.23180757989272216 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,fruit,2441088,1998.505661659265,0.16222393176021743 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441095,15919.519613653263,0.04411808444955767 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441083,7745.402721926334,0.2687678701011942 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441084,20631.103691936827,0.1567105879225208 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441094,12897.354864656008,0.047311224499349436 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441078,4804.5641163052715,0.47615788054537767 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_36,leaf,2441088,15866.154330018777,0.04265980044244788 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441095,787.8938426913818,0.0644598333631512 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441083,722.3941747423984,0.0267663620833547 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441084,636.0377167750966,0.028525003266834492 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441094,798.0980128096539,0.07004835629358075 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441078,514.8723245149271,0.1203083249627186 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,fruit,2441088,513.5531926733064,0.12142243966393274 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441095,336.78148313424714,0.031803620011317424 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441083,288.705035003578,0.09869746716132433 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441084,612.6204958474106,0.22803969729576012 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441094,387.9578313310575,0.029632697791524 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441078,246.65716800880176,0.16705808433951352 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_37,leaf,2441088,406.1091993433677,0.0494910022233479 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441095,117.9733367707114,0.2653432217062779 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441083,28.345203658533073,0.3539610597994842 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441084,61.958806420045704,0.014337598636394056 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441094,19.2065066312533,0.5229922609722213 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441078,66.1180434150545,0.013879351800524686 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,fruit,2441088,94.86693528248638,0.17067422921895004 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441095,30.031891558828708,0.2832028874399706 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441083,30.256362795045337,0.2799688555122659 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441084,153.31939019924604,0.4248115087158839 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441094,70.6823722056746,0.08852554210851848 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441078,58.288489761254915,0.004797228474200166 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_38,leaf,2441088,57.00786326294476,0.004850811215661777 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441095,136.7725029584107,0.12227944364795995 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441083,104.43801511105156,0.005139258273769265 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441084,71.62631506172738,0.15864674229301978 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441094,89.65889038489122,0.061125991253415 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441078,803.8076502500248,0.8914327842751923 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,fruit,2441088,101.98083131764405,0.00520080311766602 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441095,2362.1384493192736,0.01170048240862176 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441083,2217.9498577487752,0.03905410761642436 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441084,6882.4151344850015,0.45273503367281087 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441094,2119.677108328514,0.05873612160690689 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441078,2491.14690508908,0.011393507775284473 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_39,leaf,2441088,2596.3719858879103,0.02936108333308507 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441095,31.91209102765038,0.1474084894389882 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441083,36.914106847878465,0.08417138659538437 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441084,49.34890279509705,0.041913749627272345 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441094,40.26878760379485,0.04639519730248254 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441078,74.14783417865137,0.2187347184779873 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,fruit,2441088,57.925205085061485,0.11150382854497365 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441095,210.36,0.07662183707560821 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441083,221.10642990707825,0.05498362691167724 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441084,335.6656963481783,0.12632196119118477 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441094,118.88467779817728,0.3244591141231439 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441078,349.72729716224785,0.14414453227513357 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_4,leaf,2441088,280.79102670521377,0.04879822562721037 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441095,152.0026834770604,0.004094344309547804 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441083,181.4461851044533,0.0728022421974579 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441084,133.50063640492945,0.060462263407360606 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441094,164.38705063050602,0.02992200416719326 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441078,127.9008653330892,0.07907211664365255 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,fruit,2441088,154.88226966208805,0.004056104792077075 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441095,7575.389240107268,0.02746385930114359 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441083,8307.483609779343,0.012600681060398689 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441084,8064.061731233186,3.1496836771305325e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441094,8095.496797416308,0.0013746932623353025 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441078,7243.244717541155,0.046935653692846024 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_40,leaf,2441088,8075.762757695344,3.147401051277754e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441095,172.85204100766208,0.018952260656857067 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441083,170.22320027388582,0.012296499863174049 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441084,160.71907391966232,0.012654830031056274 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441094,150.4025038585708,0.04146718499946722 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441078,155.06743318514995,0.02820165321148238 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,fruit,2441088,185.00463715042767,0.04846036282459476 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441095,1392.8840829736837,7.462638859898618e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441083,1034.6603268553745,0.12986344268427263 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441084,1397.6750840737827,7.4498375319898e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441094,1485.0561857171028,0.027081645642341723 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441078,989.4556466460092,0.14926490816117433 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_41,leaf,2441088,1453.8403556567416,0.017855480372795718 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441095,49.78803201201017,0.046992773003114996 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441083,43.82000891737544,0.008459725506485993 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441084,46.13665005754939,0.013913870471162548 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441094,44.47284204490415,0.0020373031080329618 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441078,41.85501323884964,0.028384703476830975 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,fruit,2441088,44.89107212574392,0.002027790595680923 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441095,151.70820973074615,0.013837304933937755 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441083,163.83957602067576,0.019572427122680036 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441084,162.25605576872226,0.015354526322789663 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441094,149.63013974048897,0.01982730679273903 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441078,157.61709178895202,0.002756921706525972 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_42,leaf,2441088,155.6223086183197,0.0027745346418717176 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441095,836.2246831629915,0.3439177514043892 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441083,1404.16147529955,0.5690118222845553 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441084,78.3903464463053,0.6841426474184813 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441094,208.98086498684435,0.2582987088133857 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441078,548.6108679966841,0.1608591755044868 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,fruit,2441088,40.86169274239754,0.9670888774199562 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441095,252.00871569488768,0.04381703536291637 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441083,279.0040605877196,3.7792755018939417e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441084,278.51868736805636,3.782567131143111e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441094,223.28968476421292,0.09636393584916636 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441078,292.04423999082394,0.0202160486063252 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_43,leaf,2441088,322.25014556961895,0.06296052577562827 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441095,72163.646612842,0.11536512165362023 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441083,118349.74065232268,0.3302139611267272 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441084,24584.468754489902,0.3522925213779855 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441094,43652.55596413199,0.10294367164862983 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441078,19908.35111672433,0.4439180577993982 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,fruit,2441088,67005.57868881203,0.0831576128554925 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441095,514507.94625921577,0.0075211371864494225 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441083,497691.4355256444,0.02195305645398271 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441084,672981.9557143771,0.10909019613885373 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441094,532483.706918822,0.007393099905265821 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441078,207883.10308468775,0.4010940328068573 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_44,leaf,2441088,534707.5480145694,0.00920309096356231 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441095,86190.40616426645,0.10478964069502883 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441083,136773.57869678727,0.3053329238428075 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441084,32738.871246584476,0.3156055846341834 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441094,49234.73041580696,0.1383977223060997 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441078,32815.58830027884,0.31458909213229 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,fruit,2441088,88710.01471715068,0.11730336470229474 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441095,146871.901495131,0.005239338420989448 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441083,117848.49384636678,0.10085401954694007 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441084,152421.97061694154,0.010869516211736041 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441094,152392.00327194433,0.010784122143705055 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441078,33552.963606776604,0.6464471701820154 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_45,leaf,2441088,150437.095406873,0.005176883631700768 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441095,3924.540144453317,0.13087800751024226 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441083,6685.005340835439,0.10043497518070277 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441084,2936.7851234371697,0.25679461184557306 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441094,3346.2463984407245,0.20010886662246508 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441078,9355.104081096277,0.24638184025999044 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,fruit,2441088,6755.179444207732,0.10497010669823226 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441095,48027.617487418785,0.009738535956802075 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441083,49641.76815958355,0.024094734859186673 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441084,39217.23860923957,0.07827549653964283 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441094,73711.34727910355,0.19578184209641947 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441078,35937.39826352253,0.11620587453529829 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_46,leaf,2441088,45897.663456645016,0.009961929933358427 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441095,110.91304275882972,0.18986408462423743 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441083,125.36972551841455,0.13665402936940074 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441084,104.62552032612123,0.21520907354909458 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441094,265.8416158863772,0.1897762636861886 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441078,226.02285566110368,0.1193056532684027 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,fruit,2441088,218.09069717160267,0.1037904364053075 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441095,430.9458478733337,0.0848997816814423 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441083,558.4242133979911,0.027641758769866964 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441084,719.5447349299174,0.1377353173443927 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441094,453.17966767930903,0.06305206574984634 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441078,538.7500698085931,0.012064857083783576 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_47,leaf,2441088,509.2286838854595,0.012409623704082051 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441095,42.13934469046891,0.05639824842021435 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441083,62.36062081652765,0.1138244040298082 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441084,67.33279969484296,0.1471406467634675 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441094,32.56814902341296,0.1682929494303922 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441078,53.826352254862606,0.04990892318915896 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,fruit,2441088,36.6929788295012,0.11650305570570829 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441095,2682.0407701072827,0.07570658161933874 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441083,3151.89613699693,0.005600059016855674 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441084,3676.793967605451,0.061297337514965466 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441094,3233.707423947112,0.005528766737423307 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441078,1779.7998503360068,0.2538007910466784 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_48,leaf,2441088,3412.075240078725,0.02884664231939338 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441095,30.935627523247852,0.003482514460795061 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441083,31.15441907912359,0.006543242029687368 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441084,31.928797690770725,0.01720614951125854 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441094,29.56097754769352,0.016257623982820935 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441078,30.44147905989137,0.0035106658909493937 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,fruit,2441088,30.154720136476023,0.007621113390882561 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441095,29.82536053780393,0.02336051268194539 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441083,35.6824762579947,0.05450877056198733 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441084,31.222347413456035,0.0034806630908135183 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441094,33.078189094003335,0.021595510611144064 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441078,31.724822713348804,0.003452988885204622 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_49,leaf,2441088,30.162901467564293,0.01847309953111287 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441095,1214.2823000390265,0.10175888516114728 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441083,1000.0546367875338,0.017462948389901367 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441084,756.0603424908109,0.10400432073485533 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441094,921.2258639553196,0.0181946568821032 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441078,439.03895881142824,0.34005771966233533 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,fruit,2441088,1483.1185840247188,0.18861509738906035 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441095,19514.983340753577,0.05345480934341129 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441083,22368.752090931048,0.00581876211088872 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441084,24500.28872663432,0.04534820817176666 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441094,7222.8607141860175,0.4851137542229478 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441078,21773.34786844485,0.005897782954508379 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_5,leaf,2441088,23323.787034894955,0.023976073086919847 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441095,113.00729341929625,5.679961840980852e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441083,89.88791498628507,0.09997316288648372 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441084,113.30308213720184,5.67254295047892e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441094,101.49193852265392,0.04724292193802038 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441078,134.3886269783691,0.07468804719775424 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,fruit,2441088,164.07415618914249,0.16136570975438014 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441095,5776.418311352206,0.086974138265699 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441083,6883.709912406734,0.01081021394142212 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441084,11921.474587242512,0.22769720303693353 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441094,6498.316885479525,0.03583188873936116 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441078,7230.701425250794,0.01054765443378658 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_50,leaf,2441088,7905.225624568647,0.0492814954229166 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441095,37.565692526039776,0.019235598776691454 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441083,36.889883041087614,0.011351477583230407 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441084,38.1008765766324,0.02537916676650287 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441094,34.353610293252814,0.019583416004842924 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441078,34.98643081012374,0.011656161139380172 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,fruit,2441088,33.043909227059466,0.036464380252858364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441095,246.25478359171825,0.030550171518573865 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441083,294.2658963993166,0.046805085863033113 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441084,262.9378062981958,0.0020818118294694266 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441094,265.4646682341488,0.002071880151750971 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441078,230.94473057001815,0.05842678963769421 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_51,leaf,2441088,269.31452175733347,0.008324924610981999 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441095,199.59464781557935,0.03941078202162984 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441083,161.21945769227662,0.05332065341630754 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441084,174.9134624915866,0.01791487243444001 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441094,170.7062310495654,0.0284887355169805 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441078,189.645773167147,0.01720505821130036 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,fruit,2441088,197.4222422018348,0.03465797069079324 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441095,1665.6148242929423,0.01993502179695472 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441083,1781.385465334158,0.009248305216924102 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441084,3394.5547829714537,0.28927322263674426 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441094,1275.758851060311,0.13574100918799648 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441078,1933.2813996938096,0.04478547328427274 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_52,leaf,2441088,1706.3183380591868,0.009449541055578603 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441095,77.77296517099295,0.06589941956127499 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441083,68.27979783762811,0.12243585014907032 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441084,63.13941693304408,0.15642750969647 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441094,103.26016988131374,0.057204758465872585 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441078,177.6390389971951,0.2928103382970375 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,fruit,2441088,144.91961690936947,0.20439910058221744 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441095,201.45490493104168,0.12392273318825486 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441083,279.62364025982276,0.01847330620085952 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441084,349.00077099339626,0.11472580733686089 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441094,256.33413376040494,0.01929413783434608 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441078,248.80827326463856,0.0322357618126059 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_53,leaf,2441088,431.3504952552477,0.20672972196660133 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441095,558.8436964378799,0.003215554523799291 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441083,571.1927964706505,0.006276810621678397 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441084,435.62058654691873,0.11139751568166867 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441094,567.149864004875,0.0031919211518105506 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441078,372.4646241863398,0.17942088035333015 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,fruit,2441088,914.3470882554436,0.21060517508707255 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441095,7142.452077379549,0.040242706611175905 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441083,7897.392862814048,0.003393701158387774 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441084,8435.4899722215,0.03202027173098454 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441094,7774.448879939248,0.003420429508858458 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441078,7222.677436002193,0.03539182200783131 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_54,leaf,2441088,16508.688523974146,0.3236225318441761 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441095,81.53490191942679,0.2352022013462136 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441083,67.75664289399766,0.15481052830855035 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441084,41.583665890849005,0.05721857898825289 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441094,43.33593584101431,0.039293172160704604 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441078,4.284953828374899,1.0441952051310788 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,fruit,2441088,51.54333696709156,0.03603118001737826 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441095,96.23013977809728,0.011230017390217562 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441083,27.183839113041017,0.5377703080641714 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441084,245.88037334111328,0.4186427646412949 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441094,19.751736409711036,0.6764758180056638 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441078,91.31728054646985,0.011528129631719786 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_55,leaf,2441088,127.62180031803013,0.1338437675421824 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441095,79.8276800627467,0.24782673132149058 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441083,195.45569725720145,0.14106809463268322 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441084,96.76426979158292,0.16426521572747288 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441094,129.7797113399995,0.036773435537390764 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441078,274.4119080541654,0.2884227141824831 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,fruit,2441088,152.71494364811602,0.03390129685668741 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441095,5773.981459786875,0.12038819989629079 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441083,6111.007220631423,0.1450256117387383 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441084,2978.2174813836937,0.16713077663535536 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441094,2672.9675985916488,0.21409349081390738 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441078,1901.385331827444,0.3620170458973395 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_56,leaf,2441088,7419.247788507841,0.22927269078363022 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441095,148.88867064909343,0.011490739512497239 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441083,168.14760359853614,0.041338290375274145 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441084,139.53421004484127,0.03967169383310987 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441094,132.1683595146419,0.06322489232277384 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441078,156.87253875485192,0.011194533180273858 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,fruit,2441088,189.8761642093044,0.0941180578649714 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441095,100498.88655027687,0.10492999667798397 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441083,44891.99798786734,0.2450623186790848 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441084,106200.74194099716,0.12889629737064912 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441094,66554.84388864927,0.07405158436884918 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441078,53473.70423950583,0.1690909837957495 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_57,leaf,2441088,91301.21257424388,0.06324529199199524 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441095,284554.49503529945,0.10146494065564582 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441083,547433.9100231295,0.3856311858849777 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441084,323000.602284977,0.1565028223587861 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441094,28603.03907891511,0.8962883303222222 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441078,165982.54912813124,0.13263807966898344 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,fruit,2441088,124985.52381550944,0.25584079510369495 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441095,324497.78521956195,0.07671888506117064 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441083,452127.8765047776,0.06733066278785582 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441084,419835.42543664086,0.03514845923815102 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441094,384738.0622468782,0.002765468726766862 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441078,166379.8820267031,0.3668298100158518 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_58,leaf,2441088,389653.5096956068,0.002747970342886319 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441095,959.0174325269048,0.017702127948043156 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441083,923.1951871176994,0.03423509785736378 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441084,717.4979044180972,0.1437079926001532 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441094,1371.4500517978154,0.1376513656535403 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441078,1038.8130040380613,0.0170087479908112 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,fruit,2441088,1501.1378814717384,0.176891955017064 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441095,1400.5536198033594,0.0018402627378426573 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441083,1435.2584046350803,0.012470621120808545 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441084,1236.1505724657206,0.052388103263453445 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441094,1388.7094274808987,0.0018480937911768969 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441078,771.3876841068649,0.25718677689652436 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_59,leaf,2441088,1512.5724534135975,0.035256709288284505 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441095,182.48632471754055,0.10966569101541213 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441083,132.06022408212837,0.030792603689444142 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441084,98.7040368530406,0.1572297184935454 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441094,151.4669107767082,0.02875313436432947 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441078,118.16421284978424,0.07907866728101975 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,fruit,2441088,237.62289802842724,0.22432365465004267 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441095,134.5275798924132,0.0014216371369264458 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441083,232.1727722972903,0.23557832059057482 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441084,135.40975903628987,0.0014169986719867467 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441094,226.20574419992587,0.22427066248690242 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441078,103.96752249411468,0.11333527155895728 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_6,leaf,2441088,97.75899830065124,0.14007622371408734 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441095,70.5364235640291,0.029006565285001118 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441083,33.47730372258743,0.2946563979483596 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441084,66.70674896846384,0.004762904917012811 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441094,65.25159785705671,0.004815719417523789 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441078,139.11830571083323,0.3239774094552679 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,fruit,2441088,24.683005594983705,0.4270088287416747 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441095,121.85771907059927,0.06873689354071866 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441083,171.55123980377303,0.0798039227640559 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441084,83.06613587277329,0.23516593016532195 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441094,332.5049129400203,0.36720812832931493 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441078,44.55748817229122,0.5056692378075223 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_60,leaf,2441088,163.6513670808665,0.059329699295808336 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441095,94.45775519683492,0.005467875608762052 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441083,80.00773830530403,0.077573502145029 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441084,148.7710281960856,0.19181286864911273 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441094,117.1352654210448,0.08798217007277342 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441078,94.73123138472266,0.004212313282419444 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,fruit,2441088,96.57780824672832,0.004171849326497723 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441095,570.4234894517868,0.02520015563491107 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441083,445.6191382031351,0.08203341097229133 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441084,638.5650460226958,0.07420789692748109 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441094,506.10924737594735,0.026752972782964513 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441078,496.42986410231725,0.0351393455863227 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_61,leaf,2441088,581.0647914556752,0.033227315590032 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441095,2257.5864706348675,0.052585473668620875 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441083,2838.7707682100895,0.04690045707430368 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441084,721.8476531854321,0.5477843185589699 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441094,3311.225087900324,0.1137588364629214 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441078,608.0967128548796,0.6222572116430589 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,fruit,2441088,4612.003929461052,0.2576598012175868 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441095,673069.1679520078,0.23774134357112242 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441083,1181769.348626938,0.006731681199123152 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441084,1785771.1946234885,0.1860247729391613 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441094,1150656.5772096892,0.00485531610280443 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441078,1176529.1035682638,0.004801634341578875 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_62,leaf,2441088,762232.6095688337,0.18371351569205085 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441095,819.7661577445426,0.07201129591914546 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441083,1139.2284841006367,0.07090955371184338 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441084,703.5231605280943,0.1384228820532174 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441094,296.3406630277075,0.5139100331409243 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441078,2599.4267664309064,0.429176305206568 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,fruit,2441088,1115.458001212921,0.06175194167171538 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441095,10432.136331023636,0.030752905120243312 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441083,12664.998833071437,0.05347899504510334 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441084,11963.126037726985,0.028718519209919968 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441094,14056.425771562706,0.09874874447487958 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441078,7761.005035329847,0.15920819386042417 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_63,leaf,2441088,9834.825950956949,0.056359480546470664 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441095,1022.6178344187696,0.026119527845533508 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441083,1149.3974950070833,0.024637355916359294 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441084,573.2075527892833,0.2775209861988541 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441094,1477.8762785619338,0.1338051879342137 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441078,392.5796496788187,0.4419051072459852 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,fruit,2441088,1649.425136567916,0.18149971836626744 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441095,5673.3353277727465,0.034587828833819945 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441083,4657.124944092416,0.05113273527236517 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441084,5781.121051532437,0.042761438340781055 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441094,3923.596866896847,0.12556624580401365 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441078,5394.1108226866345,0.012669239973710056 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_64,leaf,2441088,5083.942893185275,0.013049961294913537 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441095,41.22781382340273,0.24579234215522505 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441083,56.92155443115216,0.10570589692599719 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441084,48.63315795396685,0.1740501773087273 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441094,111.402471405017,0.18591217719216857 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441078,88.29383505377342,0.084947732517898 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,fruit,2441088,136.11226220151397,0.27291460372387455 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441095,667.7789588214605,0.27285301036096765 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441083,1968.0440526953828,0.1965490744265468 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441084,3932.133464408851,0.4971425092017072 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441094,750.649485885259,0.2220485495347564 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441078,784.7241834478533,0.20276870422259963 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_65,leaf,2441088,1718.592171121991,0.1376870880503982 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441095,1284.7764494328503,0.008291098206244296 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441083,1236.1865100880918,0.008452468941857472 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441084,800.8604296559723,0.19697963318074363 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441094,1347.241775921531,0.0289090722010914 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441078,534.1138476801126,0.3729026311429937 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,fruit,2441088,1609.6858054832437,0.1062046454033374 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441095,4570.872643619284,0.02513361815761961 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441083,4056.8365517066577,0.026677992219412694 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441084,7138.714594962371,0.2187545165309266 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441094,3266.4487047995062,0.12078966016190318 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441078,4821.748664330342,0.04833906612124128 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_66,leaf,2441088,3868.734623574948,0.047296562479747895 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441095,879.5741066357091,0.1083141481023846 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441083,633.7946066262242,0.03400974861203654 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441084,532.934498131144,0.10928445370896522 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441094,837.7458741136867,0.08715400983292865 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441078,358.9910968991125,0.28087460972409106 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,fruit,2441088,737.050175903488,0.031538766391301376 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441095,1537.303111155156,0.1386771674388556 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441083,522.3645035160396,0.33010868120797454 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441084,1822.181174122396,0.2125092167507594 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441094,946.7143579254594,0.07186337495493733 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441078,262.4789560293796,0.6289878486174758 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_67,leaf,2441088,1287.4356739351938,0.0616432002958649 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441095,233.83069173160564,0.019024624012247138 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441083,244.05507001706647,4.3830427930169336e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441084,244.5479354952673,4.3786237415011087e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441094,285.607543884136,0.06784353604717852 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441078,247.85752948605105,0.006275978132577631 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,fruit,2441088,186.5876917212258,0.1170431463600985 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441095,1443.7842832554384,0.013003228330990435 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441083,1542.2127520907814,0.041645208323512595 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441084,1358.608959961443,0.013404607114315237 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441094,1235.484273244804,0.0546618599880655 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441078,923.0166031456066,0.18128956838084997 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_68,leaf,2441088,1597.8719558448452,0.057042893011234774 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441095,45.67682420521354,0.2223147096892628 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441083,57.513596218008,0.12224008650140572 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441084,77.07957344410276,0.00492869204536972 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441094,75.33995239078283,0.004985269147212978 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441078,130.27072149930865,0.23283620790182358 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,fruit,2441088,162.0598952721871,0.32766494334456686 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441095,165.33656593173015,0.025419897738251596 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441083,186.70780852316625,0.027373670706358766 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441084,153.2518777904503,0.05838300613456493 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441094,135.42191043016496,0.11209987455069204 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441078,207.19590890658333,0.07259236523765766 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_69,leaf,2441088,185.26900007763584,0.02401394681875768 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441095,47.24241754926575,0.0015595240655084108 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441083,42.98387556790359,0.03946701937315056 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441084,52.23057483787566,0.04515221589402851 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441094,104.41240157821764,0.3459794953211339 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441078,46.903736925992135,0.0015651444063182751 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,fruit,2441088,34.366325581741705,0.13663948949262705 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441095,154.7517845124553,0.30744758990553045 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441083,383.4831746828817,0.0866630583690906 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441084,450.85822841160814,0.15695674452583264 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441094,143.5691858934204,0.34002201794136067 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441078,787.8595560740175,0.39936555133803564 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_7,leaf,2441088,244.7389847907345,0.10838010147737975 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441095,600.9775297520714,0.03278968513682434 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441083,583.6388554192963,0.020075647970909216 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441084,569.8760276336193,0.009711839238841335 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441094,178.44082116065613,0.4945743359780046 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441078,544.6713767045233,0.009933996068742346 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,fruit,2441088,172.7753596385442,0.5085867434743845 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441095,620028.8342061945,0.02357716152599032 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441083,788542.835353489,0.08083624192760297 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441084,916350.9122625996,0.14607276835043947 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441094,689210.497815742,0.02236283565525632 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441078,568763.9495761035,0.06105698683750482 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_70,leaf,2441088,603178.0060969918,0.03554355088443639 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441095,158.05227994832558,0.035748666385261085 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441083,171.55105083037043,0.07134128400219097 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441084,114.17889619594584,0.10546625842810009 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441094,133.07445809860516,0.03895739232603512 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441078,62.765029093535574,0.3653343641850113 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,fruit,2441088,181.7600314882139,0.09644629061351839 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441095,2019.9701416094413,0.07156228909982065 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441083,1965.6817053677264,0.08339404332987099 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441084,2790.6651406503183,0.06880048843568298 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441094,2525.411348149546,0.02542488864845227 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441078,2334.238623011561,0.008761988276990706 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_71,leaf,2441088,2429.382744985514,0.008588703502020678 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441095,94.52996245703284,0.056886750455240165 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441083,111.7027265804572,0.12938103909361098 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441084,83.03032381716626,5.539967126979572e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441094,72.41306871347864,0.058865782599761385 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441078,54.84598751279833,0.17953787450972447 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,fruit,2441088,82.81862782557481,5.547043072386959e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441095,292.6213554350598,0.09015356736716207 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441083,362.15161629164027,0.0024308427898191987 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441084,608.2146611841282,0.2275972997056881 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441094,358.1088547070484,0.002444525377873763 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441078,314.81745358719303,0.058400783229330955 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_72,leaf,2441088,749.7054182693562,0.3184310645713042 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441095,73.00541101473358,0.0519076751231915 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441083,85.87670521113384,0.018612648250202257 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441084,69.6777389561878,0.07216867610815902 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441094,78.67133764479918,0.019446190953952947 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441078,154.73716346747958,0.27433190594137713 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,fruit,2441088,95.5344114352189,0.06489710689149453 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441095,1967.7576689837656,0.006239035171513585 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441083,2029.0757833284104,0.019565689182353463 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441084,2589.4590233866684,0.12547646447722505 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441094,1812.5358722003184,0.029445967962411945 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441078,1788.9199916791492,0.03514166103084593 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_73,leaf,2441088,1911.624579103075,0.006329972570589426 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441095,212.818874855102,0.030752009353375964 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441083,205.3251131919343,0.04632008124032527 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441084,168.0322886503036,0.13336940950811638 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441094,272.34791172949286,0.07636189744232569 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441078,269.01065638382914,0.0710073319966753 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,fruit,2441088,244.0506059153527,0.028717738077957744 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441095,1046.7641633149383,0.049702318086238595 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441083,764.9164160572703,0.08653254624649431 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441084,1214.416515891639,0.11422113716634197 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441094,693.25878012593,0.12925114914179714 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441078,820.3742908196361,0.05613448593317738 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_74,leaf,2441088,1105.7298643338245,0.07350251171502808 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441095,131.1356491638608,0.007238759354523783 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441083,135.77658504103775,0.00786535155711432 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441084,148.42067213067637,0.046534864138802146 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441094,134.78128314364724,0.004670056778532494 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441078,131.89815134693072,0.0047208212225169355 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,fruit,2441088,130.8059476687832,0.008332038294069921 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441095,9389.33518685496,6.729664877589414e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441083,8776.203945627636,0.030001102536107993 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441084,12913.066755961356,0.13772158661689504 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441094,10312.988497076843,0.04007672378259164 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441078,9418.45646899419,6.719252972389178e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_75,leaf,2441088,8832.56550984493,0.027220942345654642 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441095,65.04133092401337,0.07444372893963558 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441083,44.54987005229478,0.08989924901417812 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441084,40.4432177473818,0.13189998891838983 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441094,13.20553133469959,0.6179898105268391 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441078,95.93046783069916,0.24321087183535695 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,fruit,2441088,109.74648886411087,0.3016449440943787 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441095,287.9109199269041,0.1520255192487041 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441083,125.45956900094404,0.20872882668047277 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441084,525.0509606440318,0.4129688394850395 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441094,80.62276372448511,0.40077493636697703 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441078,206.3474890016163,0.007366570483565482 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_76,leaf,2441088,199.4063276104579,0.00749368259229044 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441095,671.7778999370298,0.022983487975170913 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441083,583.8282785716194,0.03795709755526122 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441084,581.4611740372434,0.03972150355595794 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441094,624.0565774630813,0.00901825945275947 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441078,650.2449980734647,0.00883479572450696 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,fruit,2441088,814.9484811377981,0.10688793027130528 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441095,12631.025776992356,0.12009067290538589 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441083,16703.381559508845,0.0012751075847399207 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441084,24341.773202432236,0.16482291735177235 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441094,21765.360047203245,0.11623656140489924 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441078,16605.441690786167,0.0012788623833106527 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_77,leaf,2441088,13974.204896756506,0.07620218753224961 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441095,64.14183538397104,0.001289854141835578 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441083,63.76139824903795,0.001293696421642343 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441084,63.18839391593034,0.0052142118584601604 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441094,61.00610278914051,0.020478246587229743 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441078,66.01212772924234,0.01377220259984413 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,fruit,2441088,67.71536971951912,0.024835725284000798 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441095,96.8525419036598,0.016077107063526386 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441083,109.9089972999342,0.03884511544951419 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441084,101.01932824923908,0.002216345881114634 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441094,107.16964241549964,0.027883651272853527 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441078,99.99088579532832,0.0022277146577911466 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_78,leaf,2441088,96.67702447029612,0.016864855159231418 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441095,125.42848186268832,0.002232972771762931 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441083,127.98919606711073,0.011010118160350135 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441084,111.23874039397276,0.04990713049025519 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441094,124.14198340597264,0.002244513208465637 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441078,117.69447396121384,0.02540712084842678 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,fruit,2441088,147.7702937279281,0.07342394358486715 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441095,260.8013913279313,0.0036617250226167464 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441083,288.6274285178543,0.04036597113375784 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441084,265.2178428231425,0.00363110938562361 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441094,277.3942400856643,0.02312581001252534 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441078,244.40331649634444,0.0318645340847179 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_79,leaf,2441088,257.32851937473,0.009483707817845577 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441095,60.42811960236427,0.011186446845049991 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441083,95.34409765601264,0.20924117963527356 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441084,53.72986109131773,0.03983691548940205 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441094,57.35488503062758,0.011482219726014264 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441078,29.597813678453303,0.29879300134890774 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,fruit,2441088,92.4448397697806,0.19583004077418265 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441095,402.6336602620557,0.005504097214901638 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441083,282.5566658823269,0.1483004246379429 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441084,506.468380179936,0.10514635471230083 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441094,469.18737660779914,0.0719403370256737 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441078,392.492381577113,0.005574750623224212 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_8,leaf,2441088,311.3770387989876,0.10611939779148294 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441095,51.829486161749664,0.01968510677173052 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441083,52.529192854482424,0.0255089311471024 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441084,47.235867009955754,0.02061990528727997 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441094,46.76602949285442,0.024961297277009242 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441078,46.10075275764875,0.031183779648386034 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,fruit,2441088,56.167449714869505,0.05459290867922029 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441095,123.56640546958414,0.03978107683920529 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441083,139.9297082633323,0.014228438551469491 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441084,133.58924504064333,0.005909994621488224 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441094,137.54172445280693,0.0067529749512926784 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441078,137.24993218307634,0.005830648401883742 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_80,leaf,2441088,128.35493896920698,0.023268905585215993 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441095,485.0303317396291,0.056225831489740585 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441083,619.1111480843158,0.049773894372564076 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441084,351.55174329213696,0.19600547399839918 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441094,772.5807441789884,0.1459491497015768 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441078,383.94212414073985,0.1577289666039845 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,fruit,2441088,845.6945480710627,0.1852188009632174 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441095,7356.500277815359,0.04589479954310116 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441083,5788.547136755685,0.058206882017561856 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441084,6923.706306221109,0.019562181274281443 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441094,5747.466657615473,0.061299995659445106 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441078,7110.643784151948,0.031132466540255255 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_81,leaf,2441088,6313.808285205204,0.020485065486075538 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441095,3947.682024809796,0.0714695047602012 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441083,4587.1445106549545,0.006269246810919338 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441084,5574.679256896526,0.07840821608781257 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441094,4720.5402223341025,0.006180033568324195 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441078,3915.566890119431,0.07501702143795796 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,fruit,2441088,4886.266116122906,0.021165446942235988 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441095,103384.23837482248,0.11728217283360998 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441083,66985.2101381922,0.07119323571739855 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441084,112164.55243335804,0.15268346788684628 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441094,77840.81502426749,0.005964785324983346 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441078,63004.47691520407,0.09780074958990159 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_82,leaf,2441088,79993.763730111,0.005883971107424557 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441095,124.39126858556504,0.2851652435680836 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441083,154.00912274273873,0.19240869343001732 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441084,441.3200248719224,0.2647984934856771 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441094,276.59288724084627,0.061885867265650596 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441078,440.4548824451983,0.2639462880091301 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,fruit,2441088,203.1241426775044,0.07219359518916768 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441095,1684.2430078833038,0.04999763754601538 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441083,1623.4243845261929,0.03402494945472023 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441084,2182.5256046733193,0.16255223189408508 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441094,961.1372435659456,0.19362170925227717 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441078,953.8622072515165,0.19692147346406674 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_83,leaf,2441088,1378.7582681988551,0.036918985661076764 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441095,1119.4028277945424,0.0718250889986165 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441083,1786.9291210375063,0.1312958377852711 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441084,276.05512275789783,0.6798156779112405 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441094,1522.0416373931807,0.061615044607791436 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441078,296.87823765814295,0.6482331253994991 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,fruit,2441088,2552.893153338611,0.2862211499159186 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441095,923188.036203318,0.013190987676628296 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441083,1022595.4279271632,0.03122269123645527 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441084,220812.55247837532,0.6344573974136161 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441094,1034486.3281278204,0.03624359995436066 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441078,323615.7883100237,0.4684514539357867 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_84,leaf,2441088,980129.070867726,0.012802115259480829 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441095,47.668918608389525,0.013802287502208133 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441083,65.7490575382723,0.15345651956788742 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441084,44.68663331462342,0.014255376163294864 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441094,41.26394427123774,0.04886227410352095 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441078,37.72250816010859,0.08783245120756034 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,fruit,2441088,94.17093628086845,0.3094838759869556 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441095,917.9784507440978,0.018592376687113 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441083,957.6886685596124,0.03698423914003923 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441084,590.0392075569836,0.1733592386414844 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441094,857.1325524300179,0.01119212052909635 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441078,563.238909941481,0.19354746039633408 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_85,leaf,2441088,901.8847256597955,0.010910922059677475 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441095,725.6882546062682,0.02482453972576426 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441083,518.4851641765299,0.1708382996370701 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441084,1129.1020276066538,0.16715855356597542 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441094,788.3183601152886,0.011127007768096497 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441078,1212.2699418278576,0.19802470325540478 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,fruit,2441088,748.436620688034,0.011419604536997419 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441095,23924.32317072948,0.008605242098957078 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441083,22472.54152184164,0.01858222661500708 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441084,42014.87861875434,0.25316869505335937 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441094,22985.566748287096,0.008779201659946168 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441078,18826.98467095419,0.0954536491474105 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_86,leaf,2441088,23998.455622984213,0.009948876230163606 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441095,276.48388828084495,0.013277454063068905 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441083,291.61223620543376,0.03641336885698365 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441084,248.3681396765425,0.033296490021596625 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441094,259.8341079993786,0.013696214793012196 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441078,198.44940704599665,0.1307425687988104 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,fruit,2441088,340.7480087965493,0.10404095226011734 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441095,24565.402831468,0.08698444892380852 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441083,37284.77026551856,0.09422313232331447 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441084,36796.02879233876,0.08849261085962112 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441094,7030.068851163164,0.6303487607166804 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441078,27450.663282315112,0.03875549651234156 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_87,leaf,2441088,32575.188955522044,0.035578604403659675 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441095,62.86460885374628,0.10507700678818455 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441083,97.88611204557762,0.08723785454937105 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441084,90.48825103982745,0.053108969747428736 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441094,69.65668861624394,0.06052039964054279 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441078,47.061248547005064,0.23081977955055377 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,fruit,2441088,122.59994414508,0.18500704783610278 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441095,1238.0978008542704,0.06671805461802283 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441083,1770.4498377808093,0.08861061957805028 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441084,1797.3352876390288,0.09515609422232574 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441094,1264.8879086437416,0.057420965735586194 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441078,1156.2145857029277,0.0964345630896033 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_88,leaf,2441088,1622.4858321897934,0.05070790634975042 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441095,8185.231927701232,0.16754380392983315 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441083,15065.134077445377,0.09739820764123852 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441084,4754.008901937408,0.40351480292699193 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441094,11028.836236295125,0.03804510547295692 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441078,13532.319989894228,0.050797465172674805 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,fruit,2441088,13048.297730235628,0.03497906414156393 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441095,126868.74676012696,0.0655583460284852 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441083,126956.90579855198,0.06525666662712126 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441084,155764.01183106314,0.02355412841860094 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441094,193627.2832179139,0.11805355606815571 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441078,174254.4646675633,0.07227091835430066 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_89,leaf,2441088,139318.1737732488,0.024905222897428025 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441095,69.87374440011922,0.22933018627678758 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441083,52.94968138891045,0.10887952058546824 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441084,66.02296211198266,0.20471117438875175 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441094,29.466753894567315,0.14565153471058312 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441078,26.037075174637224,0.19939163361983536 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,fruit,2441088,9.358007903257704,0.6438004229730504 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441095,132.95832726956914,0.018499379012012707 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441083,154.06408246463351,0.0454864801358017 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441084,142.5616447778935,0.011787775624518382 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441094,148.88265982175304,0.030629197272035835 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441078,134.9268092533994,0.0121166713924854 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_9,leaf,2441088,131.90495905087926,0.021953798256539425 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441095,68.01515637504961,0.009178896875837728 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441083,70.92078033131376,0.008988907668581625 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441084,61.59264377772858,0.05225575179631403 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441094,48.212139381925866,0.1586281943251895 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441078,130.06938842663587,0.27239050047233104 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,fruit,2441088,120.45340516708,0.23903448406282712 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441095,3115.8102137507976,0.013276997478596453 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441083,2842.962258365669,0.053076899825059254 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441084,5562.3725931386025,0.2384120824374576 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441094,1091.0550877266337,0.46900131528262445 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441078,3309.2616528092017,0.012883112708515831 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_90,leaf,2441088,4028.245306300044,0.09826791563444859 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441095,361.5328256812119,0.028528314185896964 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441083,317.8506782876179,0.08445290720046916 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441084,492.51029261418745,0.10573926118826371 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441094,262.073514022733,0.16825291775254803 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441078,410.6249432967708,0.02676927718757316 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,fruit,2441088,595.1495380242357,0.18795005107507734 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441095,680539.3350687837,0.010973526317570759 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441083,589759.10609158606,0.07315210346501466 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441084,1139717.9540430903,0.21297063105786584 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441094,715368.530522784,0.0107030726300259 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441078,495299.13569214713,0.14895918860686486 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_91,leaf,2441088,740203.7129742018,0.025524500515023973 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441095,28.33352411977163,0.03290791753391886 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441083,42.98088334181568,0.21388265902108827 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441084,24.19832321828122,0.03560740450879041 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441094,22.386555952689125,0.06940539290936854 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441078,6.320683230525082,0.6186286522075017 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,fruit,2441088,89.00157026478696,0.5300049911861255 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441095,34759.60804286225,0.021127479043808073 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441083,31283.207665897655,0.024636113916896463 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441084,35697.706385994745,0.03269292158721537 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441094,31458.594398478155,0.02220807755031462 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441078,17776.66156995396,0.2700971871109399 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_92,leaf,2441088,51759.61645152175,0.19404365791046718 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441095,9.010074611429614,0.07305414480776717 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441083,96.7104723052166,0.9576909721137898 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441084,67.53116206193117,0.8017216908857181 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441094,5.753464648325906,0.26785308319365897 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441078,12.311168777843957,0.06251675308997151 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,fruit,2441088,4.314281081103178,0.3928740955995679 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441095,11.250898521466612,0.291334555803449 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441083,6.150237053045758,0.553629907921932 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441084,162.39472581557808,0.8680501569621399 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441094,37.54907276294165,0.2320774536546666 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441078,5.983192057076566,0.5655888196743328 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_93,leaf,2441088,32.759141045298215,0.17281074255642626 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441095,307.7404557124783,0.003666497233904664 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441083,326.6233586263149,0.02952914495575598 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441084,302.56617865037305,0.003697715091677267 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441094,311.6577622831776,0.00915985275521125 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441078,204.22277373302387,0.1744139248940173 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,fruit,2441088,203.1920177392821,0.17661145235135267 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441095,5079.488297009574,0.02615687215904794 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441083,5224.067393187213,0.01396806529096617 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441084,5625.792519637279,0.01820687503756524 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441094,5892.66710210296,0.03833507071651043 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441078,4878.654901405667,0.043676737458100856 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_94,leaf,2441088,5565.569559464743,0.013532778790650735 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441095,72.34308039790163,0.20703010356991136 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441083,87.64245218152956,0.12371258047631528 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441084,114.06478429306443,0.009275517299971447 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441094,118.98950290180248,0.009081549366057207 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441078,259.1425470201456,0.3471116221528887 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,fruit,2441088,123.2130480775684,0.024229600574472432 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441095,108.20851993391214,0.07607199885282356 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441083,131.95927582145566,0.16225046553144806 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441084,28.829122549085625,0.4983580337003255 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441094,106.84250196996229,0.0705545915149759 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441078,74.80082743953675,0.08428305597153662 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_97,leaf,2441088,66.0316245726065,0.13843747565734854 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441095,1654.7323120149665,0.04785962205773364 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441083,2939.756456218795,0.20172398330228347 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441084,969.9422037831746,0.27984151291365045 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441094,2040.2925524888403,0.04310507477514269 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441078,894.4247201770459,0.3150435757528993 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,fruit,2441088,2842.4139399589008,0.18709995485853348 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441095,56038.11423481564,0.0017117824572832063 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441083,48712.83435675073,0.05912833001688167 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441084,46354.84306960019,0.08067661460488207 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441094,61899.629356700294,0.0449163188019277 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441078,89518.81823174826,0.20514261053695293 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_98,leaf,2441088,55597.232448354014,0.001718556197907617 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441095,13660.39415240206,0.10037399001189407 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441083,24990.9704981396,0.3626938813240397 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441084,5418.883794465859,0.3011794026390562 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441094,8022.59917516593,0.13077414596278825 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441078,6738.678997753683,0.20651447159379988 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,fruit,2441088,15735.717717593763,0.16179731568914502 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441095,104421.45513283144,0.048228118814692245 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441083,127342.41116991018,0.037955209063945894 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441084,136075.8049296675,0.06676305227258528 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441094,116064.76149254812,0.0023174764232054557 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441078,70311.3200546996,0.21999260806607968 +1017363 Sl10g007190 #19.2,transp1-1,0.6,m_99,leaf,2441088,117306.75877528168,0.00230517554715437 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441098,223.37123551445336,0.048867880192608126 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441081,119.73874453787488,0.2219246659473395 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441101,175.8276883401001,0.05507209986054162 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441086,155.03869578965484,0.1097192598308947 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441085,258.68596626863865,0.11261350265205738 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,fruit,2441100,361.4938660539963,0.25794156624423836 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441098,606.5080820377455,0.604542293420141 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441081,11.392165440189796,1.1216880157387328 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441101,262.8206634784013,0.24136520829558616 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441086,38.705008975399785,0.5905271265200396 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441085,281.1234913124066,0.27060283872695123 +1017363 Sl10g007190 #19.2,transp1-1,1,m_1,leaf,2441100,3.614764528001093,1.6202142871623648 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441098,55.39572655603541,0.005719694670953235 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441081,61.114822069356414,0.036950594178134066 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441101,53.11734043820186,0.023959635537929458 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441086,56.86451003575147,0.005645343957887183 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441085,67.98122615240271,0.08319303601854089 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,fruit,2441100,49.40875789613689,0.05539202136179555 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441098,312.47679502618996,0.017941026660506676 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441081,363.4581028585646,0.047695557162473534 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441101,295.54144732820976,0.04214040238664385 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441086,336.57091778341334,0.014317788797137965 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441085,314.74065334919516,0.014805956201139114 +1017363 Sl10g007190 #19.2,transp1-1,1,m_10,leaf,2441100,372.4147651020598,0.058268092884939726 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441098,6.660086131662909,0.769249591607894 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441081,41.27567655511688,0.02296476323756469 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441101,103.94475597848918,0.42407314669337226 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441086,37.0239035342333,0.02424723161533593 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441085,71.8594188184265,0.2637542630799037 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,fruit,2441100,30.83690244842587,0.1036586904301009 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441098,1561.7776290543366,0.10198384004468197 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441081,1330.5000806806272,0.17158813251329263 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441101,2463.7563931325685,0.09599472649154306 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441086,2033.1735648107783,0.012571416663004875 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441085,1919.934159317813,0.012316702123750023 +1017363 Sl10g007190 #19.2,transp1-1,1,m_100,leaf,2441100,2030.3927158439144,0.01197700895980347 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441098,31.003088967123492,0.08567857272176882 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441081,35.30235364409112,0.029279878072042242 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441101,38.6434138328704,0.009991946557705633 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441086,46.497539980936914,0.09034643724184166 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441085,53.66636569938666,0.1526186464613153 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,fruit,2441100,36.8855514279081,0.01022725886834519 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441098,57.07100181735224,0.2961850375654669 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441081,168.68043827104597,0.17446418700915522 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441101,33.77737269407204,0.5239746679193231 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441086,738.6562848361118,0.8158418636276972 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441085,211.57922862606895,0.2728724957174209 +1017363 Sl10g007190 #19.2,transp1-1,1,m_101,leaf,2441100,55.50441005296236,0.30827304276239476 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441098,99.8563717565596,0.06131968154312051 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441081,111.66257480242702,0.012787825693860277 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441101,98.92886257560797,0.06537244777329199 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441086,118.33616649760047,0.012422032567338537 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441085,119.85551206946904,0.01796254809885678 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,fruit,2441100,167.42397306835446,0.16312218015256352 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441098,484.6510434997784,0.05653571885463071 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441081,600.7587010018016,0.03673519855656071 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441101,518.6462477766098,0.027093630731337193 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441086,585.4193220721947,0.025502181445527405 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441085,516.2527948010993,0.02910245522625443 +1017363 Sl10g007190 #19.2,transp1-1,1,m_102,leaf,2441100,589.9632760758757,0.0288601075952144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441098,1687.8819926577205,0.3365877117210072 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441081,3766.304739284301,0.011985665129621292 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441101,4417.897588762082,0.08128585266435184 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441086,268.2429111805192,1.135401537864353 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441085,9648.106726359065,0.4205123073314101 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,fruit,2441100,3561.262077692412,0.012325856492117815 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441098,735040.472730199,2.261659011137951e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441081,752381.3631381039,0.009900610594407944 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441101,735806.2406212811,2.2604818284932549e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441086,872326.4470194181,0.07414162080291753 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441085,656855.2077195634,0.04906777126459971 +1017363 Sl10g007190 #19.2,transp1-1,1,m_103,leaf,2441100,730750.8269312939,0.0027681032405793005 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441098,1654.686831967209,0.33658771172100765 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441081,3692.2337487921777,0.011985665129621292 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441101,4331.011881697774,0.08128585266435184 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441086,682.0795524025182,0.7214684922022201 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441085,9458.35978046245,0.42051230733140965 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,fruit,2441100,3491.223610877631,0.012325856492117815 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441098,735040.472730199,2.261659011137951e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441081,752381.3631381039,0.009900610594407944 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441101,735806.2406212811,2.2604818284932549e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441086,872326.4470194181,0.07414162080291753 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441085,656855.2077195634,0.04906777126459971 +1017363 Sl10g007190 #19.2,transp1-1,1,m_104,leaf,2441100,730750.8269312939,0.0027681032405793005 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441098,51.76182100547136,0.01833137809175911 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441081,51.27048360974452,0.014189245426119435 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441101,47.97440855607521,0.01466853920540756 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441086,41.749638250324345,0.07502545173595321 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441085,69.16536119188358,0.14421048070790232 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,fruit,2441100,41.966832628283754,0.07277197567577498 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441098,92.14468295713372,0.09798288621437212 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441081,78.42261326474139,0.02795391625055066 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441101,68.64511688392253,0.029877745038803027 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441086,46.46243096432714,0.19938546507056754 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441085,67.59607994384075,0.036565882973091934 +1017363 Sl10g007190 #19.2,transp1-1,1,m_105,leaf,2441100,81.04358765640842,0.042231264343691066 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441098,140.65287441449178,0.06068986109863905 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441081,157.22688370769896,0.012311666394749121 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441101,166.26878383309682,0.011972247133626546 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441086,186.1394988451244,0.06100006726807239 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441085,154.56722107978536,0.019721074094026125 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,fruit,2441100,179.57050970738766,0.045396542355838676 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441098,3302.5381865823547,0.013648241795420901 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441081,3273.719263524146,0.009841827744864418 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441101,3050.177066033391,0.020874554842922777 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441086,4538.054001795715,0.1516700534042137 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441085,2714.042779776679,0.07158291728678501 +1017363 Sl10g007190 #19.2,transp1-1,1,m_106,leaf,2441100,3127.0121214311134,0.010070041450754186 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441098,210.6367224305588,0.14888820730263586 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441081,194.0351026046214,0.18454199109025726 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441101,531.4589154059931,0.25304740118601865 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441086,304.003821322857,0.010456747014136347 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441085,289.60114696585475,0.010622018150590495 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,fruit,2441100,303.9419950383714,0.010368414095121015 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441098,4334.93299323692,0.01446551982185662 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441081,3375.6346937281983,0.09416142720177367 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441101,6170.234327451004,0.1677847885987327 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441086,4855.762811089728,0.06374059566890855 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441085,3679.167027397239,0.056767364534602294 +1017363 Sl10g007190 #19.2,transp1-1,1,m_107,leaf,2441100,4050.912659376109,0.014963989402192457 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441098,76.01429518895408,0.0041639065087992755 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441081,77.47891715715902,0.004124362852709673 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441101,90.26347867950156,0.07045288730415256 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441086,38.60082839740719,0.2984625545539379 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441085,104.43143904765752,0.13377208299892485 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,fruit,2441100,48.50338521869436,0.19928712897994427 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441098,175.62876036835462,0.002770615533906895 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441081,222.63319784910007,0.10022367293898826 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441101,103.57347824275764,0.23211769038557284 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441086,481.4484786762349,0.4351835672069142 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441085,80.38105790880073,0.3422125337973818 +1017363 Sl10g007190 #19.2,transp1-1,1,m_108,leaf,2441100,177.87679827159167,0.002753052163626979 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441098,148.08983011063785,0.09367003005502328 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441081,83.66525403895886,0.15431007077077852 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441101,149.29481327764924,0.09718951511153495 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441086,90.62818816943528,0.11959190714012147 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441085,179.02162772982163,0.17605029673011918 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,fruit,2441100,85.24206204494722,0.14620125788990768 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441098,2572.114559981089,0.03785106387860493 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441081,3656.395509068517,0.19061392291009316 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441101,2142.750195120305,0.04146770062104865 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441086,2046.3547948975977,0.06145831050596273 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441085,3304.656489455666,0.14668707843051054 +1017363 Sl10g007190 #19.2,transp1-1,1,m_109,leaf,2441100,2104.4065303324337,0.04930960312557531 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441098,274.1354485518679,0.282120240487723 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441081,543.697461926963,0.015271867213647372 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441101,1188.709860124427,0.3549904266803585 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441086,634.713684843424,0.08249242365719311 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441085,286.9919725578228,0.2622156891631464 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,fruit,2441100,506.1239688508345,0.015828533461984318 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441098,4.775611032668599,1.8561702892616672 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441081,678.4512591445225,0.2963194167133021 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441101,705.4443304907362,0.3132635113808755 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441086,7.398881077895638,1.666033189131447 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441085,3.873333521995395,1.9471143416123113 +1017363 Sl10g007190 #19.2,transp1-1,1,m_11,leaf,2441100,814.7017104788212,0.3757993920190237 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441098,257.31434396325966,0.14139116847483635 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441081,271.6176985495086,0.11789710000054665 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441101,414.8050950295998,0.06598891710254584 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441086,301.7334822363825,0.07223166018003413 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441085,410.93107508202314,0.06191381928955364 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,fruit,2441100,490.37875313205967,0.13867647997535926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441098,4278.19,0.3514032867618395 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441081,10318.971685375003,0.030973065767506913 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441101,8898.371711796462,0.03335281143029745 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441086,8371.98192360721,0.059835073050977794 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441085,14388.080139317635,0.175339493094135 +1017363 Sl10g007190 #19.2,transp1-1,1,m_110,leaf,2441100,10362.86357832034,0.03281642592209577 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441098,314.7730336723463,0.028538600006907444 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441081,112.88680307605097,0.41681574553863054 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441101,256.25624728963817,0.060784457759659016 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441086,277.89210759571137,0.025582707079478073 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441085,359.94931089216044,0.08678242681310522 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,fruit,2441100,311.6148230361595,0.02415918856086874 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441098,52295.50758003567,0.007310884706084764 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441081,72647.87522384452,0.15006941883873992 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441101,45071.450568099666,0.05725196238977315 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441086,73908.1737762962,0.1575389733634296 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441085,50549.5660816161,0.007436065957421967 +1017363 Sl10g007190 #19.2,transp1-1,1,m_111,leaf,2441100,30511.05921228973,0.2266962131746979 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441098,2671.391530748532,0.12761894778178728 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441081,716.6132802226188,0.44383374477379034 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441101,3057.0662669288654,0.18618625588316817 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441086,891.2148591177839,0.3491361781611535 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441085,1311.0425204969613,0.18150181977979152 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,fruit,2441100,3802.450654595584,0.28094498981698734 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441098,5577.336538009499,0.2531243494450819 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441081,11239.546957397542,0.05119760590976563 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441101,9993.108261537453,1.4939224279597596e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441086,15609.431181083852,0.19383587717209982 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441085,9421.335701954024,0.025438721281671572 +1017363 Sl10g007190 #19.2,transp1-1,1,m_112,leaf,2441100,9986.23441819633,1.4944364967117707e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441098,49.06162387403993,0.23039294071044591 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441081,67.8770753116666,0.08941173822208626 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441101,249.95677351679169,0.47673005070244767 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441086,138.5897441586833,0.22059623366130965 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441085,44.12039815244571,0.27649543642698204 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,fruit,2441100,98.91094545661493,0.07410949377382892 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441098,46.418957135475274,0.07642501107815014 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441081,139.7233201818197,0.40214850673488134 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441101,53.73127002931848,0.012893284322325504 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441086,196.9599891927496,0.5512576214614435 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441085,38.937455220959365,0.152752825741846 +1017363 Sl10g007190 #19.2,transp1-1,1,m_12,leaf,2441100,56.969434781531064,0.012521520358218297 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441098,77.66216975762997,0.10451733953295483 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441081,92.442187602681,0.18017803396736842 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441101,71.21355193371943,0.0668704673653786 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441086,47.15760082418397,0.11214047839380648 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441085,23.05725814159834,0.4228845185293051 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,fruit,2441100,50.88827891825784,0.07907441740472043 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441098,336.2053060327939,0.24866350380223246 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441081,222.875839132148,0.07012193187086879 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441101,302.71944070583965,0.203099252891366 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441086,144.62119897805692,0.11770910172414073 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441085,156.41386606910598,0.08366580886293518 +1017363 Sl10g007190 #19.2,transp1-1,1,m_120,leaf,2441100,114.78868592057718,0.21804197525253288 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441098,39.5947918889368,0.27403254140765165 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441081,74.15120511790894,0.0015523924051963345 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441101,90.1754816580173,0.08341786465739309 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441086,74.6822629702394,0.0015468631129846866 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441085,132.47257332038015,0.25045536664453727 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,fruit,2441100,21.9206814506913,0.5308165550705961 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441098,143.47620456371442,0.0087214117262997 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441081,186.2624171392799,0.1046239432148024 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441101,150.11031929268637,0.010909257416551021 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441086,149.29697346116012,0.008549712515995456 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441085,94.514971579379,0.19000068322927088 +1017363 Sl10g007190 #19.2,transp1-1,1,m_121,leaf,2441100,94.33700501833488,0.19081920702442634 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441098,356.65428954693954,0.0061360540265980035 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441081,174.52227173685282,0.3165326482403916 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441101,560.120831555536,0.18989821913945715 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441086,238.77489258230608,0.1803948473936483 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441085,451.81694862654473,0.09657901245643563 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,fruit,2441100,366.8040069450517,0.006050565476295233 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441098,10956.305362712716,0.11161388030514807 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441081,14040.760351587553,0.0038873814078801416 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441101,15258.6710730357,0.03223870289778219 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441086,14293.247109056209,0.003852893825004422 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441085,13991.382377908109,0.005417382441546437 +1017363 Sl10g007190 #19.2,transp1-1,1,m_122,leaf,2441100,14405.554696253172,0.007251977501580242 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441098,169.7732179083913,0.06691450973013957 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441081,139.85178342693024,0.01728666170812554 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441101,151.20965168440344,0.01662484229818295 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441086,111.91769805532732,0.11405590176562086 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441085,73.19204466719515,0.2984907910636636 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,fruit,2441100,244.9844494038567,0.22618384733898678 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441098,363.3994815442466,0.3969766782306996 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441081,137.213190649127,0.026011761942859923 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441101,173.44700427361525,0.07575917809310884 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441086,131.05164052076805,0.04596516327223954 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441085,143.01295844086002,0.008032234358897217 +1017363 Sl10g007190 #19.2,transp1-1,1,m_123,leaf,2441100,148.35220226078562,0.007886372579998913 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441098,756.3848408633511,0.28501904694334 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441081,1182.9353493004528,0.0908008533841902 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441101,1997.0843546923368,0.13663454612725046 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441086,2382.4358902252357,0.21325935962813336 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441085,1093.801762947148,0.12482324424393143 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,fruit,2441100,1733.093786239056,0.07506020190078022 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441098,79215.94399013369,0.17248230293214295 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441081,48309.284430506625,0.042299694333113536 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441101,58193.33629409848,0.038542957547003986 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441086,77734.34190339065,0.1642826272040594 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441085,41588.70170434677,0.1073549360013617 +1017363 Sl10g007190 #19.2,transp1-1,1,m_13,leaf,2441100,46017.09382066757,0.06341111137023425 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441098,32.10287512201419,0.0196149545675246 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441081,44.796313192860026,0.1250833883762541 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441101,46.79734870362125,0.14406236491330948 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441086,35.069217730116605,0.018767194447078417 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441085,7.827203992465301,0.6325522314294738 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,fruit,2441100,10.751122437514454,0.4947050761888283 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441098,29.227282309942936,0.0597929033175959 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441081,15.298642251884036,0.2213426421015927 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441101,122.43031890251392,0.6818934495551487 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441086,40.8364182732046,0.20505211231787834 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441085,14.788021732205005,0.2360854510426751 +1017363 Sl10g007190 #19.2,transp1-1,1,m_14,leaf,2441100,21.70879861448508,0.06935974132470135 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441098,73.19783114007382,0.005042474757067872 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441081,70.59424080690043,0.010686466251821791 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441101,71.50790068651186,0.005101709993358128 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441086,32.19305648547478,0.35169352670204823 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441085,84.05533932915847,0.06510956743169927 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,fruit,2441100,105.56439264336994,0.1640617150679211 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441098,587.2784007671344,0.033403396951400044 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441081,681.1834814780933,0.031016682512277072 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441101,573.8380545769638,0.04345807989117567 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441086,899.3788202032132,0.15169523061670764 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441085,514.1010999716308,0.09119889229269429 +1017363 Sl10g007190 #19.2,transp1-1,1,m_15,leaf,2441100,813.164944892489,0.10793122278785283 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441098,59.657837406791586,0.14861398961499628 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441081,44.06252967960303,0.01701591032114802 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441101,153.8366682032514,0.5600063488300617 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441086,0.986746896115142,1.6328477475816483 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441085,40.676504973259014,0.017709886357277993 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,fruit,2441100,10.347676205479525,0.6122106860236411 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441098,2.826244318150562,1.2440724873395435 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441081,51.69,0.01812434257454143 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441101,344.40244623710475,0.8417840379257007 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441086,31.872016227577912,0.19187265172925905 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441085,47.940004782983216,0.014584116565870886 +1017363 Sl10g007190 #19.2,transp1-1,1,m_16,leaf,2441100,51.2144395933819,0.014110235281192596 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441098,753.2251202066275,0.249516427076244 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441081,598.0956123582433,0.3496706060386914 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441101,2689.1795740462708,0.30317858139539666 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441086,1448.69788307019,0.034536603032455204 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441085,6791.9775168662445,0.7055550171463931 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,fruit,2441100,1227.2103645948353,0.03752220794762717 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441098,22210.159522593854,0.09565626039348363 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441081,16766.719505188565,0.21775983926557885 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441101,30575.214931455735,0.043161580397900856 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441086,56708.99331502042,0.3114439996223002 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441085,24790.12030414089,0.04792930387303951 +1017363 Sl10g007190 #19.2,transp1-1,1,m_17,leaf,2441100,32513.31278528242,0.06985328383012934 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441098,9.702820530802915,0.5037423614848406 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441081,27.588111433466384,0.04991838845233487 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441101,10.766971061041616,0.4585468141900415 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441086,34.30899621718157,0.044767652062988716 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441085,51.81754232677396,0.22383645085772375 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,fruit,2441100,59.13519036888974,0.28120563926832154 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441098,277.90143299039005,0.13964249874691514 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441081,488.68879814108607,0.10549909916830602 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441101,57.09286718997402,0.8269514312383737 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441086,2390.7036701809348,0.7949924633128389 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441085,77.60373704584508,0.6936506495319437 +1017363 Sl10g007190 #19.2,transp1-1,1,m_18,leaf,2441100,1042.7168183110637,0.4346330935146634 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441098,2.452778487589363,0.07742933714486155 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441081,3.2369776042691987,0.04305202901651212 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441101,2.6259922517373213,0.047794225311589944 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441086,3.5477341400910296,0.0828634016066832 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441085,2.1658237050724805,0.1314645628528009 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,fruit,2441100,4.174364255725882,0.1535026773563793 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441098,1274.8353549786295,0.05187575031800007 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441081,1598.3248676626297,0.04633520694825677 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441101,981.4748935820382,0.1654506548684025 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441086,4097.57293102805,0.4551968425762758 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441085,893.2540405092864,0.2063548602162073 +1017363 Sl10g007190 #19.2,transp1-1,1,m_19,leaf,2441100,2225.1778334867963,0.19003487542170072 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441098,386.7779515110968,0.7814487929960205 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441081,97.64674354917992,0.18364484852135354 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441101,107.44402283711652,0.225169344561841 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441086,30.304028749072845,0.3245125465924281 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441085,5.140398160005743,1.095016156464338 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,fruit,2441100,24.232562454149623,0.421613575215646 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441098,984.4987341393786,0.17554443249834506 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441081,1249.832390300376,0.279181045965605 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441101,589.0825995782806,0.04749453490236988 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441086,538.5919726253378,0.08641085332619092 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441085,702.987401545404,0.029276812400095942 +1017363 Sl10g007190 #19.2,transp1-1,1,m_2,leaf,2441100,611.331414017621,0.031394016443755834 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441098,71.77444558801375,0.3132555151002572 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441081,36.95472117158985,0.02495559838351058 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441101,2.7311342091497655,1.106371289344207 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441086,32.82742579007087,0.026477503195817764 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441085,68.37856848173742,0.29220567308631273 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,fruit,2441100,15.06988420007837,0.36460441630814877 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441098,184.1772797227245,0.7494634505143236 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441081,5.187770989419618,0.8007918074830681 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441101,70.95725262206874,0.33522418811145793 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441086,60.077755124349736,0.2629410926903568 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441085,5.506954394542761,0.774861123770381 +1017363 Sl10g007190 #19.2,transp1-1,1,m_20,leaf,2441100,3.937585952769539,0.9205425566594367 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441098,4051.220030910773,0.12133491194201085 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441081,4418.194781340641,0.08367588493728206 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441101,7031.459172361021,0.11812471612712772 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441086,4080.3101196401058,0.11822757084497892 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441085,14606.331124404143,0.43562039855909696 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,fruit,2441100,6295.7829394864375,0.07012900310226122 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441098,402727.5338184515,0.1139269172626225 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441081,531291.2931525495,0.006394458828880012 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441101,601537.0165933241,0.060324117656674225 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441086,968700.9368458492,0.26725147986620534 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441085,475353.3879225339,0.04192164633791329 +1017363 Sl10g007190 #19.2,transp1-1,1,m_21,leaf,2441100,515760.6703462761,0.006490018217647275 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441098,70.72209012999208,0.3494456402867778 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441081,11.534970246387456,0.4380929684766972 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441101,33.26244695509131,0.02184474786943036 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441086,18.226492347828227,0.2394063495166856 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441085,29.99904684904713,0.023001990877233203 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,fruit,2441100,105.60668352006252,0.5235819571164395 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441098,13.873549475357333,0.4804492208051012 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441081,25.24556545094731,0.22045170559367122 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441101,35.18161891167086,0.07632098806949528 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441086,59.18587246206616,0.14958124587785004 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441085,48.7,0.06489215313942753 +1017363 Sl10g007190 #19.2,transp1-1,1,m_22,leaf,2441100,71.68419563068619,0.23278660830444453 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441098,2808.574243641269,0.16149194636478725 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441081,1854.566463703433,0.01875156028545133 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441101,1598.7299971158254,0.08321883867245194 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441086,1198.8845795014413,0.20821658824017186 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441085,2108.4774137131913,0.03697499074010757 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,fruit,2441100,2018.223624092314,0.01797532303703253 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441098,74139.7192925483,0.029520160520600136 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441081,125907.2051795409,0.20047948590913034 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441101,53223.216813906074,0.17346997810455012 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441086,68529.78806557154,0.06369170916817168 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441085,84569.1119923479,0.027640672465376603 +1017363 Sl10g007190 #19.2,transp1-1,1,m_23,leaf,2441100,89183.77133703261,0.050714735630586816 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441098,112.45397214023345,0.025084865436595383 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441081,56.00572077312996,0.3278272749720703 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441101,125.82716360206553,0.02371474105343463 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441086,81.69622462165871,0.16385767858007116 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441085,194.16073846708824,0.21210174932668258 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,fruit,2441100,162.3950928153651,0.13451323599340004 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441098,131.03042584088786,0.17825959472766884 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441081,53.865236028752975,0.20780399053198662 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441101,71.41784947586304,0.08530578908618036 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441086,102.41928456405552,0.07126918007800431 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441085,62.461023883653105,0.1435034586616284 +1017363 Sl10g007190 #19.2,transp1-1,1,m_24,leaf,2441100,105.4017287276383,0.08373517621226578 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441098,70.14106658327519,0.0307776376393043 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441081,79.87271857585334,0.02564846325360448 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441101,72.29006162417416,0.017671408265155453 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441086,78.29434393692077,0.016980386086129062 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441085,51.76988001827533,0.16267284476630128 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,fruit,2441100,89.47274075357093,0.07494073774523824 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441098,3063.024535199832,0.03241393617354227 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441081,4030.327986011842,0.08677597849433427 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441101,3037.700872161941,0.036019405867941945 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441086,4903.016619535376,0.1718989536114095 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441085,3099.2440432829853,0.027308636578391 +1017363 Sl10g007190 #19.2,transp1-1,1,m_25,leaf,2441100,3501.5230253749705,0.025692574788701794 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441098,202.7391855774772,0.030430486236773913 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441081,180.5075855845581,0.08087272653957012 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441101,292.1303351935597,0.12820847322175144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441086,232.16959853673893,0.028437166609514897 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441085,348.6200688075485,0.20498420047324517 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,fruit,2441100,172.14844471407406,0.10146508039905644 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441098,3436.803482301809,0.004117158294112855 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441081,2983.785496670661,0.057269942793941375 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441101,3371.948850799191,0.004156563257793344 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441086,7524.718108114009,0.34445269354554453 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441085,3228.447350388237,0.0230438331206968 +1017363 Sl10g007190 #19.2,transp1-1,1,m_26,leaf,2441100,4305.85424559766,0.10202178330992107 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441098,66.23371263657909,0.08956718945352904 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441081,135.13331566443404,0.22011614391027923 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441101,96.5744910449428,0.07421613911494274 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441086,45.75653326005827,0.2501931761962939 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441085,35.35624688783463,0.36218013108579394 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,fruit,2441100,103.6474713170824,0.10491242215290875 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441098,748.8190782295563,0.004414418759747019 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441081,520.2002912004131,0.16262072850793796 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441101,778.5379447291707,0.012488464778428021 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441086,938.6698908003008,0.09372156798369513 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441085,598.1065978970781,0.10201272620549018 +1017363 Sl10g007190 #19.2,transp1-1,1,m_27,leaf,2441100,764.1195630661805,0.0043699991973005226 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441098,64.18143682358657,0.018438884842425507 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441081,285.61575642475196,0.6299338420572169 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441101,69.74870103941923,0.017687803745682906 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441086,36.466664887967845,0.2639522741244926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441085,0.5143695940345118,2.1145730320239915 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,fruit,2441100,107.9173045246264,0.20724276910691652 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441098,313.54717454324236,0.03974328393222981 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441081,208.77454943583496,0.13688205256351926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441101,328.9370783834316,0.06055322304881949 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441086,461.4774708713566,0.20759089615846227 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441085,217.77658363499893,0.11854842711407887 +1017363 Sl10g007190 #19.2,transp1-1,1,m_28,leaf,2441100,258.70783516272394,0.04375002580097531 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441098,255819.88297488325,0.002182185380013024 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441081,215787.67736552592,0.07608984080185976 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441101,258397.17228042617,0.002171275420080221 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441086,206369.35120479637,0.09547128249837478 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441085,692387.0075240906,0.43023242853702115 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,fruit,2441100,386293.393540985,0.1768007995149361 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441098,373265.8722297904,0.06485509388094712 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441081,400611.4689073415,0.03414999965752319 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441101,543434.7534084468,0.09827403071155949 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441086,408423.37389938417,0.02576278937648091 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441085,458345.63264417864,0.024319719527189143 +1017363 Sl10g007190 #19.2,transp1-1,1,m_29,leaf,2441100,682671.037918902,0.19733810045561828 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441098,49.40677076924173,0.2894377172919427 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441081,24.54305383604876,0.5932955865623539 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441101,83.77048673489665,0.06013314773677725 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441086,108.65127309289824,0.05281063283393217 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441085,641.0191141142608,0.8236467930600153 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,fruit,2441100,229.28426713549436,0.3771500690583951 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441098,39.963823121672355,0.24634272067094676 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441081,90.72715932296462,0.1097275644795137 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441101,17.190449123765838,0.612722525437267 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441086,102.54031688460525,0.1628849064206661 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441085,50.21461821859534,0.1471795837010157 +1017363 Sl10g007190 #19.2,transp1-1,1,m_3,leaf,2441100,101.26398597930894,0.15744526939535053 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441098,145.05093232502668,0.09830225441013507 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441081,136.92655052514036,0.12333511153530585 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441101,144.6311808422269,0.0995608469986915 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441086,225.3730644861455,0.0930792309902495 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441085,218.74075793996107,0.08010693360193422 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,fruit,2441100,307.0840443753638,0.22743447272583195 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441098,7593.551416964346,0.03294812017471038 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441081,6598.054097738392,0.028080945760629916 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441101,6613.043822874075,0.02709541711730168 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441086,7464.497584791703,0.025503764069723545 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441085,6604.687688752927,0.02764453152761215 +1017363 Sl10g007190 #19.2,transp1-1,1,m_30,leaf,2441100,7913.921570468055,0.05089492416774544 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441098,39.14816772255159,0.4132421521878846 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441081,41.51872860225276,0.38770954652634004 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441101,84.45199846238252,0.07934366136384607 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441086,126.9969897436468,0.09783983434897126 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441085,118.30861108671505,0.06706276339471007 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,fruit,2441100,166.06303609500745,0.2143193812858728 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441098,532.8425334935401,0.006953124874045091 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441081,516.5415476377816,0.020446750021293703 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441101,548.92296865269725,0.005959393962660986 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441086,753.8405089082321,0.1437274618592541 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441085,533.9612013933867,0.006042307901492627 +1017363 Sl10g007190 #19.2,transp1-1,1,m_31,leaf,2441100,599.8717985133416,0.04450643570041235 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441098,129.31500738552523,0.13865448066682662 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441081,88.31496227420918,0.3042691218667217 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441101,183.21281999803492,0.012652449775946817 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441086,172.69161943611573,0.013032147448206466 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441085,200.39661800373275,0.05158697826104541 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,fruit,2441100,201.77476098600405,0.054563431914865124 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441098,2416.2310713895977,0.022604985297442592 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441081,2104.1299342082857,0.03746092465757167 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441101,2155.1392973844772,0.027058133496440373 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441086,4522.866263881438,0.29488026681621937 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441085,2171.1358133872486,0.02384648832267411 +1017363 Sl10g007190 #19.2,transp1-1,1,m_32,leaf,2441100,2666.359943983345,0.06538529689555306 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441098,262.11574001845327,0.3057652240470765 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441081,108.43519677979928,0.07755760508627763 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441101,12.66435788565384,1.0101447021359342 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441086,150.83814937473718,0.06578331841663765 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441085,81.81088004224816,0.1999168126076183 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,fruit,2441100,1280.4282358905432,0.9946273655876658 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441098,1211.0126706652966,0.01630492427501684 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441081,1578.4044448758286,0.09876468383605541 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441101,1276.7043007742532,0.006636709964952914 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441086,2691.3018442624875,0.33050879759596263 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441085,1237.9807908428422,0.006739705411373809 +1017363 Sl10g007190 #19.2,transp1-1,1,m_33,leaf,2441100,1232.3015081204285,0.00873663142599801 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441098,313.71908445568204,0.008037759280407286 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441081,386.08939100425823,0.0821091700149208 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441101,263.37179022348005,0.08400944239874608 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441086,266.67421683753935,0.07859766985490957 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441085,381.1609215354812,0.07652967008014144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,fruit,2441100,325.4395995027824,0.007891698591257157 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441098,51922.32619742227,0.04156160180126456 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441081,43716.52574224348,0.03314689924654424 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441101,41650.61162427122,0.05417115621739477 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441086,74075.60200863848,0.19588265019002993 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441085,36167.67133503125,0.11547199196743207 +1017363 Sl10g007190 #19.2,transp1-1,1,m_34,leaf,2441100,50650.99279958142,0.030795422830093067 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441098,125.91311022094008,0.09761718879131642 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441081,26.55030855922664,0.5783841902435392 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441101,75.22008763267836,0.12611992787533488 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441086,60.13703673885057,0.22331173855389252 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441085,258.9277857378176,0.4107248944846771 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,fruit,2441100,1536.4811782951465,1.1840734816487144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441098,12589.777034511646,0.3009820315320346 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441081,6957.602468327843,0.043423603869853444 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441101,2891.7022663388016,0.3378824319057907 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441086,10621.807231179992,0.22716240813397137 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441085,3931.280257820747,0.20450200184065848 +1017363 Sl10g007190 #19.2,transp1-1,1,m_35,leaf,2441100,5633.565076767589,0.04825269178595448 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441098,1937.8969542087111,0.03159114628932835 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441081,1395.2073410976673,0.11110078114984301 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441101,1682.5090776314248,0.029782117802628072 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441086,1380.2370291855902,0.11578585931411212 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441085,1921.364349045897,0.027870194246114366 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,fruit,2441100,2652.333243325011,0.1678885547519542 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441098,11323.798394920712,0.2187852825112362 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441081,7630.244486832409,0.04733160753994392 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441101,3590.4080729123634,0.28006303448073844 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441086,11392.765027125648,0.2214222940405568 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441085,4856.152184321279,0.14891455781864238 +1017363 Sl10g007190 #19.2,transp1-1,1,m_36,leaf,2441100,6054.504693181058,0.053128226041960325 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441098,471.9263413961715,0.030266157276333416 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441081,350.3428868281902,0.09911475741143949 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441101,408.38856799251306,0.03253448525695868 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441086,359.1104767884623,0.08837998611278008 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441085,512.78267872378035,0.066325285082472707 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,fruit,2441100,620.9521112064451,0.1494500463503461 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441098,422.2350288975344,0.04183027531154426 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441081,360.37617671382,0.02696791103920093 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441101,406.550739600746,0.025390770961235543 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441086,602.8656474632571,0.19649655305636093 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441085,355.64936325158044,0.03270194903112866 +1017363 Sl10g007190 #19.2,transp1-1,1,m_37,leaf,2441100,334.09998670366394,0.05984752615811795 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441098,56.382624907826326,0.06327752286724198 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441081,35.060247752353654,0.14305278713242853 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441101,62.6384088176478,0.10897294912188871 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441086,8.785006062805415,0.7441257022804941 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441085,41.093389504806765,0.07409580319406661 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,fruit,2441100,61.21659707611861,0.09900141642734961 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441098,48.274903892636225,0.40642727759406294 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441081,218.08941348392273,0.24848588909050795 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441101,3.2726176009077768,1.575253433642711 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441086,521.3766774861889,0.6270029047248458 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441085,197.86310953707655,0.20621613455474552 +1017363 Sl10g007190 #19.2,transp1-1,1,m_38,leaf,2441100,23.14541799179734,0.7256836671609135 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441098,114.82669076531666,0.9464833095119944 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441081,594.6023268126751,0.23229955405277503 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441101,85.04142296491065,1.0768956399610772 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441086,5281.505149256607,0.7162315491288167 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441085,1435.6786904978524,0.15053109586412372 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,fruit,2441100,1740.6845883505218,0.23419392576827258 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441098,3532.5320479387747,0.09181677544813649 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441081,3015.37781193514,0.02307239972811459 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441101,2703.348740843502,0.0243672603855698 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441086,7007.841728077675,0.38931494963204605 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441085,2591.6283758248933,0.04269660870523051 +1017363 Sl10g007190 #19.2,transp1-1,1,m_39,leaf,2441100,2524.175384313933,0.05414980791527357 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441098,20.983895050172716,0.29381116466194035 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441081,39.9494072660114,0.01418693012885841 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441101,42.602529316160734,0.013738113823192899 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441086,24.581045257909583,0.22509692373491008 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441085,147.44779995402152,0.5529410267458166 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,fruit,2441100,146.35540465460974,0.5497114946687953 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441098,369.9578803635985,0.3457031291195727 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441081,144.3675695302653,0.06297950835248356 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441101,229.95939427886324,0.1392020026132852 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441086,189.4269094377952,0.05499252025005141 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441085,140.8696865116468,0.07363160528166235 +1017363 Sl10g007190 #19.2,transp1-1,1,m_4,leaf,2441100,135.2697459230578,0.09124847912282519 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441098,111.21435245502444,0.0253180327648157 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441081,140.83347246566328,0.1278630828656624 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441101,113.60864569715572,0.034568577996343386 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441086,80.3411341141981,0.11590484670801104 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441085,79.0181221626433,0.12311610013386076 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,fruit,2441100,98.6181695054546,0.02688586760718592 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441098,6876.065209533997,0.014094850044685803 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441081,7329.706540300226,0.01365175039257105 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441101,6702.5038064099035,0.025197767439711694 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441086,8099.780621964589,0.057038419680103924 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441085,6559.54223586577,0.03456130397055768 +1017363 Sl10g007190 #19.2,transp1-1,1,m_40,leaf,2441100,7721.05,0.03624152813483983 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441098,133.98669116501867,0.09614151496480616 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441081,171.08873788347523,0.010018245333715203 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441101,190.9132193514497,0.05763282396258962 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441086,163.28577976082187,0.01025481267888484 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441085,161.9838935150464,0.013731343559630904 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,fruit,2441100,215.1497346429373,0.10953763757208179 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441098,1568.7520959592598,0.022749592758172454 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441081,1742.897534536385,0.022967943728359863 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441101,1426.3281314161432,0.06408446396538059 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441086,2182.6273248472703,0.12067567610976981 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441085,1277.6123838164067,0.1119047990906723 +1017363 Sl10g007190 #19.2,transp1-1,1,m_41,leaf,2441100,1737.4843387193512,0.021616986819538386 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441098,44.43809902319962,0.004335775796594277 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441081,49.15705093352436,0.048166123894232804 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441101,43.514270335334096,0.004787991087049193 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441086,38.26392032677759,0.06063023300722259 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441085,50.439228102970645,0.059348735140585696 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,fruit,2441100,43.5552185956089,0.0043794988583629735 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441098,156.71266879786222,0.0319021194153053 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441081,189.4346960442521,0.05045329938934051 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441101,168.44583104843463,5.459591977445832e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441086,198.1446958784167,0.06997622515420376 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441085,144.17726519537388,0.06810944265627805 +1017363 Sl10g007190 #19.2,transp1-1,1,m_42,leaf,2441100,168.8696097698823,5.452737245073003e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441098,751.6490661471462,0.5841359041180687 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441081,1430.115544804306,0.8634919091752318 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441101,12.18317948472548,1.2061185757517205 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441086,52.796917825224455,0.569270648049685 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441085,312.5188353555208,0.20299697907173986 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,fruit,2441100,79.14115941018312,0.39347680976266 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441098,446.900972352323,0.014243378876704682 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441081,377.1368885822297,0.05946890693378215 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441101,445.5886749884375,0.012966223637588037 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441086,744.032437748621,0.23562394928408015 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441085,325.2809304700076,0.12370931710790023 +1017363 Sl10g007190 #19.2,transp1-1,1,m_43,leaf,2441100,419.3750939144128,0.013365285939698435 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441098,39771.76533495034,0.03683079367693143 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441081,35382.43917195034,0.08761789324189273 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441101,50316.72750744652,0.06530672580691643 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441086,37191.30697347574,0.06596422139896418 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441085,115348.3399315216,0.42560568666669774 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,fruit,2441100,46811.838361763184,0.03395003480867853 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441098,244600.64244041548,0.12316297504713791 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441081,197238.3363985073,0.029696712505860923 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441101,107409.39747876748,0.23425233794103573 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441086,162638.26357450002,0.05407188946202979 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441085,171165.8985938264,0.031877373915336626 +1017363 Sl10g007190 #19.2,transp1-1,1,m_44,leaf,2441100,203314.14162812245,0.04287296895925685 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441098,48470.90074042652,0.06464530379452427 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441081,47243.31681469637,0.0757860135839783 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441101,64030.10106662393,0.056257793187872274 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441086,42501.891886924066,0.12171813190449932 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441085,156885.24445141642,0.4454557046140213 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,fruit,2441100,72923.07686075688,0.11273859052257684 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441098,41178.02691154645,0.15536948834539732 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441081,31077.027037633343,0.03314342087535849 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441101,17655.523605411574,0.21241544290640135 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441086,26018.319582454344,0.04401680094310745 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441085,26510.183253275576,0.035883314927604104 +1017363 Sl10g007190 #19.2,transp1-1,1,m_45,leaf,2441100,31399.5895704674,0.03762792661266179 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441098,1570.0214527910664,0.27491033143641364 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441081,3311.560126085152,0.04921672659769083 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441101,6689.560555792269,0.35458167135655794 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441086,1082.2595655864193,0.4364844850628713 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441085,6180.626958357211,0.32021661375260146 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,fruit,2441100,2601.957746853652,0.055515678308619254 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441098,14244.267612976684,0.14578372957335084 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441081,9864.53551355212,0.013779754113794507 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441101,13044.720634288338,0.10757838790958374 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441086,10094.707988392993,0.0037626342371606114 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441085,10270.38467156162,0.0037303153843843972 +1017363 Sl10g007190 #19.2,transp1-1,1,m_46,leaf,2441100,6804.936810528293,0.17503229800218545 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441098,46.613250346240896,0.2544092799930231 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441081,80.28130812114567,0.018304227013603347 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441101,178.27302153151467,0.32816695798415996 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441086,87.19318153388978,0.01756385725883125 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441085,53.21974738317388,0.19684585861007053 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,fruit,2441100,88.46908009233938,0.023872844094925183 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441098,409.18917792506534,0.35127440870633064 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441081,281.9084730388388,0.18945839878377857 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441101,182.2975005499679,1.309837224949817e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441086,182.18755485292013,1.3102323925728854e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441085,155.8214556351012,0.06802247336095668 +1017363 Sl10g007190 #19.2,transp1-1,1,m_47,leaf,2441100,162.24542423837121,0.050477273074338136 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441098,19.611606605617855,0.06727012947608402 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441081,73.43205125077522,0.6406426164004289 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441101,13.968743811499744,0.08008569114919695 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441086,34.81669911518842,0.3165445507932707 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441085,13.983269146165648,0.07963432664313586 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,fruit,2441100,13.025973481333352,0.110432853868774 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441098,1748.3885856677314,0.14251170891851972 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441081,2919.815525131163,0.08020574199290165 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441101,1211.792693493578,0.3017213418705067 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441086,5542.2893296336515,0.35853952248464926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441085,1935.077524721749,0.09845130268107427 +1017363 Sl10g007190 #19.2,transp1-1,1,m_48,leaf,2441100,4618.152908124808,0.2793186369517868 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441098,31.18165375085471,0.004301943710931289 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441081,34.5607598582222,0.048986081373474155 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441101,30.167948333018444,0.010051425398142744 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441086,30.08682931778291,0.011220778712569102 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441085,30.62949907030873,0.003457306802186144 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,fruit,2441100,31.119112474915916,0.0034300012999246565 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441098,31.16995054260333,0.012953110943223711 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441081,34.006033574400774,0.024866755140583896 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441101,30.130080593921008,0.027688930770700892 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441086,33.05728355061766,0.012577938859688942 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441085,30.076859079580515,0.028456743123975947 +1017363 Sl10g007190 #19.2,transp1-1,1,m_49,leaf,2441100,35.667301098386915,0.045581023917450336 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441098,1333.8059363119808,0.09260422578247463 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441081,497.8237701615772,0.5206212422413743 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441101,2541.8448954198307,0.187452174406451 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441086,1124.2798214499476,0.16682245573898458 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441085,2613.0095635426287,0.19944412747106632 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,fruit,2441100,1967.8123969330777,0.07628682047043434 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441098,11877.589511577851,0.00781292002368783 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441081,8699.617207253443,0.14304108844281682 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441101,12511.52178373704,0.01476890435293754 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441086,20021.460176790544,0.21895451560276413 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441085,9337.668884128703,0.1123027623596129 +1017363 Sl10g007190 #19.2,transp1-1,1,m_5,leaf,2441100,12308.810302202008,0.007674846542778724 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441098,129.9735163375764,0.016850142995546324 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441081,207.9233637954832,0.18719828098081592 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441101,122.6392501734751,0.042075525066680886 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441086,145.71617388250615,0.0328027476978523 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441085,101.17087210124568,0.12564951794439816 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,fruit,2441100,140.25738342916583,0.016220721051337872 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441098,3089.882056566043,0.011079354061127589 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441081,3024.7574775834746,0.020330697379892015 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441101,4197.17699030845,0.12193602690379457 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441086,7021.227309761792,0.34539177698171386 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441085,2730.730260587363,0.06474245342447471 +1017363 Sl10g007190 #19.2,transp1-1,1,m_50,leaf,2441100,3249.5631441472815,0.01080372400170937 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441098,36.06876714852007,0.06683037670106007 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441081,40.07545385345981,0.021083225407033224 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441101,36.309310799210486,0.06394366935167062 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441086,44.42051008447939,0.023621866446766004 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441085,44.062446582339554,0.020106932998496863 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,fruit,2441100,51.32953965651826,0.08640569452001712 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441098,222.84842493868877,0.045093920467659476 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441081,250.85547282964663,0.0063200909556475615 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441101,237.2247999559022,0.017943400287501632 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441086,298.28663216307314,0.0815303013456452 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441085,243.6071691604284,0.006413424286887626 +1017363 Sl10g007190 #19.2,transp1-1,1,m_51,leaf,2441100,323.4555022617733,0.11671105390095748 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441098,158.23871008284632,0.08150690451940346 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441081,186.3480687544807,0.010494742302633586 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441101,159.5332254622025,0.07796849263912531 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441086,195.46398439657665,0.010247108772383662 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441085,277.3598738987215,0.1622239926557003 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,fruit,2441100,216.73701848288388,0.055113456210929 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441098,1524.745039086265,0.08516874355651227 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441081,1805.220411281379,0.011835737206708163 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441101,1904.9680312322548,0.011521719268210884 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441086,2842.986614308724,0.1854088423306881 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441085,1543.356099989688,0.07989982977184562 +1017363 Sl10g007190 #19.2,transp1-1,1,m_52,leaf,2441100,2159.855099234477,0.06605864353117452 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441098,102.56670642894947,0.04117264898445283 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441081,55.09831464231404,0.31104074410320415 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441101,124.19647656760556,0.041930216280296584 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441086,100.51774182037973,0.04993633548144283 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441085,444.0513979394634,0.5952541827464315 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,fruit,2441100,122.96575228882828,0.03760511221319973 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441098,92.24421429665465,0.4499100514530352 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441081,302.61771248645226,0.06604515657711207 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441101,396.9997290158978,0.18394102282244962 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441086,298.2846225294175,0.05978167725071826 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441085,166.86614296755977,0.19248095995179737 +1017363 Sl10g007190 #19.2,transp1-1,1,m_53,leaf,2441100,221.56673589357288,0.06934462775337558 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441098,690.987798565531,0.07561264114540078 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441081,330.7263000695193,0.39561428751105243 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441101,1267.7571301941696,0.18795304197834062 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441086,524.2994214281001,0.19550364136916754 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441085,2042.2240657548573,0.39502036981919053 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,fruit,2441100,953.8118915650537,0.06437971282649446 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441098,4896.234547399566,0.02006129796876044 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441081,5351.48400289377,0.018550719648939396 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441101,5233.835982808836,0.008896596773778853 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441086,8426.79,0.21573865932519887 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441085,4396.696563249319,0.06679701794100357 +1017363 Sl10g007190 #19.2,transp1-1,1,m_54,leaf,2441100,5021.58534913984,0.00908266332892893 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441098,43.7084117440164,0.27771914865499414 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441081,25.227840702582412,0.03903420311252792 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441101,18.752297775244376,0.08979138620131 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441086,12.149435440581836,0.27828977930322596 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441085,54.84243699202744,0.37627086803272225 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,fruit,2441100,20.890733539328696,0.04289218723742949 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441098,161.4389899078241,0.38506575960613576 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441081,103.06677593908682,0.19017601897060255 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441101,24.837065431659187,0.4278423905644988 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441086,327.8031905179708,0.6926705042562604 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441085,19.104018145192093,0.5418179500527744 +1017363 Sl10g007190 #19.2,transp1-1,1,m_55,leaf,2441100,29.970292903275347,0.3462516846210275 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441098,141.60912188853175,0.03702034331542148 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441081,282.23480085477155,0.3365396767975759 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441101,282.6471193883544,0.337173677247248 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441086,117.89623263756148,0.042570958958788374 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441085,118.46724045260802,0.04047261421557202 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,fruit,2441100,96.81571231554857,0.12812504133880687 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441098,1192.609425532951,0.507896935024073 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441081,3612.568644640177,0.026579064260954244 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441101,4165.150332236814,0.03523550856003199 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441086,2967.164765021595,0.11205350928139657 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441085,5017.9010429173695,0.11612692002255143 +1017363 Sl10g007190 #19.2,transp1-1,1,m_56,leaf,2441100,4068.5622862712858,0.025045796665565057 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441098,137.58969836899993,0.04231355598140096 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441081,146.4427559588083,0.01523158112380063 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441101,156.89709581816635,0.01471543027055322 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441086,96.78793419379204,0.1950782540190008 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441085,206.9140847690633,0.13489057981055685 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,fruit,2441100,210.47879979301183,0.14230888406622366 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441098,91135.30664536556,0.23677606296715492 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441081,54909.75301643186,0.016738894030191354 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441101,36669.14487427835,0.1586098139145493 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441086,122529.70568531736,0.3653307941124391 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441085,46606.12411246764,0.05446760886496449 +1017363 Sl10g007190 #19.2,transp1-1,1,m_57,leaf,2441100,50757.54245263678,0.017410009701445794 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441098,517592.0453082569,0.1508078369499959 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441081,746854.7589172302,0.31005639639897087 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441101,506573.91203051055,0.14146306412640897 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441086,66711.48873960001,0.7389791237258567 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441085,154310.3831558979,0.37478460661639534 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,fruit,2441100,224918.376160679,0.21115481686110993 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441098,126338.53030038248,0.07707814210044273 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441081,108560.35073359168,0.011213559432228237 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441101,96712.92472570312,0.0389731612045896 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441086,75022.93384346103,0.14926363468039483 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441085,103026.0125281295,0.011510786912372062 +1017363 Sl10g007190 #19.2,transp1-1,1,m_58,leaf,2441100,153191.7448710797,0.16077768453080576 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441098,524.4456643688824,0.1040069844143594 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441081,483.1132570786084,0.1396585287362173 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441101,934.8889420873056,0.14705253912239913 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441086,643.260819714889,0.015320384009265275 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441085,689.4547745946585,0.014798299677352134 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,fruit,2441100,857.7408115190784,0.10964859057556664 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441098,855.3170637583073,0.21988512456766207 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441081,2163.782599460475,0.18320136304471912 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441101,931.1189593944116,0.1830070911316497 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441086,1374.4105829264756,0.013895770394499518 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441085,1463.7845869145283,0.01346490894235286 +1017363 Sl10g007190 #19.2,transp1-1,1,m_59,leaf,2441100,1921.4841479664856,0.13162454498230636 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441098,208.91251610516952,0.012280158728865675 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441081,96.75103472771988,0.34658900001114423 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441101,305.0981626246876,0.1521949738273185 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441086,136.65746608344386,0.19661125466688434 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441085,353.4431844680716,0.21607499307465705 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,fruit,2441100,220.8956019847985,0.01194245079028855 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441098,308.81906471999775,0.20549382985803621 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441081,67.54234847577915,0.454634116323569 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441101,8.167035279699393,1.372145841842692 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441086,289.06813633899236,0.17678994902166423 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441085,113.8197834991631,0.22799251830131384 +1017363 Sl10g007190 #19.2,transp1-1,1,m_6,leaf,2441100,270.9848290348161,0.148734704284736 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441098,40.578971406409806,0.15932761047447142 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441081,72.42919414597118,0.09228500838823894 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441101,44.698242964241054,0.11733819297980252 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441086,42.73323438260434,0.13686288000222335 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441085,323.5934588568014,0.7423710893286339 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,fruit,2441100,125.32126645666143,0.3303961302349714 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441098,53.22620334478819,0.06531901906757454 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441081,76.62595456619734,0.2235694280356617 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441101,67.34378549955584,0.16749105537182407 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441086,29.348241231452707,0.19322438958483334 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441085,38.361351666565966,0.07691256855534223 +1017363 Sl10g007190 #19.2,transp1-1,1,m_60,leaf,2441100,36.4356395208766,0.09928007304413566 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441098,115.91712171751752,0.07014274662582354 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441081,97.76795637785398,0.1440937981473358 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441101,121.22862655809212,0.05068515055005207 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441086,211.72355585925965,0.1914788438139139 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441085,151.24240196977718,0.04538323056732141 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,fruit,2441100,206.89868575045895,0.18146739651015809 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441098,790.0039121739048,0.05454719436824451 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441081,603.5123564603377,0.06239588121839512 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441101,515.9099740467602,0.13050812345939855 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441086,996.2717625535016,0.15529577363867864 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441085,591.9371849350065,0.07080642479670596 +1017363 Sl10g007190 #19.2,transp1-1,1,m_61,leaf,2441100,1050.593740692811,0.1783527614073761 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441098,843.567164424122,0.0022291339685449607 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441081,785.3393699985602,0.03329143089635789 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441101,1303.753832671509,0.18684679754636013 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441086,852.2491001151639,0.0022177507377940664 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441085,1883.8501949247816,0.34669756383687345 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,fruit,2441100,547.5791269146226,0.18990191562214642 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441098,926433.103825702,0.0792021539252632 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441081,1275221.3395349982,0.05956935255110807 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441101,933808.0405055832,0.0757586099582177 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441086,1602289.163944416,0.1587246765872541 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441085,1043883.0349893846,0.0273643794767926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_62,leaf,2441100,1179663.457963051,0.025741907592308877 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441098,452.8827147818196,0.34008174552089265 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441081,545.5942958337793,0.2591976696198848 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441101,258.9404386370727,0.5828676114132119 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441086,1436.37757483092,0.16120112540689657 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441085,1646.244721890449,0.22042690479742255 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,fruit,2441100,1529.5680108094189,0.18850130148665656 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441098,4066.595652426656,0.03939422062325937 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441081,3680.0850309839248,0.003978917917825786 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441101,3747.827262033691,0.003942794583524645 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441086,5455.7759252559745,0.16701975367019894 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441085,3389.5349859132652,0.03969665044521653 +1017363 Sl10g007190 #19.2,transp1-1,1,m_63,leaf,2441100,2747.5055918944126,0.13089818639079365 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441098,798.505927903072,0.030879948924738443 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441081,286.5358643868827,0.4759791051374562 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441101,1451.2692688569778,0.22858990551696978 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441086,555.1743612240243,0.18872869195582131 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441085,1506.6038112007338,0.24484096821489354 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,fruit,2441100,916.1938403854748,0.02882927416555603 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441098,6796.970224038675,0.06602535639773999 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441081,8736.821482502592,0.043012738181436916 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441101,6698.008803528865,0.07239500976081414 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441086,8391.678597539025,0.02550811818472898 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441085,7434.305297589388,0.0271003318931049 +1017363 Sl10g007190 #19.2,transp1-1,1,m_64,leaf,2441100,9187.958808171386,0.0648783157007089 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441098,49.44482728983072,0.06643671403092233 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441081,78.15050677836986,0.1323742203345062 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441101,63.69903334983813,0.043575263572635636 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441086,51.53680718803905,0.04844006867029371 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441085,49.47271837919865,0.06619180406179903 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,fruit,2441100,69.24083945922764,0.07980474624096567 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441098,1863.444336620901,0.003494891426890856 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441081,1969.4807335712867,0.020540420884778587 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441101,1893.5566703306756,0.003466991409903475 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441086,1129.4934011835633,0.22092761780511339 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441085,2112.5700293390373,0.050999798438744026 +1017363 Sl10g007190 #19.2,transp1-1,1,m_65,leaf,2441100,1266.4341906158716,0.17122868890102882 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441098,1184.8344008574863,0.04785217361530192 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441081,440.1326623947019,0.4779262298549205 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441101,1920.1510836518712,0.16182557297698663 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441086,798.5429322741797,0.2192115585642278 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441085,2511.170893519703,0.2783664401454229 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,fruit,2441100,1460.8608906570264,0.043099033793536634 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441098,4973.6568823223515,0.11076981247921891 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441081,6466.674690954765,0.003235380340702587 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441101,6370.682621440346,0.003259664099129811 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441086,8037.080705203491,0.09765269559193435 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441085,5637.643310930825,0.05634803882315875 +1017363 Sl10g007190 #19.2,transp1-1,1,m_66,leaf,2441100,6752.58059117857,0.02202414236684236 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441098,492.5066413107023,0.04258414034854363 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441081,384.1572561257752,0.06531891012039193 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441101,809.4288366282858,0.25835072160058425 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441086,326.86608026352485,0.13545809580128454 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441085,417.3054304852197,0.029373914545135715 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,fruit,2441100,475.70790954755034,0.027512421589575897 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441098,769.3621024012651,0.34529898747139987 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441081,460.60703080956745,0.12249876050240216 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441101,124.37928472262077,0.4460837473907997 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441086,408.33156966795656,0.0701811558352805 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441085,206.40428990002752,0.22611308293397325 +1017363 Sl10g007190 #19.2,transp1-1,1,m_67,leaf,2441100,286.47161118823954,0.08375021169693175 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441098,235.66751807650465,0.019071334765526693 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441081,215.41748535531647,0.01994744140508553 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441101,200.3133747293853,0.051518445633406795 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441086,246.95098466529288,0.03938236884360036 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441085,158.67831823458707,0.15271080439548745 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,fruit,2441100,297.28086950267027,0.11993856924702939 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441098,886.9137298899726,0.04975556546195392 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441081,678.455627899785,0.16611549415827254 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441101,928.1644028252022,0.03001203527770091 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441086,1190.6169999917045,0.07813513573054731 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441085,1060.9828722826935,0.02807142951308128 +1017363 Sl10g007190 #19.2,transp1-1,1,m_68,leaf,2441100,1106.2840773568323,0.046229718158403266 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441098,54.63427363327329,0.08268640751360268 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441081,115.78033155652916,0.2434832079208682 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441101,77.55054413642534,0.06943326841725095 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441086,108.8508941120173,0.21668041974234353 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441085,28.97915006870418,0.35806593711522394 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,fruit,2441100,23.779504134891177,0.44394878679063665 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441098,178.28951626648615,0.1395911425769314 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441081,148.07334134470744,0.05894221247744591 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441101,110.48863563197914,0.06821705335285255 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441086,83.07833028212401,0.19204690462852891 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441085,44.50463796898332,0.46312939153867205 +1017363 Sl10g007190 #19.2,transp1-1,1,m_69,leaf,2441100,149.457719642445,0.06298368762539974 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441098,23.48043075992544,0.21437934873767528 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441081,60.131599999674336,0.19401735110737595 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441101,89.11895931771825,0.36488469767683807 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441086,22.656969076600323,0.2298835968189341 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441085,31.04466568109951,0.09309842142453228 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,fruit,2441100,45.88881904625255,0.0766214724928731 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441098,282.229493403958,0.13987176592998685 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441081,677.0324235608213,0.5198788375701366 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441101,189.0959849980183,0.0340483225464383 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441086,219.9391609536393,0.03157193364800159 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441085,157.6163523141877,0.11312935779254296 +1017363 Sl10g007190 #19.2,transp1-1,1,m_7,leaf,2441100,160.79031907209705,0.10447073325891676 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441098,744.261678614427,0.03096372949025028 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441081,1144.3735534539476,0.1558784250627383 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441101,854.2631392021823,0.028902279680989462 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441086,274.31597532939895,0.4644382872803452 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441085,1079.5688839487325,0.13056097092772712 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,fruit,2441100,106.03098814901674,0.8772565788074238 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441098,508988.4687953531,0.023640865802603273 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441081,583342.8264595661,0.035575052338577606 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441101,394392.80750009377,0.13441982308996892 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441086,998473.6262202788,0.2689877886125913 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441085,436671.3445144601,0.09019411590219928 +1017363 Sl10g007190 #19.2,transp1-1,1,m_70,leaf,2441100,565938.1185737166,0.022420137432012766 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441098,105.6213764029383,0.00604303382320337 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441081,96.58732338157732,0.04487472540463333 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441101,107.99528218083852,0.003609927052139028 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441086,131.05208273687833,0.08764907082210183 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441085,173.48412507218924,0.20946488365747795 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,fruit,2441100,106.20737412738112,0.0036401850436775796 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441098,3881.1017396430216,0.009664774242467367 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441081,3209.5598117685213,0.09217432838393513 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441101,6075.454044273501,0.18495893836259958 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441086,4553.558975270919,0.059731163922424724 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441085,4055.77795534453,0.00945436856032611 +1017363 Sl10g007190 #19.2,transp1-1,1,m_71,leaf,2441100,3078.2301567933214,0.11031871321809339 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441098,93.0122990199426,0.04911889515636947 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441081,84.0190287107071,0.09328161764854292 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441101,103.8956769522433,0.0010617971293362949 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441086,170.86968718637306,0.21500575007917 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441085,249.91927467409596,0.3801404774881263 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,fruit,2441100,104.4043230477567,0.001059207494692238 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441098,479.677680096443,0.015222638925755483 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441081,391.5587490727873,0.07292993945326831 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441101,304.2250875318109,0.18253184710296422 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441086,587.879191329462,0.10356121626640835 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441085,521.2625446261186,0.05132964793901573 +1017363 Sl10g007190 #19.2,transp1-1,1,m_72,leaf,2441100,446.63341832176144,0.015775656794053905 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441098,58.508407374263186,0.0030468380490582536 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441081,73.55493455314968,0.0963466987715984 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441101,59.332237446702976,0.0030256114710496274 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441086,67.35029183054789,0.0580743672469608 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441085,52.46441498370228,0.05040028009835118 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,fruit,2441100,53.49525925012285,0.04194981807579934 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441098,1895.3110422805169,0.00956763460306398 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441081,1877.214152013036,0.013734307833336512 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441101,1979.7462075420592,0.009361392229748855 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441086,2781.566654999077,0.1570413439879581 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441085,1672.7315724527878,0.06382187326313238 +1017363 Sl10g007190 #19.2,transp1-1,1,m_73,leaf,2441100,2043.9975728830564,0.023232248304144498 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441098,160.78691999861172,0.06362771736674766 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441081,192.93705582872283,0.015537213614153611 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441101,255.2116104153358,0.1370219945832205 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441086,179.37613995885602,0.016113759314213993 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441085,130.89143640582338,0.15296719970845185 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,fruit,2441100,220.71392008487587,0.07395129090597541 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441098,825.9774215466266,0.06229092007093895 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441081,923.8025312586668,0.01367994802661876 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441101,982.9269940894684,0.013262166321300839 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441086,1286.7270017302462,0.13022731872011217 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441085,706.5143919078719,0.13013808294214746 +1017363 Sl10g007190 #19.2,transp1-1,1,m_74,leaf,2441100,1177.107101710711,0.09155688396737816 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441098,115.93218751262248,0.02894029239766649 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441081,124.68175069586404,0.002658568715774745 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441101,115.54112172897176,0.03040774343161967 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441086,173.14068485638953,0.14525480803459612 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441085,123.1599146734576,0.002674943650633921 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,fruit,2441100,159.57944504422343,0.10983262743303701 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441098,7661.875381408298,0.03430295908912706 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441081,8921.313172010847,0.03179074192790443 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441101,7052.7401931338345,0.0702801573756684 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441086,11615.81627255144,0.1464116910748805 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441085,7164.622318070475,0.0634447415245476 +1017363 Sl10g007190 #19.2,transp1-1,1,m_75,leaf,2441100,11676.744538512015,0.14868373580749505 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441098,67.6238320465054,0.16874671708534228 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441081,71.01624245123838,0.19000462931615636 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441101,26.94844378927551,0.23081936951272408 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441086,25.768992431992512,0.25025562228906884 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441085,64.75445324575507,0.1499165805109437 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,fruit,2441100,14.774327816287464,0.49184532923012325 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441098,127.45250710623412,0.2792778866517325 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441081,252.46991163604656,0.017583358535795846 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441101,232.43464497950237,0.01832540825822493 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441086,304.97841886408946,0.09964283902082416 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441085,290.68953744773444,0.07880313133661021 +1017363 Sl10g007190 #19.2,transp1-1,1,m_76,leaf,2441100,224.21540975088624,0.03396081227461334 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441098,654.6743449948975,0.002465796228936945 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441081,1116.290873751222,0.23421784803433532 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441101,647.2613129751059,0.002479876274484649 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441086,618.5435799813649,0.022189222534591657 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441085,696.3571303158951,0.0292725007486645 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,fruit,2441100,566.8687602749088,0.06007700214448519 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441098,15353.275273652203,0.038019155592550646 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441081,15602.867134023898,0.031015781901446715 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441101,17912.978990128544,0.02894762434040743 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441086,24679.73259604589,0.16812025763899818 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441085,14021.354932259026,0.07743020913998233 +1017363 Sl10g007190 #19.2,transp1-1,1,m_77,leaf,2441100,22560.51369497618,0.1291287919730877 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441098,61.47446927495087,0.004338724957497542 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441081,67.82312959941147,0.047021762697532665 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441101,60.75915546189519,7.443344518685002e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441086,59.21397928372864,0.011931815675453095 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441085,60.06223474489287,0.005754576066661965 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,fruit,2441100,60.96760347236629,7.430609243332942e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441098,96.24334935296318,0.02214330891523697 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441081,105.78618918123858,0.018914935143941047 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441101,96.29943428969342,0.021890301466524376 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441086,105.68604833153888,0.018503622319146373 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441085,96.86944835819654,0.019327210768898873 +1017363 Sl10g007190 #19.2,transp1-1,1,m_78,leaf,2441100,111.96370843408651,0.043563237287232326 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441098,105.44416538596472,0.025974697463019503 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441081,112.2597365468918,0.0012267675848636195 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441101,118.26138706513755,0.023845717359561647 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441086,100.59390079437698,0.04642560169870924 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441085,114.99127003114111,0.011667619513780814 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,fruit,2441100,111.62642303246102,0.0012302426989485582 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441098,236.91888325944544,0.01932619228325594 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441081,258.48095998688456,0.018502688796078637 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441101,233.6599451473821,0.025341598761945416 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441086,263.0546150066437,0.026120056256516033 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441085,230.6994237964624,0.030879359354801128 +1017363 Sl10g007190 #19.2,transp1-1,1,m_79,leaf,2441100,272.7788759948579,0.04188486634055888 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441098,64.43965734912149,0.06795831732099122 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441081,50.86965955269521,0.1706527086533154 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441101,113.62546836249628,0.17836414662855282 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441086,49.46250425724836,0.182835439106672 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441085,126.03522192054255,0.22338039065953752 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,fruit,2441100,86.27015719753979,0.05874904962959149 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441098,325.29606216686454,0.03899991023378524 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441081,269.4189364070726,0.042850778452857785 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441101,325.4033413104386,0.0391431122722401 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441086,240.41376089623455,0.09231957342082131 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441085,375.01572924370595,0.10077058789644822 +1017363 Sl10g007190 #19.2,transp1-1,1,m_8,leaf,2441100,253.00795105338764,0.070144726206764485 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441098,47.518423037602155,0.017994202913897306 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441081,51.53881580816643,0.017278213192964742 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441101,47.032381615860885,0.02245925146751926 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441086,55.058206117788615,0.0459658348132026 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441085,56.8433386725808,0.059823355647985244 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,fruit,2441100,41.75189064537223,0.07418007611837063 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441098,155.0725900913595,0.01200944974444873 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441081,169.57766459097544,0.026824159431797945 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441101,147.23978119293446,0.03451932708424765 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441086,204.83167131401035,0.10885261814763059 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441085,163.7686474620672,0.011686271802830106 +1017363 Sl10g007190 #19.2,transp1-1,1,m_80,leaf,2441100,136.31828142343952,0.06799038820352887 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441098,268.03054590364763,0.123893175300537 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441081,198.9818773421636,0.2532639421962215 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441101,573.0470432589563,0.20611280984925928 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441086,308.7709473529287,0.062441035928817 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441085,426.5490147041391,0.07789147690561915 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,fruit,2441100,404.2584930139713,0.054581686510021044 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441098,5964.637831010872,0.02461505627003735 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441081,5175.994877838707,0.0862052971108409 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441101,7184.824222918081,0.05621701256996614 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441086,7843.247540584141,0.09429678699199995 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441085,6135.347217894005,0.012359989194641763 +1017363 Sl10g007190 #19.2,transp1-1,1,m_81,leaf,2441100,6489.587196193958,0.012017937134891632 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441098,5354.797566056373,0.07032102130194717 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441081,5301.69135611848,0.07464963742130548 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441101,6475.226672685407,0.012190897376280319 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441086,6116.754749764587,0.012543010732231519 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441085,7994.3853662011825,0.10372100080716651 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,fruit,2441100,7888.471385113734,0.09792877588255067 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441098,293832.35888772813,0.1032779890555009 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441081,163410.07341870485,0.15154280748043192 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441101,180037.7175119067,0.1094581342094676 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441086,580863.9825766833,0.3992528155719466 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441085,131119.4711688796,0.24715444362870986 +1017363 Sl10g007190 #19.2,transp1-1,1,m_82,leaf,2441100,283250.89793262054,0.08734966269499189 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441098,144.22873487432554,0.07225041031609392 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441081,93.40549438528528,0.2609297809046236 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441101,286.8634534222705,0.2263730180281338 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441086,177.26902819911606,0.017330659511929802 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441085,203.89896432815112,0.07811281549308147 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,fruit,2441100,163.3996457472483,0.01805109372118663 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441098,1174.6460061146388,0.03842389334354479 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441081,1301.9931037733604,0.0062777841890255814 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441101,1101.236164389412,0.06645043463014044 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441086,3028.803723368811,0.37294023077183835 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441085,1264.6228850968196,0.006369863028606204 +1017363 Sl10g007190 #19.2,transp1-1,1,m_83,leaf,2441100,2518.63989515009,0.2928351785495371 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441098,555.1820615741028,0.014603701151274517 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441081,246.72253048811675,0.3668303156868409 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441101,838.1840557150103,0.16430026886248994 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441086,593.1543139043467,0.014128566910738272 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441085,1651.1500612204525,0.4587474185919418 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,fruit,2441100,512.3866252412291,0.049441341493539515 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441098,8156.509789269178,0.06780662571834428 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441081,14015.344594753553,0.16729279273750342 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441101,7911.241806559845,0.08106632857543161 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441086,10913.063850468592,0.05863570872094437 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441085,6944.462482785098,0.13767235147991697 +1017363 Sl10g007190 #19.2,transp1-1,1,m_84,leaf,2441100,11718.518514687434,0.0895617230524075 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441098,41.469629859154274,0.03752182351225675 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441081,45.569341172002595,0.07846441419194772 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441101,40.93210881402118,0.03185578445081516 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441086,34.56339698999076,0.041591915920918154 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441085,35.142255354196266,0.03437870539789967 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,fruit,2441100,33.99164153392373,0.048836197374390045 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441098,375.5479787215349,0.008770280067415648 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441081,444.1457337691584,0.06408978593473824 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441101,328.03424484619643,0.06751652505695338 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441086,449.8219509422494,0.06960493590584083 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441085,367.4107797526504,0.018283814662696685 +1017363 Sl10g007190 #19.2,transp1-1,1,m_85,leaf,2441100,390.8700364758788,0.00859667040439982 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441098,605.3727682428441,0.07659486898931611 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441081,804.646527610923,0.046987391475706186 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441101,1022.5288525735208,0.1510578213033149 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441086,700.802032906501,0.013022397008409126 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441085,495.5377119947616,0.16354103871474424 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,fruit,2441100,743.4658233043833,0.0126432590656127 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441098,8732.743136363048,0.01437911292866545 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441081,7040.489798129943,0.07916869962216433 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441101,9245.352903661558,0.03915192009025459 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441086,9542.898406310816,0.05290872720998596 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441085,6410.309448541049,0.11989257817169463 +1017363 Sl10g007190 #19.2,transp1-1,1,m_86,leaf,2441100,8163.944240110177,0.014871543328089487 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441098,396.9452761537428,0.08665691872346537 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441081,306.30744836581005,0.025916161752797873 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441101,184.47195859586623,0.24614336043961726 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441086,275.29628799788605,0.07227336371452564 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441085,367.3950105655717,0.0530595347750098 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,fruit,2441100,343.97751958488226,0.024456341213350274 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441098,14711.603720929645,0.08659258795576719 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441081,20643.53397282079,0.06053144035196745 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441101,9890.09213283343,0.2590522686112582 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441086,31014.088848979252,0.23730642074608532 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441085,15272.022656228704,0.07035604630414927 +1017363 Sl10g007190 #19.2,transp1-1,1,m_87,leaf,2441100,21284.569250736,0.07381225953919834 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441098,126.97639487633134,0.023904269601153327 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441081,69.53547155674887,0.23761231861017484 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441101,49.5949712733384,0.38438107974608715 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441086,113.37614646463535,0.025297031094077216 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441085,140.64186449416138,0.06829589243558587 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,fruit,2441100,141.79202190019404,0.07183307264003158 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441098,726.0818428127067,0.11388322637681991 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441081,1499.548541637194,0.2010917259651368 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441101,682.8989870888303,0.14051233428181797 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441086,1305.7784211853984,0.14100068450402858 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441085,904.758520838244,0.018336120932894495 +1017363 Sl10g007190 #19.2,transp1-1,1,m_88,leaf,2441100,982.7929301915062,0.01759322085061843 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441098,1811.109980390607,0.5001582686906447 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441081,4529.064063831533,0.10209462867165531 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441101,8555.086411794586,0.1741213080341404 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441086,7280.401350073417,0.10405222901236222 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441085,3532.6447556065355,0.21000312573838587 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,fruit,2441100,6929.576276948231,0.08260358708861659 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441098,55692.092494391945,0.21123967019668832 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441081,98469.3592138928,0.03626790582391326 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441101,138173.2023996392,0.18339061727534567 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441086,82691.01187128799,0.03957489962180194 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441085,113575.8067882571,0.09825262457034434 +1017363 Sl10g007190 #19.2,transp1-1,1,m_89,leaf,2441100,51365.842907362065,0.2463587867184005 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441098,49.41979755484953,0.07221228566437032 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441081,34.27889461719595,0.08666186745163573 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441101,50.64971277309494,0.08288831053978529 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441086,12.09712965800938,0.5390063408685226 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441085,52.720381968562485,0.1002898717934737 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,fruit,2441100,12.734950587314284,0.516691412141224 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441098,129.57203884777994,0.019890268459446858 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441081,141.71656884108253,0.0190190678932467 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441101,129.18485697128372,0.02118995229911791 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441086,145.10504803542554,0.02928096028871563 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441085,129.53085977887915,0.020028312785765667 +1017363 Sl10g007190 #19.2,transp1-1,1,m_9,leaf,2441100,150.29050726346324,0.04452998928175944 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441098,45.09128299802191,0.17482779126879633 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441081,66.64046303599642,0.005182377878762079 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441101,68.24041348588337,0.005121265783554874 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441086,94.42978652274466,0.14618862399475674 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441085,41.77140452492223,0.20804130562199918 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,fruit,2441100,147.93648013024395,0.3411548973863261 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441098,1692.9961003886017,0.006736964230805942 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441081,1745.9305888036404,0.006634051910163308 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441101,1579.9913603653024,0.0367382098239859 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441086,3633.9603015021407,0.3249872566355205 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441085,1687.839135839546,0.008061869366684515 +1017363 Sl10g007190 #19.2,transp1-1,1,m_90,leaf,2441100,2591.435564209384,0.17814749262401985 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441098,380.2520817662334,0.04323337633310054 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441081,419.95048425835125,0.08635986236467152 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441101,336.2779973517477,0.010139771647091234 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441086,311.3613177470016,0.04357356741230767 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441085,337.5090251899133,0.008552833418337347 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,fruit,2441100,350.934341392206,0.008387645032252422 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441098,609534.830389213,0.11920412864281893 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441081,1065253.4014527893,0.12325027360631058 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441101,665936.1954393813,0.08077003539319616 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441086,1451722.5522244652,0.2576809675491871 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441085,748088.5830343362,0.03024962920903551 +1017363 Sl10g007190 #19.2,transp1-1,1,m_91,leaf,2441100,856015.8967445153,0.028279173858208217 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441098,85.23567636944456,0.10480731291409762 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441081,44.92647771820303,0.17331172804380146 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441101,48.68390853090506,0.1384286610555132 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441086,192.0751512993769,0.45765708511806324 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441085,473.1348730490718,0.84917086065355 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,fruit,2441100,43.05382426528119,0.1918023650353624 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441098,112979.69882662132,0.07944873765525262 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441081,179451.19249986892,0.2803946736439409 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441101,46715.39151259252,0.30409168209840587 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441086,105826.82219688008,0.051044080148029636 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441085,82356.73371794216,0.05785256094017566 +1017363 Sl10g007190 #19.2,transp1-1,1,m_92,leaf,2441100,76959.2392642992,0.08729090894872549 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441098,6.059709781630549,1.3889941769560545 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441081,67.49774211682617,0.34215675652037203 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441101,699.5514705917802,0.6733736719926653 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441086,89.77179601923845,0.21830608792346018 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441085,231.32623519638497,0.19277888791189746 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,fruit,2441100,207.0364739814838,0.14460086071812084 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441098,56.436047563245566,0.345425389141234 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441081,178.2539129310532,0.15405709206982632 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441101,85.8992911188349,0.16299240010571503 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441086,132.09070361555723,0.023890273617729108 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441085,151.4458208237112,0.08327531344486916 +1017363 Sl10g007190 #19.2,transp1-1,1,m_93,leaf,2441100,117.95072731924294,0.02528135673162968 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441098,345.5218590047108,0.171916927854316 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441081,329.8646140784053,0.19205672602152468 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441101,378.2585798806595,0.13260366779995403 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441086,672.7584624163052,0.11746671379691298 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441085,648.3915139726998,0.1014448667220127 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,fruit,2441100,807.9486129388996,0.19699128417543843 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441098,2855.4675758965795,0.02318371593692703 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441081,2888.6710377737813,0.018162861861840796 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441101,3010.9240581642493,1.6114718006532414e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441086,3013.1589101876684,1.6108740776088482e-4 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441085,3284.6537780896033,0.037628650093542326 +1017363 Sl10g007190 #19.2,transp1-1,1,m_94,leaf,2441100,3182.1753734531735,0.023863161442359893 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441098,78.39108033811596,0.07514495738982108 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441081,74.16480966473803,0.09921372056325617 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441101,108.00707183087133,0.06404058506186883 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441086,62.775868354847965,0.1716188782021959 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441085,120.37676546617588,0.11113106255620786 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,fruit,2441100,134.1472168544199,0.15817005975554665 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441098,161.09248597369597,0.259027679539763 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441081,59.70844290616907,0.17201185836964528 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441101,73.11322412086501,0.08405166835379774 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441086,104.3374280056857,0.07039252279647568 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441085,70.82548616347299,0.09785803973720375 +1017363 Sl10g007190 #19.2,transp1-1,1,m_97,leaf,2441100,159.38171066697296,0.25439087981625597 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441098,1176.5814339260048,0.1523454698753235 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441081,951.133061782339,0.24472618276011726 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441101,3068.4084019238576,0.2639457023073266 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441086,1657.185414754656,0.003596358630628682 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441085,1684.837729076613,0.003590618282357294 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,fruit,2441100,1684.745413924955,0.0035668218901809823 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441098,14657.18799750486,0.01345235110371057 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441081,11692.263626451804,0.11160441051238301 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441101,19961.444573354995,0.12068895780619648 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441086,16262.326518028,0.03167966727932381 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441085,15579.415509267896,0.013048150895012434 +1017363 Sl10g007190 #19.2,transp1-1,1,m_98,leaf,2441100,12429.9572420093,0.08503337467409189 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441098,11529.310950475498,0.007221415861088154 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441081,9241.8468910997,0.08882316726773976 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441101,11149.064045666884,0.007343526323487559 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441086,11134.289104871154,0.007919442897175166 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441085,28933.823562378813,0.40682389222983684 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,fruit,2441100,15174.734464790155,0.12653916371853047 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441098,77806.08480589677,0.12333679552823629 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441081,63922.77284030481,0.037978838845099006 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441101,52076.17570475553,0.0510376830456849 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441086,57079.156809553744,0.011199217722206 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441085,49803.471485450995,0.07041715094345058 +1017363 Sl10g007190 #19.2,transp1-1,1,m_99,leaf,2441100,60061.25928372029,0.010917666977434237 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441092,164.9120873940779,0.11903418765365092 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441087,123.01219992032392,0.008270115814666301 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441090,119.88354332410783,0.019458730561825455 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441093,122.94140150450256,0.00852014152675018 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441082,333.903828771292,0.42540309780274477 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,fruit,2441097,127.74204679455777,0.008115569323078109 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441092,720.8366168124898,0.23285557866832374 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441087,40.34530947765416,1.0191882098383358 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441090,122.52,0.5367742728713911 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441093,925.2653853674584,0.3412850542955508 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441082,31.50078704171311,1.1266598563082943 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_1,leaf,2441097,850.5575977553077,0.30472246733692776 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441092,45.24490866765,3.2587103490278047e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441087,48.33744692901955,0.02903986341885978 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441090,40.27154098724164,0.05024559667052708 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441093,118.28072193928766,0.4176701217869554 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441082,45.17703548179146,3.261157344818244e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,fruit,2441097,39.59689565837883,0.057582705663015155 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441092,357.926421011974,0.015206817104107984 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441087,322.71277973415175,0.029770776512670682 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441090,367.0539148681151,0.026142919731354297 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441093,374.7550946890004,0.03516060493729656 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441082,312.70011083990727,0.04345890554990417 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_10,leaf,2441097,333.2945987492076,0.015758665033731134 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441092,88.44837006287537,0.023320447325198224 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441087,22.04086397837445,0.6267816670199238 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441090,26.478517953703335,0.5471166081442276 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441093,122.7269353558076,0.11892960806604824 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441082,98.20690888972264,0.022131760213339513 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,fruit,2441097,150.35688743968225,0.20711304532597286 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441092,4897.714391232262,0.07068187001431303 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441087,4138.795840045502,0.0024375818578614705 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441090,3844.119642505051,0.034514689781867336 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441093,4606.302777328705,0.04404089546022716 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441082,4185.386435194486,0.0024239766723668232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_100,leaf,2441097,3801.019250256857,0.03941151666589171 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441092,37.22050579680816,0.098369417322834 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441087,40.18783508197921,0.06505707648570769 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441090,63.8623775893449,0.13609339536934195 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441093,44.39102302202621,0.021856534111870163 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441082,110.8727620501413,0.3756731788888974 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,fruit,2441097,48.97345715363236,0.020809075116777764 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441092,67.65040634073067,0.047518638660001944 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441087,175.9473886292771,0.46263105465804255 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441090,31.130440461606888,0.28956650534524164 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441093,53.62752109414752,0.05336404848439136 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441082,467.1194399126768,0.8866761706520583 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_101,leaf,2441097,29.07546239223647,0.3192251407444713 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441092,95.6104454803649,0.08663455935721887 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441087,75.15289642162288,0.19119417795312632 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441090,167.2351583825122,0.15618768474503097 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441093,124.74393550240124,0.02887954025911066 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441082,154.69601418801818,0.12233922297649613 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,fruit,2441097,108.69317385950971,0.03093763066201749 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441092,566.0479150883062,0.010348379246697625 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441087,499.903713725949,0.043618452772505645 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441090,531.5788195798523,0.016937147431888455 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441093,628.582581694098,0.055857526493224174 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441082,638.7222303673407,0.0628072159360169 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_102,leaf,2441097,539.3911588656625,0.010600992184343738 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441092,47156.4681810144,0.05909325971017143 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441087,1653.548714080663,1.514217536646604 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441090,85019.76010003401,0.19688534464469143 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441093,39015.84789397234,0.14139348108166683 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441082,60903.423086281706,0.052007172366278276 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,fruit,2441097,67060.56939591738,0.09383270606242711 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441092,1096895.1096273342,0.010976782405493601 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441087,886111.4797151003,0.08169995488542359 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441090,1112231.1960039726,0.017006754226482457 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441093,1172159.4102215136,0.03979836063398867 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441082,1042141.9723791973,0.011261430327294875 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_103,leaf,2441097,983123.1503331604,0.03658039495472476 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441092,46229.053500559785,0.05909325971017143 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441087,1621.0287775493969,1.514217536646604 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441090,83347.69735473185,0.19688534464469143 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441093,38248.532793775295,0.14139348108166683 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441082,59705.65041926725,0.052007172366278276 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,fruit,2441097,65741.70564431736,0.09383270606242711 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441092,1096895.1096273342,0.010976782405493601 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441087,886111.4797151003,0.08169995488542359 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441090,1112231.1960039726,0.017006754226482457 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441093,1172159.4102215136,0.03979836063398867 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441082,1042141.9723791973,0.011261430327294875 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_104,leaf,2441097,983123.1503331604,0.03658039495472476 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441092,44.60529015481893,0.046164452679627654 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441087,49.66878693613863,5.327318691321636e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441090,63.66252613558455,0.10833304602203264 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441093,43.75067210687757,0.054566092323297344 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441082,49.54700816790476,5.333861529182027e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,fruit,2441097,51.87230648417526,0.019384737722351275 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441092,161.33843917260958,0.01809726932168232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441087,175.06863214308004,0.017373218023604142 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441090,217.79821705344455,0.11221919972101535 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441093,54.96875034438903,0.48571925661977566 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441082,204.10072571065425,0.08400942843953318 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_105,leaf,2441097,72.19431952906062,0.36733209318890814 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441092,276.33003533222677,0.032637684164153136 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441087,230.5523958661489,0.046020768686963365 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441090,231.1857552227772,0.04482933737243977 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441093,270.35268732629106,0.02314028246391464 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441082,269.75398185795655,0.022177455665000068 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,fruit,2441097,242.89535987336183,0.023371190005186282 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441092,3807.543070988804,0.01832289590880709 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441087,3152.4632265858536,0.06367189963416875 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441090,3618.6122648658634,0.0037798780254822972 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441093,4899.50509067835,0.12783028437103416 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441082,3681.876291519544,0.0037472635475861438 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_106,leaf,2441097,3234.359425365523,0.0525336486834318 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441092,572.312901454012,0.16171838655010973 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441087,713.6540543965763,0.0658641852806241 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441090,1026.7474146910597,0.09211169527009533 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441093,955.9110862923112,0.06106557569708393 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441082,416.8047639889233,0.29941924850835067 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,fruit,2441097,947.3929349733264,0.05717821900366138 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441092,17825.579152015132,0.05506771422695422 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441087,16039.608489678556,0.009217828668292682 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441090,15365.907295784791,0.009417726014853578 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441093,21999.844720171845,0.14644368075709213 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441082,13930.684347613847,0.052003482978244975 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_107,leaf,2441097,12623.924280458796,0.09478155379619224 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441092,293.99025504812056,0.009155712867682908 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441087,261.7347141352413,0.04131589477103903 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441090,440.91524759677606,0.18517789558567044 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441093,281.724311271782,0.00935289629138758 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441082,397.4454565762929,0.14010031454255767 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,fruit,2441097,249.9636394546349,0.06130038279847749 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441092,548.059669392186,3.41131860449817e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441087,97.89073881714673,0.7477451062319813 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441090,547.1990220007298,3.414000251091842e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441093,772.9645523373239,0.14967286537540225 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441082,673.3478466763769,0.08975276308249258 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_108,leaf,2441097,294.54,0.269342430047395 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441092,83.2147630066932,0.02664130195149661 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441087,73.31216950482671,0.02838300706790231 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441090,9.181313537619424,0.9306542601080854 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441093,111.14738514482664,0.1523401712270016 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441082,27.520361455066254,0.4539049450429118 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,fruit,2441097,91.3211896203496,0.06701248160118967 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441092,1306.638604574077,0.08083606488319228 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441087,723.566428971103,0.1758410115057063 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441090,840.6311766908376,0.11071392761740384 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441093,1366.61758482829,0.10032758429810906 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441082,1356.6677926485045,0.09715409458382585 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_109,leaf,2441097,862.8102503694121,0.09940412439748281 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441092,2835.4164766059207,5.3887395803498e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441087,2828.384452836228,5.395434252988274e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441090,2822.092203465435,0.0015067858284725233 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441093,3376.3807228837013,0.076373427284224693 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441082,1238.479600281404,0.35918912729503605 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,fruit,2441097,4961.700354512112,0.2435525481902867 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441092,3707.8319034795354,0.06750146515703648 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441087,2088.4053249903727,0.18180377989282137 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441090,2701.4830167785913,0.07001633015615027 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441093,29164.62941078812,0.9632378905148267 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441082,3646.687262176616,0.06027994827156036 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_11,leaf,2441097,2271.2445188541074,0.14535467954791637 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441092,910.6349052686664,0.003658798174964062 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441087,732.3286019741058,0.09829709491416061 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441090,788.3836161159587,0.06626550091456895 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441093,926.0433609896608,0.0036282312570876663 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441082,1183.909165045492,0.11031529132021944 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,fruit,2441097,989.159962322051,0.03226343807323717 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441092,2061.435478953967,0.026384615764305064 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441087,1818.4162246551527,0.028091832877877643 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441090,1512.3118611693674,0.10814377219187232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441093,2416.1566190945728,0.09533995195143286 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441082,2742.1239809783706,0.15030195629844423 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_110,leaf,2441097,1718.4384815663736,0.05265114113590341 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441092,130.52116111526172,0.07615022749862854 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441087,195.0089585440047,0.0982234068240797 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441090,158.81701590257356,0.009065875459447259 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441093,152.25514907290557,0.009259167279172864 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441082,999.0406993452486,0.8077520249477579 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,fruit,2441097,113.26445806203849,0.13773750475799185 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441092,19442.0402500666,0.022895398176713933 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441087,15136.0682599805,0.08583336209629078 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441090,15072.18577298676,0.08767020132038184 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441093,30046.297755904747,0.21194452702613908 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441082,27146.747297301234,0.1678713604855222 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_111,leaf,2441097,17445.223021895144,0.024169913826589173 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441092,1979.4933389983228,0.026520766068859114 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441087,1895.501620994484,0.04535065059473231 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441090,2428.104888076138,0.06219263248987694 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441093,1659.127771438083,0.10319497790112298 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441082,2833.303476076093,0.12921828368085952 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,fruit,2441097,2228.788388861126,0.024994025819728982 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441092,305517.1447677694,0.1055423587344606 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441087,166972.14712420022,0.15684919604831116 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441090,176138.27384372515,0.13363949198056968 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441093,303068.8036317177,0.10204800667326808 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441082,324396.6619317501,0.13158314871652 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_112,leaf,2441097,134439.47284690506,0.25096642703908145 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441092,392.3495158492729,0.04331557252227025 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441087,436.17441995951594,0.0026714986425893095 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441090,430.82476502600144,0.002688033739324247 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441093,505.9569082110048,0.0671248364773005 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441082,186.60846084910244,0.3660573627392436 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,fruit,2441097,717.8983334659504,0.2190742516021693 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441092,572.8454586419908,0.10253233355995439 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441087,140.1326405424843,0.5089658353507578 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441090,375.53238082893984,0.08085775028609365 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441093,5761.258742372662,1.1050122392315753 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441082,529.2312538226313,0.06814034267369884 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_12,leaf,2441097,315.0447848960696,0.15713284601489708 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441092,66.06900981824072,0.030171236649991995 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441087,38.102820582824286,0.26921190893944336 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441090,124.50447772233724,0.24501593613094474 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441093,44.7572393900704,0.19930574313968874 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441082,80.49461507805053,0.05559779324465319 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,fruit,2441097,75.5752666602368,0.02821065352041585 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441092,229.9399750979589,0.06183176028334314 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441087,328.0315826669387,0.0924694190393418 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441090,163.83240264713191,0.20904643992533156 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441093,315.9965619633626,0.07623611725336721 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441082,160.81581175323467,0.21711749300444128 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_120,leaf,2441097,300.304602404898,0.05411574788050677 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441092,82.81713466174155,0.04601960838600094 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441087,57.91329899272752,0.10932228722145743 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441090,75.64090737353513,0.006656137758875635 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441093,74.34446171050496,8.519708546266269e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441082,74.63643632844494,8.503027850277345e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,fruit,2441097,15.183504796452036,0.6907285611725928 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441092,1051.3063883074706,0.22994988445461573 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441087,1222.611641378677,0.16439066117658419 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441090,2479.7764951477184,0.14273335128859976 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441093,2242.0975663687263,0.09897531939866733 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441082,1660.5294590026904,0.0314326031817469 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_121,leaf,2441097,1909.8073185850967,0.029310365385465165 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441092,301.88397796518376,0.13027046564765676 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441087,273.267516834515,0.17352251935579277 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441090,357.5895794371451,0.056725675282438104 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441093,457.37836252678784,0.05016508556583643 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441082,841.0044295369325,0.3146877534550616 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,fruit,2441097,498.5492850742732,0.08759756804806029 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441092,12146.278130017288,0.09453032458446842 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441087,9628.751341028546,0.00634292559842109 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441090,9912.073534671124,0.006251618325832986 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441093,13087.375913020922,0.12693968002232925 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441082,9063.810216293668,0.03260209353128163 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_122,leaf,2441097,8358.314380456512,0.06779419476289394 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441092,176.52474470060062,0.12369631643669177 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441087,51.21056679477001,0.41374969303074804 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441090,173.41490168913833,0.1159771384047974 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441093,150.94462512338023,0.05570837752928215 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441082,59.929240339683176,0.34547050299665205 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,fruit,2441097,114.60107368042075,0.06392058914012333 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441092,213.13110687118396,0.006779798007876536 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441087,219.83772515793305,0.006675582985244954 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441090,169.5530973951357,0.10612091053864559 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441093,387.97903618802735,0.2533816214222777 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441082,397.299337301113,0.26369120223420195 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_123,leaf,2441097,202.52364818270985,0.02895089641646198 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441092,15645.99680018911,0.059535745562758535 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441087,13043.1019100115,0.019486603951476056 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441090,11121.211321185274,0.0887153983960074 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441093,14240.235077314865,0.018649667150148375 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441082,16643.079225860958,0.0863661890250631 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,fruit,2441097,12551.069567363662,0.03618675476217792 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441092,237826.32567857663,0.09988913720884174 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441087,150376.87846689616,0.09918972356754452 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441090,166815.07624156275,0.05413549074144264 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441093,378173.3466433892,0.3013201278206461 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441082,211105.71456273328,0.04812920063914827 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_13,leaf,2441097,149057.4402806763,0.1030171300897722 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441092,10.632701264122542,0.5376917373837731 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441087,12.95888466001004,0.45176772505176066 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441090,60.38524260250709,0.21659546593779666 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441093,67.09947346519637,0.26238376272490616 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441082,4.895481083835383,0.8745399727241913 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,fruit,2441097,79.89645766228521,0.3381921750829966 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441092,65.60698357464686,0.08984058919107607 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441087,16.451305795972345,0.6905902846824508 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441090,191.8064152222119,0.37607246887415635 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441093,95.7622199434624,0.07440354549223405 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441082,21.45379192897057,0.5752865954906146 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_14,leaf,2441097,173.7837222251407,0.3332184352555505 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441092,7.106090672741199,1.0879122830320633 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441087,95.30942886828004,0.039592839331958896 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441090,118.82156596540842,0.1353522439451269 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441093,88.5424459145673,0.007608487089115545 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441082,85.46707985142878,0.0077441620594678184 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,fruit,2441097,35.682716661411455,0.38708511629936737 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441092,831.4478894383806,0.017984857070397986 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441087,659.5680857223493,0.08259054472458427 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441090,882.4153667202168,0.04382288431038628 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441093,763.9909995693885,0.018761935892262827 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441082,840.7441515744147,0.022813676778102643 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_15,leaf,2441097,685.1585402199923,0.06605910275948945 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441092,36.27686350171449,0.37133344487432174 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441087,5.425096191658428,0.4538888430215142 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441090,6.450591343879064,0.37869675656922075 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441093,1.0830214489727783,1.1536592282223668 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441082,24.404460586832,0.19917292683521204 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,fruit,2441097,32.290341851726225,0.3207763568068296 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441092,132.42018055597822,0.45801452556960576 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441087,3.902560319526301,1.0725900257253254 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441090,35.217245745642565,0.11718426228631085 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441093,57.033449055712694,0.09218998587723726 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441082,338.49054429351077,0.8656068910686245 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_16,leaf,2441097,34.68857514366009,0.12375318886693387 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441092,13431.570913413996,0.05463330997937099 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441087,18721.27732461321,0.08957535736570499 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441090,13577.405895802724,0.04994331790129092 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441093,19862.492271827716,0.11527362193154111 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441082,9606.157836310693,0.200210401164429 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,fruit,2441097,16886.817749016223,0.04478769697486129 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441092,55379.65012415763,0.054809710663699995 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441087,70278.28357803822,0.04866122777356008 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441090,50174.52917316899,0.09767661245565318 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441093,97010.05349069058,0.18865682574299214 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441082,126211.63940162669,0.30293948964762585 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_17,leaf,2441097,48396.26311280831,0.11334808914750827 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441092,16.381467300234807,0.5240917313232525 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441087,64.51923582056311,0.07124468430162056 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441090,44.9959958556032,0.08527066246584392 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441093,21.319243691550675,0.40967273670792026 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441082,471.5183968783067,0.935054111374428 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,fruit,2441097,76.6218508871469,0.14590810807602628 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441092,701.0515003038938,0.09254074221917685 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441087,291.71236263819657,0.28825434613334755 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441090,431.972675057665,0.11775290497633284 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441093,3050.754489043185,0.7311980781390823 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441082,1041.1913058896507,0.264321352176331 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_18,leaf,2441097,139.34098729896672,0.6091302974510961 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441092,3.90961303227455,0.07176787000746387 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441087,2.211771214987916,0.31916144205093433 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441090,5.31464916918754,0.06157295743858637 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441093,5.42044323349891,0.07013315685518307 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441082,10.003789456201456,0.3362628991134118 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,fruit,2441097,3.572509211116418,0.11092828648393172 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441092,1388.629848299393,0.014862232940770603 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441087,885.247586356773,0.18065951182624396 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441090,1295.1955518670443,0.015388918910443916 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441093,3497.536045740827,0.41603793589613325 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441082,2376.3582469223065,0.2481876499865594 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_19,leaf,2441097,853.729011642475,0.19640422316534156 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441092,260.23612159906014,0.243654886759602 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441087,36.7544667844716,0.6064025644985798 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441090,21.960959269164672,0.8300613846401212 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441093,408.1100507533895,0.43906459941542053 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441082,422.94577518440343,0.45457200003773224 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,fruit,2441097,2.9350309752733197,1.7041000021041453 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441092,465.6330566056321,0.0033521876326694233 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441087,361.4732560846531,0.10661544573371051 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441090,458.47256577945535,0.0033782635568386787 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441093,841.1343065249996,0.26017372958709606 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441082,597.7888876105199,0.11185622071609869 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_2,leaf,2441097,142.8419478282749,0.5098358531868135 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441092,45.40024812769357,0.02803814992159337 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441087,48.3500166881924,0.055376551809382724 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441090,111.27531200270803,0.4173787441581578 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441093,39.72336949147496,0.02997399656666211 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441082,21.036413702358715,0.30604837344227787 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,fruit,2441097,13.628310434914118,0.49457805884477857 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441092,38.89582895745878,0.0423101339160461 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441087,20.46171557688217,0.23665085423161325 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441090,78.89192443693042,0.34943965228092755 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441093,20.781048587224372,0.22992544003641102 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441082,75.86538262880858,0.33245075474013297 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_20,leaf,2441097,31.674622130313736,0.04688145522774878 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441092,26927.073973011666,0.15325163781231588 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441087,17366.218315321028,0.037232269258037576 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441090,21132.16411865817,0.04800644927808673 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441093,9825.710474490828,0.2845735625933101 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441082,7081.048160181691,0.42683997745521474 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,fruit,2441097,20475.21007817235,0.03429084076033728 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441092,632870.1758331918,0.05793839375613352 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441087,528239.0610812029,0.1364225113471189 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441090,813511.8604764784,0.051110865375732395 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441093,1027568.7263792888,0.15255785455028548 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441082,875578.2153499601,0.08304192397683252 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_21,leaf,2441097,558945.5851157311,0.11188349348930515 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441092,100.5739850967951,0.5243234416070468 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441087,38.04444540664015,0.10212904040496462 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441090,29.229958378183547,0.012334020197758866 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441093,30.914028387888013,0.01199338425106955 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441082,3.3312314639341363,0.9555574073244755 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,fruit,2441097,15.32958339313856,0.29263186480304015 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441092,1.0376717979984975,1.4922980057567956 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441087,30.61075290174452,0.022484007698874153 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441090,92.41086922813967,0.4573650359614756 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441093,71.69629558055419,0.34713869769791916 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441082,29.13201730310547,0.04398746009625665 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_22,leaf,2441097,33.86375186765851,0.02137705391002953 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441092,2410.3603858147367,0.022516297838189647 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441087,1995.8274859003527,0.10447527965181891 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441090,2571.267911785902,0.005549051116899406 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441093,2505.9788889681668,0.005620870886667628 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441082,2757.4120419655674,0.03590338892810596 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,fruit,2441097,2647.9887457432305,0.01831785602194902 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441092,155749.20751638562,0.07009554520772454 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441087,178327.48257271323,0.01130311203302714 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441090,187731.76814937376,0.011016379801866982 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441093,257763.5005843459,0.14870003033112145 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441082,226381.65360905748,0.0923198371424716 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_23,leaf,2441097,118321.5948018695,0.18945737608391244 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441092,160.72110191634252,0.030548454820392923 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441087,138.8876132272364,0.03286093182853023 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441090,126.23577390325958,0.07434199960433707 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441093,132.21762798230338,0.05423508494471063 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441082,484.2139634455513,0.5095128626998258 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,fruit,2441097,180.3981622412669,0.08070766248121952 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441092,119.11970867129438,0.2643831610283547 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441087,294.8876629544588,0.12928981997503142 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441090,289.5723616276462,0.12139032443053344 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441093,172.4205030296598,0.10377787583341913 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441082,96.8016971221251,0.35448381222584757 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_24,leaf,2441097,265.5015128909663,0.08370021650973003 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441092,65.43554888681206,0.06129210186590295 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441087,52.822985796277855,0.03169870197803415 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441090,60.822357142000506,0.02954159916446253 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441093,50.07833409146212,0.054871774670066875 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441082,79.97236261123876,0.1484182786527406 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,fruit,2441097,51.96143886930819,0.03884047919063183 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441092,6116.747570962708,0.01214752819802234 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441087,5814.562494101014,0.0098559873685784 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441090,6609.608153426286,0.0458026833813574 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441093,5207.072801678217,0.057779380262726665 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441082,5652.266228357896,0.02215042054799543 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_25,leaf,2441097,6081.494210245091,0.009637267632836455 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441092,329.4504052530731,0.14481298592322434 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441087,268.00489438148765,0.055165665129167873 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441090,175.84317492393626,0.1278515436578691 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441093,204.06581640343208,0.06320679917270633 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441082,1005.22429493755,0.629285916187619 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,fruit,2441097,201.0665758199108,0.06963717826388116 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441092,5773.787213329951,0.11226174250109944 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441087,4269.972721727862,0.0187739312968751 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441090,3702.923948993086,0.080654239326740207 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441093,7398.204997637492,0.2199273291713193 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441082,4647.237959280495,0.01799587897378707 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_26,leaf,2441097,3736.712182015072,0.07670938401677363 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441092,153.07522277507078,0.08410976459473662 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441087,111.58586650260854,0.053185945332496765 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441090,70.83462960973408,0.2505495082107523 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441093,132.1926654999562,0.020412224123071976 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441082,324.24154832771137,0.410073529038697 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,fruit,2441097,120.053824185954,0.021419136956746243 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441092,410.3517924520429,0.026029598671144516 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441087,259.7910459589621,0.17250255766519285 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441090,362.60769434026486,0.02768972077543097 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441093,1075.5220475326346,0.4444925814532934 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441082,915.4725368641524,0.3745185843641239 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_27,leaf,2441097,197.60669166535345,0.29132508887172026 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441092,174.5690413566519,0.30107356802355767 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441087,105.53064439077605,0.08248493106055221 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441090,31.615828060215147,0.44098909793104313 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441093,69.02088349563886,0.10191314483556613 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441082,127.8966317152389,0.16596544807870783 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,fruit,2441097,53.950571959583165,0.20889760573707084 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441092,118.55590325947504,0.2581781837262933 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441087,61.97489631333532,0.5398855585766253 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441090,262.0242294803568,0.08624008512912473 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441093,453.83011068406046,0.32479193961680686 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441082,986.7245036526872,0.6620945458895431 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_28,leaf,2441097,167.64214083235836,0.10771816917663335 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441092,1975489.707325161,0.0838711039911848 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441087,1336959.7908056497,0.08568532126575956 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441090,2420563.371837377,0.17211278994649337 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441093,1292392.214072868,0.10040933429927623 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441082,1484917.5814993507,0.0401013179278884 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,fruit,2441097,1772201.6958569402,0.03670948053076817 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441092,1458264.0687496972,0.028124519930186942 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441087,1160278.0754919415,0.07114956915902404 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441090,1444188.0770672683,0.023912100131746605 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441093,1811373.106957391,0.12229626049177345 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441082,1014517.9212128924,0.12945193194813776 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_29,leaf,2441097,1289454.000744457,0.025305801118274296 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441092,14.791555697513653,0.8393053571032199 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441087,61.610006709899054,0.2196679542044213 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441090,153.80886465029883,0.17766215610364666 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441093,30.403852328417152,0.5263905958003356 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441082,720.7835819224321,0.848485675385787 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,fruit,2441097,142.72802511549747,0.14519004633609978 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441092,31.541502865601643,0.05033256102737771 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441087,268.8783782560514,0.9810060586231488 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441090,6.148931716005882,0.6597501511689081 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441093,31.542359749295475,0.050344359285900975 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441082,10.395892910323806,0.43168802427411257 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_3,leaf,2441097,24.638249048642994,0.05693998054349336 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441092,402.9155170185674,0.057744449943282206 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441087,299.9729433752604,0.0703874587702602 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441090,385.1453102408088,0.038155070753114195 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441093,320.35878477882426,0.041832905668267806 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441082,430.057764805772,0.08605725012630483 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,fruit,2441097,276.8509837509903,0.10522347219247363 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441092,6638.838099541705,0.07130505488227756 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441087,7637.128352976883,0.01046704296657941 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441090,8083.368183068333,0.014195228014811878 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441093,9610.312387573136,0.08934037226076397 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441082,8009.729179154643,0.010220699613923134 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_30,leaf,2441097,6067.28446161216,0.11040277547478272 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441092,133.2793325573338,0.05136894342532816 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441087,124.68896462945096,0.08030373387836187 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441090,166.74864070494542,0.045930549725581304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441093,179.1771047725988,0.07715076216563688 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441082,103.959438271694,0.15926782841855536 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,fruit,2441097,197.03624358288505,0.11841436664686533 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441092,623.6551273524049,0.0035362792049800085 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441087,633.8529174394912,0.003507717167525737 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441090,606.4883645540261,0.01565830306509408 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441093,1697.5059513025776,0.43133052912062553 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441082,672.3295653647779,0.029101433130886978 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_31,leaf,2441097,519.0436742778022,0.08327687388233951 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441092,101.66103053970949,0.01776623060441951 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441087,84.42163492638691,0.09846697991020714 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441090,129.45616276219536,0.08720199141262741 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441093,183.9603271979092,0.23980343490873102 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441082,90.42795479051496,0.06861802993255406 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,fruit,2441097,110.15105389079416,0.017067918255830872 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441092,6951.014425879745,0.1300577606226101 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441087,3958.531472359112,0.11445632705303188 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441090,5282.890417650742,0.010881173056330962 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441093,4853.13914972079,0.025967685575479127 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441082,6218.891068620265,0.08172252048158812 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_32,leaf,2441097,5021.455388783061,0.011160820485778267 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441092,31.29147653287268,0.41950951015433313 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441087,116.87826589140504,0.15279819281220597 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441090,76.19756012687128,0.03299450128991155 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441093,88.22657352683193,0.030663846184667998 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441082,1100.8065753182343,1.1267754484317445 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,fruit,2441097,33.252313734084204,0.3931136971894187 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441092,1162.6517093632008,0.07108294684946603 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441087,576.1314743486299,0.23384508600966125 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441090,811.5734547781366,0.08503885406625411 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441093,2089.964549590297,0.3257722319734011 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441082,1681.1216285788882,0.23123244802688658 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_33,leaf,2441097,634.3065716687587,0.19206747672295643 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441092,419.22573080102615,0.07727112956230409 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441087,507.67168721548103,0.005863883501532108 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441090,483.4376481379031,0.015378591572556388 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441093,529.924713638584,0.024495113769960053 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441082,852.4750901951608,0.230962637488072 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,fruit,2441097,494.0545655238129,0.005944143096983101 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441092,21335.63703680868,0.02379263740683424 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441087,17921.179557551965,0.051946385914344084 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441090,19060.791693931904,0.025172041904733433 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441093,37944.72730644071,0.273838458980201 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441082,31093.60718221808,0.18735813055523742 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_34,leaf,2441097,14216.24419540768,0.1525281022642453 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441092,265.15507106379624,0.27836480775689987 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441087,82.04563446890646,0.23107965180053047 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441090,197.31494654963927,0.15002485456360626 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441093,65.51216596462824,0.3288131712922213 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441082,77.76714681598007,0.25433896411496937 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,fruit,2441097,212.5260721040049,0.18227708607178927 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441092,3601.245428906508,0.04465176520812664 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441087,2653.3540440860384,0.08800575191032634 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441090,2897.521331445879,0.0497743129193009 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441093,25869.367989820945,0.9009848638439273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441082,14695.952389569784,0.6553967814908122 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_35,leaf,2441097,1882.1696027135629,0.2371421996016987 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441092,2678.0408400463134,0.03274639743811436 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441087,3097.5123627203775,0.030449455254697888 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441090,1487.2698070052863,0.2881738317061946 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441093,2354.6111478702137,0.08864439729512341 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441082,4475.591669740847,0.19028686369724568 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,fruit,2441097,3593.7161935694926,0.09498018346031856 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441092,3843.832997421975,0.05028259527142831 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441087,2899.7059850189394,0.07212795044345288 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441090,3003.3496232454545,0.056876023549659926 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441093,20922.83748035681,0.7861386662613858 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441082,12554.188587816148,0.5643067329020557 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_36,leaf,2441097,1780.6860050158632,0.28389456993810036 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441092,672.3110911970348,0.08889788720650627 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441087,1041.1163675741795,0.10103111102245466 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441090,444.95088262286384,0.26815609053693645 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441093,661.7863301035331,0.09575037102398953 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441082,1172.801598952844,0.15275638626924604 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,fruit,2441097,977.742914644124,0.07375651432890695 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441092,270.1192343788121,0.005267467388654801 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441087,228.7222236134866,0.0775146129460409 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441090,276.71157206658347,0.005204344216202639 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441093,866.1767613922666,0.5007835504058993 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441082,704.9475873270202,0.4113338510260176 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_37,leaf,2441097,130.55275874659785,0.3210369240287112 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441092,117.99349195018232,0.6869062845026359 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441087,14.031644485535285,0.23784319690829703 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441090,27.006671057825265,0.04651928522739879 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441093,28.257953370964213,0.06618893464024067 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441082,15.529197805853698,0.19380274762325955 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,fruit,2441097,21.52014140929264,0.052106648753051266 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441092,134.38882276924676,0.08645587508666086 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441087,6.7436528508234685,1.2130120688795465 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441090,85.87200659013178,0.10805566322566929 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441093,156.0098343461711,0.15124470121326272 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441082,173.57579832799968,0.19758189688789551 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_38,leaf,2441097,3.495117765773666,1.4984454608929578 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441092,1249.3290734978327,0.036535517070235723 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441087,300858.20405433903,2.418220529080932 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441090,33870.849090034666,1.4696847542599456 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441093,1047.7255633587058,0.03989378926430742 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441082,814.5562550137513,0.14922024662019107 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,fruit,2441097,852.8144638851121,0.1292867721584332 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441092,3145.0588885805455,0.049067034370929186 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441087,1991.9282145830211,0.14928806408711948 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441090,2563.7230959159915,0.03969063143441032 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441093,4211.791685263677,0.17590513560397358 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441082,2698.224179204967,0.017483717535954568 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_39,leaf,2441097,2919.9052860854204,0.01680701704083143 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441092,6.126412181633669,0.6613007011870958 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441087,37.67124409715211,0.12750304933122392 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441090,49.31198855384586,0.24444560249727365 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441093,72.71383389031566,0.41311013000929453 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441082,18.502957614080188,0.18126575977357184 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,fruit,2441097,17.352598717651844,0.20914238998326184 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441092,383.5138709944069,0.023761432862436038 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441087,139.2185025546091,0.46384555092403623 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441090,394.25021165881526,0.011770573909460236 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441093,526.6113206589844,0.11394768190996185 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441082,415.9129741098767,0.011459959016586918 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_4,leaf,2441097,490.1409372213155,0.08277846781115894 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441092,317.7055694501555,0.0227657088736426 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441087,240.76251314204103,0.09767025134454732 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441090,565.4442406333178,0.2731306655947736 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441093,354.5845391588346,0.07046067596804262 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441082,285.2552812034517,0.024025425627077546 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,fruit,2441097,226.3199620338725,0.12453625770606358 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441092,8561.934704497258,0.018403911221444247 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441087,8655.910781337823,0.013663051289154904 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441090,9321.121084154813,0.01849232693505698 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441093,10462.34914843435,0.06865338647218877 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441082,9209.204309151342,0.01324628534744754 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_40,leaf,2441097,8435.610576867562,0.024859300014555608 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441092,309.720723028337,0.14907322268375722 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441087,192.03746975591957,0.05851106658393013 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441090,171.24075534339266,0.10828990690826412 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441093,205.6344212233801,0.028801228623266173 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441082,376.8208749243743,0.23423791185546028 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,fruit,2441097,233.83335629797048,0.027009421547737666 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441092,1085.6180863664472,0.03137779746599856 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441087,647.2074203326472,0.19325578469385984 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441090,934.2791186501812,0.03382263020354381 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441093,2288.321013597323,0.35521767614914124 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441082,1405.4907855968752,0.1435287301367878 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_41,leaf,2441097,603.5882911673119,0.2235584661460126 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441092,35.594269358928784,0.03011826807079787 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441087,36.202588953218,0.02275872138822077 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441090,36.61571488254719,0.017830833013498193 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441093,49.10047771938935,0.10958736687594683 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441082,58.76489901137128,0.1876196434424653 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,fruit,2441097,39.68495420979591,0.01712753283138735 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441092,159.71049559809308,0.0041469929110315995 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441087,138.69502829107557,0.0654195567699487 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441090,165.3925855748992,0.011035586302957867 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441093,188.5066234335665,0.06784616407494104 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441082,162.77519286532092,0.0041077683408103915 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_42,leaf,2441097,142.64757264724287,0.05321606434193127 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441092,849.6165986965196,0.04050702986518173 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441087,995.8973192260356,0.10949860469902095 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441090,242.70037209202283,0.5036455164681883 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441093,698.2942865152229,0.04467746999931643 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441082,223.86062386693771,0.5387382488903718 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,fruit,2441097,1074.899821904423,0.14265203229740786 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441092,347.4985148086675,0.020193099344697707 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441087,217.06854506194136,0.22454915679155052 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441090,301.2520775990607,0.082216001396342 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441093,454.7068911918098,0.09658548397001576 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441082,380.5763659966604,0.019295762738441802 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_43,leaf,2441097,472.85374392026984,0.11358077988318893 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441092,572751.6948632166,0.21005468711594322 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441087,426240.32968944096,0.0817428431797751 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441090,389565.6526013261,0.042668962930681786 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441093,230806.87142748825,0.18466296169331908 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441082,279844.8620947267,0.10099435815247304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,fruit,2441097,316657.07772652723,0.04732249633562624 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441092,330319.0084429191,0.008858960433738794 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441087,332676.98452948435,0.005769770358649673 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441090,343689.9056359241,0.008374250223603497 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441093,763315.8069077473,0.3549117293082089 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441082,341575.44853300345,0.0056941206626888174 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_44,leaf,2441097,295306.1442255056,0.05752004351360185 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441092,534018.1689894078,0.10917748231708302 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441087,399182.8091438339,0.0172067209631539 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441090,566278.53170993,0.13465154628367237 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441093,320244.91843745974,0.11289630383634197 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441082,366763.00768593326,0.05399302547819307 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,fruit,2441097,431448.9775258986,0.01655089307227353 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441092,64918.6525999353,0.04193596006062261 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441087,82740.23365054087,0.0634112855309441 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441090,71856.32348049807,0.0021595353795023087 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441093,203876.68651613456,0.45506210921324364 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441082,71143.48410611357,0.0021703273850981475 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_45,leaf,2441097,59343.8521128222,0.08092972372932739 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441092,44425.68868831987,0.10723602242970287 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441087,36558.789488184775,0.022593660666563764 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441090,32852.185085021156,0.02383388562363198 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441093,22374.411389872563,0.19064652751814837 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441082,14959.808496531698,0.36547211247108624 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,fruit,2441097,39134.050323343195,0.0521566525957855 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441092,127871.14303994928,0.03254142732619325 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441087,91615.84503500097,0.11226052827747157 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441090,109408.84712853446,0.03517867824990972 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441093,587091.443446493,0.6944746307811389 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441082,138915.34370970374,0.06851909778126952 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_46,leaf,2441097,80294.19748413558,0.16954695820493715 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441092,394.9792684775225,0.08746593176709894 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441087,413.6458289520099,0.06741158348295428 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441090,552.5612801110395,0.0583402162160116 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441093,688.9391766662702,0.15414064879107725 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441082,215.2642386226754,0.35106834548425425 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,fruit,2441097,772.1205791820058,0.20364489486916781 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441092,1720.014389711895,0.09020888843655195 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441087,685.3915823184819,0.30938442550135203 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441090,1266.5856663128895,0.042688622913293006 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441093,5202.629960357052,0.5708997457716305 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441082,1528.230118751333,0.03886556280680775 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_47,leaf,2441097,1207.56654686809,0.06341211852395245 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441092,61.76072598928194,0.017226653818085857 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441087,66.7587783423201,0.016569334422038784 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441090,114.08773783990428,0.24929992266662304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441093,26.300800122671692,0.3879700854577768 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441082,154.50979592921837,0.38101697267602286 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,fruit,2441097,9.05116054859322,0.8512347778151191 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441092,4414.075320219448,0.008183151395324106 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441087,4249.289112668329,0.00834030756564097 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441090,5362.844862634177,0.09273864565295309 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441093,5498.663910143518,0.10360058736370537 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441082,4040.924951154763,0.0301758034250712 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_48,leaf,2441097,3624.782499324587,0.07737463576549963 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441092,29.772950742542896,0.03422569295973199 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441087,31.237163774121793,0.01337597730295581 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441090,33.19126904453063,0.012976285797136944 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441093,35.282507946447176,0.03951187614939866 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441082,36.40667886409598,0.05313349111366317 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,fruit,2441097,30.048403167692783,0.030226174195429056 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441092,30.710731855007623,0.00880940308572109 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441087,30.27333151363863,0.0150393524075918 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441090,33.766396655303716,0.03238514869167375 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441093,33.82949192754407,0.03319590618301893 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441082,30.1329683874227,0.01705765318056951 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_49,leaf,2441097,31.96935142338754,0.008634256485613667 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441092,762.0710969207622,0.08700731905410608 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441087,713.0682809317493,0.1158716911332518 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441090,389.2445618728579,0.37878025573734897 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441093,1100.156700943292,0.07245173884607858 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441082,1494.1722099000856,0.2053978452064742 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,fruit,2441097,1353.1855901080896,0.16235455489554518 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441092,37650.40312877642,0.012302304167752354 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441087,39813.95567732835,0.011963393850337845 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441090,31504.825685361673,0.08969485376059705 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441093,51142.25787948673,0.12070796299162367 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441082,44806.27488493857,0.06326690414425507 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_5,leaf,2441097,30242.744336977095,0.1074507367051698 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441092,70.31483534542282,0.25916052824148217 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441087,163.6685582502166,0.10775776438468787 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441090,207.2110537496312,0.21020542692537925 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441093,50.91147617649591,0.39939180279071684 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441082,159.40300051250065,0.09628899968815707 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,fruit,2441097,96.00675892465736,0.12390568369588162 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441092,9262.758964620814,0.002006256703357412 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441087,11029.648322492088,0.07381504559570162 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441090,9348.536993594722,0.0019970312478490015 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441093,15778.600078874437,0.22932184907557351 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441082,7310.153843854735,0.10482010281662513 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_50,leaf,2441097,9191.635176426997,0.005353841180565144 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441092,54.58862288538409,0.11181406992027387 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441087,37.99119500112443,0.045605114151601844 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441090,38.82454647644576,0.036181677238423804 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441093,43.73083013299505,0.01549965302446532 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441082,55.68957058035651,0.12048580056056957 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,fruit,2441097,40.66443156022508,0.01607336275307425 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441092,270.17700035959075,0.002668498078751469 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441087,181.98382704017436,0.17428407988411188 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441090,294.23398098771827,0.034375954120696495 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441093,307.2631622030711,0.05319362209150169 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441082,273.50739643933605,0.002652201723103431 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_51,leaf,2441097,230.7063647603488,0.07125729763223365 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441092,234.3075192104985,0.010589523608680373 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441087,223.0193287120522,0.010854197989519143 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441090,239.4348988664959,0.01999074909084575 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441093,210.23993281927304,0.03648149314102733 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441082,250.02239858095052,0.038782215004590004 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,fruit,2441097,158.52862487439955,0.15908900980745466 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441092,2114.84916662926,0.08100920085380725 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441087,1351.6870539189715,0.1133940433388756 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441090,1660.58,0.024010394618547704 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441093,2666.3474778375867,0.18164654832954996 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441082,1849.364046628415,0.02275221268156935 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_52,leaf,2441097,1541.5852141517075,0.056302661394344256 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441092,91.91680100680294,0.28586430342464175 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441087,163.2577581572177,0.03638537605024128 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441090,193.9770997793468,0.03849125719569324 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441093,134.70803586615202,0.11986570068054014 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441082,257.4304510526433,0.16140071307746906 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,fruit,2441097,191.79198287782748,0.03357124465600325 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441092,298.87779824940844,0.14201437946286166 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441087,333.47287732343494,0.09444751790660444 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441090,444.7630640779035,0.03062067882975672 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441093,790.6809583575689,0.28049324529252484 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441082,406.9173305278331,0.008001847934145268 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_53,leaf,2441097,422.0511737981253,0.007857077759721776 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441092,757.0924284143514,0.05271295412057908 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441087,558.8930800172405,0.1845331246076447 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441090,680.3113203768859,0.09915415932369509 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441093,952.497114347366,0.047001811623619716 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441082,1067.27120159098,0.09641293392036232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,fruit,2441097,1042.0846231813002,0.08604113056810059 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441092,11607.108021436168,0.02464264157268481 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441087,11386.158635501211,0.03298943754631534 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441090,13307.635745852407,0.03473423714142587 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441093,40884.52930974674,0.522192334436455 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441082,12962.411494406677,0.023319136313503463 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_54,leaf,2441097,11160.22696362449,0.04169364092583372 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441092,26.45405044296356,0.5159955076795555 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441087,54.52188567342935,0.20191681724129462 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441090,61.80464433220731,0.14746657347929837 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441093,182.7907464670575,0.32346652137751675 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441082,115.3422333521725,0.1235006713176825 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,fruit,2441097,111.78254876351195,0.10988632276935761 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441092,98.18731291626015,0.11311441350582063 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441087,59.479004318230785,0.3308060985989125 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441090,170.770169032611,0.12724221990024898 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441093,458.5203443793824,0.5561888215238815 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441082,153.76036531850568,0.08167461376743024 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_55,leaf,2441097,101.03984612607736,0.10067711223717168 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441092,123.14040597426488,0.0076824018813037576 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441087,142.66297070910102,0.05622828026996851 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441090,127.53572244909007,0.007548863710401754 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441093,140.87330099975,0.05074570834520209 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441082,94.6644702785412,0.12189597391742257 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,fruit,2441097,120.7105582494877,0.016337724531933606 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441092,3135.555226879049,0.04233138902621203 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441087,915.8684010984912,0.4921499899954416 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441090,2532.314509692511,0.05046542200568016 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441093,2553.145162543648,0.046907557518810705 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441082,5198.6650548270045,0.2619087717148467 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_56,leaf,2441097,4580.076940006524,0.2068897082822132 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441092,308.4776008572053,0.012472101271240543 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441087,222.34371745850513,0.12972667075957967 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441090,245.0149082277634,0.08755902295773232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441093,344.09158093788454,0.05992251335090382 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441082,359.9346759348061,0.07947215509338523 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,fruit,2441097,291.01182748194486,0.012840893089621996 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441092,79984.41732375676,0.0733889465896258 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441087,30154.81602795384,0.350259755563501 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441090,55112.80956564648,0.08836388753407487 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441093,287922.3988307304,0.629659013208614 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441082,86030.7144686961,0.10503709086490254 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_57,leaf,2441097,51889.82052769391,0.11453427018876461 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441092,190910.40712453067,0.055855250160465 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441087,241608.6483590605,0.04642762180528415 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441090,206234.79227818892,0.02232292035809813 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441093,233393.4572552745,0.031403823301952905 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441082,221549.3824838457,0.008785689924287077 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,fruit,2441097,212675.64329002015,0.008967098842694199 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441092,322167.55759991537,0.003643502134285548 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441087,327595.928853416,0.0036131892021842305 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441090,339134.65653822577,0.01864686627610279 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441093,484317.03660992417,0.1734044395097385 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441082,247427.74229829723,0.11827691444490007 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_58,leaf,2441097,293071.3628162693,0.044751922945855505 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441092,2235.0728097218753,0.011706897662854931 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441087,2339.886825188055,0.008196279181068356 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441090,2265.997671566635,0.005739113669471774 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441093,2379.3830511006267,0.015465790743562469 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441082,1907.932515471138,0.0804355635100058 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,fruit,2441097,2326.2845346902845,0.0056642605379209066 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441092,1762.4659146426025,0.024505763707772132 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441087,1502.1914096977343,0.09390121624554792 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441090,2103.473685540834,0.05231059298447427 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441093,4528.359475474929,0.38531440483821866 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441082,1967.084533377906,0.02319653328865945 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_59,leaf,2441097,1234.3283993359892,0.17919576905572665 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441092,84.00851941551173,0.19061798011843822 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441087,81.34680150315677,0.20460082932716084 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441090,38.50584142376986,0.5294146928262442 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441093,180.7148908806037,0.1420526290434445 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441082,176.58961747321632,0.13202385500130953 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,fruit,2441097,200.01089234524207,0.1861123366533035 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441092,234.68937388639543,0.03734168732630616 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441087,276.83355936300444,0.03438362299608233 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441090,168.48202795644437,0.18128153234908373 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441093,316.68907193599915,0.09279796366351434 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441082,299.4090245747052,0.06842977273539308 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_6,leaf,2441097,168.27556231944203,0.18181406317052273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441092,26.81129349247395,0.39410723536396564 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441087,55.906989999970705,0.0749588913676289 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441090,69.78774522660581,0.021354164833289113 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441093,91.70951057242864,0.1399893736539981 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441082,63.09084069470442,0.022458687609621553 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,fruit,2441097,105.34684568507376,0.200196534320495 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441092,87.29914489750695,0.16744638253061028 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441087,96.16000009498244,0.12546191721826516 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441090,140.7208060807619,0.039901941888128345 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441093,286.09409574038904,0.3480525228505358 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441082,217.6421979998537,0.2292867309525315 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_60,leaf,2441097,116.01495594781844,0.04394239284687762 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441092,110.52738145024652,0.287947754684295 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441087,203.0683287114682,0.023775441268484965 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441090,170.21266501922358,0.10042576426485406 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441093,240.70128623810487,0.05006077524628205 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441082,269.2974690430942,0.09881463599188489 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,fruit,2441097,225.92212842711945,0.02254113512850875 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441092,503.2985453285079,0.008562277966167375 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441087,483.64745839556247,0.008734487337458408 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441090,433.05978462435087,0.05671554163349146 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441093,1144.3487696592624,0.3652950098197554 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441082,807.6538541262132,0.21396187266595046 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_61,leaf,2441097,412.4642527904161,0.07787708186421582 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441092,7927.659159735956,0.02729345075906453 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441087,9244.215116414662,0.03943162245940357 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441090,10525.253738091027,0.0957941537466298 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441093,8956.071536478457,0.025679133177449742 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441082,5275.584840630441,0.20416780902007137 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,fruit,2441097,7353.193438297849,0.05996242968437393 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441092,948271.7952537342,0.02758228356054726 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441087,570284.259839707,0.19325916485026973 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441090,831566.494346878,0.02945356750661432 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441093,1166297.476939851,0.11745878628089379 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441082,981231.0266998973,0.04242072238694394 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_62,leaf,2441097,734118.8122465623,0.08358419655587657 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441092,4339.220980808406,7.276388668056022e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441087,4643.550897282939,0.030166081277907875 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441090,4324.692855659968,7.288600359363073e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441093,4533.644605634003,0.019763343721510118 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441082,2882.7068192826027,0.176883653406537 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,fruit,2441097,3284.879829258142,0.120164642476984 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441092,22696.947035182093,0.03412533179206534 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441087,19003.7276198818,0.11125397893608913 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441090,26407.720123830164,0.031638132583970524 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441093,83477.12061302304,0.5314746844846301 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441082,26411.501066061417,0.031700308523458176 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_63,leaf,2441097,17306.817760560276,0.15187555537723973 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441092,1959.863346961691,0.06320031440313212 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441087,1529.6009879630055,0.170847949844255 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441090,2228.1880532459013,0.007474263918123558 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441093,2394.750515112603,0.023834170062822846 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441082,2427.2413879417977,0.02968686356328032 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,fruit,2441097,2305.5466255886986,0.007347804193966301 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441092,5814.51053654301,0.054282993551633574 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441087,5163.162633125637,0.0026856366979584045 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441090,5099.502634383328,0.0027023478192087502 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441093,7457.406010547711,0.16235762014163413 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441082,4896.787798089788,0.020318883985261937 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_64,leaf,2441097,4308.182664386109,0.0759360594499765 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441092,151.95262805901635,0.20409906831540958 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441087,142.9072898622528,0.17744523580996585 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441090,56.78461229734475,0.22337848245703373 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441093,95.67823464724084,0.003204006181513286 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441082,51.531322975130735,0.26553785505492344 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,fruit,2441097,94.27169763441594,0.0032278195187247505 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441092,2372.1331105568484,0.10490927305963238 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441087,1697.8532415954571,0.04032963429535208 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441090,1985.7329282864855,0.027691055086103145 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441093,2235.3476045389234,0.07911528462165984 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441082,1740.4123032668322,0.02957763770917987 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_65,leaf,2441097,877.3887518918114,0.3270377199842489 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441092,1573.1817118312426,0.03720827902709756 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441087,1182.2076198649704,0.1612934138927029 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441090,1310.4037268194463,0.11658204857778687 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441093,2070.2057294104434,0.08202633804570914 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441082,3142.454263071273,0.26328179731440704 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,fruit,2441097,1854.6316219736475,0.03427049220937972 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441092,5038.956453792114,0.09580610267810918 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441087,3971.966117068184,0.0075289674781919835 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441090,3740.020398662065,0.033660531642424996 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441093,6082.210587405577,0.17752695030244547 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441082,4110.88349033248,0.00740066572532827 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_66,leaf,2441097,3468.459748341517,0.0663978437056687 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441092,992.2693871994916,0.048235148000260075 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441087,856.3535504413497,0.1122116383622962 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441090,861.1473360255529,0.10978727858532444 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441093,1225.389456276049,0.04340939816155087 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441082,1321.684724284611,0.0762631295427676 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,fruit,2441097,1259.9398167464935,0.05548505975596507 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441092,276.3047202461488,0.10797264352940505 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441087,154.66390692717667,0.14402668412412734 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441090,138.22894357542478,0.19281667180513962 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441093,1869.385237428766,0.9382831480237974 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441082,933.9938384477964,0.6369283504896859 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_67,leaf,2441097,64.2151556127242,0.5257781213935404 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441092,200.78602024034575,0.0010713906107384652 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441087,169.98300560903488,0.07339935822250698 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441090,201.77790860901763,0.0010687540273672802 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441093,297.01878019439204,0.16897904787065832 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441082,163.92158159111634,0.08916872662459108 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,fruit,2441097,258.5805813246213,0.10879104516149418 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441092,1130.5952759238812,0.07391245552204717 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441087,1352.44217414195,0.003899083215718413 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441090,1377.315974566065,0.01181396261079204 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441093,1669.331267836774,0.09532290612680283 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441082,1328.2664878967878,0.003934406441630234 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_68,leaf,2441097,942.7664402636902,0.15281550748487804 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441092,0.17517039313622207,1.6851928112506054 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441087,61.12856003555137,0.857590649613738 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441090,0.11071262906047692,1.8844563519589248 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441093,16.794894833077837,0.2965237727912111 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441082,0.07802855154304658,2.0363999708031897 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,fruit,2441097,17.0604471522851,0.3033368938742518 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441092,324.6830202202758,0.053884234511709206 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441087,446.2832424954837,0.08426676815053025 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441090,424.9472828858015,0.06299124504676579 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441093,163.48,0.3518791826184575 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441082,308.7745546094181,0.07570230771465836 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_69,leaf,2441097,410.4633331981583,0.04793055588528139 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441092,136.23121361468247,0.05632936465049454 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441087,124.56494933416424,0.09521013448907834 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441090,138.04354565188004,0.05058988457008917 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441093,266.8462282118295,0.2356550783687097 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441082,172.1523062168182,0.0453068548540263 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,fruit,2441097,334.4363718335236,0.3337075131020071 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441092,670.4801298800302,0.1328433380470213 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441087,418.6860932438583,0.07165403779009072 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441090,308.86,0.2037809066187517 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441093,2690.4711364625095,0.7362857635414923 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441082,568.8945506780587,0.061489200043190806 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_7,leaf,2441097,349.8531904752014,0.14965673492734677 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441092,1690.5192331541843,0.3124771990827102 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441087,986.6956245542704,0.0786402853068342 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441090,648.0107891295845,0.10396068027920169 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441093,659.8467528127093,0.09609983322446025 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441082,197.72444139286583,0.6194825597907281 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,fruit,2441097,1022.578935354228,0.09415392517478915 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441092,1085997.5638002837,0.022937647186527244 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441087,753879.6626106956,0.13558917630112344 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441090,1056438.0929720688,0.010952848755740874 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441093,1217734.249477758,0.07266131716935931 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441082,1003817.9634506224,0.011236240651246732 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_70,leaf,2441097,933531.0136860274,0.042762453203810225 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441092,264.0499700025532,0.2040124423417029 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441087,402.30289150442104,0.021145410805442744 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441090,539.6687277819262,0.10642868787627391 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441093,382.3353877249065,0.04325406805838128 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441082,605.251749846041,0.1562374888781921 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,fruit,2441097,442.44780882286256,0.020163483816932004 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441092,2998.365687701826,0.010769912819219574 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441087,3428.6742581095937,0.04747171470586409 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441090,3642.038491928081,0.07369001931495989 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441093,2847.650980591355,0.033167752763174185 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441082,3148.9357243461213,0.01050928383231664 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_71,leaf,2441097,2645.7499761450267,0.06510571125110332 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441092,237.3153984243303,0.04617490928077039 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441087,189.44194709748373,0.051674860666609757 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441090,349.76212782399983,0.2146217729241524 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441093,131.44653628484608,0.21040186283448747 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441082,418.3604667230239,0.29239962938354536 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,fruit,2441097,156.92243395937248,0.13346597376827152 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441092,343.4474430213451,0.040480969356093244 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441087,282.3147400180799,0.04464576421419064 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441090,122.75102527492083,0.4063541897861067 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441093,533.7073650869868,0.23192387801779946 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441082,419.03293527154193,0.12686884108057628 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_72,leaf,2441097,181.5450938909381,0.23639480107923028 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441092,136.10195601624036,0.015639499955579783 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441087,101.821714127325,0.11038446290724568 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441090,229.66536878182333,0.24287064606824682 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441093,160.4648382216506,0.08715501576031581 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441082,126.47394384306844,0.01622380544669033 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,fruit,2441097,93.89014389913972,0.14560486216762314 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441092,2014.823108670228,0.0028631164780525964 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441087,2542.9323930036317,0.09823477431551986 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441090,1863.6021100719297,0.036746846250471865 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441093,3048.4260421369127,0.17697562330865502 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441082,1875.112353295426,0.03407274478609734 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_73,leaf,2441097,2041.4765916333688,0.002844364738864069 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441092,229.41111056565032,0.015513327647608488 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441087,212.6366233106987,0.04848970793849183 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441090,246.09682665860993,0.014978238692530788 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441093,350.0133158633938,0.16795679195499025 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441082,175.5205464753461,0.13179981256612772 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,fruit,2441097,309.9397007264695,0.1151494343983237 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441092,1033.1150794593457,0.019889413929340183 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441087,848.3376119303828,0.10546939220371421 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441090,1129.9426489668592,0.01901828659140259 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441093,1702.8511204866145,0.1971385649198596 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441082,1430.012645235532,0.12130176330710318 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_74,leaf,2441097,777.5143983282404,0.14332967431439192 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441092,145.8458439785936,0.04931667743152923 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441087,141.98250955330377,0.06097588731627779 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441090,203.97793138469956,0.09637244771502562 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441093,185.52173454995503,0.05518406070380921 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441082,138.4485948122321,0.07192218319496124 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,fruit,2441097,180.92306725014484,0.04428320646269679 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441092,11153.372607984553,0.011452959021831077 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441087,9998.887530350608,0.03600156881023686 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441090,10572.801115021366,0.011763189410132213 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441093,13526.339051020432,0.09522701706536196 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441082,12055.443711106482,0.045229947414688 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_75,leaf,2441097,8644.087200055237,0.0992341128587948 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441092,68.21371531945293,0.24026048701797165 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441087,39.121376454929965,0.0011970906899021472 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441090,22.52434908690304,0.24095896788025395 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441093,39.33734253572693,0.0011938000934532678 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441082,16.380254643575082,0.37929056846836007 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,fruit,2441097,42.62255158446186,0.03602822766211422 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441092,250.30978111391883,0.047983496898208244 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441087,197.94436909245945,0.05395117162447205 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441090,9.325113017656273,1.3808402195128635 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441093,368.24774879338054,0.21564577700485987 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441082,250.39969828399677,0.04813947769273996 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_76,leaf,2441097,69.1496547699925,0.5107043073149267 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441092,1075.7922559632057,0.1868582523364326 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441087,840.4273258025396,0.0796300033174675 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441090,628.0403444438643,0.04688261826282236 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441093,665.7736155641414,0.02154358118962385 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441082,733.4919831808963,0.0205252101400335 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,fruit,2441097,584.6600975208956,0.07796670669791617 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441092,18555.732707256193,0.04770828234362501 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441087,14075.80224202263,0.07229666901077891 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441090,17772.405614420164,0.0289763908613363 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441093,22151.129563101626,0.12462605171249397 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441082,15478.220018607955,0.031048809853405857 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_77,leaf,2441097,11914.562378076536,0.14469173025928939 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441092,62.3766739628857,0.004956704441661852 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441087,63.72653594059967,0.004341393545180372 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441090,61.84129939849439,0.008700311787287918 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441093,66.29881789033993,0.02152686687920058 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441082,63.515759145232984,0.002902575064156254 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,fruit,2441097,62.669584207245514,0.002922104808811943 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441092,97.33589894535368,0.007045963181385062 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441087,95.29527225108131,0.01624765220169011 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441090,107.97240656920326,0.03799377401896531 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441093,109.62133293950616,0.04457607122820728 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441082,96.37202080209444,0.011368041641940607 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_78,leaf,2441097,100.52,0.006933472581030609 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441092,162.27274405109816,0.032156677050307 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441087,140.60561113292215,0.030086250771472756 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441090,139.59049859445554,0.03323304465940602 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441093,178.24695055628888,0.07293320554589044 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441082,132.23474129736152,0.056743333232109894 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,fruit,2441097,160.77749103716036,0.028136343988460766 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441092,264.50818321187836,0.002147227149368991 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441087,241.10791021319287,0.04237488085221175 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441090,293.044876067527,0.042347792384092475 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441093,345.8614176476295,0.11431577757186373 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441082,265.59332954120765,3.691763050386321e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_79,leaf,2441097,266.0450619690906,3.6886274960323817e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441092,173.6502276684407,0.01296301968047242 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441087,187.0616202753841,0.019346315042726214 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441090,169.57525125468072,0.023275907501241644 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441093,184.1728710806592,0.012587281672266748 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441082,248.22986232741823,0.14221564969267853 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,fruit,2441097,159.51849932121488,0.049827321381874956 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441092,503.33404267287534,0.14436003941334086 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441087,360.4191374399216,6.884222312728561e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441090,332.03138265567503,0.03631713128886238 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441093,861.5497289882888,0.3777840849514362 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441082,361.56268088946825,6.873327050795908e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_8,leaf,2441097,332.28461699276704,0.03598602898028469 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441092,50.328863250941474,0.05377423499349998 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441087,58.04721976922577,0.00819006725372562 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441090,50.72224932882206,0.05039285181856901 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441093,66.16713720017793,0.06505098844122559 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441082,108.3605793010594,0.2792799617853019 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,fruit,2441097,55.878387442646265,0.00834749173566074 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441092,127.10836405000556,0.024795472871962154 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441087,123.55326632581534,0.037115370884623466 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441090,146.7817602270923,0.03770248947878052 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441093,142.04486701743076,0.023455942491192427 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441082,123.84320316049146,0.03609742567861396 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_80,leaf,2441097,142.90282699868197,0.02607121834265813 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441092,1422.957938797946,0.010616482716800046 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441087,1195.550212855748,0.0650077591390632 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441090,1735.1567011307577,0.09676312156450928 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441093,1626.879549094929,0.06877981958288837 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441082,1329.6961238596546,0.018823177485775222 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,fruit,2441097,1354.2319532455629,0.010882523443837666 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441092,7221.307224811585,0.02135828525007799 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441087,6528.212630859926,0.022463245441898483 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441090,6472.0574570343515,0.026215172692538147 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441093,11327.732924309988,0.2168854641857041 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441082,7993.008734312546,0.0654527506895004 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_81,leaf,2441097,5503.522605546968,0.09661678218704273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441092,3463.310981471342,0.016015295164719223 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441087,2646.5671879480324,0.1328238612913295 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441090,3701.625058841104,0.01288564142105697 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441093,6681.600649644365,0.26937372975787044 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441082,5451.06189180212,0.18097432795250734 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,fruit,2441097,3485.1951573245387,0.013279683207542359 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441092,105978.12661257056,0.07215284470266337 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441087,51903.91306382424,0.23786329269393747 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441090,73533.83353142465,0.08657618588103144 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441093,303467.5603307097,0.529048879791465 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441082,127150.6441812467,0.15125517130597288 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_82,leaf,2441097,73512.66323691083,0.08670123669629337 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441092,437.3752782101443,0.026377466277436756 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441087,381.0222307618481,0.03352645011513644 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441090,418.6991874625323,0.007425352625892501 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441093,343.30126036429186,0.07880136760708112 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441082,561.3310543062299,0.1347423037300448 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,fruit,2441097,404.5034650378622,0.0075545192676500506 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441092,1835.319181359193,0.010236007850533912 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441087,1686.8081411460932,0.026409907285884326 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441090,1749.8164582324532,0.010483098642402044 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441093,2178.6030361973694,0.0847025088529274 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441082,3090.2916649416666,0.2365238748281917 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_83,leaf,2441097,1459.668529390142,0.08922135100794826 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441092,7122.185454896477,0.12261563141041965 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441087,5528.558631572886,0.23261698976783762 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441090,12074.288606238431,0.10663264287656515 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441093,10622.319402826002,0.05099044658388463 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441082,31949.074667035627,0.5292293748066217 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,fruit,2441097,8268.85272664775,0.05778365256203122 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441092,3005811.0325083486,4.73705903243804e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441087,3012371.775570632,4.7318977232269077e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441090,3074802.237756336,0.00938180841273617 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441093,4167277.911211656,0.14141708399548314 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441082,2985483.141169602,0.0034207569603204036 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_84,leaf,2441097,2517544.127288616,0.07745828848490355 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441092,65.86275387411114,0.0241452978296004 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441087,50.88175084863685,0.1362231364067632 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441090,89.47730054093303,0.10892768986061396 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441093,73.19524952967161,0.021697712233761157 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441082,130.4094256308151,0.27252379868622634 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,fruit,2441097,66.06115538471458,0.02283901837349167 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441092,1487.5850090086656,0.025636527486616156 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441087,1499.676045908182,0.02212086602619845 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441090,1656.4062299420566,0.021048534631172178 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441093,2881.7730572555174,0.2615414560287528 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441082,2378.3354403383937,0.17815478684377917 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_85,leaf,2441097,1215.1767967235662,0.11347885236753807 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441092,934.6894918060603,0.05594983027823375 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441087,1050.864824196827,0.005070335407383997 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441090,1394.9822672177097,0.1179514965014099 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441093,1371.2745115051127,0.11050721319337331 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441082,361.82568345828446,0.4681177993380392 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,fruit,2441097,1075.5460578175291,0.005011822332507521 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441092,33425.39554731394,0.14586718895421047 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441087,19852.833609377572,0.08038686364605852 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441090,20431.756649260493,0.0679036590147497 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441093,52656.26526503323,0.34324068645273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441082,26261.216391754857,0.041105471943642335 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_86,leaf,2441097,21518.03731979212,0.045406709939610934 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441092,331.70992720166066,0.10283299105048593 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441087,306.88598507954003,0.13661440459908958 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441090,513.4961108106339,0.08694569857408174 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441093,414.3790473780873,0.006193672382458271 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441082,432.8195224283426,0.012715381446263496 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,fruit,2441097,426.2830281872642,0.006106582163913465 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441092,35576.46685093174,0.05020195339047273 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441087,44767.16706563687,0.04959484355541921 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441090,35335.34271215681,0.05315546105495628 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441093,44295.57089086202,0.044995534454921327 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441082,47367.288045817375,0.07411375157555788 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_87,leaf,2441097,26738.705371019863,0.17422439302611537 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441092,141.8585423616405,0.031417197987416934 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441087,54.184679861070975,0.4493961792463863 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441090,218.09214720326304,0.15536733729384578 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441093,163.1434572962279,0.029296970512085796 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441082,170.63598519257854,0.048797933248342584 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,fruit,2441097,138.89856042103972,0.04057494639322545 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441092,1732.735934411492,0.01885283425306472 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441087,1567.0340231153143,0.06250679049283026 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441090,1886.485972747094,0.01806836391161326 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441093,2222.8706410038644,0.08932897347985946 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441082,2226.548906237389,0.09004702249314711 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_88,leaf,2441097,1196.100446504822,0.1798175638704329 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441092,116571.9019278272,0.16204285188777767 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441087,71280.53993923882,0.05158004961260598 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441090,89258.63476357123,0.046099209528131624 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441093,67044.51013856563,0.07818780842155526 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441082,65788.07106464506,0.0864038774909961 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,fruit,2441097,93765.40213411818,0.06749159016404427 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441092,216301.82012211537,0.05138488928113816 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441087,246220.0887216433,0.10764819881995269 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441090,143365.59112131913,0.12723035492663115 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441093,871232.3171899978,0.6564586919701467 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441082,168029.0598743933,0.05829088713576436 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_89,leaf,2441097,129313.06055806804,0.17203289401225685 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441092,21.31580971504395,0.05656678180695551 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441087,12.031316431948506,0.19182190366885576 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441090,7.887037449426394,0.3752211498996796 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441093,76.8138938299561,0.6133047279536239 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441082,41.42788697674704,0.3451577298789066 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,fruit,2441097,16.10946944809962,0.06505381532912868 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441092,135.0453313665478,0.012633589354350327 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441087,134.6435081794913,0.013927745406693948 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441090,147.3500842904014,0.025237224417658854 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441093,165.0777401589196,0.07457535074421129 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441082,138.9969163340617,1.0799872550437684e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_9,leaf,2441097,139.0660553956614,1.0797187546218723e-4 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441092,46.97711476422548,0.35273891080144226 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441087,237.51053697810244,0.3510576309328597 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441090,291.9725558215063,0.4407167809258832 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441093,96.73200474021095,0.039055062124276896 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441082,114.93601475206953,0.03583088388933353 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,fruit,2441097,29.790662889409635,0.5505450835444039 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441092,4242.354295510943,0.017678049503309534 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441087,4594.851739812127,0.016986517926965483 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441090,3620.7476501255414,0.08648672732623952 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441093,6264.566400202042,0.1516060320078223 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441082,5558.055515701566,0.09963789552018287 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_90,leaf,2441097,3747.861565921661,0.0715014437641206 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441092,475.0948049622094,0.09192688286815232 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441087,377.3940256599571,0.008058377900094893 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441090,0.15497539460336762,3.394590647840428 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441093,391.5299350964723,0.007911573716926856 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441082,429.38286213288086,0.04799130786246675 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,fruit,2441097,0.10437364878611408,3.5662625324977584 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441092,321933.21576016635,0.0686580699156858 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441087,170283.26471862834,0.20793574981957264 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441090,227781.94350009688,0.08158842366589791 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441093,840398.6369429802,0.4853776215243828 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441082,747344.152601233,0.43441292302620393 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_91,leaf,2441097,151935.35570995937,0.2574488708631293 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441092,172.17906619594697,0.5785128771943506 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441087,28.50573290125792,0.20253525943849704 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441090,62.3803668283931,0.13758045338109426 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441093,9.65189557953546,0.6728548561378701 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441082,72.84861921811722,0.20495385359109908 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,fruit,2441097,23.633474885918275,0.28393988924481883 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441092,12653.002823000388,0.0018788033067052012 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441087,12543.762860551367,0.0018869665338794306 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441090,10885.31638486334,0.06347374517305227 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441093,28068.663118389577,0.3479069264985668 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441082,27615.829148772176,0.3408432855597052 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_92,leaf,2441097,7014.226299528292,0.2543350282418855 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441092,17.155633683544288,0.7440323444002692 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441087,64.81347782731646,0.16677378288134426 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441090,1034.0688162095062,1.036110332794509 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441093,190.71706115967888,0.30195043710984737 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441082,26.502877617231732,0.555146077650382 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,fruit,2441097,125.49980662603843,0.12020394786983135 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441092,292.7853620689132,0.490506254792181 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441087,158.06268896809286,0.22278626050318806 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441090,31.20352777207909,0.48183940864243824 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441093,218.4436363527699,0.36329629207190983 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441082,23.76440992689695,0.6001160702146382 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_93,leaf,2441097,7.314198076948728,1.1118763880375873 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441092,1198.2549692142586,0.07011773661802945 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441087,788.0379326593263,0.11188437907970705 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441090,1084.4476733412148,0.026777099235423485 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441093,954.7601928832704,0.028537198551314535 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441082,1164.3359055215385,0.05764678825183944 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,fruit,2441097,618.2552979648167,0.21726365547355053 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441092,8330.321223875293,0.04604338702657529 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441087,9545.43787044802,0.013090719739456969 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441090,10367.984487122369,0.048989203222867594 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441093,6813.737291089486,0.13331975050514977 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441082,9328.821368779125,0.0031216416471755437 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_94,leaf,2441097,9195.193936959771,0.0031442420714791197 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441092,176.0621788599627,0.01761756138552073 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441087,177.46037621509072,0.014182235670505694 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441090,205.37453456338707,0.0492629586539759 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441093,153.99158934000715,0.07578663221984971 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441082,677.7766777850134,0.5678029871804346 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,fruit,2441097,189.2419198207921,0.013733711671589877 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441092,41.30684875246438,0.41824633814992107 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441087,87.93965779954063,0.09008363129789787 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441090,301.37238533602857,0.44483505291420533 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441093,228.07204497872175,0.3238036540142688 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441082,101.44033196186442,0.02805774084873347 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_97,leaf,2441097,114.98016914106988,0.026354540566940532 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441092,2900.0148068085928,0.060782023800935114 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441087,2846.173279720743,0.06892090199619183 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441090,5148.867102470434,0.1885294432735498 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441093,4314.620168592557,0.11176033012796527 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441082,1687.3125995082598,0.29598668962142716 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,fruit,2441097,3771.312290574164,0.053310257348967216 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441092,85753.22605516974,0.02862527136006321 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441087,97545.46510533006,0.08458188790695687 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441090,74813.36666226196,0.030645997128209146 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441093,110005.7739579025,0.13679028499018475 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441082,69180.0619602287,0.06464424926696832 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_98,leaf,2441097,45113.42159943212,0.2503194287736896 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441092,77885.46518049896,0.08520854087502006 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441087,57502.61054038045,0.04656031573197428 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441090,92045.62258130674,0.15775526231627346 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441093,48010.027372858,0.12491592366679782 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441082,59401.28489031931,0.03245203807975816 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,fruit,2441097,68618.72986406588,0.030194797734660384 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441092,111879.15414812676,0.0029666291340388895 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441087,101212.47522568368,0.04648175742348304 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441090,113412.86070759875,0.002946501750295205 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441093,181634.17673083485,0.20748176638266624 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441082,158085.52232788678,0.14717629511214358 +1017363 Sl10g007190 #19.2,transp1-1,0.4,m_99,leaf,2441097,92176.59946538268,0.08709512110154005 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441077,121.07406653909734,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441066,119.30638699616884,0.006387435404920705 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441075,137.3938855621154,0.05491627635991403 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441072,147.34035270246602,0.08527057573836627 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,fruit,2441055,62.70635092094633,0.2857396008394173 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441077,30.86936986032912,0.41018592061927395 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441066,68.23751398476783,0.06569048857380588 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441075,287.5580046756008,0.5590117765486164 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441072,83.0147520831177,0.01944159036244364 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441055,75.74619483372989,0.020352864276280025 +1017361 Sl10g086080 #2,log2-1,0.8,m_1,leaf,2441065,1249.3113970522948,1.196957017024309 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441077,58.31457817035037,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441066,59.831002080716,0.011149138271585812 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441075,58.80112826285307,0.0036085208800895607 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441072,47.71140585428407,0.08715492484341736 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,fruit,2441055,54.591186479625335,0.02865460509778761 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441077,308.2754962891483,0.010144901955304597 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441066,320.6926211179418,0.007005059726156393 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441075,340.6790062402421,0.03326146419272158 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441072,310.3199837482791,0.007274163699125591 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441055,336.5887473521794,0.028015685244138222 +1017361 Sl10g086080 #2,log2-1,0.8,m_10,leaf,2441065,310.4302274054259,0.0071199045088530255 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441077,66.2605181409528,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441066,133.8649353190993,0.30541200485309883 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441075,34.587801870279,0.28233186509882646 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441072,214.083271904794,0.5093279059680866 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,fruit,2441055,10.466249346577175,0.8014637505325093 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441077,2337.9831421017034,0.023473681322468742 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441066,4153.600474111503,0.273057026298404 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441075,1550.0924771438076,0.15501008549106965 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441072,2091.955283289622,0.024815297050473806 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441055,1930.4076077006785,0.05971867360764804 +1017361 Sl10g086080 #2,log2-1,0.8,m_100,leaf,2441065,2989.648638380867,0.13025245634679417 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441077,33.387014852256414,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441066,41.633153363799295,0.09586171598517823 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441075,22.96879260498044,0.16243942398772604 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441072,41.182569636612925,0.09113585113209033 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,fruit,2441055,12.933045494493298,0.4118767850375329 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441077,100.33291243357372,0.23766667524782958 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441066,67.37715328827316,0.06473591416581681 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441075,99.6589428789845,0.2347395323786483 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441072,26.826925542891768,0.3352058398552267 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441055,48.71603525334575,0.0761048076741977 +1017361 Sl10g086080 #2,log2-1,0.8,m_101,leaf,2441065,28.025869650015416,0.3162176460043151 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441077,102.72984589774552,0.025345614144108186 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441066,112.91588567033814,0.01571279453770469 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441075,150.13122470114777,0.1394287766018869 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441072,108.90360361708906,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,fruit,2441055,90.930080797889,0.0783346737961641 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441077,580.7283383858994,0.018679085427693476 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441066,643.4411734869858,0.025856743063726206 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441075,573.5433719556446,0.02408583939696607 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441072,517.4217762953878,0.06880740213158942 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441055,674.6880555415344,0.04645091693116443 +1017361 Sl10g086080 #2,log2-1,0.8,m_102,leaf,2441065,631.7726473541978,0.017908714479285326 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441077,2359.5522545176013,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441066,162.02996766883587,1.1632342543052214 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441075,2376.3946268579084,0.0030889620973737486 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441072,1097.076114342441,0.33259283999265676 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,fruit,2441055,15801.77417902226,0.8258762514143836 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441077,732744.9999639314,0.05414861563508566 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441066,917172.7816714084,0.043349678721681606 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441075,649137.7415557747,0.10676461905171752 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441072,834788.8102983461,0.002475139791044967 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441055,829250.1514786555,4.159197341815357e-4 +1017361 Sl10g086080 #2,log2-1,0.8,m_103,leaf,2441065,830839.2424026555,4.155217928447641e-4 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441077,2313.147519715591,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441066,158.84336408111923,1.1632342543052214 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441075,2329.658657254722,0.0030889620973737486 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441072,1075.5001877884906,0.33259283999265676 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,fruit,2441055,15491.004566365938,0.8258762514143836 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441077,732744.9999639314,0.05414861563508566 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441066,917172.7816714084,0.043349678721681606 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441075,649137.7415557747,0.10676461905171752 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441072,834788.8102983461,0.002475139791044967 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441055,829250.1514786555,4.159197341815357e-4 +1017361 Sl10g086080 #2,log2-1,0.8,m_104,leaf,2441065,830839.2424026555,4.155217928447641e-4 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441077,52.43108596949835,0.15606031330609693 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441066,48.499082885871694,0.12220498645523148 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441075,36.07728311102058,0.0062947152657335526 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441072,31.50800199853949,0.06510767540323048 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,fruit,2441055,36.603999415818706,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441077,71.14352033412581,0.09105223278786423 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441066,46.03681165605901,0.2800823456667272 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441075,244.3505438698855,0.4448257260153652 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441072,203.86509921608865,0.36615529889572174 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441055,99.46322286773992,0.0544749434050138 +1017361 Sl10g086080 #2,log2-1,0.8,m_105,leaf,2441065,76.01271798543051,0.06230132212240913 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441077,155.5247718079159,4.959627764278274e-4 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441066,172.432236815806,0.04432292638927082 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441075,155.70248200521024,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441072,96.03512789175436,0.20986541650621193 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,fruit,2441055,240.1238227529733,0.1881397130963567 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441077,3224.4071702280185,0.040404364689298866 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441066,4004.8781077617305,0.05373505953256119 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441075,3715.973813849689,0.02121840196910796 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441072,3204.848086428394,0.04304679465404382 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441055,4101.359360504295,0.06407358084620718 +1017361 Sl10g086080 #2,log2-1,0.8,m_106,leaf,2441065,3361.5972484754425,0.022308563342533727 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441077,263.45567467459455,0.046444369575464606 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441066,318.22591207229164,0.035583612874991566 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441075,166.59087577880905,0.24550071571146326 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441072,293.19187240429477,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,fruit,2441055,1022.3830569766594,0.5424617166836612 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441077,6914.399259846241,0.024684629187273988 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441066,8519.609034995363,0.11534984112718094 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441075,4645.267311113441,0.14805911386509418 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441072,5617.397934488942,0.06553463408171956 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441055,6150.312121888079,0.026172667991535725 +1017361 Sl10g086080 #2,log2-1,0.8,m_107,leaf,2441065,9916.923183153038,0.1813071248700413 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441077,20.324890910171337,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441066,19.742524794792445,0.012625531163393156 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441075,111.17403169379511,0.7379751322264194 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441072,27.32796497287128,0.12857906907741068 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,fruit,2441055,1.605999318698813,1.102282866577526 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441077,244.40065581365064,0.07803488551261539 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441066,518.3900870829617,0.24851943569269475 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441075,60.798858659851895,0.6822418258488405 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441072,222.0319856515859,0.11972170957064199 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441055,340.61467612498893,0.06612610410229314 +1017361 Sl10g086080 #2,log2-1,0.8,m_108,leaf,2441065,777.7916911402975,0.42472604697876415 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441077,186.3608396214368,0.1753195105600751 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441066,114.98219917888171,0.034404537054150364 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441075,69.24065445359591,0.25467398375331385 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441072,124.46153356131023,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,fruit,2441055,177.5873488588275,0.15437687597904626 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441077,1776.9307007739549,0.09787830228194849 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441066,1144.6511862170148,0.0931190259552257 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441075,1385.3735077379097,0.010225310189976966 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441072,1898.385352916362,0.12659218577156306 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441055,1451.3838129158412,0.00999008651522404 +1017361 Sl10g086080 #2,log2-1,0.8,m_109,leaf,2441065,827.5711575610602,0.23398684236720158 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441077,981.0150160320404,0.19302963137895146 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441066,628.9933061489887,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441075,294.59806639997134,0.32941613162015715 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441072,479.7634182363009,0.1176188935177338 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,fruit,2441055,3441.7777292572296,0.7381367964304903 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441077,888.6461748275806,0.08966997438999558 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441066,1409.46351719179,0.11065498879642499 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441075,985.5265133607608,0.04473053771695623 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441072,696.8837627226233,0.19523850455230196 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441055,1199.3598085710787,0.04055064101835226 +1017361 Sl10g086080 #2,log2-1,0.8,m_11,leaf,2441065,3959.6738413636585,0.559260564329255 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441077,268.27475815473093,0.02235635885123033 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441066,325.2366371566126,0.06126329106610884 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441075,282.4464827238203,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441072,225.22621535090488,0.09831723177441276 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,fruit,2441055,533.3215223472649,0.2760529392356097 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441077,7929.117383401563,0.2962792319316545 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441066,3761.527032809614,0.027581428011297593 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441075,3358.1865823031553,0.07684079324160509 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441072,6743.30266388732,0.2259270375222342 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441055,4254.803408767803,0.02593388320384582 +1017361 Sl10g086080 #2,log2-1,0.8,m_110,leaf,2441065,3489.756068799222,0.06015054412593601 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441077,210.46563322089477,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441066,345.81840662290267,0.2156669150941739 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441075,212.77220929824378,0.004733712723265615 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441072,123.6671413159096,0.23092686856044242 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,fruit,2441055,155.10601690562615,0.13255254494868396 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441077,40198.710761498776,0.09290924717973414 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441066,35564.25577915387,0.14610764690893951 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441075,71093.73819747986,0.15470997862235691 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441072,64691.21386026093,0.1137239283283682 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441055,57409.36911900156,0.06186140240823068 +1017361 Sl10g086080 #2,log2-1,0.8,m_111,leaf,2441065,42165.872206363056,0.07216028376018357 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441077,737.1512417774027,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441066,1075.197168694805,0.16393151061896427 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441075,727.6383122502789,0.005641043622038655 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441072,860.7493717474982,0.06732011292027451 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,fruit,2441055,658.6458392141041,0.04890464881799916 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441077,6793.744514623467,1.3353559028219903 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441066,612711.5025053015,0.619790919873731 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441075,2724.3889352053698,1.7321960058195875 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441072,287306.31287942204,0.29088005509868164 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441055,335226.09500470007,0.3578727044629124 +1017361 Sl10g086080 #2,log2-1,0.8,m_112,leaf,2441065,3809.933798898146,1.5865476841209305 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441077,150.69066486986247,0.11860993384680718 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441066,107.53287190804834,0.02793517043649807 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441075,31.020752171867173,0.5678240911019508 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441072,114.67702432406078,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,fruit,2441055,589.8796535950706,0.7112870013299148 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441077,11.581552081450656,0.8719813429069105 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441066,618.4319357136427,0.855543800963954 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441075,69.3695736809496,0.09457908191531628 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441072,35.47075176188978,0.385877714471345 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441055,103.12605867636948,0.07762031256756718 +1017361 Sl10g086080 #2,log2-1,0.8,m_12,leaf,2441065,128.7799211525828,0.17410004743882035 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441077,73.4029789526354,0.13147413794215135 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441066,90.27126111567526,0.22130996218340004 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441075,43.64598518403374,0.09429524663575539 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441072,10.704580407971587,0.7046698988014317 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,fruit,2441055,54.2299928953212,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441077,365.8191578194755,0.20665020001066203 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441066,132.9947050670977,0.23278189487616663 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441075,176.1367603507458,0.11076624138667324 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441072,126.7451716769466,0.2536848215835965 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441055,282.67357092486276,0.09466895966886701 +1017361 Sl10g086080 #2,log2-1,0.8,m_120,leaf,2441065,278.48083578555287,0.08817906812341958 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441077,69.78634660658744,0.20080390496866007 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441066,99.40065970333852,0.3544227085872673 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441075,33.3813178697488,0.11946307984304094 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441072,18.1362569025791,0.3844188991465374 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,fruit,2441055,43.95077708471968,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441077,60.6624891801438,0.418245518079958 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441066,158.06951508763743,0.002317623939452673 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441075,137.13516328127815,0.0640169169868865 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441072,218.29910613165816,0.1378862124673046 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441055,159.76110895051374,0.0023053215015100825 +1017361 Sl10g086080 #2,log2-1,0.8,m_121,leaf,2441065,639.8157375007914,0.6048891732471349 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441077,204.60432864712016,0.14921242570736037 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441066,290.0175299472491,0.002297006183894723 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441075,178.70788116054365,0.20798353753317889 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441072,288.487661436743,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,fruit,2441055,439.6452737861909,0.182975165631452 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441077,18537.198548424043,0.2551643005955553 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441066,11124.83245381758,0.033413677975497436 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441075,8954.829039927035,0.060822502027762404 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441072,13799.884548111018,0.1269956520345623 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441055,7559.76306804031,0.13437161660031194 +1017361 Sl10g086080 #2,log2-1,0.8,m_122,leaf,2441065,9477.187177793325,0.036200342830677634 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441077,193.44636379498067,0.02122095581514838 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441066,147.54195991290936,0.09642406667249759 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441075,184.22120337991026,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441072,168.24903014636527,0.0393870454406704 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,fruit,2441055,382.800840724225,0.3176332680231395 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441077,179.06186496134814,0.03853391471614653 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441066,130.3175574478207,0.09946625735773251 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441075,148.65529638137698,0.042288801594262626 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441072,91.83823121689628,0.2514456779958856 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441055,279.3093526209468,0.23161628949422486 +1017361 Sl10g086080 #2,log2-1,0.8,m_123,leaf,2441065,260.2549159711992,0.20092975295637094 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441077,1607.9385725458278,0.041962090204059166 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441066,1427.1504255415564,0.009837611993070094 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441075,827.2630639170159,0.24666372919315638 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441072,1459.8470726870885,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,fruit,2441055,8779.262595757542,0.7791506760221796 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441077,90054.54329155055,0.004195746067986228 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441066,126049.84669028998,0.141840947671664 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441075,86506.21791548106,0.02165404921128733 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441072,69434.42239411465,0.11712654704797032 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441055,91803.02088271268,0.004155598264768301 +1017361 Sl10g086080 #2,log2-1,0.8,m_13,leaf,2441065,108272.861806417,0.07581824182946839 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441077,31.52043334702651,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441066,80.07949939357682,0.4049291699493929 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441075,12.198169111659528,0.4122975296073579 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441072,127.09796262383377,0.6055464092878142 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,fruit,2441055,11.6531801626465,0.4321477187301186 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441077,62.37033577563431,0.1320261935884044 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441066,12.631737693851742,0.561488789837753 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441075,29.67078199095724,0.19062289597283666 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441072,214.85344444468495,0.6691904319838582 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441055,21.918844124823032,0.32213424033247784 +1017361 Sl10g086080 #2,log2-1,0.8,m_14,leaf,2441065,85.33075866999297,0.268153718404909 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441077,43.84987637378829,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441066,90.1257288317556,0.3128804165139907 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441075,82.90093888754424,0.27659107584858056 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441072,25.760760731785098,0.23100968942311217 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,fruit,2441055,21.813936570205797,0.30323432731962363 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441077,489.639413349133,0.14435931889459797 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441066,928.1407035837548,0.1333781312436293 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441075,902.3742234691478,0.12115099327508139 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441072,682.5652651901497,9.150396325141585e-5 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441055,641.4785327916082,0.02705356061610731 +1017361 Sl10g086080 #2,log2-1,0.8,m_15,leaf,2441065,682.8529225736163,9.148468782393948e-5 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441077,9.470098897202782,0.7410917515457317 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441066,52.173054797858754,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441075,19.149505880603513,0.4352886937117928 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441072,60.99994030543554,0.06788314405624551 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,fruit,2441055,116.56219534445374,0.3491114524322061 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441077,348.8639601608881,1.002335718631995 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441066,60.88873342316851,0.24421655238833795 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441075,5.887209601164481,0.7704108895962295 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441072,114.05992786485638,0.5168127048028672 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441055,8.509814493822498,0.6104002948195569 +1017361 Sl10g086080 #2,log2-1,0.8,m_16,leaf,2441065,5.51647316854787,0.7986588776201458 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441077,934.086910913122,0.0617995060273997 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441066,1226.0708413183947,0.056328771560892665 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441075,722.0685083005967,0.17360838806102796 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441072,1076.9283069765966,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,fruit,2441055,8733.165152840284,0.9089848806688021 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441077,30827.069744919216,0.037295569242579596 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441066,39833.73150616749,0.14861431598435892 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441075,22748.3562759562,0.09468665436779844 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441072,16945.960063630548,0.2225704971786282 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441055,25753.415980604117,0.040801832934120874 +1017361 Sl10g086080 #2,log2-1,0.8,m_17,leaf,2441065,35663.23444976913,0.10058405287804639 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441077,83.8479681618037,0.18541554981903907 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441066,27.334111231869027,0.30137203586944206 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441075,54.71129483996765,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441072,37.687012165681786,0.16188528539364655 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,fruit,2441055,64.27545653826206,0.06996817680054135 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441077,1740.2575282095106,0.07407864602074632 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441066,2741.3666920177056,0.12327496455423725 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441075,1155.0073303050976,0.25210742667344554 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441072,998.7577077349272,0.31523202325410704 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441055,4581.02810233977,0.346270788786434 +1017361 Sl10g086080 #2,log2-1,0.8,m_18,leaf,2441065,2387.5758914048192,0.06326501776509508 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441077,3.4364136081056325,0.028875417819827054 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441066,3.215363017936294,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441075,3.3958845125935544,0.02372289997353294 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441072,3.193722631554908,0.0029328165114901328 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,fruit,2441055,3.142536366059859,0.00994970021180408 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441077,2369.950112606163,0.09420678475579747 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441066,3518.1608346288235,0.07736970060928927 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441075,2080.5925447971235,0.15075895098788683 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441072,1870.304823305785,0.19703359511557883 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441055,4931.602916632451,0.22404211178512412 +1017361 Sl10g086080 #2,log2-1,0.8,m_19,leaf,2441065,3910.029875204595,0.12323408673100333 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441077,128.9233780975643,0.3272350695862527 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441066,60.68713104970555,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441075,29.254019704241834,0.31691105736806824 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441072,5.870031560869887,1.0144561706602755 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,fruit,2441055,82.73586812957684,0.13459722127233964 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441077,673.1588480770346,0.23436478769319136 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441066,642.836648978757,0.2543817177679544 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441075,1251.9374381603102,0.035100280569714926 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441072,1390.5991288898683,0.08071960672004286 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441055,1057.5326511920796,0.03818856123201764 +1017361 Sl10g086080 #2,log2-1,0.8,m_2,leaf,2441065,5720.864678981983,0.694979328833961 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441077,45.17933412493172,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441066,54.654548646214074,0.08268648633063957 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441075,8.309830805116686,0.7353476445007074 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441072,49.61363745524703,0.04066124299084217 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,fruit,2441055,12.187837380628332,0.5690131748846832 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441077,34.63439117523429,0.1300970974968978 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441066,42.806120886074375,0.03809878162404923 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441075,50.6557888610498,0.03502442775879522 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441072,111.5327789659108,0.37779786803607607 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441055,95.54634626427276,0.31060942885046106 +1017361 Sl10g086080 #2,log2-1,0.8,m_20,leaf,2441065,41.37562527925051,0.05286008523468411 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441077,9034.984880706748,0.22377694438020956 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441066,5396.9759872185905,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441075,3810.2806039346733,0.151193525767777 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441072,3953.255862576281,0.13519556210714656 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,fruit,2441055,23026.001616227335,0.6300680450480174 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441077,310190.9489093691,0.022049113069425808 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441066,591475.0977571468,0.3023564564393535 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441075,308179.8543274676,0.01922423726892486 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441072,246887.74265308108,0.07708047942037144 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441055,281491.46369286964,0.020114778988056692 +1017361 Sl10g086080 #2,log2-1,0.8,m_21,leaf,2441065,109507.86652834404,0.430134690311041 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441077,132.91900180717488,0.1299916536833643 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441066,201.9276131956667,0.3116002944247205 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441075,98.53611096221212,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441072,14.04277004468447,0.846142633298435 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,fruit,2441055,9.060576479443013,1.0364395869233696 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441077,385.10193011419017,0.6836324770391453 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441066,86.45492936705345,0.0348465420611388 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441075,73.12314271919305,0.03788836982443633 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441072,29.125040559110392,0.43767667942745625 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441055,40.09432168285488,0.29886034778912673 +1017361 Sl10g086080 #2,log2-1,0.8,m_22,leaf,2441065,109.76373272272552,0.13851564936249394 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441077,1982.3549252350624,0.036606942147280996 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441066,2022.542876862483,0.04532326518648189 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441075,1822.1094982674454,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441072,1212.2387432831715,0.17698631201865433 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,fruit,2441055,1227.234682686248,0.17164685170737126 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441077,135615.09896244053,0.15896427540492386 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441066,100911.86414344623,0.03059845915157844 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441075,92479.87265499817,0.007296546759740785 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441072,81624.40581279134,0.061523736976614174 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441055,95613.61768813193,0.007175980891186207 +1017361 Sl10g086080 #2,log2-1,0.8,m_23,leaf,2441065,60639.020325852136,0.19059159352241117 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441077,56.47020648944649,0.3233932056052016 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441066,140.77597035025744,0.07331594816818443 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441075,118.90841259214501,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441072,128.53044638968117,0.03379343447041494 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,fruit,2441055,102.40491429058844,0.06489178297207099 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441077,45.16212235197282,0.4590103719288374 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441066,102.35268282970532,0.10368548421697454 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441075,1.615204711762703,1.9055571420958977 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441072,157.55236273644866,0.08364020553583362 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441055,161.7928424512287,0.0951745900335319 +1017361 Sl10g086080 #2,log2-1,0.8,m_24,leaf,2441065,184.86092404994585,0.15306040465316517 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441077,68.71223754466399,0.09602762842313006 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441066,70.96380974764439,0.11003046017905826 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441075,55.08158930018965,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441072,41.58425347291822,0.12207755334321502 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,fruit,2441055,53.71182943437541,0.01093651793551631 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441077,2929.32291799028,0.00897869324038103 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441066,4458.199162592489,0.19137090982026894 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441075,2809.4435469841505,0.009168246340636621 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441072,2804.0198196352017,0.010007477110712593 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441055,3132.14426776335,0.038053201479543386 +1017361 Sl10g086080 #2,log2-1,0.8,m_25,leaf,2441065,1927.6197101431576,0.17276719777193117 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441077,216.09035978991128,0.033569201068003096 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441066,233.455760009577,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441075,211.13296123821158,0.043648554736340994 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441072,272.8677140737698,0.067747558974943 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,fruit,2441055,264.9887561027315,0.05502285285323216 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441077,4496.998231582671,0.0013732065401805826 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441066,6029.612684068717,0.1259934925347248 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441075,3436.26702393256,0.11820901888862467 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441072,3744.283506136904,0.08092719851231545 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441055,4525.4815804054515,0.001368878246361671 +1017361 Sl10g086080 #2,log2-1,0.8,m_26,leaf,2441065,4948.83761465725,0.04020728029162335 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441077,97.03517710413333,0.02445738179084911 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441066,102.6565310655932,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441075,152.29998636003015,0.1713132797986634 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441072,46.81420441309118,0.34100893750287353 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,fruit,2441055,133.45603204117322,0.11395162347770516 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441077,712.3129688407842,0.06209146994040182 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441066,856.2898499993953,0.017858474749060882 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441075,608.8472586021182,0.13025396648792498 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441072,787.2957101318326,0.01862443637298572 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441055,873.5478755380365,0.026524390442155266 +1017361 Sl10g086080 #2,log2-1,0.8,m_27,leaf,2441065,1496.262173038429,0.2602453752795486 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441077,93.09498168403806,0.2097558809039839 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441066,223.80180070184176,0.5906931866055647 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441075,57.434175369607196,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441072,27.678482383815965,0.31702811592707536 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,fruit,2441055,45.16575016061328,0.10436116206871904 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441077,241.998483567119,0.056608601719264406 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441066,496.6827966784124,0.25565787155028197 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441075,246.4902956924683,0.04862142048947371 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441072,304.89,0.04372193400565472 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441055,235.87353059360615,0.06774203860810024 +1017361 Sl10g086080 #2,log2-1,0.8,m_28,leaf,2441065,576.2189135753615,0.3201662629911777 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441077,176004.893642957,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441066,207664.2934409871,0.07183708565783942 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441075,155173.15872862225,0.05470814232596144 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441072,106545.41678106178,0.21798997052217395 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,fruit,2441055,704157.5104213952,0.6021450726421715 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441077,464438.05564529746,0.0038998592388601594 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441066,862095.9174171847,0.272527649438989 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441075,365098.66275694914,0.10061769672630927 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441072,362847.4856792418,0.10330382097174429 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441055,456134.31179030327,0.003935196590539647 +1017361 Sl10g086080 #2,log2-1,0.8,m_29,leaf,2441065,1012812.3383076744,0.3425010443854557 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441077,34.96852459651669,0.04084810646116099 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441066,0.9215219222541012,1.5383235311500079 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441075,17.730073258916804,0.25411867227245266 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441072,31.82945499002164,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,fruit,2441055,54.87633441484245,0.23655589167564872 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441077,175.74678477581728,0.21975743971637574 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441066,70.53359817476634,0.1767339094398681 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441075,225.64201995516532,0.3282900301030751 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441072,32.09198872471377,0.5187333178426181 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441055,141.38054593109163,0.1252597055393876 +1017361 Sl10g086080 #2,log2-1,0.8,m_3,leaf,2441065,48.40201097169421,0.34026654301507175 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441077,147.2549230144662,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441066,161.69081100742017,0.04061551637429428 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441075,91.09770515790497,0.20856238619978917 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441072,33.48517966120614,0.6432171895594532 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,fruit,2441055,326.9080488882798,0.346355790590422 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441077,6781.603645534662,0.011898617644372056 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441066,7496.852099637579,0.031647921772294474 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441075,7158.339963338118,0.011581298770296566 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441072,6556.378769733315,0.026566985926447906 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441055,7451.653625830651,0.029021638189898002 +1017361 Sl10g086080 #2,log2-1,0.8,m_30,leaf,2441065,5657.034312112381,0.09064220834077075 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441077,57.84526338605677,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441066,52.13988250856703,0.04509775468219801 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441075,38.144589065579744,0.18083486231055312 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441072,124.91971748278682,0.33436319048187046 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,fruit,2441055,57.92006650297154,5.612489586943603e-4 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441077,588.42765328467965,0.010626662254517694 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441066,617.5790791277647,0.010372839030810432 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441075,507.9024788022968,0.07453940415807958 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441072,618.5283645380281,0.011039883790695981 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441055,576.4189368686508,0.019581496467440118 +1017361 Sl10g086080 #2,log2-1,0.8,m_31,leaf,2441065,624.0343790905584,0.014888779793345908 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441077,72.52371456267255,0.28815770810802777 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441066,216.8205518381331,0.18746269737189447 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441075,148.30462983143843,0.022516961159745552 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441072,140.8113778303042,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,fruit,2441055,18.99148057130553,0.8700789245025033 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441077,1778.0414168105217,0.09705338357829119 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441066,4675.075561813416,0.3227933780643628 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441075,2276.0099061107703,0.010178891381950717 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441072,1984.435357359279,0.0493583001640161 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441055,2631.161851809355,0.0731523072842406 +1017361 Sl10g086080 #2,log2-1,0.8,m_32,leaf,2441065,2170.56130879855,0.010423199314910647 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441077,99.17908009398546,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441066,81.4889981289803,0.08532109742547345 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441075,180.90745364947762,0.2610363849863271 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441072,175.79167549007337,0.24857822966388943 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,fruit,2441055,59.3903649731244,0.2227040816384933 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441077,812.5206491816652,0.20288399426758996 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441066,1402.1832501172814,0.034086373808181136 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441075,1454.8474792108068,0.05009906479084414 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441072,1190.493640953787,0.036991321147924694 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441055,2339.309928598113,0.25636936297429136 +1017361 Sl10g086080 #2,log2-1,0.8,m_33,leaf,2441065,1123.0626805454383,0.06231440525444176 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441077,387.4904224886654,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441066,273.4312095673409,0.15141288898030947 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441075,306.92134140915573,0.10123388498829433 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441072,403.61696192813656,0.017708436475102562 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,fruit,2441055,538.661914003539,0.1430552972975221 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441077,48759.25908810583,0.09761657553761793 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441066,61534.31562126797,0.0034437014825972057 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441075,51888.118081660534,0.07060575364338018 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441072,60562.3120876732,0.0034712264252787506 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441055,73597.50847765165,0.08118943896619246 +1017361 Sl10g086080 #2,log2-1,0.8,m_34,leaf,2441065,73561.24911542474,0.08097542192080898 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441077,80.94371079445523,0.1697430670153608 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441066,77.35095791767942,0.1894604809916891 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441075,119.65371232189787,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441072,345.3116562369095,0.46028506112900125 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,fruit,2441055,163.7176185188938,0.13616924127083685 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441077,11733.22308592751,0.07917943265664373 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441066,16458.849689483963,0.06780271832790863 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441075,9920.713953379369,0.15205383304377884 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441072,9037.107827240585,0.19256729658405103 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441055,18291.90626474763,0.11366220648300818 +1017361 Sl10g086080 #2,log2-1,0.8,m_35,leaf,2441065,16426.3947399337,0.06694549434670449 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441077,2290.628821513618,0.19997115825995815 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441066,1445.3850640572596,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441075,1148.95393678246,0.09968094506002112 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441072,1105.7591107506062,0.11632303624003493 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,fruit,2441055,1871.2561009130284,0.11214966669062543 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441077,9861.739541335051,0.02358821973438685 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441066,13620.926600640383,0.11666490472915125 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441075,9478.33520568993,0.04080968425852527 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441072,8181.78360911079,0.10469375877505938 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441055,13564.692087274769,0.11486819199210796 +1017361 Sl10g086080 #2,log2-1,0.8,m_36,leaf,2441065,10962.62432214656,0.022372783620742354 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441077,569.6914786224346,0.18192184450415816 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441066,327.60735683042276,0.05836423305543992 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441075,299.90656528230693,0.09673190583157165 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441072,374.7294959231535,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,fruit,2441055,528.8700863158579,0.1496311244915831 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441077,216.16943770137513,0.14670858886025062 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441066,433.5515066399584,0.155537818049575 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441075,320.85899272405925,0.024811334047173172 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441072,322.3671368923636,0.026847880326265283 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441055,285.22508845392707,0.026315158247742332 +1017361 Sl10g086080 #2,log2-1,0.8,m_37,leaf,2441065,192.65504052706513,0.1967225055799502 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441077,74.90201827968107,0.7436378236273473 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441066,5.557214404327442,0.3859985438179099 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441075,22.848551985458418,0.22800298554728848 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441072,13.51623383370737,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,fruit,2441055,2.4234626899966867,0.7464193585501564 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441077,12.146682170547134,0.935956289770961 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441066,122.01138036202438,0.06598638281288505 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441075,61.415892585758726,0.23213318964727292 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441072,181.95951973035653,0.23956082418808355 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441055,95.69583506277988,0.03952092114350658 +1017361 Sl10g086080 #2,log2-1,0.8,m_38,leaf,2441065,113.92958860020345,0.036222571463993436 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441077,112.61146617462948,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441066,77.18778542319642,0.1640340320539313 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441075,90.63581540125304,0.0942827667063113 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441072,197.1661334383432,0.243249706792247 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,fruit,2441055,118.3878978982552,0.021724696352727335 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441077,2519.8577880783546,0.026308831630746266 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441066,4481.74721588383,0.22376249431681217 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441075,2834.592103978731,0.024805709973168888 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441072,2983.076149149382,0.046979476713803425 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441055,1803.3058099835812,0.1716154811260795 +1017361 Sl10g086080 #2,log2-1,0.8,m_39,leaf,2441065,1481.565112081992,0.25696412036381444 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441077,43.00997711529457,0.010211246467155544 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441066,78.66104987045732,0.2519792805959671 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441075,27.100943989762133,0.21079603930392832 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441072,44.03322130178998,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,fruit,2441055,88.8276727971105,0.3047678262018305 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441077,134.4783538944312,0.23960650871596023 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441066,74.11077735688207,0.4983775244652713 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441075,175.82327022350424,0.12318253967287607 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441072,419.4191572782304,0.2543893701788522 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441055,303.39859990641935,0.11375467919337279 +1017361 Sl10g086080 #2,log2-1,0.8,m_4,leaf,2441065,291.1466309839145,0.09585287589223279 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441077,171.69008234427235,0.17808208638858014 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441066,117.3411253984614,0.012787126612155308 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441075,113.93656512530562,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441072,84.75438001591374,0.12850097120103166 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,fruit,2441055,86.55101629965645,0.11939095071588901 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441077,7145.138670182975,1.618505793006264e-4 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441066,8077.605394905217,0.05343382205559033 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441075,7139.814037156246,1.6191091940953584e-4 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441072,7017.776778811139,0.00764926117862208 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441055,7536.5537283146605,0.023323988338736612 +1017361 Sl10g086080 #2,log2-1,0.8,m_40,leaf,2441065,7007.459956673553,0.008288186541204112 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441077,151.34649413931834,0.062971332890009 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441066,130.9185034932939,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441075,108.71341233737093,0.0807179045645583 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441072,124.69642935920427,0.02114701454095158 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,fruit,2441055,216.62002721918768,0.2186975737496497 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441077,1799.2981663631026,0.01632403782880054 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441066,2097.9732851032713,0.05037277852835542 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441075,1786.906803181488,0.019325272903464974 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441072,1751.7597516792312,0.027952631403686645 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441055,1937.1345907910552,0.015732621049659112 +1017361 Sl10g086080 #2,log2-1,0.8,m_41,leaf,2441065,3452.9554479951917,0.26676379966761976 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441077,46.3080425522443,0.04690770274864153 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441066,51.589833523378054,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441075,47.30807973814751,0.03762880629262244 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441072,78.77298174647831,0.1838131584302336 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,fruit,2441055,57.1872151179868,0.044734821509304634 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441077,165.8554023500918,0.006197867964742532 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441066,165.7681084863866,0.0059692276968004165 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441075,161.24243084538986,0.006052417412191868 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441072,154.25726077486098,0.025286139138063657 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441055,169.40391896447352,0.015391698769711581 +1017361 Sl10g086080 #2,log2-1,0.8,m_42,leaf,2441065,157.96850754941815,0.014961239192588405 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441077,27.487043788986252,0.2868866525831333 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441066,21.741040037528233,0.38873437107123143 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441075,53.21262543106949,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441072,146.56286523233092,0.4400092597602496 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,fruit,2441055,183.6733062430907,0.5380313567651336 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441077,196.53309527633573,0.24922213986164676 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441066,612.2614593906352,0.24427908840458779 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441075,326.89269225701634,0.02825262197999745 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441072,391.24957673174487,0.04979604677871796 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441055,370.83800347157165,0.026526400303190645 +1017361 Sl10g086080 #2,log2-1,0.8,m_43,leaf,2441065,298.10451174588087,0.06828928490687414 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441077,28505.755211538068,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441066,36752.67245655363,0.11035637273917942 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441075,27678.701957112222,0.012786832151251204 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441072,25768.759422524312,0.0438390404385407 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,fruit,2441055,243527.97032589937,0.9316162977802183 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441077,214045.34545232824,0.0061255537650790615 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441066,368533.0872253352,0.24209625077947727 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441075,208049.67641324113,0.0062131898508681616 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441072,138829.51980477865,0.18189841301952114 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441055,137279.46330975974,0.1867746618615751 +1017361 Sl10g086080 #2,log2-1,0.8,m_44,leaf,2441065,300485.7182069482,0.15344360072888819 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441077,39289.897352750035,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441066,44392.22359940592,0.0530260051190945 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441075,32138.966483764776,0.08724898746570009 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441072,32543.137611801645,0.08182147153509778 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,fruit,2441055,220587.4903612849,0.7492999855294755 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441077,37186.15321930601,0.007956470409884453 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441066,64635.775305078445,0.24804817854051375 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441075,35836.02433326517,0.008104961177894943 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441072,20676.556924417997,0.24694656258648529 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441055,20880.464583294928,0.24268462664658053 +1017361 Sl10g086080 #2,log2-1,0.8,m_45,leaf,2441065,48847.09369370362,0.1264139451632902 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441077,5102.364131245482,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441066,5429.53604585414,0.026991271794508 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441075,1693.673082395661,0.47894186356736235 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441072,1153.802242379019,0.645640070232206 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,fruit,2441055,29199.45158721092,0.7576032458812234 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441077,19300.490325870785,0.0554034056269046 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441066,26220.907014612745,0.07767596245717545 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441075,24484.912066285113,0.04792680069993516 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441072,17261.666534046162,0.10388902543030021 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441055,19368.333774405997,0.053879487263747805 +1017361 Sl10g086080 #2,log2-1,0.8,m_46,leaf,2441065,46136.26675391073,0.32307070148776607 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441077,139.95167726176695,0.12343222727773773 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441066,105.32849539675176,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441075,60.4542042640023,0.24111937130461936 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441072,80.44663002758661,0.11703802451194645 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,fruit,2441055,536.3158138343401,0.7068747223885712 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441077,207.0042051085663,0.18492915646792696 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441066,336.26457220867974,0.025772789481255387 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441075,297.5151210627889,0.027399280891853284 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441072,257.88015665786446,0.08949039895955879 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441055,419.0358259668209,0.12134283075210961 +1017361 Sl10g086080 #2,log2-1,0.8,m_47,leaf,2441065,758.4729046658638,0.3790317465399773 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441077,79.6233401039563,0.08066973051382664 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441066,69.27284484262289,0.020192362015891474 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441075,66.12575767394472,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441072,7.861387100214552,0.9248714794837235 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,fruit,2441055,64.51537076813571,0.010707463754962454 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441077,2919.3851311826666,0.05989499148092525 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441066,3768.9669242796017,0.17082592589075096 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441075,1644.8328260521146,0.18927463564247704 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441072,2167.200919765044,0.06949722395097924 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441055,3025.178907959082,0.07535466347093633 +1017361 Sl10g086080 #2,log2-1,0.8,m_48,leaf,2441065,2097.4400424856744,0.08370684537489836 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441077,32.93963184922719,0.07376218722010153 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441066,33.68939212826886,0.08353662116003413 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441075,27.79435202708752,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441072,23.990311442375184,0.06392066771745086 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,fruit,2441055,19.962912513270087,0.14373265024286108 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441077,30.45461914215572,0.0054018796427839355 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441066,31.21695702215314,0.005335514138651298 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441075,32.585554834790294,0.02397006779792643 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441072,29.656799710180675,0.01693076819252748 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441055,31.53886490933266,0.009791006584368045 +1017361 Sl10g086080 #2,log2-1,0.8,m_49,leaf,2441065,30.04848514002971,0.011232469904465914 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441077,413.2100984470312,0.3182934657548615 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441066,859.9325586531971,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441075,681.6838711475687,0.10088137388321217 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441072,1378.220270768582,0.20485424073820058 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,fruit,2441055,1317.810568368746,0.18538859365097604 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441077,16512.70038674138,0.023546680554062505 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441066,18796.780521521407,0.03271868895511165 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441075,14800.808687360231,0.07107933645899767 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441072,13033.743809519732,0.12629560122948202 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441055,18352.70965430652,0.022335412478312833 +1017361 Sl10g086080 #2,log2-1,0.8,m_5,leaf,2441065,36737.30848683922,0.3237425535839771 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441077,104.32045811547523,0.031204672538827083 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441066,184.65069858167627,0.21677679693668628 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441075,129.20004224095385,0.061688497545772325 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441072,64.6630667117272,0.2389178604809128 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,fruit,2441055,112.09188126706115,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441077,3671.31905016243,0.03886950829439728 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441066,6737.667590348246,0.22481794470374394 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441075,1819.726261146155,0.3436855735197146 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441072,4358.793488489064,0.03567465733010122 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441055,4634.7664252249015,0.06233621611355744 +1017361 Sl10g086080 #2,log2-1,0.8,m_50,leaf,2441065,1706.36380527416,0.3716200056586274 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441077,40.88646966067468,0.09145261591306952 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441066,38.5100030909846,0.06544655634730412 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441075,33.12279655694198,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441072,18.255042577361483,0.2587441469151124 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,fruit,2441055,19.51178537116204,0.22982998702336133 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441077,261.96,0.00799989557225711 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441066,273.9512287348804,0.027438166502197436 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441075,237.84234578997868,0.03394590660964214 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441072,238.7070355217293,0.032369866829046856 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441055,252.3975059862137,0.008150026982364889 +1017361 Sl10g086080 #2,log2-1,0.8,m_51,leaf,2441065,331.41868775791056,0.11014190722082873 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441077,182.5762118561284,0.007158902743362283 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441066,179.59129795445924,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441075,123.9010553358151,0.16121028369970203 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441072,129.47287591895272,0.1421064943408057 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,fruit,2441055,236.79524162474272,0.12008768181219942 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441077,1624.9326666139918,0.021748743193447773 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441066,5076.478978020064,0.5164759657335138 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441075,1549.8061915285068,0.0011907652287495019 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441072,1541.3191959914866,0.0011940390928808498 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441055,1428.7501788689078,0.034130328579136116 +1017361 Sl10g086080 #2,log2-1,0.8,m_52,leaf,2441065,1468.5364443258609,0.022201897575666152 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441077,24.801665334270407,0.4300029380973811 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441066,78.10023666280654,0.06816856882888334 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441075,66.75499705319872,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441072,49.12033493989345,0.1332224615747466 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,fruit,2441055,162.33373669993043,0.3859250045616718 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441077,372.1739031122116,0.058521940976802966 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441066,493.85003628276303,0.1813711139180536 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441075,256.26267634752975,0.10353861858956348 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441072,217.9724016406684,0.17382246677327373 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441055,278.33608878977134,0.06765445590377839 +1017361 Sl10g086080 #2,log2-1,0.8,m_53,leaf,2441065,707.9916059379558,0.3378041325614176 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441077,330.3058562974579,0.18010039520365284 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441066,568.3022708168853,0.05556272242688687 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441075,382.89906838415027,0.11593235928605594 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441072,500.053727533029,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,fruit,2441055,1014.576340356256,0.3072680614993857 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441077,5824.49868777819,0.06759054052274838 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441066,6912.631851824236,0.006794335861810996 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441075,5003.580236069319,0.13356822387437184 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441072,6698.0250982593,0.0069023217232055956 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441055,7580.618016160582,0.04685552101187307 +1017361 Sl10g086080 #2,log2-1,0.8,m_54,leaf,2441065,9180.875798965306,0.13003501991346766 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441077,27.510558282982092,0.7281057784528389 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441066,147.0974629192311,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441075,183.53778836245525,0.09612031188728043 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441072,59.37567248941604,0.39399664076294094 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,fruit,2441055,192.3447213124444,0.11647508982893973 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441077,57.292930682207015,0.39624709482062515 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441066,185.0367281271245,0.11290980758082725 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441075,146.4086408975582,0.011218576193397833 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441072,138.94152448548508,0.011516073225983803 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441055,321.0702048216462,0.3522518721641785 +1017361 Sl10g086080 #2,log2-1,0.8,m_55,leaf,2441065,134.3998319695951,0.0259494071780364 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441077,205.659283796876,0.19415041015188406 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441066,131.52184994844112,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441075,95.72922162408264,0.13795338122820633 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441072,103.97577869619325,0.10206572732927999 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,fruit,2441055,170.15610490855747,0.11184962655087594 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441077,4173.380811907995,0.18097098982155435 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441066,3263.2267263110884,0.07413022413615611 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441075,713.9419398386744,0.5858541302003886 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441072,2239.108180852469,0.08944194842170994 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441055,1287.5263311170297,0.3297609055915198 +1017361 Sl10g086080 #2,log2-1,0.8,m_56,leaf,2441065,5068.371400534402,0.2653514065203728 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441077,101.91648592903474,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441066,137.57698859573532,0.13030135818786848 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441075,89.87412000061698,0.054609789783905516 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441072,83.84725975012513,0.08475556701462184 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,fruit,2441055,104.28757196135903,0.0099881154513497 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441077,49837.329291933005,0.031374483889702987 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441066,61749.95509352035,0.061707401127899963 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441075,32477.697642577263,0.21734401062667352 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441072,51962.0008986379,0.013243378888733837 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441055,55179.87368420073,0.01285145700134116 +1017361 Sl10g086080 #2,log2-1,0.8,m_57,leaf,2441065,123721.5350702318,0.3635160548852836 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441077,343787.1174755355,0.3576831920051946 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441066,107095.46748743096,0.1488353156632014 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441075,114636.84908388852,0.11928216609302833 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441072,177139.41807562477,0.06970880703516613 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,fruit,2441055,150871.2215215679,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441077,173914.3579319071,0.0410356966726253 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441066,266796.431182295,0.22688027484827522 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441075,125215.52638004096,0.101641557538378 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441072,101149.5409821536,0.19433582479248201 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441055,142553.59420111106,0.045321569427949626 +1017361 Sl10g086080 #2,log2-1,0.8,m_58,leaf,2441065,194558.5038377513,0.08975047679435999 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441077,599.2347033431801,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441066,643.8265195706196,0.03117190493071842 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441075,412.48704685275027,0.16218664147370943 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441072,534.5260383430989,0.04962809078950192 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,fruit,2441055,2016.2953230850096,0.5269571861327957 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441077,1938.7947500053967,0.23941904803729352 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441066,1092.3127529830404,0.009765782840774229 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441075,692.1666665854762,0.20790210632886597 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441072,1600.4501835463125,0.15612937360804402 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441055,865.19324248503,0.11099966824233265 +1017361 Sl10g086080 #2,log2-1,0.8,m_59,leaf,2441065,1141.9939204225775,0.009551004879440939 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441077,67.26758583253442,0.30298814779060423 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441066,118.90240198250386,0.055603361333197654 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441075,135.1431350138103,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441072,301.0569726452753,0.34785470080753944 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,fruit,2441055,2396.0837623581174,1.2487080067089034 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441077,102.89187928086396,0.15902939645614422 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441066,146.47010008233963,0.005661517662939097 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441075,218.7579071522634,0.16855326387149594 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441072,78.01289558612481,0.2792440981681523 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441055,150.31390522292273,0.005588662139666578 +1017361 Sl10g086080 #2,log2-1,0.8,m_6,leaf,2441065,284.93781726715923,0.28333959714243484 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441077,75.23973564438586,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441066,31.924062665588263,0.3723291063437124 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441075,104.86323988504304,0.14417601069041552 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441072,48.46746884841873,0.1909969211417062 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,fruit,2441055,250.84203272798248,0.5229530504913775 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441077,41.7495953645352,0.05218013943819466 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441066,32.29649401071298,0.05931675176741846 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441075,28.6009010692551,0.11209241547664761 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441072,56.338902325797555,0.18233624995616515 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441055,17.057487742953974,0.3365570633566173 +1017361 Sl10g086080 #2,log2-1,0.8,m_60,leaf,2441065,216.2617441686688,0.7665075700525228 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441077,124.8262625159693,0.007664366010186274 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441066,127.04873151110696,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441075,173.37878190559132,0.13502561414124115 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441072,72.31065111865121,0.2447680611539913 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,fruit,2441055,330.9730588131184,0.41582231037552164 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441077,955.3848195607952,0.031203604126556872 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441066,951.0785033751304,0.029241633481768226 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441075,827.2202657531133,0.03135356672594103 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441072,531.9609898380786,0.22309494676629082 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441055,802.5517969798623,0.044501660718081926 +1017361 Sl10g086080 #2,log2-1,0.8,m_61,leaf,2441065,1552.7096048298083,0.24211550727303166 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441077,437.8220808035293,0.15147953138054815 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441066,704.3210342447751,0.05499346654398529 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441075,288.05501566892707,0.33330175041312904 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441072,620.5505888497713,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,fruit,2441055,3832.064351228338,0.7906556014438264 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441077,966797.058977302,0.02581324885265346 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441066,1447047.2467113603,0.14933414179630855 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441075,902666.1381463364,0.055621418445140236 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441072,1085208.6519234572,0.024364678100366355 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441055,1085609.303196811,0.024524986926586223 +1017361 Sl10g086080 #2,log2-1,0.8,m_62,leaf,2441065,929446.0984694436,0.04292436073259864 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441077,1352.4199507813155,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441066,784.7244888282191,0.23639436300488548 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441075,217.59688760073135,0.793458889680275 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441072,2298.9075489182414,0.23040993755527817 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,fruit,2441055,3897.11798287441,0.459631985177408 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441077,4060.086515595063,0.026370978222018504 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441066,7240.126739418148,0.22483990245396823 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441075,4541.295633506554,0.02227350873465328 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441072,3099.1433074965853,0.14366460727831099 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441055,4087.223408255902,0.023477889231461546 +1017361 Sl10g086080 #2,log2-1,0.8,m_63,leaf,2441065,5318.136298089417,0.09085319744210496 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441077,369.99854380796154,0.2806275054757017 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441066,847.9077115150578,0.07952106477939003 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441075,436.85426697348646,0.20849093826716425 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441072,706.0370965271387,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,fruit,2441055,1476.080307222413,0.32028246593042375 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441077,9349.697555947876,0.2950991743341893 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441066,5151.229837571378,0.03621253945795555 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441075,3910.450891428649,0.08347155194323186 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441072,7242.3029754053505,0.18417830098452637 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441055,4069.951497242732,0.06610915455948252 +1017361 Sl10g086080 #2,log2-1,0.8,m_64,leaf,2441065,4327.025058257602,0.03950897795492336 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441077,48.326281226085975,0.5222375866057463 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441066,160.84996230875632,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441075,183.8099643490026,0.05794808734597723 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441072,47.27664635137498,0.5317743019172698 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,fruit,2441055,245.99097432471876,0.1844982091890368 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441077,763.5633003696627,0.3523721592445983 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441066,961.4520606323248,0.2522895711213522 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441075,2032.3533663102385,0.07278201548404972 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441072,1761.6341240122222,0.010698508584133126 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441055,1675.9014509147123,0.01096872874093524 +1017361 Sl10g086080 #2,log2-1,0.8,m_65,leaf,2441065,2055.841032141939,0.07777232411629953 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441077,419.59056119996023,0.29527962093357196 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441066,875.454252749048,0.02412812576490797 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441075,514.6838494456877,0.20656479050346999 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441072,828.1429918438491,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,fruit,2441055,1510.8638980383876,0.26112001289716824 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441077,8366.155450949209,0.28997239572554756 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441066,5370.545364250648,0.09746485517095227 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441075,2509.315052215788,0.23299834244474527 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441072,5863.254203034137,0.13558518936289587 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441055,3211.3562208201624,0.125865051682442 +1017361 Sl10g086080 #2,log2-1,0.8,m_66,leaf,2441065,3098.9810738332317,0.14133461027504923 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441077,499.38641494768535,0.046064605347523546 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441066,449.1300552474973,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441075,256.3355807814504,0.24356322568456523 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441072,269.9388041665169,0.22110679888225082 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,fruit,2441055,886.8513961748005,0.2954787355691231 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441077,797.595715844442,0.010096645332411835 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441066,835.1157911135616,0.009867237889150005 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441075,517.3801183896512,0.1980697220383134 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441072,405.0898817274579,0.30432806232163445 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441055,1176.4272596924382,0.15868562134599262 +1017361 Sl10g086080 #2,log2-1,0.8,m_67,leaf,2441065,1240.4356092666214,0.1816947671643394 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441077,211.2893350262492,0.029729865892361484 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441066,197.309370228886,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441075,195.8602489843217,0.0032014081414786233 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441072,166.30104735391444,0.07425272601360833 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,fruit,2441055,264.7965017739836,0.12776453294003387 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441077,926.4364242148748,0.06334180723911942 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441066,1032.4766514241676,0.11040642483324214 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441075,895.0636765806702,0.048380118565670927 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441072,706.35102093796,0.05445323719352935 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441055,645.5325324777971,0.0935556804013431 +1017361 Sl10g086080 #2,log2-1,0.8,m_68,leaf,2441065,584.7021540115903,0.13653912065025509 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441077,100.89344524210576,0.06462161548845957 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441066,94.79698750339573,0.09169003140089216 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441075,117.0804998181496,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441072,210.63100721913392,0.25503773674329144 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,fruit,2441055,516.9019595147977,0.6449236107559315 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441077,243.7711665087399,0.23691929416519786 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441066,150.9817937041629,0.028861539220794707 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441075,131.56672646200548,0.0309169723231264 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441072,96.71958855186097,0.16454860102572155 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441055,259.5876155642775,0.26422092787149865 +1017361 Sl10g086080 #2,log2-1,0.8,m_69,leaf,2441065,98.96959696808894,0.1545612396802567 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441077,77.48946469808868,0.18293976139218882 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441066,61.64733857969771,0.08361143272751836 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441075,39.027613875230614,0.1149308997883145 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441072,50.85139827966447,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,fruit,2441055,9.460071609415484,0.7304084755078464 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441077,197.50107894274456,0.03297813629804702 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441066,278.57861370836724,0.116400164068859 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441075,192.10105706001912,0.04501785417753146 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441072,164.6377854479891,0.11201809306692789 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441055,228.66374961092723,0.030649711937035473 +1017361 Sl10g086080 #2,log2-1,0.8,m_7,leaf,2441065,268.89175094003826,0.10102987033810473 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441077,1143.3510670997955,0.0899530650363265 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441066,929.4510800025448,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441075,626.976071899341,0.17097556979146722 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441072,654.9950561448475,0.15198851441419015 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,fruit,2441055,2096.5016823369015,0.35326867884404223 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441077,343288.5415955382,0.011452449423169142 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441066,722383.9474790195,0.3116563296396926 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441075,361634.5751138789,0.011158188703237926 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441072,275929.9564441258,0.10631290466860488 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441055,414824.6964198375,0.07075284697387385 +1017361 Sl10g086080 #2,log2-1,0.8,m_70,leaf,2441065,253452.59466751895,0.14321501547801585 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441077,104.59111542877828,0.10252007108906369 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441066,109.15257168133438,0.08398089338496417 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441075,132.43868676156896,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441072,177.70002272511388,0.12767261763027893 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,fruit,2441055,275.6719746833255,0.31837775146461533 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441077,2600.780849201599,0.00957348332688257 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441066,3545.2743354992776,0.12497260488446882 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441075,2517.42565089895,0.023720588851500857 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441072,3562.129979879023,0.12703252064053183 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441055,2716.7159550808833,0.009366991434684113 +1017361 Sl10g086080 #2,log2-1,0.8,m_71,leaf,2441065,2028.8599127409784,0.11742518069214691 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441077,54.66238149581507,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441066,99.24945769486638,0.2590395935957579 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441075,80.6516835720067,0.16892488871105238 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441072,26.08878293323918,0.3212347295157305 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,fruit,2441055,18.89005132909516,0.4614554108216602 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441077,330.76729187263413,0.07022327765477909 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441066,824.1353321605778,0.32625269834193693 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441075,466.0667431152606,0.07870227912916317 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441072,285.8713714355705,0.13357517002990216 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441055,446.8677647937762,0.0604331923878596 +1017361 Sl10g086080 #2,log2-1,0.8,m_72,leaf,2441065,282.32763463395685,0.13899244558668133 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441077,82.40668779576056,0.03743459900092927 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441066,63.62906451372321,0.07487232151673417 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441075,75.60105563924557,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441072,66.28054518027167,0.057141787738668404 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,fruit,2441055,289.050960211465,0.5824465566939376 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441077,1756.502312723974,6.491559993460072e-5 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441066,2053.3219657257673,0.06774341156051644 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441075,1656.6687720916154,0.02547795559881738 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441072,1757.0274537442583,6.490589820984383e-5 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441055,1668.9873777461307,0.022260589348459092 +1017361 Sl10g086080 #2,log2-1,0.8,m_73,leaf,2441065,1857.607947259473,0.02424041885833006 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441077,141.59440553846386,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441066,137.32893340547244,0.013284047484074968 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441075,115.45791804039271,0.08862237256279881 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441072,185.9300617204147,0.11830351894741842 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,fruit,2441055,343.0570899117585,0.3843203047435013 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441077,796.2188172396337,0.02064461390987571 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441066,882.8184172273644,0.06548356152118329 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441075,576.1481916096383,0.11985362017299384 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441072,560.7877639387902,0.13158929423999988 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441055,722.2917514534732,0.02167516798942204 +1017361 Sl10g086080 #2,log2-1,0.8,m_74,leaf,2441065,2283.1092081258394,0.4781388623758134 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441077,104.7884050243138,0.025649189014703477 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441066,152.37512743949608,0.13695166278860693 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441075,125.3282338274285,0.052086500409548986 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441072,107.19479929871471,0.015788703580570385 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,fruit,2441055,111.16355296196514,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441077,9209.16164675795,0.023168154272450447 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441066,10746.519404008082,0.09021588533427449 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441075,10603.911505576483,0.08441415283567766 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441072,8252.354002929158,0.024474092136655745 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441055,8137.884400361284,0.030540425502106672 +1017361 Sl10g086080 #2,log2-1,0.8,m_75,leaf,2441065,8045.294961451212,0.03550997076430429 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441077,2.018396031248862,0.9838508484794463 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441066,19.447206780517664,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441075,30.852433822858206,0.200432197402578 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441072,11.364679677018335,0.23330003276001587 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,fruit,2441055,61.6803625835979,0.5012896859783622 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441077,251.43147216561235,0.07576335794007827 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441066,276.66900273990046,0.11730422437036081 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441075,205.5087619916634,0.011825937278562293 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441072,89.6440823900616,0.3721346542189885 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441055,216.85463673869387,0.011512432278200535 +1017361 Sl10g086080 #2,log2-1,0.8,m_76,leaf,2441065,91.16401822276934,0.3648328210330316 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441077,661.7284596833438,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441066,796.51707609076,0.08051527761158805 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441075,571.4312304344211,0.06371584103124528 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441072,636.1116105698354,0.017146490655731483 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,fruit,2441055,886.2988034980729,0.12690034978238884 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441077,24766.09958995846,0.17026813108629213 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441066,20424.275283494204,0.08655717146611863 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441075,16453.80386081008,0.007323167948373843 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441072,14495.099502807778,0.062368282947657505 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441055,15474.652675870751,0.03396857371245865 +1017361 Sl10g086080 #2,log2-1,0.8,m_77,leaf,2441065,17013.40388393978,0.007201728015563624 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441077,66.13052542133515,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441066,67.37790698471481,0.008115542726980118 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441075,881.6574818837147,1.124897924073807 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441072,60.0823498868991,0.04165506321737755 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,fruit,2441055,63.16010052378525,0.019959160734013937 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441077,98.18736375125413,0.0055693352812733465 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441066,100.1368101145716,0.0029688176927316068 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441075,103.0255501316059,0.015320007209472797 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441072,94.742057279937,0.02108212402314491 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441055,101.44895980676505,0.00862266339106088 +1017361 Sl10g086080 #2,log2-1,0.8,m_78,leaf,2441065,98.77241736345194,0.0029892521672389982 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441077,113.4153191545208,0.012006735329314289 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441066,116.89782131224892,0.0011279624885407458 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441075,116.59460476115946,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441072,114.97597535963251,0.006071352116785889 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,fruit,2441055,172.7677036071102,0.17078410616652606 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441077,244.54397943149937,0.004456134702143455 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441066,251.866057037394,0.008356533497099417 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441075,249.58816368888077,0.004410875945971338 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441072,230.6427294320914,0.029873340983280983 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441055,254.2357468469378,0.012423504691702725 +1017361 Sl10g086080 #2,log2-1,0.8,m_79,leaf,2441065,241.77468616832908,0.009402281612945096 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441077,43.72154444380527,0.14690890501423204 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441066,61.320318202001,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441075,31.4887010993735,0.2894496533462063 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441072,87.57883467873806,0.1547947623663899 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,fruit,2441055,113.37464841238588,0.2669115534546713 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441077,325.615586624078,0.13754988686719116 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441066,482.0864213196916,0.03286982663949445 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441075,461.6139962996821,0.014023895843193301 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441072,238.62374822448325,0.272541409286315 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441055,432.27803994426705,0.014491898864955832 +1017361 Sl10g086080 #2,log2-1,0.8,m_8,leaf,2441065,631.2323786235212,0.14993419513806838 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441077,48.06981449027492,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441066,51.734686950038885,0.03190937937243121 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441075,48.09317201837838,2.1097609660469807e-4 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441072,41.67068150255811,0.06204184293620507 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,fruit,2441055,44.60758122771665,0.03246377113403254 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441077,122.61807074036916,0.041253981475338986 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441066,132.60524554909327,0.007247756108805348 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441075,137.06836876597367,0.00712878414287621 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441072,142.96958479986014,0.025435195759515583 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441055,146.56777517174612,0.0362300353428302 +1017361 Sl10g086080 #2,log2-1,0.8,m_80,leaf,2441065,125.32793405255433,0.0317605795040814 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441077,260.546131236778,0.03720303168292194 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441066,283.8491908433456,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441075,177.07878718561435,0.20492112170889154 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441072,314.30182279923247,0.0442592391851262 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,fruit,2441055,987.5881906437075,0.5414882275570871 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441077,8593.1843689544,0.07400922147135303 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441066,7272.89292492938,0.0015622854041321688 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441075,5047.718624869106,0.15704977029911538 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441072,7714.926033120724,0.027186858299762307 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441055,7220.661443370891,0.0015679257016527615 +1017361 Sl10g086080 #2,log2-1,0.8,m_81,leaf,2441065,6071.491941998021,0.07684948535609326 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441077,5997.702917517014,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441066,4624.652102227931,0.11290588245302491 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441075,5025.586374406462,0.07679820859587405 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441072,7476.065213312398,0.09568813087722328 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,fruit,2441055,10431.800029192407,0.24037430315210884 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441077,130579.68567670965,0.08995845686970672 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441066,190685.8004728277,0.07448427853034634 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441075,296013.3612137382,0.26547723860467354 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441072,89810.2556722474,0.252508142990302 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441055,100775.73892338024,0.20247808449517635 +1017361 Sl10g086080 #2,log2-1,0.8,m_82,leaf,2441065,876255.7648084234,0.7367968124359567 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441077,241.9651357983576,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441066,343.2590323906497,0.15186917993069793 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441075,125.94008992218981,0.2835887949363536 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441072,186.09256066036525,0.11402378211190012 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,fruit,2441055,519.4979119353026,0.3318310123057211 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441077,2097.234574605015,0.03407991816402056 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441066,2972.0881101574855,0.1173347533601703 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441075,1041.1793834280916,0.33820136697719105 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441072,1663.1906848932713,0.13478488300223024 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441055,2936.523377495732,0.11210653562657402 +1017361 Sl10g086080 #2,log2-1,0.8,m_83,leaf,2441065,2439.64156277753,0.031599096615452904 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441077,172.01743152416972,0.2446210221529781 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441066,302.12974272532404,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441075,207.44749037249642,0.16328529561628935 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441072,428.83150223834394,0.1520932005393032 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,fruit,2441055,1039.4496820141171,0.5366099898516872 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441077,19117.287111471047,0.06735844294876436 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441066,28925.052805675536,0.2472063408023235 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441075,12035.125915114942,0.13361718131708944 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441072,11763.047820186815,0.14354795711572077 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441055,16561.027102479493,0.00501944823047662 +1017361 Sl10g086080 #2,log2-1,0.8,m_84,leaf,2441065,16180.415849110132,0.005078140550371479 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441077,42.927820007525035,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441066,45.18255235833027,0.02223192615952696 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441075,67.81840910182235,0.19860876341823874 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441072,34.277630056747334,0.09772804705228144 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,fruit,2441055,36.63769005492834,0.06881075005576864 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441077,428.9905440547951,0.013577617348217608 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441066,470.6780788707327,0.05385387007434472 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441075,377.2430861322037,0.042248813034119426 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441072,402.5819155776288,0.014015840080649156 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441055,450.8644407498495,0.03517588217826084 +1017361 Sl10g086080 #2,log2-1,0.8,m_85,leaf,2441065,347.05179571750034,0.07847580621240224 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441077,1576.38453079983,0.10047603783056624 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441066,1304.578100734908,0.018283957361125758 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441075,1148.5559606541456,0.0370339666029289 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441072,976.87958343563,0.10734509357324251 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,fruit,2441055,1250.794971525826,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441077,18353.61091423331,0.042261133710976395 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441066,26597.375517732264,0.20337839799480584 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441075,7427.130585860665,0.3506393270988908 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441072,12951.737688442669,0.10913234689933393 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441055,14949.92780792868,0.046821291476824456 +1017361 Sl10g086080 #2,log2-1,0.8,m_86,leaf,2441065,23679.86963906765,0.15291892023962372 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441077,292.49011304018217,0.042859364015753076 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441066,322.82752336300405,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441075,347.4836055840897,0.03196376487196906 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441072,401.78524694109456,0.09502343159742788 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,fruit,2441055,273.98717753729903,0.071240315817934 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441077,25952.82813013282,0.039138782521899174 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441066,29194.58825752227,0.09025644645350539 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441075,20384.11592567913,0.0657540276344939 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441072,21479.659684681108,0.04301851186503303 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441055,27634.79909642488,0.06641040347530236 +1017361 Sl10g086080 #2,log2-1,0.8,m_87,leaf,2441065,15155.72649960416,0.19446914876431443 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441077,77.473206194718,0.12421294560806628 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441066,102.29630918450742,0.0035045102337272205 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441075,103.12512192697788,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441072,105.48063499321349,0.009808260547496506 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,fruit,2441055,145.48806027982064,0.1494628786500516 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441077,1385.1020238299575,0.05650968270307022 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441066,1318.3222540520444,0.03504950215139058 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441075,863.3931226183391,0.14876349618447104 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441072,1113.89338585827,0.038128455959726804 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441055,1520.7678449284126,0.09709084011056746 +1017361 Sl10g086080 #2,log2-1,0.8,m_88,leaf,2441065,555.8431054954026,0.34001985795682765 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441077,8262.727902869405,0.13479023494050546 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441066,6058.055063443492,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441075,1456.6484545388998,0.6189784640404925 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441072,21.978516206596115,2.4403348470581347 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,fruit,2441055,65419.08207780813,1.0333712296212534 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441077,110640.6941789285,0.009909570254673206 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441066,119745.54672061054,0.024434908980183856 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441075,58400.547521422646,0.28740754344008046 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441072,68354.5896073756,0.2190567820086482 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441055,115747.85582356366,0.00968849245308867 +1017361 Sl10g086080 #2,log2-1,0.8,m_89,leaf,2441065,185786.4108752778,0.21518948266560844 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441077,31.056993860470676,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441066,26.21448746537698,0.073618045212964 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441075,24.144442726423236,0.10934223022427769 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441072,46.863241812773445,0.1786729118630872 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,fruit,2441055,171.83671208535316,0.742956538128261 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441077,135.23217853173276,0.007474034290564813 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441066,143.4595890334343,0.018175503707240193 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441075,137.57777678112288,5.791585571568447e-6 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441072,127.25178781692205,0.033890186029122304 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441055,138.94021338739137,0.0042738828607551405 +1017361 Sl10g086080 #2,log2-1,0.8,m_9,leaf,2441065,137.58144617510806,5.791508338237605e-6 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441077,90.9179451800094,0.10780847823085082 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441066,53.24926842237431,0.12452748802752067 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441075,70.93182493423276,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441072,87.10215709554096,0.089187776974468 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,fruit,2441055,2.6373421052674995,1.4296746651647458 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441077,2834.4386768676936,0.03139871431080499 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441066,3749.2761507136806,0.09008164953197806 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441075,2115.3501597887766,0.15848351213649225 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441072,2195.14865301501,0.1424018442591839 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441055,3259.4676682479617,0.02928089771465281 +1017361 Sl10g086080 #2,log2-1,0.8,m_90,leaf,2441065,3676.3473400842145,0.08155075688153657 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441077,492.213941459236,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441066,434.1548407145897,0.054509262833203564 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441075,304.2450268303864,0.20893042247995863 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441072,610.3746776934414,0.09344259747386285 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,fruit,2441055,738.8518783344582,0.1764034712471374 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441077,791409.3060531972,0.04094557875063565 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441066,1056403.7722617784,0.16637436933156735 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441075,648998.8428710497,0.04521165152943318 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441072,645679.4961657891,0.0474385785935274 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441055,1016504.3125385486,0.14965365147291187 +1017361 Sl10g086080 #2,log2-1,0.8,m_91,leaf,2441065,520733.16626356775,0.1408403345946594 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441077,106.90064026959118,0.07607306225852817 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441066,176.65095931976015,0.14206263162058974 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441075,136.26473114698535,0.02933009504879136 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441072,127.36595861043016,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,fruit,2441055,16.356132601402862,0.8913727458526794 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441077,91207.5849072357,0.12443481779849375 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441066,49058.26850066781,0.3937535581344669 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441075,197013.7910739547,0.2100308541186875 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441072,151730.5928709386,0.09660738082473586 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441055,176962.31542994652,0.16341501814571036 +1017361 Sl10g086080 #2,log2-1,0.8,m_92,leaf,2441065,84833.48238726147,0.15589847894321096 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441077,15.486828805746974,0.03400685583339702 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441066,6.361805352058155,0.42038897628595007 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441075,20.03456763972655,0.07781062104471115 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441072,16.748246856552786,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,fruit,2441055,27.66799363930241,0.218008313724936 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441077,34.27705496499656,0.12094140684302435 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441066,54.19640489200312,0.07802557091060658 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441075,78.85690365070988,0.24089481257447787 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441072,36.371621388372645,0.09518224610748227 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441055,130.9846929156979,0.4612756385182535 +1017361 Sl10g086080 #2,log2-1,0.8,m_93,leaf,2441065,32.76566716926106,0.14052589232631685 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441077,276.48248587342783,0.17239596101700405 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441066,439.7549592200877,0.02914715919260269 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441075,411.2099234100906,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441072,61.18400693098366,0.8274256711482231 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,fruit,2441055,744.2078191946517,0.257630642121188 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441077,3475.0023643208433,0.010678043937041526 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441066,3677.136274269441,0.035232664598946695 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441075,3098.964490421851,0.03906046058294832 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441072,3644.8359817366536,0.03140092929095317 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441055,3306.205486435859,0.01094721824073508 +1017361 Sl10g086080 #2,log2-1,0.8,m_94,leaf,2441065,2059.928972943114,0.21642481446956108 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441077,120.99992568116387,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441066,120.0344799529414,0.0034790883362569858 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441075,102.32578512659671,0.07280001798005165 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441072,175.27901031229982,0.1609448088078822 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,fruit,2441055,322.336575187436,0.425524483669661 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441077,58.03075313117316,0.15513863952361961 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441066,40.929752198351835,0.30675773116156746 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441075,86.49205099021525,0.018179349217341434 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441072,79.40048342951751,0.01897369982350705 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441055,127.1013495017992,0.18535331525233123 +1017361 Sl10g086080 #2,log2-1,0.8,m_97,leaf,2441065,491.0241193915975,0.7723059789867646 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441077,806.8885561767977,0.15105812056891788 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441066,1142.540692150759,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441075,726.9554831572366,0.19636386000878314 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441072,1624.5325690662708,0.15285674599126953 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,fruit,2441055,6955.493787017208,0.7844562903891665 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441077,23351.87642173764,0.12242561005520614 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441066,28319.704291457205,0.03865867952486912 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441075,35049.081268988455,0.05392924466903448 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441072,19885.151500737273,0.19221848962055255 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441055,33592.66005342363,0.035497001300437425 +1017361 Sl10g086080 #2,log2-1,0.8,m_98,leaf,2441065,71144.49632651525,0.36139391534149823 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441077,7740.703840546299,0 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441066,8405.184380288929,0.03576679311825037 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441075,7459.58636804485,0.01606570502659954 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441072,7214.806523934586,0.03055576234538515 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,fruit,2441055,37641.74007448791,0.6868892398023378 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441077,71051.4768437319,0.13128263242219784 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441066,106925.84771905695,0.046226960246185556 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441075,85966.11105520271,0.04852846130836319 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441072,83792.26350143814,0.05965181954244958 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441055,111609.863490367,0.06484683512318679 +1017361 Sl10g086080 #2,log2-1,0.8,m_99,leaf,2441065,106292.4721114152,0.04364676600503259 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441054,65.53557362728144,0.04986141326888771 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441061,105.12726051639444,0.15537682900236072 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441060,76.06230032158318,0.014830937074369777 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441071,68.55795184073072,0.030280683771557904 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441059,78.46162121927664,0.028318759136026994 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,fruit,2441073,70.95502387216874,0.015355367892016192 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441054,1119.0747063083463,1.3358135722684634 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441061,513.7050712406941,0.9976683455366635 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441060,16.612418565676844,0.4926126424788231 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441071,72.70464024908745,0.14851662232795415 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441059,30.58945670296932,0.2274737439351353 +1017361 Sl10g086080 #2,log2-1,0.6,m_1,leaf,2441073,8.440364313051607,0.7866843149511902 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441054,55.68598469024459,0.005426433686269938 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441061,57.56633954645995,0.019849145011682445 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441060,54.30306902454077,0.005495094840973769 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441071,60.129595250872335,0.03876881052904246 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441059,45.919001723491625,0.07832703201364288 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,fruit,2441073,43.5344479728772,0.10148642809520192 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441054,332.9258860982894,0.02125722185619372 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441061,360.4715297650615,0.01326618342810404 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441060,331.4323779807957,0.02320985332577541 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441071,339.39416597007136,0.012900413447471504 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441059,359.85954816375454,0.012528244153890977 +1017361 Sl10g086080 #2,log2-1,0.6,m_10,leaf,2441073,375.44459016189694,0.030941064723370104 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441054,62.42773721462811,0.026427796592735087 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441061,67.61110020264142,0.06106820607701935 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441060,34.89657068082295,0.22616704645561359 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441071,55.05655170727241,0.028140789730245475 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441059,142.01882096947796,0.3833961058645925 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,fruit,2441073,42.50396983996197,0.1405203022456798 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441054,2798.217451879764,0.03837020200237529 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441061,2000.119202245336,0.18419578353519128 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441060,5142.77781939477,0.22594609927390463 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441071,2299.498221099316,0.12361858492822053 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441059,3342.8983502039086,0.0388715080375297 +1017361 Sl10g086080 #2,log2-1,0.6,m_100,leaf,2441073,3315.1663023976416,0.035253656420894064 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441054,36.01829875728617,0.0057823041953610765 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441061,36.90110037475832,0.016298424967687186 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441060,35.06554236466671,0.005860331264104568 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441071,36.101725056875416,0.006787062535743571 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441059,17.29076185847636,0.31292676245563733 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,fruit,2441073,33.90601333668971,0.020464163348736353 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441054,104.29549313643356,0.3588494789938448 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441061,120.81447793614343,0.42270291865125875 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441060,37.44449612215134,0.08602807210176033 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441071,40.04711755669715,0.05684480027475369 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441059,30.865399434289156,0.16994416129355128 +1017361 Sl10g086080 #2,log2-1,0.6,m_101,leaf,2441073,51.24768602266588,0.050258197641218194 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441054,94.48356346657562,0.006368613113507671 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441061,98.31365030725382,0.023626170103920652 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441060,91.7327166924781,0.0064633958424176186 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441071,100.2707255356276,0.03218650610207918 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441059,87.2802897674624,0.02807147187952541 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,fruit,2441073,87.42474321014166,0.027353285960379115 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441054,589.1088041837194,0.020890499761820447 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441061,694.2452530137252,0.05042690584872389 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441060,616.3588893462428,0.0012523491308487067 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441071,604.906906349586,0.0093974700751831 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441059,619.9187343736355,0.0012487481875873563 +1017361 Sl10g086080 #2,log2-1,0.6,m_102,leaf,2441073,784.4596664071806,0.10348460587210306 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441054,3488.8653737832296,0.003621679262148181 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441061,3191.23583743436,0.03510363178115794 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441060,3459.8919175389124,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441059,1151.9937280195188,0.4776124176218124 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,fruit,2441073,31573.571690412664,0.9602611810554609 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441054,513415.6641422221,0.14174505916173263 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441061,861829.0941038529,0.08320697727306925 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441060,558077.7968286827,0.10551942946192217 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441071,937411.9886186369,0.11971632955771927 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441059,922636.1455801144,0.11281629082767974 +1017361 Sl10g086080 #2,log2-1,0.6,m_103,leaf,2441073,561299.5811856204,0.10301945570996729 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441054,3420.250715167235,0.003621679262148181 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441061,3128.4745858268643,0.03510363178115794 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441060,3391.8470727724475,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441059,1129.3377502423898,0.4776124176218124 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,fruit,2441073,30952.622008861577,0.9602611810554609 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441054,513415.6641422221,0.14174505916173263 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441061,861829.0941038529,0.08320697727306925 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441060,558077.7968286827,0.10551942946192217 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441071,937411.9886186369,0.11971632955771927 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441059,922636.1455801144,0.11281629082767974 +1017361 Sl10g086080 #2,log2-1,0.6,m_104,leaf,2441073,561299.5811856204,0.10301945570996729 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441054,51.339216321758975,0.002905512055146664 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441061,53.08597674271191,0.017436089512369524 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441060,46.589721295062,0.03925361049392673 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441071,50.65457098417463,0.002925081475799285 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441059,34.2588680122988,0.1727707141217243 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,fruit,2441073,77.03887400453806,0.17916620358970947 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441054,48.697552147693855,0.2713002631622623 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441061,144.18904816355695,0.20012488043686294 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441060,71.26023215789704,0.10596016159016375 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441071,91.69152094571854,0.003521782218300462 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441059,90.21044388251856,0.0035505747092952067 +1017361 Sl10g086080 #2,log2-1,0.6,m_105,leaf,2441073,99.59164047440096,0.0394154916420022 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441054,202.53166435689823,0.09514709745471928 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441061,196.00795292428677,0.08092785879767739 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441060,162.9385597177184,6.780388836125084e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441071,162.4301835508409,6.790991220531062e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441059,149.14757992916893,0.03772962331028218 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,fruit,2441073,154.1432689117058,0.023421269379094056 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441054,3375.102394372052,0.011518397106801359 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441061,3216.9327452718703,0.03236336873645573 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441060,3556.527177191255,0.011220781540417502 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441071,3075.779176438328,0.05185019780676603 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441059,3578.3478201610997,0.013877202117561716 +1017361 Sl10g086080 #2,log2-1,0.6,m_106,leaf,2441073,3947.55190902685,0.0565224993833624 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441054,560.2719530902881,0.20523885219360105 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441061,394.0854128286287,0.052430329370676265 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441060,220.6137019892342,0.19952754794536753 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441071,242.20904666853056,0.1589696699752836 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441059,362.45681540838825,0.016096240091208358 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,fruit,2441073,336.0811677254758,0.016715852768650397 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441054,12625.257065223175,0.08610176990829732 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441061,6690.035267214762,0.1897100525214337 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441060,10122.793034286822,0.009838102158595596 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441071,9111.155484962184,0.055565001639722666 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441059,10586.6517346839,0.00962016675984767 +1017361 Sl10g086080 #2,log2-1,0.6,m_107,leaf,2441073,10882.807113495835,0.021602472096053482 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441054,81.95314210664328,0.09059997372429818 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441061,26.78036060459739,0.3951492148699183 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441060,60.49194112255582,0.04126811469209413 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441071,41.76402129759706,0.2021633269154468 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441059,89.14184289150718,0.127115972841098 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,fruit,2441073,72.5521622880804,0.03768472486610541 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441054,612.9518827886446,0.2377229893528474 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441061,326.1851677040045,0.036239185131487606 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441060,382.9571291914637,0.033446764790405314 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441071,297.6273780135882,0.07603051564349839 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441059,200.11432629261307,0.24842521291513453 +1017361 Sl10g086080 #2,log2-1,0.6,m_108,leaf,2441073,444.2631863994419,0.09793693314129515 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441054,217.46616162263572,0.1939216345636834 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441061,211.45733135649635,0.18175269252298554 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441060,136.36641572350234,0.008762628893955071 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441071,141.92515379308725,0.008589319029031373 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441059,102.89839675725582,0.13106144633400918 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,fruit,2441073,63.99609040398533,0.33731661124291445 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441054,1381.5374106908698,0.05217816529088637 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441061,1632.9320224882465,0.020427290843604062 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441060,1820.7009239750764,0.06769779763204031 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441071,2159.364651159724,0.14178517271055702 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441059,1457.341358024158,0.028979525015625285 +1017361 Sl10g086080 #2,log2-1,0.6,m_109,leaf,2441073,1482.8768569897331,0.02143572770305635 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441054,1841.874499000748,0.44398265684986926 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441061,1339.4472977096598,0.3056482521871624 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441060,440.93207517982586,0.17690568590389377 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441071,544.8044707333247,0.08503671541988655 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441059,780.474704924867,0.07108145398976928 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,fruit,2441073,440.57144691909974,0.17726103076290567 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441054,1553.7929729285745,0.03144490339867012 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441061,969.7646338490072,0.1732819077387835 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441060,1950.76717098961,0.13025718873030012 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441071,4.9091500017270695,2.4689419472043133 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441059,1746.52,0.08222531364817565 +1017361 Sl10g086080 #2,log2-1,0.6,m_11,leaf,2441073,1336.7421128094527,0.033900619300532675 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441054,749.0975382513494,0.3072756868307991 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441061,452.3942501722359,0.08825439347791875 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441060,288.12647013033984,0.10767952435248551 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441071,323.38100011611743,0.05754818318649724 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441059,397.3157328913496,0.031873079543385696 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,fruit,2441073,341.08595148114046,0.03439885080745331 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441054,4388.023125031389,0.05893807525252148 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441061,3623.63657346354,0.024186198048774532 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441060,2986.31252225029,0.10819557704252114 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441071,2858.1325915817297,0.1272484601324888 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441059,4247.619343563699,0.044814757497930735 +1017361 Sl10g086080 #2,log2-1,0.6,m_110,leaf,2441073,4038.6930011935738,0.022910009389302655 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441054,824.5046170958145,0.43873731348112344 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441061,1227.6893194220877,0.6116326991232413 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441060,177.5291418580726,0.22818612470513688 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441071,416.14081082988343,0.14178453055077878 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441059,127.93361347335508,0.37047111181850667 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,fruit,2441073,184.32152887404231,0.21187971442813458 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441054,37444.63559867446,0.0884344037843281 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441061,44736.2138037347,0.011164786969159124 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441060,47066.18044560014,0.010884943216293408 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441071,48229.197323702,0.021486021751106144 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441059,30369.484494128923,0.17938659222532838 +1017361 Sl10g086080 #2,log2-1,0.6,m_111,leaf,2441073,50212.98273613502,0.0389920076796777 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441054,883.7848269430466,0.22281345875659575 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441061,526.2637421372964,0.002329632879932042 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441060,531.9248568900902,0.0023172029612750222 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441071,332.4391987006098,0.20182085561663277 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441059,438.28800579067473,0.08177349655434218 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,fruit,2441073,621.7119206751456,0.07005611214142293 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441054,529618.342009701,0.2123069620262088 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441061,322446.88076570106,0.0031978752853483172 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441060,218003.7167400749,0.1731921574277573 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441071,327213.0044215739,0.003174500129862423 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441059,112785.02230743684,0.45940462559234074 +1017361 Sl10g086080 #2,log2-1,0.6,m_112,leaf,2441073,533277.6711506466,0.21529734436405246 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441054,266.640061832191,0.2572918013888339 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441061,245.73232605012487,0.22182869163740415 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441060,81.9575477794193,0.2550446444101482 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441071,92.21277259936798,0.20384251964433364 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441059,202.6796380122179,0.1381765199913345 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,fruit,2441073,77.49543778503116,0.27935746395926087 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441054,152.60043763988588,3.4670546092296917e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441061,67.67652054133345,0.35346446240038043 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441060,181.04471435929096,0.07388336542767115 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441071,152.8441825244474,3.464289001953169e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441059,98.29380796110048,0.19137632436392749 +1017361 Sl10g086080 #2,log2-1,0.6,m_12,leaf,2441073,214.45406836154933,0.1474318049730896 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441054,57.29810560686525,0.07402313993737053 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441061,101.27215706165636,0.1733266569250962 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441060,78.5937406610152,0.06322455599258747 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441071,84.62164282530381,0.09531804889734063 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441059,29.994111157308772,0.35512740685194233 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,fruit,2441073,34.42766299158088,0.2952558604180753 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441054,133.12323321368072,0.021091873156427354 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441061,247.67740584905297,0.29072440647456155 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441060,120.50171972416403,0.022168738859902337 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441071,64.68680625757253,0.29234627427867466 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441059,78.77076607386186,0.20679691463162708 +1017361 Sl10g086080 #2,log2-1,0.6,m_120,leaf,2441073,184.9314675892832,0.16384883238541326 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441054,64.67150018182994,0.03625477263777288 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441061,104.4819088053341,0.244582935499291 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441060,61.47791599370038,0.014260974430351014 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441071,57.505972628500665,0.014745209438927764 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441059,51.74241382665211,0.060611477683404136 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,fruit,2441073,29.032955620811183,0.3115669124886693 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441054,139.91929285742478,0.005960275634407264 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441061,143.78628399107143,0.005879582745509815 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441060,48.97625382258769,0.4618523141976483 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441071,182.11077831491,0.10849777326970855 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441059,224.7289836680605,0.19982121049192303 +1017361 Sl10g086080 #2,log2-1,0.6,m_121,leaf,2441073,123.1652934301692,0.0613495313618313 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441054,394.862830360927,0.1747534476483361 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441061,273.34485490414744,0.015018097145722997 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441060,254.76321295403213,0.015556089185615019 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441071,247.5406925692985,0.02804620487563625 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441059,250.20766213934456,0.023392201538666058 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,fruit,2441073,355.2867680533623,0.12888622680736317 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441054,9814.903615921456,0.009412267584939737 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441061,5023.279735438255,0.28148640778311274 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441060,9394.052624560789,0.00962078279477696 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441071,8150.76588389622,0.07127535253578499 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441059,10815.806672187033,0.05158514431917016 +1017361 Sl10g086080 #2,log2-1,0.6,m_122,leaf,2441073,10968.82516175812,0.05768634255137606 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441054,151.1131736422698,0.004014169237396281 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441061,159.16052404605068,0.01851886456057983 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441060,149.2476761730777,0.009408918087249418 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441071,153.9195914015266,0.003977405949124879 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441059,742.712286690448,0.6875041126512138 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,fruit,2441073,93.97454195747164,0.21030627826739523 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441054,207.93657111513187,0.12650610758516212 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441061,359.23223196479483,0.11093831089624517 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441060,316.1402470425425,0.05544280258709078 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441071,268.86052125818094,0.014909949447922788 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441059,235.3842209020696,0.07265963940437858 +1017361 Sl10g086080 #2,log2-1,0.6,m_123,leaf,2441073,287.641801564553,0.014415014431012008 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441054,5577.142330345374,0.40030311148775377 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441061,3961.250103152194,0.2517236470368234 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441060,1672.231546143034,0.1228122044622455 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441071,1786.6051348087617,0.09408003862810643 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441059,2650.897379482265,0.077284299347188945 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,fruit,2441073,1446.3988835052196,0.18582053857704084 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441054,133007.54451475263,0.012374208660839159 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441061,79434.10997279323,0.2114950334438772 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441060,142976.44018251155,0.0437624125757301 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441071,89282.33996145596,0.16073650327997413 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441059,125535.02631426396,0.012737149305387163 +1017361 Sl10g086080 #2,log2-1,0.6,m_13,leaf,2441073,138813.44508737608,0.03092946546651998 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441054,22.982339747217345,0.33711965336839733 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441061,76.83537547651221,0.18704732401884905 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441060,86.15515044013193,0.2367673512235775 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441071,167.475980186654,0.525438634375514 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441059,23.05965634236719,0.3356610631660759 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,fruit,2441073,14.494742309159632,0.5373033951172106 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441054,132.43804044164241,0.024445270365091254 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441061,117.9407122538025,0.0259037297342406 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441060,72.98872709283864,0.23431168620717702 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441071,158.54021235978288,0.10257195965743104 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441059,111.6311430695288,0.04978210411495132 +1017361 Sl10g086080 #2,log2-1,0.6,m_14,leaf,2441073,150.9670331289406,0.08131464426052659 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441054,42.05899156109435,0.2713113478118627 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441061,92.47547414486448,0.07085636342281187 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441060,82.31896608926048,0.020329703824915946 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441071,74.78972085696694,0.02132829102860878 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441059,85.60200467798484,0.03731373205264488 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,fruit,2441073,68.86481714303535,0.05717280466692709 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441054,662.1016740311218,0.002031328731873394 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441061,437.5385425761739,0.17787704135170213 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441060,804.1400413104627,0.08643833068955464 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441071,655.9224304772453,0.002040874546685778 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441059,694.7206970256965,0.022916880306509846 +1017361 Sl10g086080 #2,log2-1,0.6,m_15,leaf,2441073,642.327525058177,0.011136824377037335 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441054,66.07455549612702,0.16929054135496724 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441061,77.18027621313527,0.23676261966734224 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441060,47.69095760507429,0.027692334061350854 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441071,31.73145042450103,0.14925378494613106 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441059,41.79887680828779,0.02957909696757821 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,fruit,2441073,0.6413156910116034,1.8436718429358603 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441054,90.26765576845304,0.021579625666082958 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441061,92.73436394517437,0.00987109220361071 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441060,424.6581290373248,0.65092765226373 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441071,96.99816060344702,0.009651708988313912 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441059,68.3160887286426,0.14258879581892248 +1017361 Sl10g086080 #2,log2-1,0.6,m_16,leaf,2441073,707.4595880187655,0.8725898471058118 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441054,7772.836504161435,0.5874697278586942 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441061,2694.018276318674,0.12729073278539804 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441060,938.984789061856,0.3304512478441004 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441071,1360.9218412663,0.16927662081048966 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441059,1936.1921205065937,0.016161356487278677 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,fruit,2441073,2083.0095714488607,0.015581460658383062 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441054,45882.41942935869,0.026753217442141874 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441061,27754.643577937062,0.24506387354864767 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441060,31173.87959347698,0.19460867444412866 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441071,55836.10436459402,0.058515582241184916 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441059,51713.01997955766,0.02520037270908304 +1017361 Sl10g086080 #2,log2-1,0.6,m_17,leaf,2441073,61447.863996486856,0.10010726278257387 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441054,149.8112116131347,0.05847019156122757 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441061,158.07191701458032,0.08178059535385573 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441060,112.06986672595195,0.06758526940105103 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441071,92.12553591855436,0.15269409758966912 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441059,82.5855538322092,0.20017003928846133 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,fruit,2441073,227.1482757715311,0.23923531966742928 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441054,3320.6441889615257,0.14033255497752295 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441061,5353.807125354403,0.06710782348010236 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441060,3820.7454455646016,0.07940679379753401 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441071,3635.582174031896,0.10098093256449792 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441059,6547.424000965408,0.1545155681756798 +1017361 Sl10g086080 #2,log2-1,0.6,m_18,leaf,2441073,7671.266901400793,0.2233121952441386 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441054,4.314013178288821,0.010248172585691329 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441061,4.723325868826156,0.02911826917007765 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441060,4.520032401264415,0.010011907984994517 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441071,4.238951945557781,0.017871146759601997 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441059,2.30634061764792,0.28220619246532214 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,fruit,2441073,4.941287325928949,0.04871046795405243 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441054,4384.65584755647,0.0491094898665243 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441061,4677.957653419828,0.02098871495381438 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441060,5141.217267579599,0.020020956464939843 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441071,3704.598894018982,0.12230380831733267 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441059,5843.332707157834,0.0756156137822721 +1017361 Sl10g086080 #2,log2-1,0.6,m_19,leaf,2441073,6366.455757359286,0.11285272431336102 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441054,115.03482714210617,0.12408647749256319 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441061,8682814.35755509,5.001917648974576 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441060,4.119070713433125,1.3219436190418543 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441071,57.85636240669279,0.17439174189091644 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441059,1.4556628235971645,1.7736820761075136 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,fruit,2441073,309.69663674721363,0.5541936222806332 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441054,636.8264645284471,0.26930975998758955 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441061,984.8643901754308,0.07995442811021114 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441060,1290.1549471687767,0.03731100902966089 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441071,1187.0825231005642,0.0011500480830903825 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441059,1180.803852534881,0.001153101594268069 +1017361 Sl10g086080 #2,log2-1,0.6,m_2,leaf,2441073,1305.8928040928802,0.04257666575448127 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441054,5.493249611168042,0.8297152302775729 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441061,34.74761250975517,0.028619594117993863 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441060,48.057456310573784,0.11221621587162822 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441071,49.13250393504921,0.12182433368353873 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441059,13.703370954928294,0.4327171495371711 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,fruit,2441073,39.4815498175419,0.026849628301453876 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441054,91.800845410579,0.04112092974306103 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441061,43.27,0.28553885577425864 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441060,366.5262212411524,0.6423792984898189 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441071,136.20394975153425,0.2124639508066053 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441059,29.12375024644967,0.4574784529119864 +1017361 Sl10g086080 #2,log2-1,0.6,m_20,leaf,2441073,75.21425794346136,0.04542557581716089 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441054,6460.538321288779,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441061,7030.889166506088,0.0367415449758699 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441060,10400.676310793611,0.20679287361595078 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441059,5454.9150964410355,0.0734807115262881 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,fruit,2441073,52.87996773678891,2.0869775253791434 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441054,323168.93619649025,0.01259640538728135 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441061,201838.76557843183,0.191828621828658 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441060,233462.87455786797,0.12861537469647644 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441071,466793.836484822,0.17229190976177655 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441059,499727.0356187055,0.2018996424915933 +1017361 Sl10g086080 #2,log2-1,0.6,m_21,leaf,2441073,304691.6178179324,0.01297269647262489 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441054,38.033376826772525,0.18416556241829563 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441061,75.74694319757852,0.48336578745395054 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441060,2.3862070120287475,1.01829120634738 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441071,286.36852351930935,1.0609259564275326 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441059,11.743692049528397,0.32619466954370036 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,fruit,2441073,3.109329819961933,0.9033325319555182 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441054,48.196108807614294,0.045495568729240654 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441061,144.93134574150025,0.5236459173676016 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441060,38.609223324403864,0.05082534213927725 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441071,25.7220000134972,0.22721167332108116 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441059,129.17566978248598,0.47366431461949743 +1017361 Sl10g086080 #2,log2-1,0.6,m_22,leaf,2441073,2.4300714361279363,1.2518973668242923 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441054,2045.432995947798,0.042181917087205534 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441061,2664.512876939471,0.15701448300816567 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441060,1800.734985407904,0.013153538111867036 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441071,1861.305454371452,0.0012143095917762636 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441059,1187.734927114189,0.19388381267732102 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,fruit,2441073,1850.911381756883,0.0012177143857265982 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441054,205125.65340787463,0.024347820332589087 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441061,182028.23906317557,0.07622903004477966 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441060,246163.2297635685,0.054855383601435825 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441071,167346.1322735556,0.11275211846191446 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441059,228782.4826052467,0.023054970577668144 +1017361 Sl10g086080 #2,log2-1,0.6,m_23,leaf,2441073,263764.13830126723,0.08484795020982272 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441054,65.57592462113612,0.05358689433793584 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441061,77.64515293431349,0.0197830325032351 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441060,78.21722618564046,0.02297109332171643 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441071,70.7300455283569,0.02072737956528603 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441059,70.003641932469307,0.025210682470674373 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,fruit,2441073,127.186476635339,0.23410961931026697 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441054,125.937010092804,0.019737895848568776 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441061,114.746024302142,0.020677835408709377 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441060,21.069702159482787,0.7567570860471915 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441071,127.23713356613872,0.024198394109311572 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441059,109.0051449971031,0.04296848558651556 +1017361 Sl10g086080 #2,log2-1,0.6,m_24,leaf,2441073,134.099036991502,0.04701017652562545 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441054,66.39123766440807,0.017788678042678807 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441061,61.06235516882179,0.018548535810968714 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441060,57.58183753975936,0.04403656691119795 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441071,66.51137350289162,0.018573829598161895 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441059,38.433542972530056,0.21961166531102383 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,fruit,2441073,70.3543578078752,0.04296891637743605 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441054,3487.9600902747216,0.011686333093360979 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441061,3029.3546360524374,0.04953505627819421 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441060,3302.7496823636434,0.012009514471997829 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441071,3504.888606367222,0.01378904568064998 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441059,4326.8490295382935,0.10528656831857308 +1017361 Sl10g086080 #2,log2-1,0.6,m_25,leaf,2441073,3269.970426295683,0.016341349031069097 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441054,376.29065610218936,0.1432132480238737 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441061,368.46676869527533,0.13408813957797827 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441060,303.1137198843429,0.049295408148017916 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441071,210.98101732218592,0.10806680409676561 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441059,221.5596894123343,0.08681943853377083 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,fruit,2441073,238.06434061288604,0.05561583840504136 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441054,5115.6872591872825,0.018508068448973347 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441061,2471.293793785157,0.2974715396268719 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441060,6886.360674372918,0.14759384706839995 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441071,5280.682303336552,0.032294122081683696 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441059,4357.196694513474,0.051188752653994474 +1017361 Sl10g086080 #2,log2-1,0.6,m_26,leaf,2441073,4688.8231923380345,0.01933206161639811 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441054,83.65473482304529,4.469164179636831e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441061,94.62901162510026,0.05398069356190427 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441060,83.48265138213799,4.4737679694972776e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441071,65.35601166132133,0.10675806887083894 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441059,209.7301587726104,0.39961727516159984 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,fruit,2441073,73.3329950727917,0.05674418761016842 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441054,976.2405523323434,0.016338737656373947 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441061,908.1375582602795,0.015066468956963508 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441060,972.2531737272355,0.014561263169711403 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441071,633.1168254965047,0.17173425098346407 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441059,673.2622445315629,0.14503384570832978 +1017361 Sl10g086080 #2,log2-1,0.6,m_27,leaf,2441073,980.5500177392996,0.018251645558382545 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441054,58.983647005264,0.04698996515435239 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441061,85.70780778046313,0.11529879996548864 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441060,67.5450986972011,0.011872253642558173 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441071,63.902174894241256,0.012205947457582411 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441059,191.7445902072673,0.4650015328416772 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,fruit,2441073,30.064003289200187,0.33967477669843116 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441054,390.6461279939073,0.04756370851601899 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441061,199.94220867917608,0.24331533024018404 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441060,549.8749680711869,0.19604413425627154 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441071,309.59854096404274,0.053420910182265136 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441059,204.5693684863953,0.23337921102869297 +1017361 Sl10g086080 #2,log2-1,0.6,m_28,leaf,2441073,536.783425869505,0.18557928225241938 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441054,230745.05607008527,0.028773001216927163 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441061,190893.03802855537,0.11111531611681169 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441060,292068.92851461656,0.07357995156367725 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441059,246550.2265017283,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,fruit,2441073,636328.4133547338,0.41177590995226776 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441054,945289.7852522888,0.12519969486751847 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441061,597059.9912001651,0.07434729986811206 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441060,771570.2785421845,0.037010219859383575 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441071,701039.2572027452,0.004622931568204258 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441059,671158.9368495964,0.023539892658464012 +1017361 Sl10g086080 #2,log2-1,0.6,m_29,leaf,2441073,716043.67,0.004574239734159491 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441054,74.18442093453402,0.3355072356022617 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441061,46.10405564820206,0.1289336553352316 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441060,10.174813667904251,0.5272790107335958 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441071,3.1575625579723106,1.0354535118354968 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441059,22.418802756939304,0.1841930594149046 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,fruit,2441073,352.1101906656278,1.0118731190328254 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441054,12.787522821962186,0.6163327596348742 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441061,193.71906238373592,0.5640531769148929 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441060,35.75685830843495,0.16975982789821464 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441071,16.914101196388643,0.49487025681405417 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441059,69.96119978817887,0.12173806728931913 +1017361 Sl10g086080 #2,log2-1,0.6,m_3,leaf,2441073,86.81261095213699,0.2154636366949807 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441054,172.84431110234462,0.033226132217015536 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441061,172.05873806482708,0.03124777553898772 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441060,142.09759791551085,0.051842221307563996 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441071,148.16900422246542,0.03367159558706456 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441059,53.200263573396015,0.47851517382661 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,fruit,2441073,179.2171966827914,0.0489507220228842 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441054,7717.190789158357,0.007247468731740536 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441061,7396.1542334467695,0.025700747001806246 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441060,8380.404653331976,0.02855828331940158 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441071,8137.551372661476,0.015787037291053352 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441059,7594.194389124832,0.0142249963986254 +1017361 Sl10g086080 #2,log2-1,0.6,m_30,leaf,2441073,7976.919551304999,0.007128506122998868 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441054,109.68099781931744,0.07482857069733084 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441061,86.64882353669634,0.027540151569787952 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441060,47.856372190770955,0.2853630487667247 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441071,47.782752963195684,0.28603165443540557 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441059,146.23340653825335,0.19974377501252105 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,fruit,2441073,97.9941637014888,0.025897388837831548 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441054,580.3824183331794,0.016187862778918483 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441061,1154.791138801295,0.2826013321423013 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441060,556.893931682752,0.03412962502454864 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441071,541.930195751438,0.04595876045970382 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441059,624.4651520379429,0.01560609724766815 +1017361 Sl10g086080 #2,log2-1,0.6,m_31,leaf,2441073,658.4524912265016,0.0386223345858987 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441054,91.4986151009143,0.11792211830328547 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441061,92.86421555335968,0.11148824455904527 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441060,136.6713214231243,0.05634075441612607 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441071,139.36689491134987,0.0648229850344837 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441059,103.41456728933412,0.06475491994804239 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,fruit,2441073,160.40540922841615,0.12588237052245033 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441054,3185.675113628583,0.10229575159264037 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441061,2330.4923084723614,0.033458057318579204 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441060,2242.8316537291885,0.050109054456644486 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441071,2787.2072380107625,0.04426352988522808 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441059,2578.24,0.010417610714476222 +1017361 Sl10g086080 #2,log2-1,0.6,m_32,leaf,2441073,2456.020991060929,0.010673656946889931 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441054,75.17340061480436,0.09566164928977172 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441061,39.03810282865992,0.1889138438644813 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441060,34.26563143822589,0.24554380826127908 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441071,45.45027088064038,0.12286607162283403 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441059,128.73817851776886,0.329304812564132 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,fruit,2441073,80.96660730254499,0.12790339410883367 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441054,2509.959533082582,0.09188817943093408 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441061,2374.6641385829885,0.06782365354156239 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441060,2142.869493623232,0.023217181995986103 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441071,1433.6202645700134,0.15134440895812107 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441059,1704.677410941631,0.07613633391810382 +1017361 Sl10g086080 #2,log2-1,0.6,m_33,leaf,2441073,1919.7723366584737,0.024528810846371485 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441054,412.1942161396312,0.020771581044058962 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441061,408.8488150375851,0.02431073118271687 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441060,452.5814692936483,0.019823293465978775 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441071,456.3850286489276,0.02345791473041592 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441059,395.7337143831771,0.03847042316604199 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,fruit,2441073,470.0700163025684,0.03628907577682039 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441054,54656.4849733383,0.04344283229231305 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441061,67036.17734500617,0.0452247106956305 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441060,70249.17638314825,0.06555670631491406 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441071,51433.17383862114,0.06984120593300425 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441059,56727.00075666491,0.027294708169805837 +1017361 Sl10g086080 #2,log2-1,0.6,m_34,leaf,2441073,64086.23776596717,0.025680246198547252 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441054,357.65056486217657,0.5368200834593364 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441061,59.61026920469683,0.2413177486906668 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441060,101.78312484043744,0.008963051829996349 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441071,106.0280164528405,0.008781804971508045 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441059,543.1059851719154,0.7182457570264575 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,fruit,2441073,90.08779118164364,0.06197289303701203 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441054,35178.47973443219,0.013856473723437901 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441061,42439.54455145844,0.06763717366132571 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441060,44000.95312714767,0.0833285431888866 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441071,29144.67143770967,0.09557437720741202 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441059,22334.13660388902,0.21116437275724564 +1017361 Sl10g086080 #2,log2-1,0.6,m_35,leaf,2441073,37459.46317083136,0.013428008363335131 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441054,2376.732863697342,0.007649290532966813 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441061,2545.85742718481,0.03750299790256406 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441060,2424.0647422934658,0.016213134066497492 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441071,2293.7424020273147,0.007786437779021771 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441059,1252.0688506970307,0.2707028695991518 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,fruit,2441073,1925.6512469374409,0.08375344558110509 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441054,24633.246645118295,0.02991856978892482 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441061,29460.4755463191,0.04779952775862473 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441060,31760.40386126534,0.08044579110654748 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441071,20524.17556919289,0.10917450404874973 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441059,17637.834679051037,0.1749949575107408 +1017361 Sl10g086080 #2,log2-1,0.6,m_36,leaf,2441073,28146.854820391705,0.027989647943697626 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441054,582.2213505324422,0.03611060752012163 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441061,595.879131763637,0.04618065649005798 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441060,554.6636208570948,0.015052162603827135 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441071,516.8742271973607,0.015592642244762533 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441059,372.02456237648425,0.15840590532287502 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,fruit,2441073,469.328415120615,0.05750067078091803 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441054,367.663861947794,0.023399434824331156 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441061,408.3694697648886,0.02220288665778547 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441060,616.7428123242083,0.20125371726636132 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441071,349.17136554066707,0.04581175819578576 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441059,334.7132373921984,0.0641774911736035 +1017361 Sl10g086080 #2,log2-1,0.6,m_37,leaf,2441073,526.6270515821492,0.13265278447233042 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441054,82.70275173077658,0.016208847427009232 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441061,121.9588626489196,0.15248455831329188 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441060,88.99270484543761,0.015625599621951425 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441071,14.368115136695655,0.7763290078116682 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441059,11.152753590301993,0.8863467003267689 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,fruit,2441073,153.44894395331724,0.2522350966309008 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441054,33.19838395978384,0.31001048202101655 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441061,98.48481504916192,0.16224184812625975 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441060,71.28164801141807,0.021850306378357942 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441071,95.44263837718565,0.14861501075555128 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441059,56.53818161777433,0.07878558894182186 +1017361 Sl10g086080 #2,log2-1,0.6,m_38,leaf,2441073,64.28642445036637,0.023008154143166593 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441054,124.90101546033364,0.16125529461784338 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441061,88.85444414451189,0.013368479723246729 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441060,83.3893523625627,0.01420007370444587 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441071,83.46753356344637,0.013793094197083411 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441059,18.36952220356823,0.6712128143059477 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,fruit,2441073,518.3998397655893,0.7793541839874185 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441054,1889.5819701847267,0.030433917274069522 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441061,1905.3374901119023,0.026827740779052256 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441060,4374.122182092617,0.3340912563350784 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441071,2302.05050217501,0.055315193253521855 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441059,2061.8429764693096,0.007455934035886624 +1017361 Sl10g086080 #2,log2-1,0.6,m_39,leaf,2441073,1991.6520951354016,0.007586176175809367 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441054,19.694950645827905,0.2876648070154939 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441061,50.92182527348251,0.12488425853099572 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441060,33.34906480113309,0.05893604423052934 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441071,43.04325519192908,0.05188540403182729 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441059,67.76347551266025,0.24897596852043935 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,fruit,2441073,32.34399570381479,0.0722260332111544 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441054,203.02673780319196,0.014336423474812676 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441061,98.76146217015648,0.29862930197120163 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441060,257.44710762607355,0.11747120392893518 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441071,203.57216142141135,0.015501574734317458 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441059,189.84140035966664,0.014825884256062682 +1017361 Sl10g086080 #2,log2-1,0.6,m_4,leaf,2441073,170.59606517827928,0.06124780315296796 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441054,171.47751840298324,0.04488353234250564 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441061,151.71313980607283,0.008300461033387663 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441060,131.3470741568606,0.07090325446435264 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441071,168.238101252833,0.03660070073080046 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441059,157.56815378841117,0.008144788959287386 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,fruit,2441073,107.30806516769242,0.15869129316179142 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441054,7780.898146255672,0.0025611060589469936 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441061,7756.602863117068,0.003919280194721875 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441060,8491.713617750811,0.03540450280314156 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441071,7553.9705090474545,0.015415551402234051 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441059,7872.939746470532,0.0025460912961450255 +1017361 Sl10g086080 #2,log2-1,0.6,m_40,leaf,2441073,8890.298536483342,0.05532550843948503 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441054,160.42609400042772,0.06299832104636982 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441061,144.79848189533772,0.01848732009990961 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441060,132.72944029683552,0.019309425496603527 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441071,116.64859697348868,0.0753971689775379 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441059,86.83540187744481,0.2035798699716036 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,fruit,2441073,220.5850369795212,0.2012993609271061 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441054,2139.0203522770894,0.029821641762159512 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441061,1855.1195308650613,0.03202137730231858 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441060,2208.5962456660386,0.0437230545461218 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441071,1775.475631557356,0.05107855906209968 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441059,1571.0243140228977,0.10421036857065635 +1017361 Sl10g086080 #2,log2-1,0.6,m_41,leaf,2441073,2496.359570011342,0.09691386527601775 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441054,45.26377348572766,0.004939483282697665 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441061,44.06044771379113,0.006762367631397481 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441060,44.610629214367165,0.0013729246605675982 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441071,49.419170916484475,0.04308418167285599 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441059,36.90810320713072,0.08368954711807985 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,fruit,2441073,44.89312851843725,0.001368598140715438 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441054,169.6007103410382,0.009583209624342892 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441061,177.168773627557,0.009376302461000297 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441060,158.73204883758967,0.03834625455656626 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441071,180.21689913849377,0.016784636317218826 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441059,145.54690530536706,0.07600790083456932 +1017361 Sl10g086080 #2,log2-1,0.6,m_42,leaf,2441073,184.74763068475715,0.027568000937206794 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441054,20.505083217658324,0.2332933335959606 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441061,650.7361791633354,1.2682500832380579 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441060,152.9481887994941,0.6393894687096777 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441071,49.67031171353505,0.1509420157241841 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441059,20.3398333177295,0.23680748014523467 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,fruit,2441073,0.3276240269187819,2.029779125708359 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441054,230.8379372723867,0.019268441990040408 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441061,214.76648859237568,0.05060911033389992 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441060,318.417924514164,0.12042188037512558 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441071,251.78240412726856,0.018449749195836418 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441059,262.4918054440216,0.03654012314072386 +1017361 Sl10g086080 #2,log2-1,0.6,m_43,leaf,2441073,194.44806078399856,0.0937720105455222 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441054,51122.428151153785,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441061,33794.81219317453,0.17976143593792493 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441060,54398.71779824203,0.026977190073084856 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441059,73827.27403935282,0.1596053598170002 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,fruit,2441073,112.73728214812398,2.656543912523001 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441054,457884.4313903272,0.07889575106559388 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441061,328365.0883072166,0.06550314936668311 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441060,456487.8974707156,0.07756914170191909 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441071,406959.151933112,0.027690693403426003 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441059,270647.3372108142,0.14945636758836933 +1017361 Sl10g086080 #2,log2-1,0.6,m_44,leaf,2441073,356683.40274721873,0.029577225045721356 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441054,62922.787248901535,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441061,43593.219337164584,0.15938900940197342 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441060,70562.4010046053,0.049765397945336076 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441059,78799.0739455742,0.09771316161684229 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,fruit,2441073,10888.259889459876,0.7618494736338262 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441054,116047.50502573542,0.1645023629411968 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441061,62304.97791490972,0.10561069838382675 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441060,106904.4205868592,0.1288622192227562 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441071,91250.59423710284,0.06010225653037704 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441059,49145.21539254555,0.20865220197193057 +1017361 Sl10g086080 #2,log2-1,0.6,m_45,leaf,2441073,67663.87453734806,0.0697765822631462 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441054,7994.342398871952,0.13201236461068833 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441061,5898.8911260548575,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441060,4404.542973776813,0.1268695289877395 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441059,4752.370631029001,0.09386007726919265 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,fruit,2441073,15277.255343350613,0.41327495685686566 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441054,44229.930617324986,0.012455924477545288 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441061,18865.028821080552,0.35760286059119206 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441060,64779.47276742957,0.17817707539356498 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441071,43371.70158640213,0.003946127379680142 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441059,38045.05014095465,0.0529621728134293 +1017361 Sl10g086080 #2,log2-1,0.6,m_46,leaf,2441073,42587.09549469051,0.003982312089679141 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441054,253.20170538396513,0.4177297279506418 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441061,216.19107805676833,0.3491008686825323 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441060,90.61795221599668,0.02852265472909088 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441071,93.0436364915474,0.017050222602201792 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441059,100.49465111254489,0.016406048291327524 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,fruit,2441073,82.02190978272561,0.0718070213984976 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441054,442.3289504559683,0.007815286523070064 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441061,388.40066694854977,0.06428068442996526 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441060,609.7278579073296,0.1315753865698639 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441071,536.0928485325163,0.0756793623621288 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441059,454.64,0.004106991614237554 +1017361 Sl10g086080 #2,log2-1,0.6,m_47,leaf,2441073,446.0817441432345,0.004146201281219675 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441054,136.71756816296676,0.2530680177841236 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441061,128.46608616533828,0.22603218608322728 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441060,52.24782690616549,0.16468807510481276 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441071,60.865652857288545,0.09838402236069022 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441059,62.07378918065943,0.08984805016398423 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,fruit,2441073,90.60767030673291,0.07440865695312326 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441054,4652.359543383384,0.08470392779468972 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441061,3474.7024056157957,0.04205172774901467 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441060,3092.3776587095717,0.09267681568786523 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441071,3719.9103081198377,0.012436874077134341 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441059,3936.044096988596,0.012090612671725953 +1017361 Sl10g086080 #2,log2-1,0.6,m_48,leaf,2441073,4098.937449992092,0.029701948329768246 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441054,30.923363649981567,0.015653915975978094 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441061,32.67530356506923,0.00827898739226307 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441060,32.71429082366967,0.008796866526989966 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441071,34.0849329978406,0.02662180099709377 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441059,24.85511450287834,0.11052487543430356 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,fruit,2441073,31.44131930868531,0.00843988245426508 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441054,29.99668965388348,0.017620417233579877 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441061,35.11959692642221,0.05085577565047128 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441060,31.664123534612933,0.005873724084201504 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441071,30.41809074494109,0.011561795969348587 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441059,30.813390797145136,0.0059542551378719555 +1017361 Sl10g086080 #2,log2-1,0.6,m_49,leaf,2441073,35.980719732117414,0.06137609926631793 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441054,650.957466351773,0.0373201205644178 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441061,767.7822574231351,0.034365338644704924 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441060,775.8554150598471,0.0389080624240461 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441071,575.1595139567454,0.09108442516444049 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441059,515.7725527208366,0.13841450613673878 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,fruit,2441073,933.1817308133076,0.1190934946879576 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441054,24554.295687625676,0.006240394703949548 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441061,6816.092782122631,0.550351593184355 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441060,21697.88669584568,0.04746964966620748 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441071,28627.032949516288,0.07288925118419698 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441059,23853.69789573611,0.00633137202888534 +1017361 Sl10g086080 #2,log2-1,0.6,m_5,leaf,2441073,31151.73258495792,0.10959511939541766 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441054,155.26068676116594,0.07987092207960922 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441061,127.04710402516616,0.007225810782284459 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441060,109.75545803747782,0.07076445424289446 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441071,131.31010030655088,0.007107552329148614 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441059,185.92116734815625,0.15813825677783422 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,fruit,2441073,124.55355359061164,0.01583445801534955 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441054,7504.517298771063,0.11596226514697205 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441061,4103.791821963763,0.14617517621331189 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441060,11245.851581317163,0.291631849657922 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441071,6556.58656872542,0.05731730182144501 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441059,4935.277850572787,0.06604888990863822 +1017361 Sl10g086080 #2,log2-1,0.6,m_50,leaf,2441073,4881.7643970407335,0.07078368215801412 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441054,37.15849689535065,0.01954757953522046 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441061,38.97407494897534,0.001170098496059202 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441060,41.084442759798854,0.02407168339518373 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441071,38.7643456990692,0.001173259554119399 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441059,21.633551190083313,0.25447790190604525 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,fruit,2441073,40.95500987419821,0.022701317483961425 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441054,249.042721247528,0.0011957242096398701 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441061,265.89051861500053,0.02723327373683304 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441060,250.41596793226043,0.0011924411110455502 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441071,224.79788934532036,0.04567734809954649 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441059,233.69828456758404,0.028814052851347416 +1017361 Sl10g086080 #2,log2-1,0.6,m_51,leaf,2441073,357.04011264203183,0.15524743347530112 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441054,157.57026672656522,0.05115603858431683 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441061,184.38080764697224,0.017085404242759505 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441060,181.78043784722365,0.010916836405608255 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441071,172.75553267164565,0.011198343758840767 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441059,138.8634364281587,0.10604240029038259 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,fruit,2441073,273.5893724467459,0.18846891449741143 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441054,1575.89728809875,0.013229003708625342 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441061,1588.209847324527,0.00984902743638294 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441060,2361.040115863918,0.16234645426304173 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441071,1496.25402467219,0.035751580276008 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441059,1717.0718700402942,0.024031561570726723 +1017361 Sl10g086080 #2,log2-1,0.6,m_52,leaf,2441073,1661.0684329731855,0.009630613084853579 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441054,95.44041810540936,0.0642078000682127 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441061,57.48330769086914,0.15598278290425993 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441060,71.8937577574242,0.05883334915929561 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441071,92.7535102353805,0.051805821217808745 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441059,38.04057039035521,0.33527751291530983 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,fruit,2441073,248.2344532166425,0.47933752524582407 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441054,276.17077061439994,0.04279939973386071 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441061,91.12066163860212,0.5243602469628321 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441060,333.376101704395,0.038957352396313816 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441071,365.0145567766726,0.07833307294892977 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441059,270.4546317542842,0.05188268802627727 +1017361 Sl10g086080 #2,log2-1,0.6,m_53,leaf,2441073,448.0186748016125,0.1673190055980589 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441054,539.4712070296926,0.07935991537791498 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441061,454.7356575001703,0.005150655330084852 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441060,444.01319833465186,0.005212475091092905 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441071,414.6272815083327,0.03495048058021677 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441059,347.80470252290354,0.11127290522079081 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,fruit,2441073,641.6895213513299,0.15471659257331494 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441054,9951.071893612096,0.071726597701117 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441061,5878.320599257813,0.15688999771883783 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441060,9928.21307849946,0.07072782318225013 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441071,8529.067808081503,0.004758300965213458 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441059,6652.485526715902,0.10315932783673754 +1017361 Sl10g086080 #2,log2-1,0.6,m_54,leaf,2441073,8343.192294618551,0.004811012845194806 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441054,53.32674437418255,0.008581994944009352 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441061,102.84070935789634,0.29380198794547474 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441060,144.8402032769979,0.44252605001760714 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441071,34.72835095611777,0.17767891391608281 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441059,35.74402717484195,0.16515959402799685 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,fruit,2441073,51.2398759019919,0.008755006386604869 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441054,283.726976751135,0.3595892968749834 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441061,101.49581576064348,0.08686319507825102 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441060,208.73541661848105,0.22628480947332763 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441071,115.1951136107306,0.031877276175686475 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441059,132.7418791100228,0.029696627686150112 +1017361 Sl10g086080 #2,log2-1,0.6,m_55,leaf,2441073,109.78863517798467,0.052753947344417185 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441054,79.64965365232345,0.2752247378647341 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441061,175.21400368284523,0.06716018394636158 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441060,125.005308194181,0.07948017435263477 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441071,324.89112506353973,0.3353292185129306 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441059,60.65245666633885,0.3935602333075914 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,fruit,2441073,214.8716186782043,0.1557704259600965 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441054,2611.18112789971,0.029815032805990516 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441061,476.6760975185409,0.7087985902724663 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441060,2264.687110948709,0.032013757060100456 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441071,1289.598174715708,0.2765675556854905 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441059,5480.034921914801,0.351761360614963 +1017361 Sl10g086080 #2,log2-1,0.6,m_56,leaf,2441073,3814.538628654013,0.19442005176878396 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441054,144.38437528306616,0.004020434221284841 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441061,152.11180609594288,0.018622290616936432 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441060,149.42759612150996,0.010890177572350446 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441071,122.99924642848518,0.0736381816500673 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441059,130.362456888609,0.04838809549069811 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,fruit,2441073,147.07003268873592,0.0039835566155694835 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441054,130881.8019736375,0.3097436413357313 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441061,68003.40535229421,0.0253950366933422 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441060,59217.36225201338,0.034686565883659704 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441071,60278.564458837216,0.02697272338469059 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441059,40031.64852261881,0.20473214944597729 +1017361 Sl10g086080 #2,log2-1,0.6,m_57,leaf,2441073,84097.53700958466,0.11764765229234797 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441054,262261.13667955325,0.18620250156292428 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441061,479462.63602084294,0.4482233311365462 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441060,232356.7056764866,0.1336237728638645 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441071,85806.08804213691,0.29901333497014093 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441059,55680.42354228882,0.4868289074652292 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,fruit,2441073,109277.5675863888,0.19400041814527746 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441054,356300.7938032956,0.08911636584567528 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441061,237121.16955875143,0.08773009568582602 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441060,347092.6667051618,0.07774501402138778 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441071,304587.83448936045,0.021012129164214244 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441059,262471.62916456134,0.04361805714209854 +1017361 Sl10g086080 #2,log2-1,0.6,m_58,leaf,2441073,275816.1961288334,0.02208065939368442 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441054,1704.5529056813416,0.37360811714322617 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441061,977.5609977880828,0.1321414977885098 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441060,602.9183565575639,0.07774386153168411 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441071,621.720617013706,0.06440709886246765 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441059,820.502205758922,0.05607738470208057 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,fruit,2441073,603.9423371496698,0.07700689291590068 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441054,1357.6038518348423,0.032872257371647784 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441061,827.6781994571974,0.2477838025807899 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441060,1673.8687449314089,0.058076081264084145 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441071,971.2467565074865,0.17831573739777395 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441059,1571.0990299043533,0.030558241583925394 +1017361 Sl10g086080 #2,log2-1,0.6,m_59,leaf,2441073,1634.6908562992023,0.04779031451260929 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441054,83.35445127431933,0.12856210736433393 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441061,101.98006292838286,0.040975628617193394 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441060,122.16072789694344,0.03744070757083939 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441071,85.73262589979836,0.11634477832507062 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441059,229.13391179857288,0.31059846525406964 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,fruit,2441073,129.7353069656141,0.0635672795083817 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441054,157.654352941282,0.02817308586692846 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441061,103.27189127175568,0.15555074998727791 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441060,116.13253991508842,0.10457895601786227 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441071,145.87,0.0055668975864389125 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441059,149.63366812592935,0.005496441838692245 +1017361 Sl10g086080 #2,log2-1,0.6,m_6,leaf,2441073,207.36810543635875,0.1472090793315015 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441054,56.26018601424694,0.12319358875428921 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441061,41.73080718550854,0.006550789783653643 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441060,50.29049028082557,0.07447829457408739 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441071,42.99926387925889,0.006453445796598789 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441059,22.090283243059087,0.2828062905348916 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,fruit,2441073,28.21793941205705,0.17648227835583596 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441054,93.85431260654444,0.04865962240445887 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441061,124.05292008323822,0.07249313593595241 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441060,155.3788818330487,0.17027813611526854 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441071,62.75657427989707,0.2234546271135236 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441059,116.10921043690212,0.043752816134976946 +1017361 Sl10g086080 #2,log2-1,0.6,m_60,leaf,2441073,56.137440327192,0.2718612492298693 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441054,127.56050850532142,0.07277407365636757 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441061,119.6239292656734,0.04487589531996061 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441060,89.68447120721814,0.08022491636360729 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441071,96.13668200611224,0.05005303906638381 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441059,138.29128884309927,0.10785265598604887 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,fruit,2441073,93.47526869804253,0.06224544595983805 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441054,860.0260665586833,0.015679351143151443 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441061,1107.2480251977704,0.09405394875121154 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441060,882.0842953458895,0.004680875676863039 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441071,901.2015454005036,0.004630962158179042 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441059,728.2950777261686,0.08788359090177211 +1017361 Sl10g086080 #2,log2-1,0.6,m_61,leaf,2441073,1139.5408027455112,0.10653891464335707 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441054,1388.610615078159,0.08049208734824065 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441061,1219.356416847626,0.024042274583471634 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441060,1088.0196794682267,0.025451642800830676 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441071,812.5770786842087,0.15222382599168638 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441059,963.4557840863852,0.07825660514512967 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,fruit,2441073,2235.286928651637,0.28724488498852363 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441054,1238052.1383728872,0.05298002068302399 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441061,1028900.648532936,0.027385472963552537 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441060,869273.829984676,0.10060230880557786 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441071,1162838.7250122654,0.02576057234365159 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441059,777909.2660899205,0.14882996929728076 +1017361 Sl10g086080 #2,log2-1,0.6,m_62,leaf,2441073,1390222.1343305907,0.10332528489073667 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441054,287.9967303094517,0.39057690791876487 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441061,724.3117230624648,0.009961049295374558 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441060,644.1634221350046,0.040968404649252665 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441071,691.463999064818,0.010194891486350333 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441059,1211.713286963257,0.23343540507894245 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,fruit,2441073,1651.378238318653,0.36788209214782075 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441054,9005.529504142592,0.021557806877885 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441061,4361.079330923149,0.2933574596818711 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441060,9251.692806570569,0.033269757482020434 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441071,9821.20747502072,0.05921343916787336 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441059,8133.311196797567,0.022684056935687202 +1017361 Sl10g086080 #2,log2-1,0.6,m_63,leaf,2441073,6922.639397371988,0.09267973687744124 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441054,1257.7033297002624,0.1734178529314927 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441061,727.5961707964674,0.06426995297119698 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441060,500.1991834000132,0.2270173793696766 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441071,595.8606646403813,0.15101564105808363 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441059,1003.8139446492185,0.07549286670489153 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,fruit,2441073,959.6962411592808,0.05597343604915661 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441054,4947.20076960726,0.01096422237528527 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441061,3362.987238704689,0.1566700937571004 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441060,4445.971784871871,0.035428610845485764 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441071,4700.532960001709,0.01124821079753513 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441059,5638.68082250118,0.06778219895959081 +1017361 Sl10g086080 #2,log2-1,0.6,m_64,leaf,2441073,5946.265329875516,0.09084897098244626 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441054,90.14778784799688,0.11091799412488101 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441061,50.79804297978684,0.1381900986452762 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441060,54.83385960745214,0.10498826406129447 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441071,112.03052589541444,0.2052992948112562 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441059,84.82454466109428,0.08448445718915742 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,fruit,2441073,41.10136811049518,0.230180801685415 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441054,2925.7838876800447,0.18804189794937454 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441061,1876.612070947789,0.004825840452836516 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441060,2206.468885372992,0.06549746163424652 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441071,1592.431621733806,0.07613955296104002 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441059,1918.55012779456,0.00477280494233101 +1017361 Sl10g086080 #2,log2-1,0.6,m_65,leaf,2441073,1638.8090637570117,0.06367198872853619 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441054,1403.2729767951912,0.19098423533532882 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441061,846.8874639473863,0.028332222360107462 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441060,757.4229949051451,0.0768194407263243 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441071,785.8387805686879,0.060824469510255774 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441059,968.0293664067468,0.029730605756099315 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,fruit,2441073,961.0688082963312,0.026596555725223237 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441054,3454.32899322949,0.028596321796902302 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441061,2782.262572331867,0.12256190601919803 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441060,3588.4011406769887,0.012059033517041406 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441071,3790.471512738978,0.011733217477071012 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441059,4173.998568756746,0.05359227623827545 +1017361 Sl10g086080 #2,log2-1,0.6,m_66,leaf,2441073,4431.903020088462,0.07963022891977989 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441054,1176.483926718219,0.3793766127799998 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441061,622.7055925204852,0.10307338075584749 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441060,476.17647349421384,0.013441451021393824 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441071,492.5019670196934,0.0011985839971151435 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441059,489.7872599464902,0.0012019010558130816 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,fruit,2441073,477.8764263245909,0.011893778108938324 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441054,2438.4298806091574,0.02570867950147715 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441061,3353.867382789878,0.11272693486616792 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441060,3077.599392378904,0.07539313650041057 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441071,2047.2020228292072,0.1016582490507334 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441059,1751.1154509680412,0.16950417100979198 +1017361 Sl10g086080 #2,log2-1,0.6,m_67,leaf,2441073,2735.8384479121883,0.024271497530623076 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441054,206.46512783357167,0.051119140040056354 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441061,183.3984292859387,3.3195753525561145e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441060,179.68866145831106,0.009206895834902085 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441071,196.36499916874735,0.029336510703354524 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441059,183.6789014832284,3.317039938219857e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,fruit,2441073,140.2776641620082,0.11673904377304689 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441054,1263.97543486699,0.06504377771185954 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441061,855.7046311002139,0.1043709734711804 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441060,1318.1152404652755,0.08325852562795388 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441071,1119.4911040144543,0.01232579094510955 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441059,1037.6820917246548,0.020630534119958632 +1017361 Sl10g086080 #2,log2-1,0.6,m_68,leaf,2441073,1056.8394113332558,0.012685855396220358 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441054,86.85921657602967,0.0025975103190358784 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441061,126.00320286994456,0.16416318695102627 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441060,85.82330958023667,0.002613139523448993 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441071,67.35417383670581,0.1078538841516008 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441059,97.23638045506966,0.05161038659498929 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,fruit,2441073,20.609521231639217,0.6221504945773468 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441054,105.75078746634186,0.28547333766302385 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441061,210.58266732975716,0.013665674676464068 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441060,140.90741401290143,0.1608231030311278 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441071,396.86008339047066,0.2888804716349478 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441059,214.66800212272864,0.022010366739835696 +1017361 Sl10g086080 #2,log2-1,0.6,m_69,leaf,2441073,197.53645435281703,0.014109693460496064 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441054,117.0902672417613,0.2963435527588738 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441061,92.89170198384748,0.19579967574022672 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441060,55.10202901504263,0.031009653341123267 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441071,63.2585933542996,0.028942286067252354 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441059,20.375836936156535,0.46306178806256115 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,fruit,2441073,48.52043949679435,0.0862525184183931 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441054,366.3072872866844,0.0018788251268406775 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441061,97.3188553849832,0.5737697411045228 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441060,496.8584357188962,0.13426593427778588 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441071,314.6805315832312,0.06409685829963507 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441059,436.78688233276705,0.07830285363562206 +1017361 Sl10g086080 #2,log2-1,0.6,m_7,leaf,2441073,363.144729070587,0.001886988544042456 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441054,506.01061383287333,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441061,404.0407586393407,0.09773444860432079 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441060,1027.1800043589406,0.3074869301105232 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441059,345.1378724173861,0.16616700889366642 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,fruit,2441073,1442.6933447224774,0.45501440187211095 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441054,594269.13968468,0.047598262368564015 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441061,493743.308106939,0.03288369310787154 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441060,379439.55071879225,0.14724231821094325 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441071,642397.7801544535,0.0814191159195472 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441059,571416.8446730928,0.030568123086127663 +1017361 Sl10g086080 #2,log2-1,0.6,m_70,leaf,2441073,462320.7151421661,0.06144156237348408 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441054,140.9027829330392,0.021832197315929225 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441061,122.6888862601795,0.03828214945217656 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441060,127.08646453128787,0.02298807545511039 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441071,119.47444024720136,0.04981236903860076 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441059,148.51798862776732,0.04469168545206159 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,fruit,2441073,194.1943812118628,0.16114928643713666 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441054,2158.3371681407943,0.023837761158647552 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441061,2023.582797370934,0.051836072039765035 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441060,3437.0851848691686,0.17823324502195748 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441071,2189.125434147428,0.017686404010910817 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441059,2371.107707232299,0.016994231369654944 +1017361 Sl10g086080 #2,log2-1,0.6,m_71,leaf,2441073,2503.7656195964787,0.040636620808960355 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441054,74.3403658662615,0.05833200834847663 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441061,104.407797571109,0.08917623214524228 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441060,94.99740784417097,0.048155052538107146 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441071,75.0565319806773,0.054168208717186195 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441059,58.31212472526687,0.16379783634972678 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,fruit,2441073,145.556636939354,0.23347531023743073 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441054,365.6631578136378,0.09940203184017182 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441061,491.6210742059787,0.029147254128255362 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441060,703.8786226358236,0.185014538242676 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441071,374.26979199793107,0.08929846146157017 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441059,427.7974148454122,0.03124508145804672 +1017361 Sl10g086080 #2,log2-1,0.6,m_72,leaf,2441073,549.3074703865713,0.07733226802677873 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441054,79.41998426277236,0.012071515312619185 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441061,75.0657128765436,0.012416668039864964 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441060,67.74278913359268,0.0569952077336453 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441071,82.20101457520457,0.027018896542346793 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441059,85.57610400436228,0.044494229254478546 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,fruit,2441073,58.1714970572956,0.123148040745092 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441054,1632.9739245069948,0.05141123810418158 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441061,1639.358944092853,0.04971643356963984 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441060,2446.4210955137028,0.12414072497212736 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441071,1853.494930302376,0.0036009144427069373 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441059,1822.8858221165635,0.0036310209066434673 +1017361 Sl10g086080 #2,log2-1,0.6,m_73,leaf,2441073,1987.4291840485307,0.03390117481263477 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441054,238.7840273618749,0.16514139778822612 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441061,166.88752439145065,0.00955999738490343 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441060,159.92740992245405,0.008940971243459384 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441071,161.51410897462773,0.004653409125876085 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441059,164.99392408439266,0.004604076574699523 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,fruit,2441073,157.97388385810206,0.014278579400319291 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441054,773.3821311744542,0.03616659687078361 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441061,677.8479401312753,0.09342844980523779 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441060,836.2206580169159,0.0022398382753054946 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441071,993.3955835291498,0.0725614944183457 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441059,920.9750828601796,0.03968714999921108 +1017361 Sl10g086080 #2,log2-1,0.6,m_74,leaf,2441073,844.8684182274611,0.0022283457390392947 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441054,157.42976804236451,0.038901857654884076 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441061,144.54500352952752,0.0018180861545578075 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441060,125.72530669109112,0.058762294203203336 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441071,143.33731622208197,0.0018257292124586044 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441059,156.15262680257203,0.03536429643372907 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,fruit,2441073,109.60485989341078,0.11835518665650868 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441054,8181.839673314555,0.01722118799953032 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441061,10993.771386559012,0.11107454859310417 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441060,8443.796525474509,0.0035343937138447856 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441071,8581.792610372246,0.0035058620032661914 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441059,8147.868874142052,0.01902812189136105 +1017361 Sl10g086080 #2,log2-1,0.6,m_75,leaf,2441073,9836.305969464953,0.06275987644259073 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441054,57.02726053343664,0.14653931293276923 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441061,102.80035420631653,0.10937278860697841 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441060,21.103236941156464,0.5782727473473779 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441071,55.701323371332784,0.15675630903398674 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441059,126.91114755900324,0.20087794866642827 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,fruit,2441073,150.03255407855298,0.273563680091538 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441054,363.321245491792,0.3665973978701471 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441061,163.5634875343011,0.019992965655248884 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441060,256.82118895574877,0.21593745576999535 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441071,114.59378717971526,0.1345323238953262 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441059,114.27548996348222,0.1357403044112182 +1017361 Sl10g086080 #2,log2-1,0.6,m_76,leaf,2441073,148.84540844515112,0.02095795428618441 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441054,586.8888655207692,0.05503148587683038 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441061,721.1585242818803,0.03444338533778035 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441060,640.7839149868281,0.016875754500716322 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441071,691.5630951460572,0.016244453336957676 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441059,559.9230025593187,0.0754590466219196 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,fruit,2441073,755.633437550415,0.054723811632720665 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441054,16888.46269152819,0.015304871904769257 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441061,15396.279761673097,0.024869452937550385 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441060,17364.342582953686,0.027373098612575752 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441071,14231.639165286915,0.05903032294223998 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441059,15718.867594086752,0.015863991141028322 +1017361 Sl10g086080 #2,log2-1,0.6,m_77,leaf,2441073,19259.354150910403,0.07235647238790044 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441054,64.50635005437843,0.0019134229592603358 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441061,65.0760106726698,0.001905029729218466 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441060,61.90013179555487,0.019824318274086483 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441071,67.96188426700759,0.020749519350790724 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441059,61.74885419681709,0.020886988681286356 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,fruit,2441073,66.7192552561272,0.012735297928942124 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441054,97.36108592164382,0.006972686076164081 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441061,106.70776193367,0.032837915949157415 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441060,100.51262149705856,0.006862504838425432 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441071,95.7911735244262,0.014032601476610784 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441059,97.02251684788348,0.00848555883985247 +1017361 Sl10g086080 #2,log2-1,0.6,m_78,leaf,2441073,112.99016964163155,0.05768256543604067 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441054,135.98790349102174,0.05189960435419616 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441061,125.33712534339152,0.01647905575170805 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441060,109.17097549235471,0.04349348306842904 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441071,121.9282361342628,0.004503617147493699 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441059,104.91617573729756,0.06075822211945425 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,fruit,2441073,119.41252033689344,0.0045508092929371635 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441054,257.7510035892593,0.0014877734468630166 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441061,259.52,0.0014826941395895687 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441060,254.90160700017276,0.006315564950029273 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441071,257.5288435124599,0.001862260832597773 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441059,266.1032480859962,0.01236203723926943 +1017361 Sl10g086080 #2,log2-1,0.6,m_79,leaf,2441073,286.2040663941034,0.043987661542328915 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441054,79.93430912511752,0.06464264140772302 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441061,57.82488068651589,0.07597583894531068 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441060,47.38646051340186,0.16243631358590682 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441071,41.922678864360606,0.21564155795005657 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441059,89.10099165005334,0.11179195326347768 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,fruit,2441073,85.7189752529643,0.0949863862449174 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441054,466.9035896967432,0.008236979546844214 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441061,606.374822368635,0.12175092702716084 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441060,449.35957815069094,0.0083962302230427 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441071,345.59217684733534,0.12242633056894636 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441059,391.6200665297555,0.06812529652574861 +1017361 Sl10g086080 #2,log2-1,0.6,m_8,leaf,2441073,511.03383116561054,0.047459418613295945 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441054,46.749560156813395,0.001309399997465599 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441061,47.03188585691972,0.0013054640140743867 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441060,44.34485007062135,0.02424373827402193 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441071,51.07986989016496,0.03716285319870849 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441059,46.11890967508062,0.0072078978394345405 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,fruit,2441073,52.36771529952206,0.047976697734195106 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441054,152.2851092161066,0.04006602564403572 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441061,137.6646951094652,0.0037688362099230766 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441060,167.6147771935196,0.0817208906284086 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441071,134.84322567093068,0.012762280458261444 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441059,126.28995561555053,0.0412226028501439 +1017361 Sl10g086080 #2,log2-1,0.6,m_80,leaf,2441073,140.06441917212135,0.0037364111850366477 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441054,919.5421873020532,0.3637337160128502 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441061,535.9369806320552,0.12927578235302173 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441060,343.3814470225055,0.06406111640885026 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441071,294.7375146192096,0.13040252583727918 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441059,452.5358418067655,0.055815039117253384 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,fruit,2441073,298.0326095269949,0.12557415741023448 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441054,6979.843974316009,0.03660494859305796 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441061,6193.392977989959,0.015312128654538348 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441060,5576.073276760316,0.06091229371412821 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441071,5963.090222737775,0.03176938567143717 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441059,8394.601211928724,0.11675930364475873 +1017361 Sl10g086080 #2,log2-1,0.6,m_81,leaf,2441073,6637.910054820918,0.014790597295692098 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441054,6209.140029445376,0.03510426553203372 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441061,6191.257453229817,0.03385167511028264 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441060,5767.37682885374,0.0030511395719359236 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441071,5686.623318431528,0.0030727271319248572 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441059,4281.986384918474,0.12628190662784888 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,fruit,2441073,4448.404078383047,0.1097229584508903 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441054,174272.6567779625,0.13134457299285796 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441061,131753.22379906016,0.009876571482421603 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441060,88498.9165775155,0.16294672504590135 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441071,125828.28021888951,0.010106418206608403 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441059,96551.86605326532,0.1251240072661597 +1017361 Sl10g086080 #2,log2-1,0.6,m_82,leaf,2441073,221601.13124663496,0.23568729403097066 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441054,551.841501451112,0.3190050648555398 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441061,783.5878627132315,0.47127840662601495 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441060,230.25848643992535,0.06059364821459434 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441071,246.74677546258783,0.03055780786890816 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441059,274.82265066901914,0.01624323027751462 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,fruit,2441073,254.64482769110433,0.016874434523297843 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441054,2224.351914897743,0.10372657349605596 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441061,2875.3235032729385,0.007756642733957708 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441060,2773.5268176234813,0.007897702117325434 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441071,2304.3420730899957,0.08838312227794809 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441059,3341.942098432769,0.07306884954880655 +1017361 Sl10g086080 #2,log2-1,0.6,m_83,leaf,2441073,4283.748212494788,0.18089386460999268 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441054,545.2261856199764,0.001376583091188266 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441061,548.688075857219,0.0013722335193762092 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441060,245.3834840724326,0.348107960158754 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441071,287.8241800265561,0.27882601256152295 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441059,608.1674433863241,0.04606987899034465 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,fruit,2441073,834.5679464342962,0.18350841193491352 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441054,451944.0306792525,0.16439313297841807 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441061,48654.74673267409,0.8035663053617261 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441060,139525.74504815982,0.3460371713174224 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441071,175725.538055117,0.2458566398250417 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441059,443318.46,0.15602429432823772 +1017361 Sl10g086080 #2,log2-1,0.6,m_84,leaf,2441073,461760.36147615034,0.17372512780407678 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441054,85.57386012060017,0.27457244830055383 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441061,54.247177015513,0.07660846816802303 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441060,43.75376604746442,0.016753234275261653 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441071,44.04632630915789,0.013858982706499878 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441059,46.902829067691776,0.01343036455608182 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,fruit,2441073,35.18775274966473,0.11137714286983091 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441054,789.1769094447176,0.06994857650499009 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441061,465.6073105521253,0.1592060026220663 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441060,554.9783456340141,0.08294975524504933 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441071,555.3706256250604,0.08264288768003958 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441059,788.1854243606117,0.06940260612342586 +1017361 Sl10g086080 #2,log2-1,0.6,m_85,leaf,2441073,886.4844973791511,0.12044535194589034 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441054,1694.4973332256857,0.24487953157471143 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441061,1038.0955294224725,0.032075962636350486 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441060,867.1458333696194,0.04606921645962281 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441071,884.71379116090975,0.03735856088755751 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441059,1333.836019017823,0.14094108285185314 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,fruit,2441073,890.2788544772244,0.034635299791367036 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441054,27130.626690346035,0.05003556373239082 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441061,14129.493925040912,0.23329765487707377 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441060,28224.55007314785,0.06720276566132011 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441071,19885.577315583716,0.08488605802541649 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441059,23650.26818137323,0.009588192144756036 +1017361 Sl10g086080 #2,log2-1,0.6,m_86,leaf,2441073,24706.164799612536,0.00938107209108896 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441054,240.59360357595375,0.09913566765827397 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441061,350.59675265833147,0.0643881445410539 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441060,285.112216979692,0.025403917551284128 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441071,294.25345756045783,0.011698170030838284 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441059,347.3474584869021,0.060344380866635294 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,fruit,2441073,310.32092404409735,0.01139131513670888 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441054,41690.68590083422,0.09447882252034034 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441061,10548.865033177386,0.5023544819269459 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441060,31933.99721366352,0.02130693467521283 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441071,29181.553405836337,0.06045181100075947 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441059,35145.56404633642,0.02031029990452904 +1017361 Sl10g086080 #2,log2-1,0.6,m_87,leaf,2441073,48693.867021180966,0.16191404765489192 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441054,62.62729362472669,0.22554429620531735 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441061,119.2801718798008,0.05426031553858213 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441060,95.0143352491545,0.0445188064790254 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441071,92.00481236822075,0.0584973967352127 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441059,115.52727317088883,0.040376581950044343 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,fruit,2441073,223.8880202288304,0.3277229153133705 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441054,1703.601702620156,0.0016969615674669036 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441061,1475.9948915440464,0.06398017262830535 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441060,1716.9410478800737,0.0016903566621637722 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441071,1564.168162427669,0.038781585138639496 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441059,1918.2944377650156,0.04985024051471321 +1017361 Sl10g086080 #2,log2-1,0.6,m_88,leaf,2441073,2274.623198917579,0.12384443719522498 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441054,12891.3947627198,0.060683027004109213 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441061,11210.290854585925,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441060,7338.336058986854,0.18401928426609793 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441059,6267.459125963299,0.2525253703180992 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,fruit,2441073,12704.4452372802,0.054338824891033255 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441054,162283.9825163263,0.023279695447635085 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441061,117309.41,0.16422250183788556 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441060,138519.44743956497,0.09204460191739194 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441071,185705.7238228873,0.03526993739544704 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441059,278285.57218574744,0.21093533838851375 +1017361 Sl10g086080 #2,log2-1,0.6,m_89,leaf,2441073,180156.6953263418,0.022095054459808416 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441054,26.49358636854137,0.3239774931533872 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441061,118.1639701058991,0.32536682934032957 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441060,55.86222693426837,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441059,39.40394012869036,0.15157859423455422 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,fruit,2441073,76.41123797703067,0.13603899120899876 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441054,137.2917540384443,0.007242342679669278 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441061,146.60730338739927,0.02126880937092368 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441060,141.90913185006914,0.007123546917770174 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441071,133.69638397070082,0.018767135038513683 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441059,133.86875287501485,0.01820757877319812 +1017361 Sl10g086080 #2,log2-1,0.6,m_9,leaf,2441073,153.39082080814708,0.040912575120454875 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441054,87.05485644071626,0.09595966438253689 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441061,69.56241799597574,0.001458669582336647 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441060,70.03048369881942,0.0014537867285238093 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441071,62.613575996605725,0.04716483130145965 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441059,19.453403391067845,0.5548377467574843 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,fruit,2441073,295.9437626860687,0.6273758519180714 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441054,3688.3677886677106,0.01407824462440388 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441061,1130.494611009285,0.5276439687673307 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441060,4401.153888877288,0.06265408898333558 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441071,3931.412709487392,0.01363617211766499 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441059,3344.847373313223,0.056536159671656705 +1017361 Sl10g086080 #2,log2-1,0.6,m_90,leaf,2441073,4380.977294642483,0.06065853715793912 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441054,408.48249646689584,0.0643910156841363 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441061,489.8262003669446,0.014477544063888015 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441060,535.0790046676269,0.052853443169995185 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441071,403.0364314273256,0.0702201625381429 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441059,695.7414803312104,0.16688342953556212 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,fruit,2441073,457.70705890337007,0.014976857064784355 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441054,748733.0312040838,0.05419512615626676 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441061,1022470.8771105732,0.08112882780995889 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441060,660708.1779239221,0.10851243677186861 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441071,603607.7343880711,0.14776732308397555 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441059,947760.135776345,0.048176318566328646 +1017361 Sl10g086080 #2,log2-1,0.6,m_91,leaf,2441073,1094593.0025011844,0.11073054836472096 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441054,37.25504351220197,0.44024967467656206 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441061,154.67442103216663,0.17798374942380635 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441060,116.04222845882424,0.05318131069483778 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441071,42.50988605724158,0.38294480875341463 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441059,89.2936049793842,0.06061439290393622 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,fruit,2441073,236.9342762099924,0.36319314303916483 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441054,53940.64610043887,0.33476521027527184 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441061,132675.9672068656,0.05611090791906381 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441060,124138.96759520155,0.027226774845972024 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441071,114910.16616863072,0.00632290172648009 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441059,74918.95508356702,0.19208964288348618 +1017361 Sl10g086080 #2,log2-1,0.6,m_92,leaf,2441073,118280.60038748028,0.006232165923056421 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441054,62.357155614381135,0.23464112634625955 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441061,145.53160496584354,0.6027121483703917 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441060,296.7707739446466,0.912175958759968 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441071,10.299460313766742,0.5474307020286202 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441059,3.7148735146919254,0.9903011391920664 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,fruit,2441073,9.720546269115031,0.5725544987116524 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441054,72.38951823506954,0.10552489193083225 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441061,53.61990224240298,0.02482477654157167 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441060,181.91277877413447,0.5057124134920545 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441071,10.628528530952623,0.7276776517145764 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441059,59.9284379027074,0.0234821631036497 +1017361 Sl10g086080 #2,log2-1,0.6,m_93,leaf,2441073,10.408910533472437,0.7367455186911704 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441054,307.77725922296935,0.04143276643503002 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441061,272.8014842675177,0.010957032559946622 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441060,278.8576103917255,0.0014212600167482492 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441071,280.6857634282815,0.0014166240083790527 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441059,74.77612748594885,0.5730407913631765 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,fruit,2441073,475.4061634116164,0.23026104637227096 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441054,3754.9353290056674,8.262255842024224e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441061,3324.869216867177,0.052001668916507704 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441060,4062.752482204317,0.035044128321978896 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441071,3460.8286374518125,0.03459614021310564 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441059,4117.455916339443,0.04085272208404289 +1017361 Sl10g086080 #2,log2-1,0.6,m_94,leaf,2441073,3740.661721924165,8.278004375221748e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441054,148.94013502370947,0.11643078574065946 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441061,154.9355322008546,0.13357007079410899 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441060,118.62668677391018,0.01760144330710789 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441071,91.2969228524934,0.09612481752431057 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441059,98.74799452564176,0.06205267318690599 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,fruit,2441073,109.20333577750192,0.018345052743447 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441054,125.14245712126036,0.02065375568533767 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441061,75.56607528745191,0.23973156696945908 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441060,14.05411898698024,0.9702548075036641 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441071,228.88220642729797,0.24155359781544217 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441059,137.3328359245503,0.019715954729583096 +1017361 Sl10g086080 #2,log2-1,0.6,m_97,leaf,2441073,153.58695996038605,0.06829591062027474 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441054,1713.0188613911075,0.11168640897804893 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441061,1393.6855106363275,0.022089049086788215 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441060,1064.7941671871292,0.09481007240229555 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441071,922.9974852692848,0.15687521808222415 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441059,1255.45949928708,0.023273028786164662 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,fruit,2441073,1440.195722695579,0.03634578089226004 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441054,69234.4907252239,0.1829810294410077 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441061,30496.007043924583,0.17309849325815474 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441060,65072.9162089601,0.1560587973226113 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441071,45481.058359818824,4.890897856313359e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441059,45378.6771357532,4.896412053412291e-4 +1017361 Sl10g086080 #2,log2-1,0.6,m_98,leaf,2441073,37170.67969426239,0.08714096995455378 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441054,10741.041497489918,0 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441061,7690.259611063288,0.14510539331527417 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441060,12259.42239356192,0.05742361428449083 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441059,14087.037596675911,0.11777327922287117 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,fruit,2441073,77.02876486090567,2.144393460360783 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441054,128240.8267960132,0.002606812719236018 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441061,116782.8195665875,0.04325416555645756 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441060,129784.96398764016,0.0025912588795078406 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441071,125733.43499302217,0.011182341576287058 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441059,141368.29070246647,0.03971888487044062 +1017361 Sl10g086080 #2,log2-1,0.6,m_99,leaf,2441073,138934.02072623913,0.032175482238028685 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441068,41.29620933652499,0.29352179504354137 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441062,93.94641296176776,0.0634482188796277 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441056,123.29900005177834,0.18152757075409243 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441070,54.15405733179127,0.17580098334758198 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441057,68.40720811394866,0.07433011771557063 +1017361 Sl10g086080 #2,log2-1,1,m_1,fruit,2441067,191.50994716344587,0.372759352704922 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441068,42.496978263941,0.024939785102723544 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441062,812.849944717556,1.256712544671364 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441056,13.358263175769627,0.5275478404610516 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441070,23.90806523139534,0.274753403756292 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441057,47.520704995474915,0.02358503915544219 +1017361 Sl10g086080 #2,log2-1,1,m_1,leaf,2441067,124.75694342985696,0.44276689005344916 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441068,53.89399128082576,0.003990400959929641 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441062,55.73726256538894,0.010614886590204264 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441056,54.888936791071536,0.003954069773437263 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441070,64.38738353757003,0.07327002862274679 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441057,42.34840575116296,0.10869368320798678 +1017361 Sl10g086080 #2,log2-1,1,m_10,fruit,2441067,47.69537609742299,0.05705447099925043 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441068,362.0171577294484,0.02987297740242889 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441062,382.06974482461027,0.05328647140745568 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441056,301.20260678765504,0.04999745072769057 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441070,336.1066221739476,0.0023791076332946304 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441057,339.79917690307497,0.0023661456239874035 +1017361 Sl10g086080 #2,log2-1,1,m_10,leaf,2441067,324.75904062017406,0.017294927143312044 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441068,37.701360219555866,0.15528821497042733 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441062,11.233919012573343,0.37053751569743465 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441056,15.033621524656656,0.24400519176773083 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441070,55.625475837073765,0.324204934752113 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441057,14.100161016326563,0.27184473224326733 +1017361 Sl10g086080 #2,log2-1,1,m_100,fruit,2441067,94.57905779290289,0.5547261788724416 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441068,2098.276273760428,0.003797725490022774 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441062,2061.739142553583,0.003831228210351423 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441056,2680.7515309371456,0.1101916182920939 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441070,2580.629642812856,0.09366073717134071 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441057,1775.2803602148358,0.06879799585325941 +1017361 Sl10g086080 #2,log2-1,1,m_100,leaf,2441067,1951.7750037715005,0.0276351926617453 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441068,31.604565014776377,4.142219399712044e-4 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441062,32.40281003489275,0.011247079293779771 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441056,30.622189489391182,0.013299355842471217 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441070,60.40758891173284,0.28175590638028103 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441057,31.544306072323057,4.1461739430381783e-4 +1017361 Sl10g086080 #2,log2-1,1,m_101,fruit,2441067,29.80766653924276,0.02500761631852444 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441068,277.85941061380083,0.22364199573867483 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441062,557.2921850530062,0.5258998385284994 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441056,43.458805892662056,0.5821053252871267 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441070,36.03187111172015,0.6634962990895301 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441057,342.28562232217473,0.31420554259028943 +1017361 Sl10g086080 #2,log2-1,1,m_101,leaf,2441067,54.197948882477235,0.4862002634231466 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441068,99.11838499683564,0.052372676477389524 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441062,114.84932283406836,0.011601545236068045 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441056,108.79449077772684,0.011919989879789927 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441070,123.91527228499017,0.04459794186719046 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441057,106.57330713675672,0.02087845082298312 +1017361 Sl10g086080 #2,log2-1,1,m_102,fruit,2441067,254.24669420188755,0.3567284211454602 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441068,584.72,0.0073251751497234174 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441062,604.6120426737998,0.007203669187795914 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441056,553.3304080347441,0.03128858668909107 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441070,556.8005831499609,0.028573442576371733 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441057,638.8211993437415,0.031106195784639912 +1017361 Sl10g086080 #2,log2-1,1,m_102,leaf,2441067,644.28597302211,0.034805552244796534 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441068,3181.5743020479213,0.15847491497847788 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441062,3369.8764558731045,0.1335030057694424 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441056,1573.4544609359357,0.4642628070824575 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441070,12926.246507703749,0.4503554486792787 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441057,5795.4297879746255,0.10196866356772372 +1017361 Sl10g086080 #2,log2-1,1,m_103,fruit,2441067,7386.946220596332,0.20734795210284584 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441068,753686.5039463162,0.01422796998203868 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441062,909904.835997169,0.06757726470796399 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441056,794526.5389330232,0.008689699642601134 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441070,763047.5153667832,0.008867125992645164 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441057,730251.1708188272,0.02794644657876244 +1017361 Sl10g086080 #2,log2-1,1,m_103,leaf,2441067,872616.8202519653,0.04940487150421191 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441068,3119.003061484483,0.15847491497847788 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441062,3303.6019230879424,0.13350300576944285 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441056,1542.509718414139,0.4642628070824575 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441070,12672.029191673995,0.4503554486792787 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441057,5681.4524934011615,0.10196866356772372 +1017361 Sl10g086080 #2,log2-1,1,m_104,fruit,2441067,7241.668963139041,0.2073479521028454 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441068,753686.5039463162,0.01422796998203868 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441062,909904.835997169,0.06757726470796399 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441056,794526.5389330232,0.008689699642601134 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441070,763047.5153667832,0.008867125992645164 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441057,730251.1708188272,0.02794644657876244 +1017361 Sl10g086080 #2,log2-1,1,m_104,leaf,2441067,872616.8202519653,0.04940487150421191 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441068,46.33206318292077,0.005893024099235644 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441062,48.43796369569325,0.013411213345361883 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441056,47.59800977870497,0.005814129875206797 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441070,43.158525524728894,0.03670806506450752 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441057,67.31662627360056,0.15634767817216466 +1017361 Sl10g086080 #2,log2-1,1,m_105,fruit,2441067,32.21775780454845,0.16367935161525327 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441068,47.3068599325812,0.2138456154214261 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441062,145.2117140786754,0.2732319144179174 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441056,46.451801334149955,0.22176717747309804 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441070,57.657383913607674,0.12791480417424217 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441057,101.86210172994303,0.11924289532420707 +1017361 Sl10g086080 #2,log2-1,1,m_105,leaf,2441067,97.15287362050732,0.09868591338898214 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441068,138.96641913502756,0.03550147620515798 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441062,142.10935069314905,0.02578868790014388 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441056,146.47042662374045,0.01266139650380449 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441070,187.46595786969925,0.0945110722225464 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441057,155.13651909377018,0.012302699616827617 +1017361 Sl10g086080 #2,log2-1,1,m_106,fruit,2441067,160.52336970945274,0.027126924842427957 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441068,3871.4532565294335,0.08698586141718723 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441062,3656.731381786328,0.06220490026983194 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441056,3181.7843196315803,0.0017825786376062247 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441070,3050.881679451214,0.016462793611915938 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441057,3155.7183350052064,0.0017899254668449771 +1017361 Sl10g086080 #2,log2-1,1,m_106,leaf,2441067,2875.595864591644,0.04216030821465644 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441068,167.651601226673,0.003030916336284939 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441062,137.3064977950374,0.08974753206563335 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441056,94.83151337394084,0.2504859407048503 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441070,169.99984769635023,0.003009910260156179 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441057,256.5109646121607,0.18166731181668938 +1017361 Sl10g086080 #2,log2-1,1,m_107,fruit,2441067,212.5407442303017,0.10000357493427892 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441068,4674.701450437021,0.01911362356328672 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441062,4272.150523897668,0.019993710221869687 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441056,4879.296277939475,0.03771693356653305 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441070,5138.819707317442,0.060223124631189506 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441057,3621.0675295904016,0.09180363225003374 +1017361 Sl10g086080 #2,log2-1,1,m_107,leaf,2441067,3668.48594793015,0.08615339647985731 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441068,42.042458747700586,0.23158112144726894 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441062,66.06123420967052,0.03532254489548037 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441056,96.78195572468869,0.1305251657127442 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441070,21.48261368201555,0.5231821094925533 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441057,77.25626579482085,0.03266448439064784 +1017361 Sl10g086080 #2,log2-1,1,m_108,fruit,2441067,180.91682109431528,0.4022097199444754 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441068,309.8269929236668,0.00621382100059753 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441062,284.1669788298597,0.04375946289676813 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441056,583.6820612221015,0.2688432730647494 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441070,202.73050566321072,0.1904139692998732 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441057,318.7566398971975,0.006126167234661306 +1017361 Sl10g086080 #2,log2-1,1,m_108,leaf,2441067,600.4504851075591,0.28114412710684755 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441068,107.9874525254049,0.09911656261834789 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441062,183.00082364605183,0.12996318569578502 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441056,114.83344347765176,0.07242147061740178 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441070,128.52938016603864,0.02348744554419291 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441057,142.81438961689796,0.022282109356980495 +1017361 Sl10g086080 #2,log2-1,1,m_109,fruit,2441067,189.1106393408747,0.1442261041834878 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441068,2012.043448475909,0.05162244667239735 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441062,2274.2349809937004,0.10482042726322582 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441056,1450.9158374000572,0.09037268680582411 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441070,1561.054353094333,0.05859688338074198 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441057,1437.3850035558728,0.09444179856854484 +1017361 Sl10g086080 #2,log2-1,1,m_109,leaf,2441067,2863.788707852585,0.20492606423924054 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441068,271.6264593246401,0.057585678821993724 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441062,238.7271873230886,0.001515487448936259 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441056,162.86376664703485,0.16456191901900308 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441070,229.18575438029316,0.01619877431501493 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441057,337.3688461348957,0.1517185819958593 +1017361 Sl10g086080 #2,log2-1,1,m_11,fruit,2441067,237.06399532766773,0.001520794325157837 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441068,1345.8906689912103,0.18693961622634214 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441062,938.0267000364768,0.03014503437071614 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441056,686.3891190820779,0.10549977567957258 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441070,1630.7810954977117,0.2703255023747366 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441057,4.659186656242279,2.273760056469457 +1017361 Sl10g086080 #2,log2-1,1,m_11,leaf,2441067,812.2236034421866,0.03239455990805107 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441068,208.090265641282,0.02010803481815371 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441062,189.26019923668773,0.02108443684681527 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441056,168.16595503739626,0.07240565174006086 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441070,209.01462279378595,0.022032940897963815 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441057,263.67480541164286,0.12292490438968873 +1017361 Sl10g086080 #2,log2-1,1,m_110,fruit,2441067,176.5040318658805,0.05138909940232361 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441068,13306.801080526611,0.26870880300936806 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441062,12154.525063214383,0.22937313172199714 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441056,3506.149204143537,0.3105344682295361 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441070,9420.601905611948,0.11871379005274685 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441057,3406.803966175151,0.3230177176017044 +1017361 Sl10g086080 #2,log2-1,1,m_110,leaf,2441067,4914.304358489098,0.16390281156311204 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441068,185.9865257291358,0.1685556800991459 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441062,291.4740121180045,0.026562677157981884 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441056,266.65933299781676,0.012080373415772172 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441070,297.8484171464173,0.035958134593985225 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441057,281.70242181219373,0.011753418777738833 +1017361 Sl10g086080 #2,log2-1,1,m_111,fruit,2441067,222.562867938157,0.09058445288999906 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441068,53906.16682316285,0.02371434442607878 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441062,56710.70395836981,0.0016877571214424236 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441056,57152.34032032067,0.0016812235349714655 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441070,40143.04765994175,0.15174245436500478 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441057,67377.76172821246,0.07316378433191861 +1017361 Sl10g086080 #2,log2-1,1,m_111,leaf,2441067,105181.10094265024,0.26658491690875064 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441068,335.25262340370557,0.3624274942948702 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441062,528.4744849888525,0.164775655057519 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441056,740.3349923813702,0.01837140219459421 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441070,1166.0723618905354,0.17892582262298262 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441057,1326.206411546704,0.23481144392493736 +1017361 Sl10g086080 #2,log2-1,1,m_112,fruit,2441067,804.3135357381125,0.01762569822312221 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441068,11440.217329439674,0.16678508715855456 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441062,17226.07991780041,0.3445372700735043 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441056,6814.614924354587,0.058207867609537 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441070,8769.393823486485,0.05132038653040416 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441057,4469.0518385756895,0.24143379538523702 +1017361 Sl10g086080 #2,log2-1,1,m_112,leaf,2441067,6511.703596678604,0.07795456378016974 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441068,50.247340887763656,0.04015700296263369 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441062,45.4297184226293,0.0036160356478487365 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441056,32.98251215498501,0.14267234951576468 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441070,40.58214189048154,0.05262111568482064 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441057,46.18939319593599,0.0035861761501181366 +1017361 Sl10g086080 #2,log2-1,1,m_12,fruit,2441067,46.30988333017033,0.004717606189001744 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441068,61.82176766196505,0.008980023718604846 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441062,22.204849401705527,0.453673610313885 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441056,47.943480524061215,0.11939188329270767 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441070,77.35900242671717,0.08838941837071879 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441057,64.7371443254419,0.01103209560985774 +1017361 Sl10g086080 #2,log2-1,1,m_12,leaf,2441067,64.40499325850847,0.008798096757031137 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441068,66.42754430670094,0.021647759276633094 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441062,59.96761282100638,0.022783677592156604 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441056,46.876647420435766,0.12974389473050119 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441070,78.54611287679758,0.09442425889477568 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441057,70.54034301202493,0.04773712868836988 +1017361 Sl10g086080 #2,log2-1,1,m_120,fruit,2441067,37.73562405289892,0.22394890193231598 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441068,130.6271660300879,0.17340667980685254 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441062,161.96438352589945,0.08002066236648764 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441056,173.60308276204455,0.04988275178797119 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441070,215.863482368118,0.044738994242791374 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441057,588.3098963329343,0.48016596929666466 +1017361 Sl10g086080 #2,log2-1,1,m_120,leaf,2441067,248.82856944338715,0.1064600580417614 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441068,51.79639215332847,5.629288016599787e-4 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441062,44.39590452978252,0.067519530273493 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441056,51.93075529777044,5.622000826082107e-4 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441070,55.53543160260904,0.029707712328306046 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441057,91.26202098444736,0.24542764285416174 +1017361 Sl10g086080 #2,log2-1,1,m_121,fruit,2441067,43.80648790580472,0.07332400316270582 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441068,72.94819263356516,0.4670289220714132 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441062,286.57616736682456,0.12719661183837294 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441056,167.81505197893796,0.10521254655608558 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441070,207.37804199361724,0.01328068867025367 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441057,220.257165737518,0.012886588093353968 +1017361 Sl10g086080 #2,log2-1,1,m_121,leaf,2441067,309.1895300310937,0.16018132080228176 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441068,195.33649667213575,0.0188695607693683 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441062,118.19605695322396,0.23704996659575572 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441056,93.24417550683708,0.3400312420790397 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441070,212.68491199212104,0.018083726636572983 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441057,390.77576778250136,0.2822746698230727 +1017361 Sl10g086080 #2,log2-1,1,m_122,fruit,2441067,239.2182631022915,0.06914137754321503 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441068,20035.2576805468,0.24548552444196403 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441062,18134.729374383875,0.20220167098525899 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441056,8744.069086239904,0.11459582769423893 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441070,14024.69218849263,0.09058393023510725 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441057,7726.062768076334,0.1683511758596552 +1017361 Sl10g086080 #2,log2-1,1,m_122,leaf,2441067,8257.784216268312,0.13944587781752116 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441068,129.18094078233722,0.05052016703758788 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441062,155.64545110963584,0.030417822443278286 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441056,120.97691445818262,0.07901610654034519 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441070,143.1844685943204,0.005822698041344498 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441057,202.00776887226144,0.14364946190835592 +1017361 Sl10g086080 #2,log2-1,1,m_123,fruit,2441067,147.04974420887666,0.005745663313906135 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441068,249.38171120237328,0.041580206112550755 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441062,268.97356382952313,0.008735209458931692 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441056,294.465525501725,0.030589650392933265 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441070,279.9031452645941,0.008562971891570736 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441057,140.02387119865352,0.29224272646485794 +1017361 Sl10g086080 #2,log2-1,1,m_123,leaf,2441067,280.8714396209959,0.010062773505671085 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441068,801.2024089133041,0.02626627903940415 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441062,728.0625233603607,0.06783984887812133 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441056,486.7530925800867,0.24269980593677687 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441070,1392.0449631925628,0.21364473783409021 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441057,1119.1138378628352,0.11886574040972198 +1017361 Sl10g086080 #2,log2-1,1,m_13,fruit,2441067,901.1070843683884,0.024767878638517704 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441068,94501.39500382656,0.1401762642528448 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441062,55621.73984900441,0.09001738576079443 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441056,61967.036431613495,0.043101228691775795 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441070,85968.84271902565,0.09907912522439144 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441057,74897.82148817508,0.039207230557481765 +1017361 Sl10g086080 #2,log2-1,1,m_13,leaf,2441067,35214.36435949568,0.2885421017185603 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441068,32.90934867182286,0.12435735290078309 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441062,37.70206238853018,0.0653115321528408 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441056,8.622949418913716,0.7060208013101463 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441070,52.47857849887819,0.07830542277355867 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441057,71.33307072480581,0.2116142798987526 +1017361 Sl10g086080 #2,log2-1,1,m_14,fruit,2441067,49.93879862542743,0.05676145044167202 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441068,63.92160580802903,9.9007607316981e-4 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441062,363.11816658206686,0.753410224291909 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441056,64.2133868415135,9.878240956178175e-4 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441070,44.61161729671498,0.15718978472996303 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441057,9.81728894276655,0.814646179302579 +1017361 Sl10g086080 #2,log2-1,1,m_14,leaf,2441067,67.59799859724053,0.023296085135585898 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441068,68.24430820484852,0.013754158432989216 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441062,55.47076409307763,0.07624812903556388 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441056,63.98942921496099,0.014204040947224605 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441070,29.147976985119676,0.355703859291993 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441057,105.35414142837786,0.20233933498746426 +1017361 Sl10g086080 #2,log2-1,1,m_15,fruit,2441067,84.13217476911946,0.10464983809600259 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441068,618.4956522562131,0.19538274761472918 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441062,1303.1227376465806,0.12826592397772174 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441056,935.8185856248356,0.015527732542987671 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441070,625.2015710030626,0.19069933805615502 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441057,1003.9476446858808,0.01499166648516237 +1017361 Sl10g086080 #2,log2-1,1,m_15,leaf,2441067,1110.133416971173,0.05865577718150172 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441068,129.03711560112262,0.3968812624825586 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441062,85.07244395863584,0.21595552526924577 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441056,18.40921436077885,0.4487981293446661 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441070,0.6755739642727631,1.884160480027376 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441057,4.785785249491964,1.0338801773109239 +1017361 Sl10g086080 #2,log2-1,1,m_16,fruit,2441067,121.81746235073294,0.3718761641089505 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441068,53.83219971297284,0.13241401910733952 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441062,56.9105479469184,0.10826337849267853 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441056,106.46741675170745,0.1637605711870902 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441070,214.1479043212624,0.46725768309090454 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441057,19.846551519253843,0.5657710897295802 +1017361 Sl10g086080 #2,log2-1,1,m_16,leaf,2441067,89.1342664990567,0.08658854935081362 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441068,649.4439789682787,0.005063944172220669 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441062,470.5792663817569,0.14497285061600573 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441056,371.8735626300757,0.2472103345229626 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441070,664.6778656460604,0.005005577670204264 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441057,998.15227559399,0.18159116225380378 +1017361 Sl10g086080 #2,log2-1,1,m_17,fruit,2441067,895.8593995047905,0.13463421578065837 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441068,17850.853499658933,0.09417285777388607 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441062,21944.1889885516,0.004512308703259471 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441056,22402.56526320828,0.004465907622674514 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441070,30973.21052212624,0.14515438083754173 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441057,24658.799180822483,0.04614008020383853 +1017361 Sl10g086080 #2,log2-1,1,m_17,leaf,2441067,13901.363724838377,0.20277443689708008 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441068,20.815844817286333,0.13338653615763296 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441062,18.004618313458245,0.1963966586734791 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441056,17.075050437364474,0.21941858250754143 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441070,35.78339176044301,0.10190092545953489 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441057,79.10109162941764,0.4464018992819663 +1017361 Sl10g086080 #2,log2-1,1,m_18,fruit,2441067,51.560616162328344,0.2605375209311118 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441068,1037.3537945839837,0.1084103552160558 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441062,1272.6423493025677,0.019630884109814062 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441056,1390.3336408897171,0.018781776070985412 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441070,439.0635141968096,0.4818099060225589 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441057,2470.8504415815014,0.2685092036063814 +1017361 Sl10g086080 #2,log2-1,1,m_18,leaf,2441067,2870.8616792747066,0.333675013171979 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441068,2.921202286273869,0.020635183200501506 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441062,2.8874351673437575,0.015585792965207235 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441056,2.6838635448986854,0.016166017352242046 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441070,2.4368013941096596,0.058106314214173393 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441057,2.4302183778439184,0.05928114789717015 +1017361 Sl10g086080 #2,log2-1,1,m_19,fruit,2441067,2.991022489611826,0.03089322985145526 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441068,1847.515407984052,0.22421295017547038 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441062,2496.6380967971822,0.0934454259737918 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441056,3695.362861219188,0.07685607058695165 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441070,1613.6858439548778,0.282982030030571 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441057,4172.04659251259,0.12954813068407267 +1017361 Sl10g086080 #2,log2-1,1,m_19,leaf,2441067,5475.312331307362,0.24760787871789924 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441068,4.0579919632111565,0.8037102892836926 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441062,30.25655190470494,0.06879796159772944 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441056,38.625027857073,0.17484733378556272 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441070,1.7683663438410682,1.1644492311985883 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441057,21.391205351527734,0.08178621498430338 +1017361 Sl10g086080 #2,log2-1,1,m_2,fruit,2441067,142.5279819540325,0.7418786641618567 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441068,831.244108017002,0.09451537593647119 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441062,804.9646297519326,0.10846715808165452 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441056,1235.439294026121,0.07757745435239904 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441070,768.2958156471482,0.1287154880081638 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441057,1368.7357229616566,0.12207564624542222 +1017361 Sl10g086080 #2,log2-1,1,m_2,leaf,2441067,2125.9406749287973,0.31330718531246227 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441068,44.295123943799815,0.09091847223017946 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441062,51.32180440697853,0.026972476275133994 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441056,57.898753127078486,0.0253948176540566 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441070,14.515711976353392,0.5754360512114003 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441057,73.55914597570195,0.12936228495309687 +1017361 Sl10g086080 #2,log2-1,1,m_20,fruit,2441067,60.9178227805069,0.047469979671062035 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441068,98.3031308943862,0.027255817881089328 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441062,150.34513975183043,0.2117778609237566 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441056,68.34588838273501,0.13059913919679444 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441070,131.1554224812184,0.15247471855621808 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441057,6.338464974019246,1.1633274373985576 +1017361 Sl10g086080 #2,log2-1,1,m_20,leaf,2441067,86.34355953470403,0.029081583596751948 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441068,6064.408504928361,0.06873055773593117 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441062,7592.891110254067,0.02888816582213849 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441056,3591.159811174998,0.296284273665433 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441070,11552.161670352498,0.21114425226067102 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441057,9551.205062824316,0.12853916351930827 +1017361 Sl10g086080 #2,log2-1,1,m_21,fruit,2441067,6615.634078929213,0.030947530176296034 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441068,515657.8542661146,0.11769853183008117 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441062,477375.05104897165,0.08419661254124744 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441056,290543.3586778196,0.1314521526199206 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441070,460661.32679948176,0.06871864883596768 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441057,325828.4846513991,0.08167405665971827 +1017361 Sl10g086080 #2,log2-1,1,m_21,leaf,2441067,303364.93197136215,0.11269772900141728 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441068,20.194148491620656,0.08288978404011904 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441062,12.98971008780263,0.27451587109534237 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441056,29.81470521721076,0.08631519033363055 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441070,12.561772141787465,0.2890644179658892 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441057,60.67105652896246,0.39486622840688734 +1017361 Sl10g086080 #2,log2-1,1,m_22,fruit,2441067,28.687441629894675,0.06957648979685649 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441068,11.148008294234284,0.6372190980618733 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441062,39.496811867409946,0.08785433988176061 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441056,52.52908843652451,0.035983483116832415 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441070,55.903793477055395,0.06302489768777053 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441057,44.175343222900395,0.03923644875471277 +1017361 Sl10g086080 #2,log2-1,1,m_22,leaf,2441067,67.03129032921451,0.14186119827026755 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441068,2119.580653088793,0.03475863514360755 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441062,2833.3052712214553,0.16080205799746006 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441056,2730.3198332309644,0.14472221223950044 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441070,1609.1254014186864,0.08490142100278852 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441057,1793.5225973498998,0.037784458697634804 +1017361 Sl10g086080 #2,log2-1,1,m_23,fruit,2441067,1278.770414348552,0.18469873173173657 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441068,134964.11797460972,0.14926036212546023 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441062,167250.80987423257,0.2424102707294784 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441056,79055.06405213622,0.08302826380709138 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441070,103005.04902706714,0.03190055447173101 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441057,88415.23414377384,0.034430857311439134 +1017361 Sl10g086080 #2,log2-1,1,m_23,leaf,2441067,84285.10713900824,0.05520711548397905 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441068,74.04382004198571,0.01882374906251094 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441062,78.3557380666859,0.005758240090028899 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441056,76.29164003320476,0.005835614707599079 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441070,46.86029273292754,0.21750756840895913 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441057,108.88685065302874,0.14866287115381627 +1017361 Sl10g086080 #2,log2-1,1,m_24,fruit,2441067,109.22896577116886,0.15002525589293625 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441068,79.01252871329785,0.07735094218951288 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441062,84.23375579681337,0.049560737995396176 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441056,104.59881207853698,0.044479848958144386 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441070,117.3931562728802,0.09459587601974184 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441057,121.92677104405556,0.11105216929354289 +1017361 Sl10g086080 #2,log2-1,1,m_24,leaf,2441067,65.28408028792359,0.16023961313066737 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441068,69.48764182609447,0.009731492525011376 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441062,75.53383791970202,0.02650248604251515 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441056,64.28793004182569,0.043509623510102013 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441070,72.63689476440813,0.009518203791970326 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441057,141.6885747700376,0.29969576581844826 +1017361 Sl10g086080 #2,log2-1,1,m_25,fruit,2441067,38.616780095185824,0.26486300692371656 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441068,4331.491824650672,0.09051479038152044 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441062,4035.407984308144,0.059764740283086315 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441056,2769.8917899788116,0.10365990563404281 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441070,4017.9496627024855,0.05788178290151613 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441057,3015.246076392175,0.06679994765140362 +1017361 Sl10g086080 #2,log2-1,1,m_25,leaf,2441067,2539.5206369615576,0.1413709622620707 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441068,170.86750313531502,0.054878872748077345 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441062,199.50602433479605,0.012417668350817923 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441056,187.8335388065823,0.01376520519448965 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441070,236.4576217950195,0.08621497135796563 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441057,243.2911678372672,0.09858799715273125 +1017361 Sl10g086080 #2,log2-1,1,m_26,fruit,2441067,188.25873894969175,0.012783200694759689 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441068,3500.5337027525625,0.07445637018106543 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441062,4181.879239557359,0.002780853979620357 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441056,5339.801676397763,0.10893449382855636 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441070,4526.900463148223,0.03721031186559287 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441057,3812.732255587403,0.03735432497758229 +1017361 Sl10g086080 #2,log2-1,1,m_26,leaf,2441067,4128.495908247186,0.0027987750257221222 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441068,62.752529698449194,0.19788029950252262 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441062,108.79509449491452,0.04109777631231282 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441056,95.1587338259532,0.017062882697376658 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441070,30.447994310581933,0.5119528476234554 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441057,102.7848974249528,0.016417769395049575 +1017361 Sl10g086080 #2,log2-1,1,m_27,fruit,2441067,106.02398046621086,0.029892567531140557 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441068,772.6427388573562,0.1087739670507406 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441062,894.187528951464,0.04532408603416682 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441056,1090.9138463930378,0.04103775946591126 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441070,870.3787418972362,0.05704441930409887 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441057,1399.9697018509776,0.14936594218420085 +1017361 Sl10g086080 #2,log2-1,1,m_27,leaf,2441067,1525.5987925379338,0.186687641714963 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441068,51.85571396798333,0.12603072600733922 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441062,241.16400740331625,0.541485147722405 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441056,210.02469962518921,0.4814430280903228 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441070,16.88622280971892,0.6132948287800184 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441057,68.64609167813856,0.004211528173389212 +1017361 Sl10g086080 #2,log2-1,1,m_28,fruit,2441067,69.98394553942958,0.00417107922744786 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441068,386.3188966831313,0.2271763051302691 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441062,1025.3673220627236,0.19675721538930668 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441056,610.8808711050553,0.028165731180342046 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441070,393.13597308605006,0.21957947234266406 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441057,1261.9418540839863,0.2869170873910445 +1017361 Sl10g086080 #2,log2-1,1,m_28,leaf,2441067,692.7428453307392,0.0264497918803408 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441068,264041.09852088155,0.018125228636719726 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441062,286546.918550955,0.017398982966138732 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441056,201696.2756592217,0.13509888056767316 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441070,359865.0428227431,0.11634290190635532 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441057,447995.7352697709,0.21147712015188613 +1017361 Sl10g086080 #2,log2-1,1,m_29,fruit,2441067,254029.5387411136,0.034912539928652286 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441068,577519.5431834584,0.09235700173011185 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441062,486409.7280997851,0.017792568607114312 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441056,441866.0813310603,0.02391901816302333 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441070,680121.4500028532,0.16337678850446657 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441057,362431.8693982005,0.10998330443638249 +1017361 Sl10g086080 #2,log2-1,1,m_29,leaf,2441067,447359.7608939961,0.018552765942647653 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441068,31.020715882147165,0.2688242002662349 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441062,15.63499652168922,0.028729826818314708 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441056,2.3462768390969493,0.8524483622208823 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441070,11.142867351359689,0.17583065522605912 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441057,337.51729739160186,1.3054684190736625 +1017361 Sl10g086080 #2,log2-1,1,m_3,fruit,2441067,17.77355229929316,0.026946620680422084 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441068,211.02917796927963,0.092168445995497 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441062,165.02007103963467,0.01463729148251991 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441056,73.44010799780021,0.36624075437344494 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441070,47.63794517423896,0.5542210409618915 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441057,176.33319058621635,0.014160004519476299 +1017361 Sl10g086080 #2,log2-1,1,m_3,leaf,2441067,215.80881182550783,0.1018951124389269 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441068,134.44694997314338,0.016046186850736444 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441062,152.79817640666656,0.0395210298807398 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441056,144.56778346431653,0.015474381165964779 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441070,61.89147850084825,0.35296628373116046 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441057,250.7363591465259,0.2546201741017975 +1017361 Sl10g086080 #2,log2-1,1,m_30,fruit,2441067,4.763657159000493,1.4666566435281339 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441068,8507.277698678006,0.019144485888491936 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441062,7701.975245985162,0.024044005124539414 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441056,7257.057799715508,0.04988554151226232 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441070,7773.536471071853,0.02002748311724467 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441057,9224.617782990956,0.05430225685022361 +1017361 Sl10g086080 #2,log2-1,1,m_30,leaf,2441067,9698.22880632993,0.07604630243319166 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441068,34.859341343636466,0.08545960223491678 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441062,35.177476748366324,0.08151409457719239 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441056,31.7822443208241,0.12559421732773313 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441070,99.88223305309845,0.3717094640209031 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441057,136.09716776106504,0.5060703082198521 +1017361 Sl10g086080 #2,log2-1,1,m_31,fruit,2441067,49.70318854337083,0.0686054711226245 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441068,534.1412428165303,0.00936823514355245 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441062,588.6500765004349,0.0328328570706824 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441056,566.8825435479727,0.01646873590704212 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441070,557.4356744077726,0.009170411239658893 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441057,509.50947203883135,0.029872085552792083 +1017361 Sl10g086080 #2,log2-1,1,m_31,leaf,2441067,498.21634858949074,0.03960637324790195 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441068,126.03716165607798,0.08109849380138945 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441062,152.48004274773697,0.0016158969022090908 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441056,151.34747382689693,0.0016219316955266017 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441070,235.7050755660063,0.19077182637867507 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441057,204.47182890582536,0.12903637342181806 +1017361 Sl10g086080 #2,log2-1,1,m_32,fruit,2441067,115.4367343837,0.11925307574355681 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441068,2387.571636756294,0.037650151540986165 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441062,2120.2874237280685,0.013911522111627495 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441056,2258.322481238182,0.0134796983899923 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441070,2570.4054891485484,0.06969538049609225 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441057,2088.456434036555,0.02048083933803957 +1017361 Sl10g086080 #2,log2-1,1,m_32,leaf,2441067,1899.574001783724,0.0616500424437012 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441068,144.0445852454831,0.06460088758871452 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441062,161.91059797884594,0.013822548272237167 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441056,163.56880585916073,0.009397341918050195 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441070,481.67716829082616,0.4596582360283046 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441057,303.15704891822327,0.2585698457505381 +1017361 Sl10g086080 #2,log2-1,1,m_33,fruit,2441067,170.72460826298746,0.009198299854030978 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441068,1257.7901781303317,0.0029305453079309096 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441062,1476.146386327523,0.06659068330962192 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441056,1244.4681219834918,0.0075549680849462675 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441070,930.2288415279024,0.13394894379873268 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441057,1274.8222868351197,0.0029109029557798927 +1017361 Sl10g086080 #2,log2-1,1,m_33,leaf,2441067,2522.098895320631,0.2992233675339504 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441068,327.70348282876455,0.008071770632013031 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441062,370.28569244097656,0.04498410384784268 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441056,318.11741438939265,0.020965383800882087 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441070,339.9987420694968,0.007924482522903897 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441057,348.6509594209237,0.01883803692257313 +1017361 Sl10g086080 #2,log2-1,1,m_34,fruit,2441067,301.8463806795662,0.043766854948027234 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441068,50413.616468588894,0.09676694067676195 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441062,52583.624891019346,0.07846427254577559 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441056,76224.54084684914,0.08278002323018185 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441070,48032.59371179046,0.1177787550212086 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441057,73408.90294105774,0.06643394004952263 +1017361 Sl10g086080 #2,log2-1,1,m_34,leaf,2441067,109539.6024772628,0.24025636676804307 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441068,76.02736047140817,0.19079657626276347 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441062,99.2659073897302,0.07496637228869574 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441056,136.6713272080835,0.06391092273627264 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441070,860.4722174416313,0.8629703634613923 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441057,862.5674822363359,0.8640265926210158 +1017361 Sl10g086080 #2,log2-1,1,m_35,fruit,2441067,84.07168685961302,0.1471167276913401 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441068,8505.26930414333,0.008361393356331348 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441062,6775.077148574061,0.10713521774552692 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441056,8835.943124466548,0.008203449044432709 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441070,5444.977372290291,0.2020533833841971 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441057,11475.427155562376,0.12171939779002994 +1017361 Sl10g086080 #2,log2-1,1,m_35,leaf,2441067,29086.719725224575,0.5256452834696237 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441068,1353.1516338360332,0.013398103909523229 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441062,1725.7371400449872,0.11902628342296495 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441056,1270.9361413795784,0.013824632519237934 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441070,1178.740737865563,0.046530069122974194 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441057,1515.9417047568263,0.06273413856048204 +1017361 Sl10g086080 #2,log2-1,1,m_36,fruit,2441067,1047.5562069464172,0.09777102788107417 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441068,9404.154409852545,0.04794035625713855 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441062,8125.455571392829,0.015531675074738072 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441056,8717.154362873442,0.014995341439876686 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441070,6291.30890807349,0.12663838517648296 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441057,5077.676705943493,0.21971434904906895 +1017361 Sl10g086080 #2,log2-1,1,m_36,leaf,2441067,20268.702878687047,0.3814465612810034 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441068,320.27171654536727,0.02827427794092152 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441062,432.0089818535917,0.10169991087920405 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441056,305.8331844439146,0.04830825862474741 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441070,363.3610354639045,0.02654548907843335 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441057,393.63618854671455,0.06130215261993888 +1017361 Sl10g086080 #2,log2-1,1,m_37,fruit,2441067,309.8743385041304,0.04260725272229893 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441068,474.5132032922048,0.680669288115531 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441062,32.77768125928116,0.4800007853258972 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441056,87.97880271047472,0.05120096558881171 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441070,496.72952237999647,0.7005409593831851 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441057,26.83049671613117,0.5669503001343583 +1017361 Sl10g086080 #2,log2-1,1,m_37,leaf,2441067,109.99558510177911,0.04579624118362968 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441068,8.303813203761917,0.9426401592454007 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441062,95.79474228097918,0.11942394306574644 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441056,210.49062644770643,0.461315030331243 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441070,1.5694397584143416,1.6661730799642944 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441057,154.73912152223295,0.3276823966692979 +1017361 Sl10g086080 #2,log2-1,1,m_38,fruit,2441067,49.73364813864681,0.1652674128688152 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441068,18.799730217807923,0.2890957452736358 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441062,6.871906812166805,0.7261701007880904 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441056,385.28384994555944,1.0225334426311272 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441070,119.9070514151608,0.5155973612384723 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441057,54.2673119208307,0.17129094743611306 +1017361 Sl10g086080 #2,log2-1,1,m_38,leaf,2441067,18.89330483291088,0.2869394305901767 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441068,64.52382722744379,0.18753055590236967 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441062,107.0984320169841,0.0325324370180573 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441056,105.88377218064782,0.02757872940030448 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441070,34.665175518985194,0.4573572720492296 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441057,2915.987518358979,1.467534985150831 +1017361 Sl10g086080 #2,log2-1,1,m_39,fruit,2441067,92.85411626227312,0.029449514577089886 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441068,2932.9727015974913,0.03090974555091952 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441062,3077.067585508141,0.010080731081542726 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441056,3221.5865577058967,0.009852038089142479 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441070,3445.311449705286,0.03901072103632197 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441057,2264.5594376212753,0.14323404234606185 +1017361 Sl10g086080 #2,log2-1,1,m_39,leaf,2441067,3322.660996013078,0.023268267012852117 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441068,15.18918092558675,0.421799320869916 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441062,33.4404939658611,0.07906099210601325 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441056,31.041584384322288,0.11138979624817624 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441070,377.9044201267019,0.9740482955387779 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441057,391.4310778859328,0.9893216276441927 +1017361 Sl10g086080 #2,log2-1,1,m_4,fruit,2441067,46.7944718205799,0.06686087356711146 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441068,341.8596684229976,0.005418274660922595 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441062,396.8552895847111,0.05936603156159226 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441056,350.44321012980794,0.005351508183636611 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441070,305.91376146691016,0.05366712764993853 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441057,118.68530292674906,0.46486919911850944 +1017361 Sl10g086080 #2,log2-1,1,m_4,leaf,2441067,480.01167878632174,0.1419856622603577 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441068,160.43022220672472,0.154112098370764 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441062,149.29961118675683,0.12288459005842434 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441056,129.8695827080291,0.06233335841920695 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441070,95.1415895907868,0.07280368348002209 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441057,85.38381641420122,0.11979852402524593 +1017361 Sl10g086080 #2,log2-1,1,m_40,fruit,2441067,86.7530304315122,0.11288943228161363 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441068,7120.691650008356,0.011475287614273633 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441062,7989.325721380421,0.03851266014538357 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441056,7253.373625762634,0.003457418558415082 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441070,7369.322770125268,0.0034301112978059045 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441057,7174.8292734447605,0.008185895972348423 +1017361 Sl10g086080 #2,log2-1,1,m_40,leaf,2441067,7497.157792052103,0.010899184128110306 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441068,134.99347268963717,0.04441822860355682 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441062,154.19426878852033,0.013337233564220785 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441056,122.99830495042433,0.08483187182521768 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441070,144.86756632893244,0.013759833912606823 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441057,198.72171864179316,0.12351433624349895 +1017361 Sl10g086080 #2,log2-1,1,m_41,fruit,2441067,160.5317722354368,0.030830001977366184 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441068,1894.646643939021,0.061586290796287635 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441062,1875.0536596734971,0.06610081496958298 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441056,2628.731020189413,0.08063163432911358 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441070,2003.8161420967176,0.03725664488887581 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441057,2362.794927257876,0.03431151408045263 +1017361 Sl10g086080 #2,log2-1,1,m_41,leaf,2441067,3303.404200580828,0.17984720098643736 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441068,45.95406847833192,1.095780088267162e-5 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441062,45.768631861851304,0.0017669943917042463 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441056,44.31419674741762,0.01579204331360673 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441070,52.039640637752186,0.05399936398673777 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441057,45.95638746651087,1.0957524410271091e-5 +1017361 Sl10g086080 #2,log2-1,1,m_42,fruit,2441067,47.487422614027594,0.014243673961102044 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441068,153.97856662871928,0.05436189768825095 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441062,186.48835693831143,0.02882955240877383 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441056,173.8461020980872,0.0016572126296154899 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441070,167.9768404322994,0.01657276207557512 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441057,175.17538600245425,0.0016509129476980355 +1017361 Sl10g086080 #2,log2-1,1,m_42,leaf,2441067,184.49553419370224,0.02416368811254399 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441068,219.73849050111139,0.7307349324550563 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441062,33.18107552977069,0.09028074522174556 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441056,26.611817250446915,0.18609667195568735 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441070,164.72119827670545,0.6055782885907477 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441057,30.03243896146832,0.1335806012605265 +1017361 Sl10g086080 #2,log2-1,1,m_43,fruit,2441067,48.51500100895444,0.07470484041016978 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441068,353.26690334386296,0.0683950752084721 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441062,535.4587302196642,0.11222797714912236 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441056,360.9254757337473,0.059080489042572903 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441070,468.3277840879752,0.05405189693907797 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441057,307.661490870424,0.1284248864084443 +1017361 Sl10g086080 #2,log2-1,1,m_43,leaf,2441067,466.11739499266656,0.051997284001056965 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441068,43542.190189967005,0.09692888156277668 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441062,53209.2461673912,0.009852045829419787 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441056,32727.63182359559,0.22092457117693876 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441070,65718.03931580996,0.08184544586247355 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441057,55650.95879454521,0.009633499064059414 +1017361 Sl10g086080 #2,log2-1,1,m_44,fruit,2441067,61585.795641449775,0.053641404542098314 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441068,295446.67802463716,0.12947846861593604 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441062,224348.52356020332,0.009922573222463704 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441056,146079.77905865505,0.17641053922669858 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441070,193264.00701955392,0.05484966286288806 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441057,214213.11238272997,0.010154591277978575 +1017361 Sl10g086080 #2,log2-1,1,m_44,leaf,2441067,378464.25947508385,0.23702423032341802 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441068,55721.18883600671,0.06483215410492171 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441062,64159.822091479466,0.003589376794674415 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441056,42095.18874549387,0.1866200666789819 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441070,90330.995570388,0.14498426895549432 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441057,79780.06366446632,0.09104185072184645 +1017361 Sl10g086080 #2,log2-1,1,m_45,fruit,2441067,65224.75883221429,0.0035599541574651283 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441068,53694.43031819031,0.19504984454678187 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441062,33943.97733436842,0.0041166656932984935 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441056,21613.17686580089,0.2001607870430675 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441070,30003.66164486544,0.05770513523403231 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441057,34590.54498510431,0.004078010059099135 +1017361 Sl10g086080 #2,log2-1,1,m_45,leaf,2441067,70444.14283115738,0.31296549451563216 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441068,2801.523933001653,0.13834325913678747 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441062,2159.0973310762815,0.025221142767589022 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441056,1381.059415003518,0.16883871489187774 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441070,711.2345465399626,0.45703823449147096 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441057,5027.768418969686,0.39232418790082413 +1017361 Sl10g086080 #2,log2-1,1,m_46,fruit,2441067,1915.4660095067568,0.026776628088275523 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441068,20130.00819160819,0.14111874803665536 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441062,10324.76555100457,0.14884500485726626 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441056,12509.883702133468,0.06547193127891582 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441070,20008.87714569351,0.13849751408436806 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441057,16580.885129631675,0.05688250699044417 +1017361 Sl10g086080 #2,log2-1,1,m_46,leaf,2441067,9834.388873571495,0.16997782631996605 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441068,59.76848575741865,0.0220323186308633 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441062,65.98920887489246,0.020968350070108555 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441056,44.901657565115514,0.14624219821751683 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441070,72.60855795651234,0.06248323983484516 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441057,75.43188339132436,0.07905037966721351 +1017361 Sl10g086080 #2,log2-1,1,m_47,fruit,2441067,58.08401255434237,0.034447961075826594 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441068,272.8005912521911,0.01107718107186928 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441062,227.97156332748648,0.0890418108837312 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441056,286.8957707011325,0.01080165778142339 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441070,471.46176631127287,0.22652399061069906 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441057,287.1396795304344,0.011170723019416684 +1017361 Sl10g086080 #2,log2-1,1,m_47,leaf,2441067,259.09449666617473,0.03346429993247346 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441068,39.12994331274665,0.21811511543628348 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441062,88.43126729215768,0.13598151467544883 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441056,68.30204663132938,0.023809383081227375 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441070,61.01456892672143,0.025190786888432015 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441057,33.49589393468272,0.28563276149378813 +1017361 Sl10g086080 #2,log2-1,1,m_48,fruit,2441067,102.84606503932388,0.20156334576689638 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441068,3132.2803657125955,0.13034063170237653 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441062,5238.82725202331,0.09303281814335618 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441056,4218.601001154757,0.001032808489724868 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441070,3582.545274380748,0.07200957237881189 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441057,4238.689636783415,0.0010303581634980574 +1017361 Sl10g086080 #2,log2-1,1,m_48,leaf,2441067,4992.926076225237,0.07215387619297564 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441068,31.71826354031692,0.028346422744461863 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441062,29.474285793414623,0.0035196902254321927 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441056,29.919859545093452,0.002996569951000838 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441070,29.508395177667232,0.003017389591772446 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441057,31.89967120498581,0.030823226230553447 +1017361 Sl10g086080 #2,log2-1,1,m_49,fruit,2441067,22.494675860765593,0.1208832409691849 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441068,30.707462651830223,0.007445242741483948 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441062,36.21088358260579,0.0641499471280167 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441056,31.88,0.008829137676112708 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441070,31.226853538350724,1.609487356073469e-4 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441057,31.25000305655712,1.6088911039835452e-4 +1017361 Sl10g086080 #2,log2-1,1,m_49,leaf,2441067,30.51557967150437,0.010167550853840801 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441068,392.25014971055504,0.19074110107332354 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441062,376.66014523094793,0.208354549568885 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441056,362.7171783001875,0.22473609481831502 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441070,938.5118251008892,0.18813552994378258 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441057,1755.969379703305,0.46021271939248676 +1017361 Sl10g086080 #2,log2-1,1,m_5,fruit,2441067,824.8721367099307,0.1320824147630053 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441068,8909.741344986147,0.11129580824147878 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441062,10987.420492712286,0.020265159191075632 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441056,12773.579199546344,0.04515170044176564 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441070,12037.11621915567,0.019361549051418514 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441057,12441.206316137115,0.0337015875369282 +1017361 Sl10g086080 #2,log2-1,1,m_5,leaf,2441067,9250.235804036804,0.09500810086254408 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441068,162.12253172746466,0.035923421809000544 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441062,167.3552582737668,0.04971940705176925 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441056,136.38132796169432,0.03916504040743218 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441070,97.78767660133956,0.18363582773880482 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441057,211.62601888642277,0.15164910674419652 +1017361 Sl10g086080 #2,log2-1,1,m_50,fruit,2441067,100.94860779877666,0.16981962143106388 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441068,2880.0703101142567,0.160943101200965 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441062,3919.1942072470024,0.02714940682251976 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441056,7189.283188650849,0.2363393996127745 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441070,4424.842135883623,0.025551589718202816 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441057,3702.972778411529,0.05179567192265333 +1017361 Sl10g086080 #2,log2-1,1,m_50,leaf,2441067,5816.525410401687,0.14431743835321686 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441068,34.90903456873298,2.2397810717667e-5 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441062,37.33269755175189,0.029173931428680522 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441056,34.905433943721675,2.239896589650847e-5 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441070,34.86127839238688,5.721314732332061e-4 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441057,45.86755086624677,0.11859011077454107 +1017361 Sl10g086080 #2,log2-1,1,m_51,fruit,2441067,16.21815377820789,0.3329140264631141 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441068,244.81786796819856,0.036000048533481266 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441062,273.2856816664484,0.011773718142662482 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441056,258.66718754049634,0.012101818962161115 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441070,295.1028049962187,0.04513017752029658 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441057,229.39155426141775,0.06426573602844465 +1017361 Sl10g086080 #2,log2-1,1,m_51,leaf,2441067,281.5196942598586,0.024665622135367826 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441068,156.86492069393026,0.009777584941439876 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441062,139.49875427502013,0.04117791995125142 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441056,149.88061088147452,0.010002794807767668 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441070,158.73829799147265,0.014933470118990044 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441057,218.76545067583743,0.154230486226675 +1017361 Sl10g086080 #2,log2-1,1,m_52,fruit,2441067,93.04294849140544,0.21706478477942004 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441068,1745.3553357405806,0.008836758231835162 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441062,2377.614699993913,0.12542086093026805 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441056,1817.109710825133,0.008660533048914676 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441070,1820.592596887044,0.009492156162645315 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441057,1573.0495743152553,0.05397820672046105 +1017361 Sl10g086080 #2,log2-1,1,m_52,leaf,2441067,1592.0022471522184,0.04877693983563214 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441068,46.99651175873021,0.17058100683463873 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441062,46.33227397828854,0.17676301534171657 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441056,50.14816868919598,0.14239155306974194 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441070,182.39608564982427,0.418368882672828 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441057,179.7745896674349,0.41208167500638626 +1017361 Sl10g086080 #2,log2-1,1,m_53,fruit,2441067,89.06381655717921,0.10705467040430272 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441068,299.0160401293298,0.04328093038427516 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441062,215.87498202378745,0.18477310179853967 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441056,294.53243454461114,0.049842289011511554 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441070,426.82047886210904,0.11126983250764066 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441057,361.6856410286743,0.03935585134148889 +1017361 Sl10g086080 #2,log2-1,1,m_53,leaf,2441067,697.2635424386184,0.3244215417935954 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441068,306.5246819187244,0.08628865163335053 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441062,275.2448182934847,0.133034950293061 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441056,273.6421297451252,0.1355711402073707 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441070,515.681880201214,0.13962776956132217 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441057,618.5045964316022,0.2185888293782665 +1017361 Sl10g086080 #2,log2-1,1,m_54,fruit,2441067,441.2729710244964,0.07195322466610099 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441068,6309.903156676287,0.07207543191893917 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441062,8436.255453353064,0.05405159614944344 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441056,8064.527348237882,0.0344807932836364 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441070,6508.688600348181,0.058604631945935015 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441057,6833.477847499825,0.037456334857417506 +1017361 Sl10g086080 #2,log2-1,1,m_54,leaf,2441067,11218.634661893277,0.17784187958981867 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441068,55.67632807572368,0.09296147194668314 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441062,85.84778972672441,0.09509706088950387 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441056,29.714209432969657,0.36566787717931604 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441070,185.0323644896458,0.4286156413957427 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441057,16.296672826242887,0.6265331105306768 +1017361 Sl10g086080 #2,log2-1,1,m_55,fruit,2441067,82.25472529080137,0.0765287990496486 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441068,94.76731798436464,0.13311571952240442 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441062,406.8311416361629,0.4996398800644939 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441056,126.38605168381147,0.008075162682503745 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441070,131.13,0.007927751882748968 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441057,87.15123869846471,0.16950074511997015 +1017361 Sl10g086080 #2,log2-1,1,m_55,leaf,2441067,293.5186969843505,0.3578614614649256 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441068,91.9665228816526,0.1017985674682691 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441062,80.63212702845784,0.15892021784537191 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441056,107.9927733478258,0.03203363985657148 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441070,763.7239349025914,0.8175080672572359 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441057,124.5261642182265,0.02983227649230269 +1017361 Sl10g086080 #2,log2-1,1,m_56,fruit,2441067,282.43552315994685,0.38549098471448184 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441068,1374.6767200939987,0.1899939634868617 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441062,4808.180311716296,0.35378620427324803 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441056,2363.1533611829104,0.04529736536854667 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441070,1588.3494816522152,0.12724847588594335 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441057,1895.0317508265089,0.05057805064697485 +1017361 Sl10g086080 #2,log2-1,1,m_56,leaf,2441067,5198.696680545739,0.38769993761878574 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441068,90.18124309514288,0.1441567202273808 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441062,133.5840177660371,0.02648156373675148 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441056,195.37148591499772,0.1915882418483026 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441070,153.11071149765516,0.0857326369087903 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441057,117.77989810138637,0.028201763482957443 +1017361 Sl10g086080 #2,log2-1,1,m_57,fruit,2441067,77.1340783164251,0.21202664327475795 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441068,38898.49218694437,0.044317579420043884 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441062,20254.413795284025,0.32773066829865893 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441056,47256.479149907726,0.040211014717423055 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441070,58453.27314509505,0.13255848828226746 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441057,34494.77644864232,0.09649701187155912 +1017361 Sl10g086080 #2,log2-1,1,m_57,leaf,2441067,50001.837162107266,0.06473561481247536 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441068,196042.1534076917,0.005625507217197345 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441062,206269.88063684045,0.016460845716077976 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441056,214600.06416709637,0.033654875934088224 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441070,201153.93894243575,0.005553569675202041 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441057,110020.64469650398,0.25650078606304927 +1017361 Sl10g086080 #2,log2-1,1,m_58,fruit,2441067,66985.42716209103,0.47199464036701144 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441068,193437.334204822,0.17303944858200726 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441062,125965.47500513012,0.01324932119051958 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441056,111789.75770648876,0.06509883502209401 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441070,182999.8791102739,0.14894995295109847 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441057,99093.51070725442,0.11745563491795075 +1017361 Sl10g086080 #2,log2-1,1,m_58,leaf,2441067,133769.7460441958,0.012857052697171412 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441068,365.7054020244484,0.029293511982734888 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441062,416.7415141486174,0.027441877760862265 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441056,330.81885905205655,0.072834628065229 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441070,341.3301392490908,0.059250249640271146 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441057,452.27705516857066,0.06297966820421363 +1017361 Sl10g086080 #2,log2-1,1,m_59,fruit,2441067,474.4580028688054,0.08377288889063017 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441068,2579.2285089105294,0.14139166241696355 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441062,2099.040493729234,0.05192265876476965 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441056,828.5991719129155,0.35175366317256085 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441070,1985.9873111511715,0.027878311269609046 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441057,1213.011513271921,0.18623323512637668 +1017361 Sl10g086080 #2,log2-1,1,m_59,leaf,2441067,1739.0287854850606,0.029791387334634933 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441068,60.14841725489289,0.0928762855744909 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441062,54.947498259807624,0.13215256544297072 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441056,55.35876460127695,0.1289140996353335 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441070,88.83244552667753,0.07647112887307639 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441057,231.5549871983453,0.4925536498251586 +1017361 Sl10g086080 #2,log2-1,1,m_6,fruit,2441067,101.99880274382244,0.13649458468956954 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441068,8.18830712225759,0.9892037439724745 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441062,68.426320679904,0.06717467915703068 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441056,93.12687618228198,0.06667716783297561 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441070,91.60125930928116,0.05950357673861428 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441057,91.31889616162046,0.05816278568136379 +1017361 Sl10g086080 #2,log2-1,1,m_6,leaf,2441067,44.948212884874934,0.24968543841970803 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441068,36.31377500794144,0.0964746915323611 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441062,36.17443749682002,0.09814430331175439 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441056,55.2991303717633,0.08617221170154532 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441070,65.38072301587495,0.15890362894928511 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441057,54.37970898466712,0.0788907891241808 +1017361 Sl10g086080 #2,log2-1,1,m_60,fruit,2441067,27.9848763345994,0.2096226978919975 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441068,54.82077774839281,0.07867788011715282 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441062,26.161267555125512,0.2426085300914156 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441056,94.43263811621507,0.3148548100044746 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441070,36.6531459478692,0.09615605634225699 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441057,35.81918010516333,0.10615167181231344 +1017361 Sl10g086080 #2,log2-1,1,m_60,leaf,2441067,85.5449484238213,0.2719270562854592 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441068,99.01952359627684,0.03881904144607451 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441062,152.3117357473314,0.1481934934157345 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441056,117.53630119896069,0.035632145626665945 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441070,69.58852367295893,0.1920022509699304 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441057,145.12128332972054,0.12719123630096973 +1017361 Sl10g086080 #2,log2-1,1,m_61,fruit,2441067,39.45763732540854,0.43840879728709914 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441068,684.8957920551161,0.10563612230771868 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441062,614.72,0.15258327707370523 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441056,916.2111231718573,0.020734939726601898 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441070,830.7796688280059,0.02177476049027982 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441057,979.539817466232,0.04976147413813603 +1017361 Sl10g086080 #2,log2-1,1,m_61,leaf,2441067,1335.4995827904445,0.18438313642867943 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441068,732.1965816560872,0.11821009535662697 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441062,561.6403416478646,0.003040693218707702 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441056,293.26217624387345,0.2791615485735903 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441070,652.2043793248226,0.06796610897572464 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441057,553.8032103043391,0.0030621326907698254 +1017361 Sl10g086080 #2,log2-1,1,m_62,fruit,2441067,356.87380153295993,0.19390293451161655 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441068,1071378.4603943266,0.007931011500553531 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441062,1329749.9528448188,0.1017580842725394 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441056,1032602.9338591932,0.00807854467715785 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441070,1089666.0100237944,0.015281504831628823 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441057,918564.167726848,0.0589023993020481 +1017361 Sl10g086080 #2,log2-1,1,m_62,leaf,2441067,988174.507226605,0.027178253483352677 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441068,453.2222319374797,0.10909228291831319 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441062,251.87485095976095,0.14603411576591885 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441056,140.6579884524022,0.39905451998548136 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441070,1915.3811967508,0.7350362973778863 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441057,1675.5612240146877,0.6769413790553727 +1017361 Sl10g086080 #2,log2-1,1,m_63,fruit,2441067,64.46655012626209,0.7378844923435262 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441068,4994.575343990939,0.1856113131788999 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441062,3200.7085827114593,0.007641121326898759 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441056,2716.557081132338,0.07886842074440992 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441070,3924.418916723302,0.08088810471967234 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441057,3312.9921776862393,0.0073331547302677436 +1017361 Sl10g086080 #2,log2-1,1,m_63,leaf,2441067,3202.050296569652,0.007459106372276203 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441068,526.938917376343,0.014385044577385653 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441062,314.33875238189876,0.20997730513856006 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441056,191.46376739920024,0.4252886300501806 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441070,492.6033283740673,0.014877888336735978 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441057,824.0220055274614,0.20856357944827453 +1017361 Sl10g086080 #2,log2-1,1,m_64,fruit,2441067,615.2110194343172,0.08164887553836042 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441068,9490.580920784478,0.210250695325648 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441062,9354.451575508743,0.2039762299636676 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441056,3987.339770450257,0.166358856709786 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441070,6173.104047526935,0.023461495865364057 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441057,4174.910206713751,0.1463949620016063 +1017361 Sl10g086080 #2,log2-1,1,m_64,leaf,2441067,5523.831499645705,0.024801678907113267 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441068,51.751379809109885,0.1529273850573145 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441062,112.34866822977078,0.18371861008484225 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441056,101.0688272520836,0.1377679077960321 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441070,45.90144644425303,0.20502294739562243 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441057,73.29885077861202,0.0017521530393653784 +1017361 Sl10g086080 #2,log2-1,1,m_65,fruit,2441067,73.89149118345188,0.001745112406189575 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441068,2169.9707891310795,0.01773920179294075 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441062,2916.012634500875,0.14607471548297513 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441056,760.486396967044,0.4376232357667815 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441070,2084.7279413158035,3.3470134769908455e-4 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441057,1833.527017404792,0.05542737211440629 +1017361 Sl10g086080 #2,log2-1,1,m_65,leaf,2441067,2081.515869899161,3.349594937365197e-4 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441068,581.2629579333883,0.04647863952192299 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441062,320.3306901501277,0.30525273771659434 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441056,209.7153776102631,0.4892210103813541 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441070,751.4778134097619,0.06506487589155974 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441057,999.4465340213673,0.18890827910357055 +1017361 Sl10g086080 #2,log2-1,1,m_66,fruit,2441067,712.5791550721515,0.04198182674196449 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441068,6055.498984352971,0.1732046746026219 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441062,6692.917484463182,0.2166702096912978 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441056,2930.676604901254,0.1419773635853372 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441070,4281.027142834911,0.02260272036179467 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441057,2738.6198036094215,0.17141351670371385 +1017361 Sl10g086080 #2,log2-1,1,m_66,leaf,2441067,3846.814933307875,0.02384396771677677 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441068,371.994661237156,0.07386006266533407 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441062,331.7978557718737,0.02419693070070572 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441056,271.40562899327955,0.06305779363938324 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441070,250.95368847379427,0.09708306113895793 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441057,369.0417028770683,0.07039880119027853 +1017361 Sl10g086080 #2,log2-1,1,m_67,fruit,2441067,295.8364015149828,0.025625033198526825 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441068,422.9358743800212,0.0018755395723015766 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441062,304.76304335385134,0.1441877623512795 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441056,426.5967464111686,0.0018674747032498829 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441070,213.72191630973757,0.29830100455123976 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441057,652.62,0.18651031479187763 +1017361 Sl10g086080 #2,log2-1,1,m_67,leaf,2441067,2088.304696819597,0.6916438011315806 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441068,179.02432315393384,0.01291582707134964 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441062,200.79834157871835,0.036932254075193516 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441056,189.83253540217643,0.012542780696461975 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441070,124.52175537697984,0.17058263323309575 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441057,216.8440593497949,0.07031966122105171 +1017361 Sl10g086080 #2,log2-1,1,m_68,fruit,2441067,105.13468728284704,0.24408184025750446 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441068,1385.8668729557096,0.14121021331566563 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441062,994.75,0.002797352606652037 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441056,958.734373273692,0.0188130021186943 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441070,1214.6102306028422,0.08392563441815115 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441057,957.85546519259,0.019211318909087893 +1017361 Sl10g086080 #2,log2-1,1,m_68,leaf,2441067,1007.6060120830366,0.0027794497137185736 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441068,42.60237784430122,0.055065851689352296 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441062,42.96428570815936,0.051392095603761234 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441056,78.3795277585663,0.20970295095977343 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441070,53.758698454083095,0.04594905397780713 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441057,74.9389140684546,0.1902077039504393 +1017361 Sl10g086080 #2,log2-1,1,m_69,fruit,2441067,13.50476191275919,0.5540127595051687 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441068,130.73486648978255,0.0434612001947734 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441062,67.13233189570333,0.3329208948872684 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441056,139.54700453436834,0.015132109387260506 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441070,149.44286807789,0.014622565956207811 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441057,239.23282629058843,0.2189681431434929 +1017361 Sl10g086080 #2,log2-1,1,m_69,leaf,2441067,257.3418621086206,0.2506578112567408 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441068,37.11268471448466,0.13212144448301233 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441062,34.082654035839816,0.09513247850759687 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441056,20.673246172694473,0.12199225151149262 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441070,19.497504799020277,0.14742189175609433 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441057,14.703810306140324,0.26997103641957243 +1017361 Sl10g086080 #2,log2-1,1,m_7,fruit,2441067,116.83065224943245,0.630155873641967 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441068,205.97949980017964,0.0440130920180426 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441062,233.7545179719968,0.010922922414110303 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441056,273.33588725429,0.07885956433509733 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441070,185.60282364606792,0.08925251217009889 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441057,278.5054567803321,0.08699661757095223 +1017361 Sl10g086080 #2,log2-1,1,m_7,leaf,2441067,222.1428520498557,0.01120474779801528 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441068,1474.6845339082367,0.029672924231453734 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441062,1279.9005848426432,0.03184996376441429 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441056,906.0462090339198,0.18187585369381587 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441070,4171.168378646528,0.48123152020012316 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441057,896.0153338922828,0.18671075928638903 +1017361 Sl10g086080 #2,log2-1,1,m_70,fruit,2441067,1932.1329676407036,0.14701080958213364 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441068,569796.0748477469,0.10028324733868033 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441062,476836.4168843501,0.02293321002422921 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441056,309316.9105839787,0.16503254199983441 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441070,502401.03754542035,0.0456143217714331 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441057,427783.6170687255,0.024212057577616797 +1017361 Sl10g086080 #2,log2-1,1,m_70,leaf,2441067,341717.0020618181,0.12176961827983845 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441068,99.27326605811449,0.08679336677363114 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441062,135.04617668839205,0.046856616289201014 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441056,110.39754515152774,0.0406662606981385 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441070,107.1213514745264,0.053749633809534014 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441057,139.79225153031055,0.06185742276584261 +1017361 Sl10g086080 #2,log2-1,1,m_71,fruit,2441067,132.07114854396931,0.03718227762200632 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441068,4378.216760949403,0.008676798405378161 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441062,4227.204108104317,0.006567242832995479 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441056,4356.0200866025325,0.006469412893262305 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441070,5761.753031480749,0.12793417816455444 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441057,2955.0551685051623,0.16205486760412624 +1017361 Sl10g086080 #2,log2-1,1,m_71,leaf,2441067,3588.010629249994,0.07776673988269911 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441068,65.92400976124729,0.1222307397168978 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441062,101.97643075875004,0.06722545257663337 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441056,122.606491681149,0.14723911077376362 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441070,72.72817335232352,0.07957167480499283 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441057,162.60505489985638,0.26985968763900847 +1017361 Sl10g086080 #2,log2-1,1,m_72,fruit,2441067,49.0401934018758,0.25072218047297423 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441068,747.4656441320063,0.03038355869424514 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441062,745.9408198997555,0.02949669634830654 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441056,584.8501491306116,0.07616307223872587 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441070,598.7543512037169,0.06595899473031874 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441057,647.9786135487759,0.03164700494958428 +1017361 Sl10g086080 #2,log2-1,1,m_72,leaf,2441067,991.557315134961,0.15311014563249925 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441068,76.96983622659643,0.05035980360105907 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441062,69.52437649426969,0.006176343846662435 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441056,66.71392521729037,0.011744265090682271 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441070,67.56088176005015,0.006265449823633196 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441057,56.72778637459481,0.08216492198050074 +1017361 Sl10g086080 #2,log2-1,1,m_73,fruit,2441067,81.05651285259032,0.07282715705876575 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441068,1699.368567220047,0.0017725201721883188 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441062,1933.773824617821,0.05434557623509795 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441056,1713.2684460128792,0.0017653152425061158 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441070,1827.8483976356545,0.02988007122923042 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441057,1615.9798940509045,0.0236241481312649 +1017361 Sl10g086080 #2,log2-1,1,m_73,leaf,2441067,1660.112031192284,0.011922704123005001 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441068,106.38655663105396,0.009452930269321591 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441062,106.87800603478829,0.007451339950612645 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441056,93.84656311114668,0.06392131042928306 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441070,115.70329743352532,0.027006053346104952 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441057,160.3190785206298,0.16864552520345866 +1017361 Sl10g086080 #2,log2-1,1,m_74,fruit,2441067,110.5771343943816,0.007325648250101402 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441068,864.6979382643563,0.0054699456213844755 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441062,1056.5708432776198,0.0815642528012388 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441056,770.474551828078,0.05557607020743793 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441070,822.0928176426978,0.027413515159425472 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441057,886.6174542518465,0.005401907624256186 +1017361 Sl10g086080 #2,log2-1,1,m_74,leaf,2441067,1160.2252669012855,0.12220795002675322 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441068,122.03889121723888,0.001319891469060419 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441062,103.80314057979288,0.0689678683855961 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441056,115.44827716633674,0.022790905413685003 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441070,126.38941043448082,0.016532326266277764 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441057,141.6369232711379,0.06599812242052927 +1017361 Sl10g086080 #2,log2-1,1,m_75,fruit,2441067,121.29822526521724,0.001323915065080783 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441068,7128.171906173322,0.05166477023534011 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441062,8540.069332349394,0.026818461482817746 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441056,8113.410367257944,0.00456050763456517 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441070,7843.157256168479,0.010152012280230327 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441057,7943.904765291978,0.0046089060073439825 +1017361 Sl10g086080 #2,log2-1,1,m_75,leaf,2441067,8266.71853556472,0.012690216032965385 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441068,28.26206724702035,0.10276716540616015 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441062,8.345720799074797,0.6325072392631961 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441056,28.137512507531927,0.1046853897699418 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441070,43.35245293509629,0.08304258459451352 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441057,53.176094499311304,0.17174534672334651 +1017361 Sl10g086080 #2,log2-1,1,m_76,fruit,2441067,89.46020682118855,0.39765880704541456 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441068,132.4333439838511,0.042250284269650606 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441062,159.4959152056438,0.03850193543878522 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441056,209.6703439021581,0.15728937799359866 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441070,250.94797353922857,0.23533606347551572 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441057,94.74314293563104,0.1876998419524405 +1017361 Sl10g086080 #2,log2-1,1,m_76,leaf,2441067,67.95869691886365,0.33200258668014926 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441068,721.0516226917172,0.02529169343027693 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441062,575.7008946320178,0.07247776076995383 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441056,529.3350589151324,0.10894400598151943 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441070,676.5139402259284,0.002397915028934161 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441057,819.6262561809797,0.08094119717251891 +1017361 Sl10g086080 #2,log2-1,1,m_77,fruit,2441067,684.005215108997,0.0023847478408307587 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441068,14576.430531117889,0.022515908354302283 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441062,17140.00919099107,0.04784395492496074 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441056,14089.894658010033,0.037259349391175256 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441070,15377.335383426049,7.139909920352849e-4 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441057,15326.815474739324,7.151667443174858e-4 +1017361 Sl10g086080 #2,log2-1,1,m_77,leaf,2441067,15941.968728413583,0.016374857343478766 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441068,59.81301150738314,0.011560445291049382 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441062,59.54480650348683,0.013512226099387847 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441056,60.05485829255941,0.009807967884641666 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441070,67.2441357016405,0.039298301492822985 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441057,62.79823899307768,0.009591350876435145 +1017361 Sl10g086080 #2,log2-1,1,m_78,fruit,2441067,63.51792368706426,0.014540178749769428 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441068,97.36685190671317,0.0018953011932298924 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441062,116.85182467014384,0.07732906870552725 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441056,96.60844473926116,0.005291339058890232 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441070,99.10360522500054,0.00578302399510866 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441057,98.21854484061222,0.0018870658507164073 +1017361 Sl10g086080 #2,log2-1,1,m_78,leaf,2441067,97.25102560707312,0.0024122396099328647 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441068,102.62673910729598,0.0068522577861314105 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441062,96.32978317136056,0.034352204773190564 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441056,94.56324406402094,0.04239042491201106 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441070,111.06818973553423,0.02747690599278707 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441057,105.890892359808,0.006745820683499826 +1017361 Sl10g086080 #2,log2-1,1,m_79,fruit,2441067,124.2147119129192,0.07606024894686181 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441068,241.103776891116,8.599162237743485e-4 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441062,281.0862264422411,0.06749546775438464 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441056,239.88372915055737,0.0013433058188696556 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441070,244.648413398202,0.007198306173641367 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441057,240.1499359628935,8.616222625010828e-4 +1017361 Sl10g086080 #2,log2-1,1,m_79,leaf,2441067,234.4875081301248,0.011224385964639705 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441068,34.57193413423597,0.03983024611846986 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441062,41.21318169193419,0.03648222067632112 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441056,25.28178676635839,0.17574615899145773 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441070,170.70802577898365,0.6537000167620255 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441057,17.969569408372195,0.3240162524849164 +1017361 Sl10g086080 #2,log2-1,1,m_8,fruit,2441067,58.48770875415065,0.18851068524748316 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441068,283.78451674216706,0.07808834666976727 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441062,321.8945573508688,0.023363409748440755 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441056,277.68784400991893,0.0875201747642751 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441070,357.476496827909,0.022170449946606663 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441057,437.1101444269232,0.10951384231826333 +1017361 Sl10g086080 #2,log2-1,1,m_8,leaf,2441067,448.28259589859186,0.12047483479599075 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441068,46.21088694064088,0.008004958253915673 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441062,45.08241580720487,0.01874208210560302 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441056,45.29286521130325,0.016719467534692667 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441070,47.93021078761314,0.007860076529054183 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441057,52.528191885199135,0.04764318945513857 +1017361 Sl10g086080 #2,log2-1,1,m_80,fruit,2441067,69.58736260179046,0.1697811144057022 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441068,130.34808216931185,0.032496849365844405 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441062,154.88272282289708,0.042401479807324005 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441056,138.56409119755648,0.005950797380099182 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441070,149.8778655262318,0.028136004417286475 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441057,133.27470852498286,0.022853753692514633 +1017361 Sl10g086080 #2,log2-1,1,m_80,leaf,2441067,142.38749652844473,0.005870359200966124 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441068,171.17582218581236,0.05793991696143452 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441062,157.13571425892343,0.09510743553110501 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441056,106.493414086326,0.2640595891316213 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441070,226.01301854133243,0.06275111610386253 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441057,283.61772717780315,0.16135103290865516 +1017361 Sl10g086080 #2,log2-1,1,m_81,fruit,2441067,220.03632854508845,0.051112050347025484 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441068,7508.068982253412,0.018714391823510645 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441062,7008.054064307299,0.011216418753317026 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441056,7724.611139033875,0.03106276370287908 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441070,7374.759731939514,0.010934013328541603 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441057,6347.029212838835,0.05424336513033978 +1017361 Sl10g086080 #2,log2-1,1,m_81,leaf,2441067,6819.213764501599,0.023079557679606566 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441068,6055.397443634302,8.615076235471975e-4 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441062,6845.942213357877,0.05242906814886794 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441056,3923.2079728663057,0.18936282969588714 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441070,5217.260274140164,0.06556165781797985 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441057,7131.945828991861,0.07020387502705594 +1017361 Sl10g086080 #2,log2-1,1,m_82,fruit,2441067,6079.4454062139985,8.598020383185911e-4 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441068,255790.1987010689,0.07748406040329936 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441062,116937.7044330516,0.4174133955996222 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441056,274615.07829962217,0.04664358030989746 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441070,336887.0252726395,0.042116325377924646 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441057,352050.9788154357,0.06123759644741167 +1017361 Sl10g086080 #2,log2-1,1,m_82,leaf,2441067,426013.60384896066,0.14405550791806565 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441068,109.073470957273,0.09583376452806291 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441062,167.73377838380176,0.09106763195169743 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441056,110.42557713883735,0.09048322031249967 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441070,174.98743333705542,0.1094539630085638 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441057,161.58318480605266,0.07484326574049716 +1017361 Sl10g086080 #2,log2-1,1,m_83,fruit,2441067,103.6749578692647,0.1178790305368258 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441068,1778.6781993076684,0.18129572721008236 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441062,1526.6213879588513,0.24766176674619134 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441056,3874.142458937607,0.15678247713991533 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441070,2238.93609568105,0.08135141129266055 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441057,3161.4287929184534,0.0684902950415478 +1017361 Sl10g086080 #2,log2-1,1,m_83,leaf,2441067,3825.4784427091727,0.15129264967760125 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441068,209.90510243620892,0.11434613694563822 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441062,192.5742880330716,0.15177083171203298 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441056,122.1217811256774,0.3495760028319914 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441070,336.3545553189584,0.09042818118126705 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441057,458.4620437523528,0.2249342534714427 +1017361 Sl10g086080 #2,log2-1,1,m_84,fruit,2441067,464.1386606399293,0.23027861206433453 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441068,12171.40538642915,0.07368962668766166 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441062,10272.20832479845,1.2717703688380766e-5 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441056,6995.755688143969,0.1668164665267171 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441070,10839.64428059898,0.023363929613657852 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441057,10271.606719231862,1.2718076118467536e-5 +1017361 Sl10g086080 #2,log2-1,1,m_84,leaf,2441067,9735.035764291391,0.023313549431673852 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441068,42.65821773365968,0.018532144843309117 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441062,39.094190992034115,0.019358331415465724 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441056,39.02300532880638,0.020149848539581905 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441070,48.165347459423494,0.0712641358206838 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441057,34.81247895891605,0.06973561173952669 +1017361 Sl10g086080 #2,log2-1,1,m_85,fruit,2441067,55.36006483834815,0.131726028335154 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441068,361.6397191164906,0.06400101276443548 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441062,430.0606871737265,0.011252608499552341 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441056,366.9396267961648,0.05768252110534444 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441070,415.44545405224,0.0037631248913405635 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441057,422.6763356226028,0.0037307976453000435 +1017361 Sl10g086080 #2,log2-1,1,m_85,leaf,2441067,443.362124628142,0.02448145359651832 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441068,1139.072551737131,0.022115799784592216 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441062,1073.5039421824713,0.003631943378591629 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441056,990.20062814777,0.03871238949838274 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441070,632.6560674699379,0.23326790951022636 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441057,1336.6833370045351,0.0915929472079351 +1017361 Sl10g086080 #2,log2-1,1,m_86,fruit,2441067,1091.5343535166194,0.003601821678796746 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441068,10949.639655152818,0.020464115597699006 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441062,10358.880507719548,0.003622888088918863 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441056,10532.431111910828,0.0035929157839476034 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441070,9267.22260038092,0.05198611651208873 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441057,8222.495058211358,0.10393209035119932 +1017361 Sl10g086080 #2,log2-1,1,m_86,leaf,2441067,10561.00153903242,0.004769394419522399 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441068,308.83586645532864,0.0775051494923864 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441062,385.10415237858103,0.01834532082419127 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441056,353.246862665202,0.019154567211468798 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441070,386.1820365287905,0.019559187868753547 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441057,449.87501292064616,0.0858589915379242 +1017361 Sl10g086080 #2,log2-1,1,m_87,fruit,2441067,314.007514180651,0.07029283975819611 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441068,19081.94773125957,0.05088219401044913 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441062,26070.91988252172,0.1864158471248869 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441056,16303.308682926014,0.017464756442662654 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441070,14376.495407854514,0.07208747793671044 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441057,16257.55098320426,0.01868538327986613 +1017361 Sl10g086080 #2,log2-1,1,m_87,leaf,2441067,17641.276326380084,0.01678949475009084 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441068,92.00311271172058,0.019557487488964798 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441062,93.96747152760248,0.010382467391958361 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441056,98.514475952895,0.010140043028798118 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441070,60.67679500742861,0.20033737545940355 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441057,149.0203545978193,0.1898855840492364 +1017361 Sl10g086080 #2,log2-1,1,m_88,fruit,2441067,102.20463749271802,0.026110593747816324 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441068,1160.3730100241842,0.0795375187365619 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441062,1525.1649026628595,0.19825670272865814 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441056,845.1421458796436,0.05813034012148277 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441070,823.2461415365749,0.0695303960357121 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441057,844.8880589379601,0.05826092779644121 +1017361 Sl10g086080 #2,log2-1,1,m_88,leaf,2441067,1087.2270049142155,0.05126013107816929 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441068,2522.9536644295276,0.06333854583815235 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441062,2611.1494964760745,0.04841608309577472 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441056,1695.70385217605,0.23589781358077433 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441070,4911.848288699244,0.22599712402319305 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441057,4571.0483609647845,0.19476799573214088 +1017361 Sl10g086080 #2,log2-1,1,m_89,fruit,2441067,3227.0350094788732,0.04355585665827233 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441068,139252.11381947188,0.24431736498143763 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441062,91628.96783824764,0.06254836302956601 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441056,67048.1951588604,0.0730973396573642 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441070,128934.19446964444,0.2108836798842484 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441057,57912.41154760027,0.13671278152551736 +1017361 Sl10g086080 #2,log2-1,1,m_89,leaf,2441067,65051.924051049886,0.08622428513429892 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441068,34.44812154668205,0.04369736917785594 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441062,47.793794683486375,0.09850859954106972 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441056,41.740990081056474,0.039699832134538315 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441070,52.51872258173661,0.13945124013304522 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441057,17.78066096985158,0.3309150128325278 +1017361 Sl10g086080 #2,log2-1,1,m_9,fruit,2441067,29.87632413618916,0.1055357514551114 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441068,131.82387921851745,5.31554764918063e-4 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441062,155.79652522262393,0.07309523440875987 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441056,130.7461754561747,0.003033538946881187 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441070,133.1060218984641,0.004735171161802221 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441057,131.5013849227826,5.32206158768922e-4 +1017361 Sl10g086080 #2,log2-1,1,m_9,leaf,2441067,130.7561493179169,0.003000410422125288 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441068,105.29630422832562,0.09907939046436032 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441062,81.31519848455932,0.013162011363533344 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441056,86.31942890283838,0.01277482056998136 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441070,126.46745497655084,0.17864504114749136 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441057,57.27275611646621,0.16538565476768863 +1017361 Sl10g086080 #2,log2-1,1,m_90,fruit,2441067,56.880961879217594,0.16836680591011066 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441068,1600.5598594121152,0.15492832589600303 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441062,2259.533972958806,0.005181371379069155 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441056,3142.5472501753743,0.13808156941863192 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441070,1885.743464547004,0.0837176356304088 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441057,2313.771832623351,0.005120282879791382 +1017361 Sl10g086080 #2,log2-1,1,m_90,leaf,2441067,2701.4248937361463,0.07239265070781409 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441068,386.0397561022097,0.05693058626306291 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441062,455.8535707056623,0.015262742154163345 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441056,424.3692308998695,0.015818731192426938 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441070,649.4782442669364,0.16900198915535025 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441057,367.3274018542001,0.07850929181614141 +1017361 Sl10g086080 #2,log2-1,1,m_91,fruit,2441067,550.663185608357,0.09732342402060556 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441068,936392.9705166396,0.0021935056824542443 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441062,1179760.536544111,0.09814221427489223 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441056,945875.8407469672,0.0021824825215839283 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441070,840856.3415314427,0.048929846607001615 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441057,915515.3071558028,0.01198604050050367 +1017361 Sl10g086080 #2,log2-1,1,m_91,leaf,2441067,1020450.8396322116,0.035140436876873515 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441068,169.4554975378723,0.010291628223838778 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441062,196.7390620617968,0.05454330542485897 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441056,193.84935575876432,0.048117070838360476 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441070,67.32925130588812,0.41114350598150384 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441057,177.58270624364332,0.010053378897178167 +1017361 Sl10g086080 #2,log2-1,1,m_92,fruit,2441067,89.63564597177647,0.28686653853416155 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441068,144968.3801185081,0.07518730102099802 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441062,189508.02897300196,0.04116702751119572 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441056,155231.1022278391,0.0454818459044084 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441070,68789.98102921774,0.3989353974542267 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441057,220812.62984867132,0.107563323030619 +1017361 Sl10g086080 #2,log2-1,1,m_92,leaf,2441067,338346.18297753145,0.2929006942575656 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441068,4.849162141834709,0.6079144576197658 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441062,20.592140883850984,0.02012033733501517 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441056,18.727646355283913,0.021097963780325912 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441070,32.239559706960534,0.21480793853070201 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441057,218.0501004856882,1.0449751276302186 +1017361 Sl10g086080 #2,log2-1,1,m_93,fruit,2441067,11.16405699652077,0.24575911846693632 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441068,126.04682233907177,0.05159605472220141 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441062,152.46972242007186,0.031055653402745964 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441056,403.0213061037942,0.45320004989990226 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441070,135.07643152947713,0.02154837738338289 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441057,65.65872484574744,0.3348355121705169 +1017361 Sl10g086080 #2,log2-1,1,m_93,leaf,2441067,148.8187045472992,0.02052956348771362 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441068,406.5467315354916,0.04449394244723459 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441062,353.1128291472898,0.016703034967794128 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441056,358.22490263593875,0.010460758113241653 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441070,115.89567085837332,0.5005493176974323 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441057,959.7212596489134,0.41752858393545633 +1017361 Sl10g086080 #2,log2-1,1,m_94,fruit,2441067,375.6913868286682,0.010214707038019188 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441068,2897.7678517038125,7.595748579887207e-4 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441062,2899.489822917822,0.0010175736085042963 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441056,2545.148223295274,0.055590935451136136 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441070,3077.921821876823,0.026953569585850712 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441057,2767.2751051122145,0.019251679006649258 +1017361 Sl10g086080 #2,log2-1,1,m_94,leaf,2441067,2887.6404013385854,7.60905671501444e-4 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441068,41.39236058942999,0.1599727334032628 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441062,67.86768090524531,0.05477008109624748 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441056,65.17294151047096,0.037174394703972435 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441070,41.75292185280386,0.15620605550978905 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441057,65.81836711492618,0.041454175551312256 +1017361 Sl10g086080 #2,log2-1,1,m_97,fruit,2441067,54.47987441412262,0.04065683036809409 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441068,72.87417400852495,9.429726992813414e-4 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441062,15.383504546733484,0.6764613337630703 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441056,57.59671871278364,0.10311887563341071 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441070,73.19097754476138,9.409296814986146e-4 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441057,189.82251976537344,0.41483111607573764 +1017361 Sl10g086080 #2,log2-1,1,m_97,leaf,2441067,192.8283270774482,0.42165421546708504 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441068,683.4462988536288,0.03286665795559651 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441062,575.5431799324564,0.10749314193717119 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441056,441.91990296732735,0.22222749238175465 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441070,790.9052473586253,0.030553403009139224 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441057,1351.908725156852,0.2633763170484249 +1017361 Sl10g086080 #2,log2-1,1,m_98,fruit,2441067,922.7084568944748,0.09749344714418973 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441068,11821.620615580936,0.11517798649427746 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441062,12279.248145818052,0.09868322825367937 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441056,20032.827570637688,0.11388724875130674 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441070,21774.31331278607,0.15008946356649755 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441057,14243.634031696893,0.0342341975539 +1017361 Sl10g086080 #2,log2-1,1,m_98,leaf,2441067,16580.082341818994,0.03173167889070516 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441068,10266.316378584475,0.15979815806360342 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441062,13789.386186629808,0.03166786725807036 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441056,9261.696340360571,0.20452226406475882 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441070,17104.858971359743,0.061906695889635266 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441057,17609.813163575953,0.07454194630674671 +1017361 Sl10g086080 #2,log2-1,1,m_99,fruit,2441067,15875.507590754216,0.029514818058033576 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441068,75127.38899609218,0.014864194623448235 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441062,75002.04962647059,0.015589358318703006 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441056,79859.77113021733,0.011665571116256324 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441070,75626.65657161394,0.01198758928976229 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441057,85855.63992641387,0.04310633948862197 +1017361 Sl10g086080 #2,log2-1,1,m_99,leaf,2441067,118853.66659350702,0.18435009400065372 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441074,31.121229328935076,0.35264551127859156 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441076,76.87070696210736,0.040058620062941364 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441058,217.63596840303833,0.4920284170907536 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441069,41.16324734500644,0.2311926264457429 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441064,154.4377655130302,0.34305125426549465 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,fruit,2441063,63.32420453318565,0.04413251215977376 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441074,40.680846984904605,0.02610273375686778 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441076,112.44832979190966,0.4676657564909026 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441058,34.395342409672296,0.046787615442619224 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441069,35.93476030857261,0.027772500323564042 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441064,956.816579485988,1.3975414393568286 +1017361 Sl10g086080 #2,log2-1,0.4,m_1,leaf,2441063,28.976500972230095,0.12124131118753034 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441074,56.28167279224787,0.011894775793863221 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441076,54.0428489218289,0.005733985958141563 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441058,55.479365664345515,0.005659265655662882 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441069,42.24780594704289,0.11266806149135222 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441064,48.298763243283226,0.05453621098924355 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,fruit,2441063,59.79431221043015,0.03818765356764042 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441074,385.9363680598695,0.033307046491051207 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441076,359.57734803128477,0.0025836660530145217 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441058,355.3117178963225,0.0025991286032973626 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441069,309.17786558432937,0.06300026431922845 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441064,360.527458466553,0.0037296880069055405 +1017361 Sl10g086080 #2,log2-1,0.4,m_10,leaf,2441063,318.29296540009096,0.050381618638462466 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441074,142.02526604386776,0.3189839376456962 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441076,155.85419316545216,0.3593368173764617 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441058,12.998307489689012,0.7194948673507879 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441069,12.155056278308695,0.748624699849642 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441064,118.26326090388672,0.2394681759124231 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,fruit,2441063,18.010320418345778,0.5778602344886619 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441074,3280.0251164432807,0.010093130955665774 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441076,3465.363894229833,0.013778545906871997 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441058,3426.31027922009,0.008856388931899328 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441069,4165.871840993144,0.09373560492485122 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441064,3287.982824841465,0.009040759957370081 +1017361 Sl10g086080 #2,log2-1,0.4,m_100,leaf,2441063,2539.822866107473,0.12116687140132365 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441074,39.604961860878745,0.018165990991421133 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441076,42.6113270040815,0.049941450817527766 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441058,30.804849124516945,0.09096452235977837 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441069,26.36697745088086,0.1585232606319713 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441064,43.41516581656987,0.05805785565900434 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,fruit,2441063,36.36004896688075,0.0189591489897587 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441074,39.98268655563759,0.2233094654518395 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441076,61.33124220621188,0.037499676752522415 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441058,1498.173022844402,1.3503805348415374 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441069,81.7275823748854,0.08718721427079501 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441064,43.692713597855,0.18477241973139513 +1017361 Sl10g086080 #2,log2-1,0.4,m_101,leaf,2441063,72.39339656571428,0.03451751565654804 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441074,102.02899156218132,0.03477553654704213 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441076,96.4182345706629,0.05933995548901394 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441058,127.01482869605312,0.06035529609630652 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441069,82.08667719828726,0.12922645458971704 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441064,136.6148266133639,0.09199870454228432 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,fruit,2441063,119.04065982553448,0.03219619471613022 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441074,532.8951482196476,0.002372976726865872 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441076,517.2302610710738,0.015330817139479258 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441058,575.2505595226215,0.030842306839372835 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441069,531.129198596117,0.003814565696729222 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441064,617.4539940842354,0.0615898613422603 +1017361 Sl10g086080 #2,log2-1,0.4,m_102,leaf,2441063,538.7345446230337,0.0023600812561990203 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441074,27298.30258570796,0.3013942988981073 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441076,26596.420680462634,0.29008184919069624 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441058,270.09840976903683,1.7032193172149523 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441069,84.76818302044722,2.2065084701680684 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441064,62350.8274134636,0.6601008766074026 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,fruit,2441063,678.9926206027126,1.302876290132187 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441074,528531.7723327196,0.091485102984036 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441076,466984.7904652373,0.14525346675963746 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441058,812759.73,0.09540597464724598 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441069,449377.0912672224,0.16194527392457836 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441064,1080040.414568439,0.21888380413833985 +1017361 Sl10g086080 #2,log2-1,0.4,m_103,leaf,2441063,776395.1713898901,0.07552662299720403 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441074,26761.433571847618,0.13507116820202114 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441076,26073.355405685794,0.12375871849461095 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441058,264.7864506667201,1.8695424479110376 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441069,83.1010679797946,2.3728316008641537 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441064,61124.58900095629,0.4937777459113173 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,fruit,2441063,13143.087763041316,0.1737407981418846 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441074,528531.7723327196,0.091485102984036 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441076,466984.7904652373,0.14525346675963746 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441058,812759.73,0.09540597464724598 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441069,449377.0912672224,0.16194527392457836 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441064,1080040.414568439,0.21888380413833985 +1017361 Sl10g086080 #2,log2-1,0.4,m_104,leaf,2441063,776395.1713898901,0.07552662299720403 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441074,49.56533644166007,0.04032012344367142 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441076,53.64529517100984,0.07467370423725783 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441058,33.777251817891596,0.12623362336403066 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441069,40.7762953387901,0.04445016885763664 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441064,60.763082272098906,0.12878186079701304 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,fruit,2441063,35.16883361533281,0.10869996995079734 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441074,49.904648545205745,0.2877990352471156 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441076,93.82619301188166,0.013615941422770117 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441058,104.49057623851878,0.03313708755418476 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441069,136.79376660156066,0.15012627131512923 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441064,87.91533492901549,0.041875401690045555 +1017361 Sl10g086080 #2,log2-1,0.4,m_105,leaf,2441063,99.80264192376198,0.013202001205634195 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441074,265.60660662477835,0.025716831953227715 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441076,285.08418442838627,0.05645108329220028 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441058,267.8739254447594,0.029408400518007305 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441069,208.8976440596651,0.07858849934719592 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441064,235.0639325346117,0.02733604393038247 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,fruit,2441063,176.5348881368856,0.15169149468723964 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441074,3362.485060235401,0.01055913729438629 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441076,3543.5007902359516,0.012213033242232108 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441058,3865.5551087191384,0.049992368398961595 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441069,3446.1817747682644,1.186806161816989e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441064,3444.298540625756,1.1871305716226743e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_106,leaf,2441063,3432.5539393589347,0.0016021302152990913 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441074,989.7138333414376,0.062405943833458544 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441076,1131.6374738023433,0.12060362388511692 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441058,354.20858271284345,0.3838446164269911 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441069,881.539855022312,0.012138255174282797 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441064,618.6639627440912,0.14164887760974976 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,fruit,2441063,832.945154800237,0.01248729039013563 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441074,15907.05211978756,0.0021561028196970256 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441076,14401.282340732949,0.04534464194821641 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441058,17458.772540391532,0.03826789998628044 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441069,18838.32780035094,0.07129654279067754 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441064,16065.389462947234,0.002145451467661985 +1017361 Sl10g086080 #2,log2-1,0.4,m_107,leaf,2441063,14144.320020260391,0.05316373302351529 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441074,237.20615442854876,0.004393203676767765 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441076,242.02953388260457,0.004349207912856201 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441058,454.1801203805888,0.27770896458569805 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441069,150.57678345678082,0.20176114076576068 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441064,423.1882201067973,0.24701441365177468 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,fruit,2441063,176.27856488776737,0.13331965030498205 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441074,707.4364960603735,0.33257493884406575 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441076,279.6999711342125,0.0704201005525058 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441058,378.1737181633756,0.06057882140790394 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441069,111.15286883989155,0.47119184584459717 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441064,475.3159053390426,0.15986982508694325 +1017361 Sl10g086080 #2,log2-1,0.4,m_108,leaf,2441063,69.18054770714012,0.6771285260725317 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441074,100.38069222302136,0.08370788410893115 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441076,184.8894117363485,0.3489697385228874 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441058,38.4014635388468,0.333594525818818 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441069,65.18574285375325,0.10378968304194092 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441064,62.97661089521365,0.11876301688806534 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,fruit,2441063,117.15322164017478,0.1508119337907503 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441074,1347.4502621777328,0.18917583260333926 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441076,717.5327601752726,0.0844951763255275 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441058,807.0594999965609,0.033431356622661834 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441069,877.2134574347716,0.002768374983831645 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441064,1100.5825003044845,0.10128569244115049 +1017361 Sl10g086080 #2,log2-1,0.4,m_109,leaf,2441063,866.0655736167504,0.0027861350363824755 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441074,2714.498475174579,0.026517400912372313 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441076,4324.8803735797355,0.1757670964123168 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441058,2313.3106548220203,0.09597304479058666 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441069,2699.687854632363,0.028893450212281735 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441064,3056.3144868993836,0.024991037041784292 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,fruit,2441063,4485.089991166299,0.19156415843046437 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441074,4030.5012807214066,0.05590752391910181 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441076,3056.810448314098,0.06418303044928475 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441058,5924.869328348437,0.2232272369512618 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441069,1146.0793748050278,0.4902368426663486 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441064,6346.781370428341,0.2531019987231393 +1017361 Sl10g086080 #2,log2-1,0.4,m_11,leaf,2441063,2014.7182737049463,0.2452372140206731 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441074,611.4384101932039,0.06607276294999931 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441076,1204.5583418973513,0.22840235926239894 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441058,1535.8827552709836,0.3339325838944358 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441069,619.9696665006511,0.06005503919380306 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441064,803.851602012863,0.05275040129962294 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,fruit,2441063,431.5003529681057,0.21744432501011124 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441074,2366.1766542071296,0.03082720868785005 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441076,2060.1003307477285,0.09098600194299289 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441058,2714.298940263232,0.02878330334998669 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441069,2730.9440138903847,0.03143842313209699 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441064,2769.542140414893,0.037533603828119766 +1017361 Sl10g086080 #2,log2-1,0.4,m_110,leaf,2441063,2067.351642178027,0.08946002039242318 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441074,68.97586016097357,0.4458066717003559 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441076,143.01338183512914,0.1291271202162778 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441058,248.94945974362932,0.11160739139159404 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441069,623.1927580927523,0.5101186011690375 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441064,242.05139352311232,0.09940379053807424 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,fruit,2441063,78.56416008929347,0.38927932481156535 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441074,22822.0645981696,0.017303550278646718 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441076,17677.749263328173,0.12823151090526697 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441058,25726.030124495053,0.034714293259313855 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441069,20840.740842467687,0.05674532747532712 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441064,25326.91128390638,0.027923748515494395 +1017361 Sl10g086080 #2,log2-1,0.4,m_111,leaf,2441063,24677.37395406395,0.016640461726477263 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441074,768.4781397887318,0.09376862661937668 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441076,2114.645790765666,0.34583748758812183 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441058,2321.1534092519623,0.38630370007334136 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441069,1130.5907541957502,0.07390528489885817 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441064,776.758133005938,0.08911433543484248 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,fruit,2441063,360.5399260479981,0.42244677932686336 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441074,209935.839056162,0.04292950868424228 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441076,189812.74,8.317181325017131e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441058,137206.27121437347,0.14178311462663196 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441069,200420.91672552697,0.022785967744360036 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441064,190540.45803463637,8.301283517377911e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_112,leaf,2441063,133761.87405378997,0.15282473175351452 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441074,440.0438542027988,0.021254586304381817 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441076,527.2379995015372,0.09976532995261955 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441058,387.3549364940288,0.03413227853161471 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441069,357.3936034086216,0.06909459828205078 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441064,398.0089222554954,0.022348565706540313 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,fruit,2441063,826.293126603326,0.2948927665909151 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441074,276.3226450104281,0.0350983952757109 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441076,308.10001260372417,0.012176843418548966 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441058,847.6952479515155,0.45172487591195365 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441069,178.16544561844998,0.22569139424524343 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441064,554.2642995877729,0.2672020337263947 +1017361 Sl10g086080 #2,log2-1,0.4,m_12,leaf,2441063,291.06282420670385,0.012528133638967098 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441074,90.41901089881608,0.25335821416907334 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441076,52.92016079616091,0.02071961733567762 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441058,8.985332214543776,0.7493673988664807 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441069,47.989218184639135,0.02175786308079508 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441064,77.75355138239533,0.18781869671933094 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,fruit,2441063,35.011973049115525,0.15868495227901502 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441074,180.17407879091533,0.09646724860484612 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441076,203.615576251968,0.043348561105861716 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441058,254.60217264365812,0.05370254653373063 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441069,157.08182155362366,0.15603363004775206 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441064,254.8795386928784,0.05417541358219902 +1017361 Sl10g086080 #2,log2-1,0.4,m_120,leaf,2441063,246.3606348277172,0.03941175567472266 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441074,96.63992500046552,0.047878124755354357 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441076,91.01302802976826,0.02182510423272377 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441058,72.236222541147,0.0785234322007069 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441069,115.97674034977416,0.1270924387951371 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441064,82.09151073777892,0.022980211376455673 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,fruit,2441063,23.65507567057761,0.5633541178201089 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441074,1362.7099384356568,0.05774324497715533 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441076,1460.633359826227,0.08788103707128014 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441058,1023.3984855854484,0.06661540835218283 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441069,689.0108356083042,0.2384341265067671 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441064,2219.0317491560895,0.26950333769083823 +1017361 Sl10g086080 #2,log2-1,0.4,m_121,leaf,2441063,704.2423381015848,0.22893804760545722 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441074,568.6772001435268,0.06514292880924177 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441076,648.9666223626243,0.12249947303648767 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441058,486.6776031696073,0.0024815271774363268 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441069,492.25520406565875,0.0024674284321557494 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441064,368.2724127473361,0.12355370060024651 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,fruit,2441063,355.40370549094223,0.1390009362032223 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441074,10274.71275394017,0.010055002905515309 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441076,8013.750233007883,0.09787888389478505 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441058,9804.40756267362,0.010293330127311595 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441069,11451.361800033648,0.05714244978777394 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441064,10571.946863822866,0.022440285222382172 +1017361 Sl10g086080 #2,log2-1,0.4,m_122,leaf,2441063,8565.66629352545,0.06895353553446482 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441074,110.70791822525088,0.03017011428094074 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441076,113.6522071313917,0.04156930416352678 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441058,79.31055265910135,0.1146775938202993 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441069,137.28439532543555,0.1236126051893458 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441064,30.603405071888908,0.5282388192805034 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,fruit,2441063,95.84843889494768,0.0324235261794128 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441074,355.4935920463984,0.07789996736330274 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441076,259.1417537602078,0.05939441583332794 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441058,295.84195635869145,0.001872043643972976 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441069,309.8336552781259,0.018196781266037743 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441064,123.90834631975189,0.37983124846881244 +1017361 Sl10g086080 #2,log2-1,0.4,m_123,leaf,2441063,298.39793827961955,0.0018640087477130862 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441074,13037.227826868871,0.013181155520390675 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441076,15242.291281545627,0.08104615736425114 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441058,16385.744008979997,0.11246206627338573 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441069,8703.108951173135,0.16232967907508167 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441064,12257.737886803116,0.013593769027637315 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,fruit,2441063,7778.116906606519,0.2111296330211303 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441074,155956.85242447123,0.018381651323740478 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441076,182137.48505928295,0.049013222730028616 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441058,222096.5099830367,0.1351556212678542 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441069,149739.01431074087,0.03605114288098221 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441064,164925.94834208136,0.0059028771544182845 +1017361 Sl10g086080 #2,log2-1,0.4,m_13,leaf,2441063,160472.9726552193,0.005984215139623217 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441074,161.22693573116217,0.670541335939244 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441076,87.09648443514219,0.40310436153693163 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441058,8.318560593056533,0.6168480795554886 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441069,42.422219288515066,0.09069712063442914 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441064,26.431318469282164,0.11477743643521165 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,fruit,2441063,3.130893824527562,1.0412279239614826 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441074,81.11254100891458,0.28922420176172703 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441076,141.7484633395893,0.04679384898914973 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441058,174.00069688236331,0.04223877915998431 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441069,243.70904668473125,0.18855944236089783 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441064,286.2302656465082,0.25840334513233065 +1017361 Sl10g086080 #2,log2-1,0.4,m_14,leaf,2441063,88.69051809940052,0.2504350165957894 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441074,88.21889788616167,0.7297251863025556 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441076,74.39250655568566,0.6556927503680692 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441058,11.450466718559143,0.15701325277035982 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441069,3.914448604970135,0.6231658462186089 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441064,21.42458443199856,0.1150759652047344 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,fruit,2441063,5.006338209556969,0.5163162559762599 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441074,497.36330742895393,0.02925292327913498 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441076,534.3415250639861,0.0018922599686974628 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441058,487.6385186462718,0.03782866238141169 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441069,529.6953066103075,0.0019005408084380448 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441064,978.8184387678544,0.26477547622655795 +1017361 Sl10g086080 #2,log2-1,0.4,m_15,leaf,2441063,633.2668607661064,0.07566009605695179 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441074,108.11389158647064,0.5026584674332848 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441076,35.40803813709556,0.017878831616876756 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441058,32.551908376966985,0.018646578284819304 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441069,55.12052368557644,0.21009030230256975 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441064,9.636337149032515,0.5473110463680328 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,fruit,2441063,2.037914080213505,1.2220371628162463 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441074,317.20706621544804,0.6440634639508769 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441076,22.331621952574444,0.5083591221392358 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441058,85.4465108692965,0.07441494409982297 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441069,132.92295909653333,0.2663206115676302 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441064,58.53588135547505,0.08985722752958947 +1017361 Sl10g086080 #2,log2-1,0.4,m_16,leaf,2441063,3.703831889573831,1.2886281227048402 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441074,44110.574355060264,0.43479421491504144 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441076,49849.39130208173,0.48791136186068673 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441058,16650.692770181333,0.011683809749792218 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441069,15766.730638358002,0.012006849641193362 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441064,9896.368632940525,0.2142726336688976 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,fruit,2441063,12656.984642834028,0.10741824460564686 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441074,44486.497402638925,0.07739263655881157 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441076,57887.23644876333,0.03696196679802455 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441058,72691.03037503948,0.1358599749678966 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441069,48441.54715563159,0.04040284448165199 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441064,46430.82466870809,0.058814452595525424 +1017361 Sl10g086080 #2,log2-1,0.4,m_17,leaf,2441063,78582.20963141926,0.16970338651810035 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441074,78.81495601170072,0.37826353846953586 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441076,40.72865260453151,0.6649721330872134 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441058,246.11451530057235,0.11626505223298356 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441069,166.0855284909771,0.05454038319762944 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441064,210.53342445529128,0.04844887861343805 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,fruit,2441063,331.7729893385326,0.24596884990319712 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441074,3148.9243887544185,0.1801840478204184 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441076,940.1242183873431,0.34479294414575756 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441058,3210.730793484407,0.1886257085320029 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441069,2254.3392425143347,0.035041086338009286 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441064,1904.845204618659,0.038118495832943466 +1017361 Sl10g086080 #2,log2-1,0.4,m_18,leaf,2441063,1461.5884238963242,0.15315309011274403 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441074,6.022582973692233,0.1367778770080328 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441076,4.5692384679732445,0.016838909401342028 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441058,2.3466418968644667,0.272558094735625 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441069,4.368163618232122,0.0027060176569509986 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441064,4.422768179139854,0.0026892612574388464 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,fruit,2441063,2.647081082487811,0.2202376706816142 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441074,3054.539697873133,0.05516739075666077 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441076,1559.3483368985037,0.23683524157187286 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441058,3449.5329720610043,0.1079819174764931 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441069,2778.9993400510734,0.014110060650348366 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441064,2601.324031095299,0.014583930007335155 +1017361 Sl10g086080 #2,log2-1,0.4,m_19,leaf,2441063,2432.228190170808,0.04377406523545879 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441074,603.9837096531772,0.5583010711757468 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441076,0.644311395811816,2.413628341332285 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441058,17.779501855201538,0.972804565256352 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441069,3.6934403681738135,1.6552930624451885 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441064,507.9432916615456,0.4830910750000075 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,fruit,2441063,316.22640682058,0.27727397930098396 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441074,699.3372601364155,0.12376137152126887 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441076,486.6219104386845,0.03373363680173025 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441058,715.2684037857429,0.13354374477330166 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441069,471.52859623748526,0.04741726018591352 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441064,536.4689509795899,0.008619295321785181 +1017361 Sl10g086080 #2,log2-1,0.4,m_2,leaf,2441063,515.3846349570169,0.008793829315214108 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441074,29.43525434563615,0.008349404878093658 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441076,69.1901724286916,0.36282721519301675 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441058,30.299494325441987,0.0042181828156737655 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441069,29.713762153616617,0.0042595550301871565 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441064,49.32339854161239,0.2158357955322301 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,fruit,2441063,10.668125313672972,0.4491290892063695 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441074,36.78685454080493,0.04792970894471704 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441076,29.099115097780523,0.05388316381426583 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441058,6.272221196774437,0.7203415803150026 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441069,10.174867901599638,0.5102341665635957 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441064,165.99317454723288,0.7023272845725215 +1017361 Sl10g086080 #2,log2-1,0.4,m_20,leaf,2441063,41.31289665822109,0.09832270051506531 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441074,17290.077190761316,0.01237157937474187 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441076,18043.705609373446,0.03090037999538975 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441058,2339.882969827342,0.8562312162484633 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441069,16318.904063143482,0.012734363527443726 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441064,19557.100722592026,0.06587911966900872 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,fruit,2441063,8097.849535742935,0.31705564980872536 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441074,561021.8323959385,0.03530255993309517 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441076,681547.240652282,0.04921364156266339 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441058,529714.8212173424,0.06024019776847833 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441069,656039.0891199096,0.03264739467473987 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441064,966298.8914534368,0.2008291590462461 +1017361 Sl10g086080 #2,log2-1,0.4,m_21,leaf,2441063,535883.018500849,0.055212327283851614 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441074,161.95667626659795,0.7685016947709149 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441076,7.64507987174886,0.5575151336177422 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441058,40.02725002654312,0.16145859333041512 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441069,4.214121683639472,0.8161900888721434 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441064,15.171234752603532,0.259876232194457 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,fruit,2441063,69.3112871330297,0.39990680324232786 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441074,18.16093826776989,0.03058407172654176 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441076,85.51294738423339,0.7034776651147112 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441058,13.752744945781435,0.09016482168143614 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441069,11.66578814893539,0.1616401250887769 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441064,15.69105190423003,0.03290215144976827 +1017361 Sl10g086080 #2,log2-1,0.4,m_22,leaf,2441063,68.7874266742991,0.6089548524187536 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441074,1611.4392551754654,0.04661245744054687 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441076,1386.0277985894272,0.01882954084519417 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441058,1191.860652235263,0.08437599921747685 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441069,1508.8582763176164,0.01804696783334503 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441064,2277.707286761172,0.1968964296286626 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,fruit,2441063,1075.3869385457294,0.12903672423747414 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441074,274413.21901673573,0.0154004424174774 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441076,231309.2217189748,0.05881163857991112 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441058,279089.86230903363,0.022739475486170946 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441069,294734.7319507286,0.046426730803094785 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441064,255292.4020963134,0.015966696218989718 +1017361 Sl10g086080 #2,log2-1,0.4,m_23,leaf,2441063,202845.06774256376,0.11584013380031877 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441074,72.27195330238611,0.24273282953460162 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441076,113.78019234818188,0.045635958520337194 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441058,403.900740107852,0.5045720268339795 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441069,138.99393386681334,0.04129322455012252 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441064,232.05043117005684,0.2638797575749501 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,fruit,2441063,18.074866205166163,0.8446275309196902 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441074,53.98155124311277,0.32647081239776865 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441076,183.7496723221963,0.20551040036743995 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441058,69.573859016633,0.21627008010992754 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441069,123.29,0.03221167966241456 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441064,542.0470625465862,0.6753208223220826 +1017361 Sl10g086080 #2,log2-1,0.4,m_24,leaf,2441063,105.66291041403112,0.03479360405316845 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441074,53.804570532155566,0.03502628352174342 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441076,56.327964600639255,0.01512139435306814 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441058,37.780972360776325,0.18857232165707383 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441069,63.88949006409722,0.03958396908080419 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441064,60.31953889225744,0.014612560215452541 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,fruit,2441063,83.99680975462448,0.1584173388994674 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441074,4174.2578120099215,0.06326335537771755 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441076,4864.455498419076,0.0031916106959792856 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441058,4233.000707876107,0.05719428288705686 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441069,5469.617624272209,0.0541143422962409 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441064,5436.860844749463,0.051505593485516865 +1017361 Sl10g086080 #2,log2-1,0.4,m_25,leaf,2441063,4793.22024021132,0.0032152394538500495 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441074,307.34740663969666,0.01290170293695203 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441076,325.8822575244516,0.012529460305988671 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441058,643.0523773108856,0.30771509223478466 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441069,265.5873337542587,0.07632389682973573 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441064,524.6011259504241,0.21929796249588263 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,fruit,2441063,204.74395487626953,0.189320167931732 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441074,4406.835143560694,0.04144658849860283 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441076,3155.805280632212,0.1035700171364633 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441058,3874.3795967573415,0.014478046715632686 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441069,4569.824660843049,0.05721932130664076 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441064,4137.053520010008,0.014010923608958059 +1017361 Sl10g086080 #2,log2-1,0.4,m_26,leaf,2441063,3676.4361342116063,0.03725318972183178 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441074,84.58337218572248,0.010946597294887006 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441076,105.74784124570358,0.0860399173919848 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441058,131.6156237927606,0.1810758534682806 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441069,38.83429297777108,0.349016190244406 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441064,60.6043719227278,0.15572763823373426 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,fruit,2441063,88.90149128484741,0.010677453152570182 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441074,629.0550987025307,0.006627798451155353 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441076,455.3200965642762,0.13374406906929526 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441058,705.8532137297229,0.05665350803184932 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441069,401.8176302027944,0.18803190036091566 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441064,610.0007556643114,0.00673051534075908 +1017361 Sl10g086080 #2,log2-1,0.4,m_27,leaf,2441063,656.4170219979949,0.02511894616125243 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441074,66.22191686551321,0.06645743108851843 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441076,90.00102274629262,0.19970312803133727 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441058,23.296200928210386,0.3872592132256756 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441069,34.135469897829935,0.2213384310501798 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441064,47.42935815207031,0.0784970691275848 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,fruit,2441063,69.9599129499764,0.09030494378486198 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441074,274.49996494217174,0.07233643826907299 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441076,162.17040856185267,0.15623424420629428 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441058,470.04797468036054,0.30593633070525916 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441069,110.81124960535716,0.32162200265927865 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441064,190.26764140128063,0.08684092044660785 +1017361 Sl10g086080 #2,log2-1,0.4,m_28,leaf,2441063,525.8502410243923,0.3546562222638028 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441074,742776.8869524614,0.010055629311144898 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441076,708775.6115960483,0.010293986581807246 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441058,695497.2697312051,0.018507322541313265 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441069,1014707.4313550846,0.14553808901311083 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441064,1386855.4216696434,0.2812284366643567 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,fruit,2441063,182258.4449344406,0.6001150915251019 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441074,1404875.5615530338,0.05638969034993391 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441076,1338315.694136411,0.03531040339964164 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441058,1120206.44251747,0.04195010141924804 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441069,1020682.250384719,0.08235760499178024 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441064,1481130.3017694035,0.07934509959461788 +1017361 Sl10g086080 #2,log2-1,0.4,m_29,leaf,2441063,1129303.633124961,0.03843744214038658 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441074,59.108844915398386,0.16752092637864102 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441076,49.01322923075827,0.24886008208253174 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441058,140.12442745554904,0.2073404521137665 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441069,123.07200423170836,0.15098587417724318 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441064,114.75264404995023,0.12058930205556595 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,fruit,2441063,8.331008772009621,1.018475807223944 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441074,6.631955277777519,0.8504574032160882 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441076,64.97355402193489,0.140637630985478 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441058,55.22309656057231,0.0700217633352489 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441069,38.77714892760481,0.0835231175169524 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441064,91.92314685472314,0.291325891244792 +1017361 Sl10g086080 #2,log2-1,0.4,m_3,leaf,2441063,34.33758058906667,0.13632930042409153 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441074,185.41205346751636,0.004505053088875943 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441076,181.5852779924859,0.004552275490824709 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441058,75.25746838548864,0.3870833058903984 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441069,289.0079805275349,0.1972769245980821 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441064,345.6898003121169,0.2750536550109195 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,fruit,2441063,34.47294968916162,0.7261544651766543 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441074,9246.880710792448,0.032235193066796786 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441076,8649.151130894345,0.003213423825916273 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441058,9288.810139535748,0.03420002413133805 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441069,7574.984480287267,0.05437831460260378 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441064,8361.034198653539,0.01150006218433175 +1017361 Sl10g086080 #2,log2-1,0.4,m_30,leaf,2441063,8521.630204694218,0.003237377883528847 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441074,296.8566061321928,0.21921718383849598 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441076,362.59904512988265,0.3060971219350739 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441058,184.60743676769823,0.01291965810665241 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441069,146.5016593799498,0.08748699031256413 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441064,173.78557249428854,0.013315815240272588 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,fruit,2441063,157.45739350433016,0.05616647614903414 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441074,638.7422138061019,0.02156425477302415 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441076,556.367382023829,0.03839970358255185 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441058,927.6781541961818,0.18363596515643854 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441069,576.8596577853592,0.022691196416380066 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441064,701.7374584157269,0.062413295180526074 +1017361 Sl10g086080 #2,log2-1,0.4,m_31,leaf,2441063,574.3104786817411,0.02461462405340642 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441074,65.70614260200124,0.056108619916841684 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441076,56.7802050987962,0.11951763488144529 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441058,72.35388853134356,0.014252715343768596 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441069,179.50359556354022,0.38035856036536186 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441064,103.29037949133787,0.14034528122334233 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,fruit,2441063,77.1817079723751,0.01379979313531976 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441074,3627.6062536012814,0.049439426188169655 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441076,3864.0921851625862,0.02201208931499732 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441058,3248.3228450429233,0.09740038161892661 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441069,4873.136097154889,0.07874897245464485 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441064,4265.889434814463,0.020950026934190014 +1017361 Sl10g086080 #2,log2-1,0.4,m_32,leaf,2441063,4293.5284315115805,0.023754775027657438 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441074,80.22847831564798,0.06349198157647584 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441076,35.412669982568005,0.4186618644749325 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441058,105.4880396101722,0.05538268483139097 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441069,133.26236952934707,0.1568869945186977 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441064,189.86826397044655,0.3106318428680579 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,fruit,2441063,13.83146307845494,0.8269524148644134 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441074,954.096541855032,0.017598571349571213 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441076,972.362931250229,0.025834643773371635 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441058,858.4865776817252,0.028260240975646944 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441069,823.571387656993,0.046292500350801014 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441064,1125.1843856220055,0.08922994636364479 +1017361 Sl10g086080 #2,log2-1,0.4,m_33,leaf,2441063,878.3180692864115,0.018341932981082998 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441074,417.6287919316099,0.011192583449537885 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441076,392.6726824394017,0.0379523261602257 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441058,483.7154647067096,0.05260695693106676 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441069,352.7069197999199,0.08456903513691438 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441064,650.6912474925225,0.1813919496741483 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,fruit,2441063,439.43472967978846,0.01091136200921472 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441074,24617.72545236923,0.003631496034912196 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441076,22700.82273971812,0.03157483040618203 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441058,31077.636340272777,0.10483155251721765 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441069,23746.47542910724,0.012017269320211632 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441064,29468.142810359583,0.08173633799224067 +1017361 Sl10g086080 #2,log2-1,0.4,m_34,leaf,2441063,24207.743537214537,0.0036621182198386393 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441074,44.00379849225652,0.4674942713043564 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441076,142.01294702370373,0.041343501367567814 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441058,56.508841640921965,0.358868033634113 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441069,116.22165457857768,0.045697384602052527 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441064,176.49463329736423,0.13574706571661332 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,fruit,2441063,320.9878756409371,0.3955041899956293 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441074,14038.900753749476,0.31058294453982027 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441076,5309.479742269491,0.1116981911795385 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441058,19015.06377640662,0.44234762705373276 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441069,4268.8753903168035,0.20643668150743855 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441064,7946.527734582772,0.06342724416650869 +1017361 Sl10g086080 #2,log2-1,0.4,m_35,leaf,2441063,5786.938212262169,0.07430131393612482 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441074,1448.2233254237972,0.010751274111389542 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441076,1792.1737354053,0.08179329621801079 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441058,1116.2425512403709,0.12382823833006817 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441069,1096.8703792339309,0.1314315035555893 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441064,2602.6752630257524,0.24383317220891465 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,fruit,2441063,1520.821864923717,0.010491535612560998 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441074,11462.173085765924,0.2103892103893399 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441076,5560.706287225728,0.10374779535238554 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441058,16259.27653230544,0.36222346556421936 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441069,5067.762335785822,0.1440615124282325 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441064,7688.885463210936,0.036985639631495815 +1017361 Sl10g086080 #2,log2-1,0.4,m_36,leaf,2441063,6433.48980210264,0.04043113500854245 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441074,342.54985470473736,0.0522591404773074 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441076,430.1537242545591,0.04664075923482036 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441058,338.9925616159869,0.05679275937320405 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441069,291.8814756907036,0.12177639483649338 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441064,777.2097317677476,0.3035553018211665 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,fruit,2441063,503.67640256154783,0.11516867634299999 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441074,392.58973217879486,0.03768096404500554 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441076,422.84727843161824,0.0699255668931893 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441058,461.31589843163187,0.10774044925560267 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441069,295.4862935117507,0.08572063238622718 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441064,327.33645040854293,0.04126360412259711 +1017361 Sl10g086080 #2,log2-1,0.4,m_37,leaf,2441063,204.89545465905897,0.2447256485510949 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441074,66.51610943055931,0.1965832193266972 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441076,45.304346535281006,0.02979625076817527 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441058,62.81439919621529,0.1717155904086256 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441069,27.68999069683295,0.18402080997071324 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441064,15.495876840300292,0.4361274638087784 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,fruit,2441063,39.29628703599553,0.03199210240444583 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441074,87.26663326914698,0.792999480613019 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441076,16.29063324178891,0.06408922565157193 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441058,5.88379435240803,0.378191255608878 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441069,2.558745670115763,0.7398216199123707 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441064,37.67692888467808,0.4282267547519958 +1017361 Sl10g086080 #2,log2-1,0.4,m_38,leaf,2441063,11.820524771575538,0.07521198322079736 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441074,61.576429584004934,0.4043193055878973 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441076,109.76566632415636,0.15326729088266156 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441058,22.938036684329457,0.8331775660159966 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441069,765.0206387739024,0.6899393427574996 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441064,1446.6673123271723,0.9666348596449463 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,fruit,2441063,202.67230168715383,0.11306059069544139 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441074,2027.8790196908244,0.01852288273640168 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441076,1665.9535431565494,0.06685627283408913 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441058,1511.7157438821832,0.10904902322845489 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441069,2141.798691295763,0.04225948954235914 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441064,2121.138672266534,0.038049902703652716 +1017361 Sl10g086080 #2,log2-1,0.4,m_39,leaf,2441063,1858.5358131358337,0.019348225152798992 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441074,59.28393377661589,0.07208340746855568 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441076,50.67298251644202,0.1402439541424545 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441058,80.69104702652913,0.06180492985621466 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441069,128.4569035892375,0.26373702833902746 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441064,49.0653530512352,0.15424549277075505 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,fruit,2441063,99.89831156867491,0.1545377271180033 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441074,325.1420253004413,0.29433287775435657 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441076,198.58241577523813,0.08020056077012638 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441058,118.79086774435623,0.14295717407722774 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441069,131.61238037180863,0.09844348491248267 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441064,790.619168215106,0.680227110555804 +1017361 Sl10g086080 #2,log2-1,0.4,m_4,leaf,2441063,130.47591150291473,0.10220988934475228 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441074,415.60902541597,0.22623095026984785 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441076,261.7666737629521,0.02546033459673147 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441058,134.93805968231035,0.26231955890494163 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441069,231.9570724016575,0.027046401156756605 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441064,336.9175759580941,0.13506964747582817 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,fruit,2441063,90.10239615055224,0.4377176793062094 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441074,8339.22758819996,0.014562132128324468 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441076,8572.622888136759,0.0025742391571914602 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441058,8579.121058797104,0.002245162440093651 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441069,8981.011227380244,0.01763728073229931 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441064,8927.78427724955,0.015055729249412675 +1017361 Sl10g086080 #2,log2-1,0.4,m_40,leaf,2441063,8668.053315625726,0.002233615343377071 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441074,205.9064266062662,0.019708084436929063 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441076,196.05794726036143,0.04099353492591362 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441058,254.6808370567905,0.07261828242541091 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441069,225.02481615094672,0.01885242938764531 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441064,259.2584416935427,0.08035492015968115 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,fruit,2441063,111.68386673779774,0.2853875444031009 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441074,1448.9983022499341,0.05495128381233938 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441076,913.9876265622116,0.14517627645351494 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441058,1347.7282460008134,0.02348573769903206 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441069,1205.8348215676217,0.02482877173319631 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441064,1450.050405797424,0.05526650637749153 +1017361 Sl10g086080 #2,log2-1,0.4,m_41,leaf,2441063,1042.587511276801,0.08800407441989089 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441074,43.83564432531571,0.012248193333979529 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441076,46.9491131570131,0.04204819194408804 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441058,39.496700449914435,0.03301838492329101 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441069,34.75121449691234,0.08860921409281963 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441064,41.39763474461444,0.012603672752538264 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,fruit,2441063,46.23983654957669,0.03543708910263188 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441074,156.8882971422138,0.026092191902844508 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441076,147.4948289879978,0.00072156263957534605 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441058,147.98534969880103,7.203657808187991e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441069,148.82899077567572,0.0031891794538387863 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441064,139.27789262361264,0.02561617035170194 +1017361 Sl10g086080 #2,log2-1,0.4,m_42,leaf,2441063,144.88186371915162,0.008484333334702665 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441074,1765.8729050979548,0.38022752694213624 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441076,55.55207821400117,1.1220316053920572 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441058,661.5055960322237,0.04619839354344446 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441069,809.9999784755726,0.04175309132447946 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441064,1588.1869039021517,0.3341696945189385 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,fruit,2441063,420.962638918319,0.24248836277075458 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441074,158.86204205671612,0.234478722125965 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441076,236.7580462722608,0.061194115400937665 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441058,248.70901410839133,0.039807336969028384 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441069,349.64159600482986,0.10812423107055835 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441064,296.4571063047667,0.03646300226154242 +1017361 Sl10g086080 #2,log2-1,0.4,m_43,leaf,2441063,924.6953942005256,0.5304998315473646 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441074,182121.8116955172,0.05784125753270253 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441076,160707.87530021588,0.11216606005264218 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441058,234012.20177307504,0.051035283387030894 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441069,272643.9015144901,0.11739256842644963 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441064,282698.57699827943,0.1331204029874895 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,fruit,2441063,76291.95679576501,0.43572446526451625 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441074,593602.1229263047,0.14223811415859 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441076,403132.2025543312,0.02580983993899011 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441058,564416.6550859112,0.12034248934554892 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441069,286300.1892852785,0.174435696149974 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441064,452500.4051880492,0.02436164112479844 +1017361 Sl10g086080 #2,log2-1,0.4,m_44,leaf,2441063,353488.6518957999,0.08288185517260427 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441074,221441.9960897058,0.002202807212390745 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441076,209593.16136777325,0.0216800720075625 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441058,219201.3089393811,0.0022140371675343218 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441069,251509.3726526399,0.05749699361149041 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441064,370667.5377886745,0.22592737284701503 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,fruit,2441063,82129.41316830597,0.42855846062079817 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441074,173275.61529554275,0.2291142642199766 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441076,103928.2624749854,0.007110481127019064 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441058,167663.34951321955,0.2148149526095553 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441069,65174.21488032287,0.1955473773127272 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441064,100552.84146650472,0.007228837875126182 +1017361 Sl10g086080 #2,log2-1,0.4,m_45,leaf,2441063,86505.14920779351,0.07258122590915672 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441074,25999.4374515582,0.004800563657474832 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441076,34311.86458187841,0.11567980428747493 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441058,13499.77013099287,0.28943814136849255 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441069,31625.045059761625,0.08026663804914769 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441064,26577.40620703768,0.004748079255271875 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,fruit,2441063,14555.574638481034,0.25673515932960367 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441074,111890.50733208776,0.012544959050555526 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441076,98669.29398545423,0.04206626329410046 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441058,240974.02230589933,0.34572194292827785 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441069,66691.48932137928,0.2121778679964974 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441064,105518.87372034766,0.012918136950868409 +1017361 Sl10g086080 #2,log2-1,0.4,m_46,leaf,2441063,112993.59450179612,0.01680554047154459 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441074,728.8258018007608,0.062411055148460015 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441076,690.2145333216698,0.03877141573174203 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441058,428.5823198527602,0.16817843264169507 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441069,477.8257393731191,0.12094314343966506 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441064,572.3182954332264,0.04257505460419875 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,fruit,2441063,719.7129509210838,0.05694663376976106 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441074,1007.286481759998,0.010650806624989961 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441076,789.0310143056338,0.09540812465365445 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441058,1238.6802701976949,0.10045702123416733 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441069,707.5848475019885,0.1427236747509073 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441064,1174.8364758728808,0.07747522293212405 +1017361 Sl10g086080 #2,log2-1,0.4,m_47,leaf,2441063,958.4812173661952,0.010918592180753972 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441074,133.31753465604038,0.10160036323275534 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441076,87.39483883398604,0.2850018513903305 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441058,176.22965203394693,0.019591346504351126 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441069,212.7547683792046,0.10139166531291588 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441064,170.25288173754657,0.0046068344061915845 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,fruit,2441063,166.6600127872252,0.004656226392821594 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441074,4346.335894684474,0.022402013321974668 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441076,5993.2901131904155,0.11714000094323351 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441058,4183.736502044555,0.038960975657618135 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441069,4791.933761478794,0.019985506339570858 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441064,4804.802437735099,0.021150235331030665 +1017361 Sl10g086080 #2,log2-1,0.4,m_48,leaf,2441063,4360.894119545945,0.020949757528834212 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441074,30.60496976312753,0.01655590619742675 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441076,31.069169307095738,0.023093593160290693 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441058,23.5117097551532,0.09795183670148067 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441069,28.315478766207928,0.017212139367073886 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441064,35.32387138970042,0.0788322463116149 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,fruit,2441063,24.402634442457728,0.0817993344387824 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441074,30.630611848642975,0.0034964309390799198 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441076,31.92722716074689,0.0145090993560133 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441058,31.125806219546067,0.003468506434632479 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441069,30.13260919417105,0.010615363868234917 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441064,30.361556407442997,0.007328072106742356 +1017361 Sl10g086080 #2,log2-1,0.4,m_49,leaf,2441063,31.25166534186874,0.00522106212916662 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441074,275.2624933423895,0.2591428425076523 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441076,531.1741803263043,0.026347074465097542 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441058,1440.9119205756376,0.4597475523368959 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441069,400.4783121042149,0.09631088008088806 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441064,556.888838619958,0.04687863175202667 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,fruit,2441063,468.6413480286188,0.028049278357597185 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441074,37276.87050461152,0.0021694573071160406 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441076,37650.22502817678,0.0021586739312757786 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441058,51059.31866343188,0.1344661129645992 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441069,25017.669121672596,0.17536205797188575 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441064,38146.89836753526,0.007850329979581794 +1017361 Sl10g086080 #2,log2-1,0.4,m_5,leaf,2441063,34472.28526387684,0.03613882735402196 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441074,91.40172725571634,0.04727060447655096 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441076,78.17184463551976,0.020633438169280316 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441058,70.26956390833048,0.06691654005305403 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441069,85.77905120796838,0.0196974398744878 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441064,87.43090023224853,0.02798115174969862 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,fruit,2441063,62.7857147165589,0.11582295599904513 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441074,7551.258035728869,0.004091933393885139 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441076,7745.804447464024,0.006955284190814037 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441058,6582.854504774803,0.0636969879322451 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441069,10093.2834550944,0.12192122566000219 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441064,7694.226787113356,0.004053738687380015 +1017361 Sl10g086080 #2,log2-1,0.4,m_50,leaf,2441063,7453.838483226458,0.00973126647042255 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441074,36.30581335799454,0.008692881941537278 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441076,37.773858219977626,0.008522293280254667 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441058,20.67160656132514,0.2532948220782716 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441069,43.66852123441443,0.07149943284344928 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441064,58.84912971686605,0.20107099208693113 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,fruit,2441063,21.311929211126973,0.24004628767236746 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441074,247.15940964224728,0.007621406573388612 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441076,237.32049415578268,0.01002049866003718 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441058,252.34557021832563,0.01663994271894742 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441069,238.5603129318652,0.007757546831504314 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441064,215.51177430635815,0.051884740164897636 +1017361 Sl10g086080 #2,log2-1,0.4,m_51,leaf,2441063,300.2579484990231,0.09213877034550899 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441074,163.34449498056867,0.053695168956907846 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441076,155.02568707771175,0.07639600663964341 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441058,206.97219449009228,0.049112332972467865 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441069,206.33866443701112,0.04778094370111097 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441064,207.28350839773557,0.04976507926775664 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,fruit,2441063,160.25360984234186,0.06199185033091803 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441074,1919.9673842872685,0.09947355733428509 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441076,1354.042745947439,0.05218791893086383 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441058,1757.0239794694396,0.06095739489541563 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441069,1432.3831011760265,0.02776110509934071 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441064,1587.7732752297934,0.0169681940032973 +1017361 Sl10g086080 #2,log2-1,0.4,m_52,leaf,2441063,1466.0949232152616,0.017658203915967174 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441074,146.12022809317622,0.03139316745861853 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441076,125.74093442770084,0.03384049058383365 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441058,176.7373576382671,0.11401118364981278 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441069,96.25051260606838,0.14991412288390316 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441064,184.10708350768303,0.13175332426252728 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,fruit,2441063,9.128607867401705,1.172912622285194 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441074,491.1119445512069,0.023367520266680764 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441076,437.82701698153033,0.07324546013699917 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441058,610.8400639347481,0.07137949674113653 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441069,545.4088346777827,0.022174151285187182 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441064,551.1249823963961,0.02670208076722469 +1017361 Sl10g086080 #2,log2-1,0.4,m_53,leaf,2441063,269.251904021527,0.2843892340901655 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441074,972.399678968812,0.073408473690845355 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441076,1160.3206772023902,0.15014169844733205 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441058,961.4466845042916,0.06848887303183648 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441069,680.9056372073824,0.08134940339046892 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441064,503.0918563423538,0.21278904573797552 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,fruit,2441063,452.919676458086,0.2584151446955705 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441074,17417.406629798952,0.10074270087104154 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441076,10101.148144043233,0.1358700496583669 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441058,16044.93654408169,0.06509721364743015 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441069,12379.454053877427,0.047539297909882094 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441064,15243.54228538777,0.04284510962589039 +1017361 Sl10g086080 #2,log2-1,0.4,m_54,leaf,2441063,11408.470611889355,0.08301336220204458 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441074,120.750295708228,0.19345066847039094 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441076,63.35781231394189,0.08663736145072409 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441058,6.027488462430246,1.1083011467666857 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441069,138.60368009998842,0.253337226978795 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441064,41.47603825966525,0.2706402680868678 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,fruit,2441063,91.33407218074504,0.0721952868338227 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441074,65.3695062533449,0.26375243810659943 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441076,174.60087331819156,0.16291876884088508 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441058,16.934700827879613,0.8503501140797742 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441069,60.482124439942865,0.2975006053941447 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441064,191.83893729742775,0.20380911717564976 +1017361 Sl10g086080 #2,log2-1,0.4,m_55,leaf,2441063,291.05516485244084,0.38484766757495104 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441074,125.17383193739136,0.13270812792994446 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441076,464.5250758416846,0.4367874875155944 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441058,95.61833517841312,0.2496804975149145 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441069,190.7530708032241,0.050249862702580916 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441064,149.06906963746374,0.05683413441412677 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,fruit,2441063,227.844734643177,0.12741732135582096 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441074,1074.5353203206955,0.0011896518473872852 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441076,875.5080533448426,0.08777089832594243 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441058,543.9822794268255,0.2944462911075485 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441069,2782.8618159394227,0.4144605981983216 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441064,2308.7045078940464,0.333337307318581 +1017361 Sl10g086080 #2,log2-1,0.4,m_56,leaf,2441063,1068.656481233823,0.001192919583762997 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441074,177.29650609042525,0.08989061865157844 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441076,198.44654843175888,0.040947246221009426 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441058,237.6883021053059,0.03741701245912532 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441069,134.22815429412452,0.21074717741636295 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441064,304.4504710069467,0.1449258544026253 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,fruit,2441063,252.43017284315184,0.06355046878776971 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441074,58065.420949520296,0.06457298008150403 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441076,61191.7205635204,0.04179789423603264 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441058,81235.70827789787,0.0812564124322579 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441069,32544.88183620421,0.3160078598706848 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441064,77029.50112321298,0.05816652627183583 +1017361 Sl10g086080 #2,log2-1,0.4,m_57,leaf,2441063,73555.72923788782,0.038125946555543244 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441074,352020.994884629,0.4519073233492028 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441076,187134.348436758,0.1774922667405301 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441058,97417.7736078918,0.10602304270419438 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441069,78696.45673601351,0.198706063726239 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441064,151291.0757854627,0.08515206836843525 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,fruit,2441063,59376.51335081425,0.3210465508635725 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441074,459756.40715620946,0.08709393402102794 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441076,379731.3019598926,0.004042542069458754 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441058,426764.1519280035,0.05475407541629185 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441069,285998.81568956847,0.11906962151507106 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441064,372694.79814113025,0.0040805250861399855 +1017361 Sl10g086080 #2,log2-1,0.4,m_58,leaf,2441063,315466.8491124654,0.07648012818221517 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441074,2047.7650737513509,0.024824626371241276 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441076,2939.1875002281517,0.1817717868795503 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441058,2288.9730281806155,0.073185170132263 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441069,1790.807979054899,0.0334064843777937 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441064,1820.2263348984889,0.026330111702326686 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,fruit,2441063,1462.3721339918932,0.12139760228258645 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441074,2161.295817346992,0.025850512608986964 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441076,2001.260337627761,0.007560112079935344 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441058,2071.545401893991,0.007430755749129325 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441069,1949.546768402639,0.018930042285875803 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441064,2089.773969168446,0.01123561479063273 +1017361 Sl10g086080 #2,log2-1,0.4,m_59,leaf,2441063,1525.2358711317486,0.12552668974668402 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441074,46.668800313164986,0.16342617747205224 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441076,65.16059834330156,0.01846775074858864 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441058,300.9618977335644,0.6460587023320714 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441069,70.82183550375342,0.01771436391222414 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441064,88.24878328257873,0.1132559119752059 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,fruit,2441063,13.55816838703512,0.7002517909822648 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441074,293.75849539737675,0.012237802173654888 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441076,293.70083391401846,0.012152546691711397 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441058,294.6408131403846,0.013540271461840891 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441069,277.49184004764953,0.012502416198628019 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441064,147.1125338506261,0.2881029571503051 +1017361 Sl10g086080 #2,log2-1,0.4,m_6,leaf,2441063,72.00937903724243,0.598363567079192 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441074,69.82562757494728,0.20036067229546428 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441076,114.60823316607986,0.01484029735682535 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441058,81.99137284686583,0.13060736180253207 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441069,231.0004052942592,0.31923722185590986 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441064,135.31770835838572,0.08697911427073146 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,fruit,2441063,106.90797855617552,0.015365402142924367 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441074,138.85515817808644,0.06008221589318552 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441076,77.86378854844438,0.19114427064959316 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441058,166.5817555963381,0.13914763315707468 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441069,64.20575410655357,0.2749058504267976 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441064,249.19833744024177,0.31406533892108524 +1017361 Sl10g086080 #2,log2-1,0.4,m_60,leaf,2441063,102.97463101237145,0.06974955719288678 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441074,97.4673600428647,0.2902204257875607 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441076,156.61355198105846,0.08425028947331414 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441058,275.82437171548423,0.16155300869107636 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441069,123.8534901437986,0.1861713795601947 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441064,234.63508565352353,0.0913133250216438 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,fruit,2441063,223.67182382242265,0.0705316500980806 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441074,860.0206125689688,0.048061370074419685 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441076,594.9802501605363,0.11194494031017577 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441058,894.7184357123878,0.06523889583275899 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441069,679.8260848800286,0.05404966584338977 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441064,911.9122627504796,0.07350556557300303 +1017361 Sl10g086080 #2,log2-1,0.4,m_61,leaf,2441063,539.6331311890432,0.15434888459899287 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441074,6047.5637994148865,0.005675741221620623 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441076,7642.153592718108,0.1073110444591423 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441058,5890.522475014361,0.005750900112458712 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441069,4581.815097780909,0.11486715850998186 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441064,7408.962383971108,0.09385267236021289 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,fruit,2441063,2035.7763142491604,0.4671746603221756 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441074,758301.1417842151,0.028820036531354454 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441076,647061.9264560591,0.04007582697408196 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441058,695072.3331883529,0.008991671277904345 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441069,614096.5884540384,0.06278498866502691 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441064,949292.1105855064,0.12637819815790596 +1017361 Sl10g086080 #2,log2-1,0.4,m_62,leaf,2441063,724154.0271771225,0.008809276849508052 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441074,2876.8032186696064,0.14855677358279795 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441076,5004.46017870264,0.09189030830809619 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441058,6440.115149747936,0.20142670310725652 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441069,3637.785809309864,0.046629805063869156 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441064,4462.4362578901155,0.04210509609663893 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,fruit,2441063,2298.3547162401355,0.24604987323964744 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441074,21757.328923903005,0.024250638552186565 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441076,23902.43784546089,0.016585981614244183 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441058,36305.87153598153,0.1981206506812967 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441069,19117.380710836096,0.08042782699136719 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441064,24802.79684280435,0.032644440086198934 +1017361 Sl10g086080 #2,log2-1,0.4,m_63,leaf,2441063,22111.162026324524,0.017244648919694683 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441074,1827.0899212998947,0.016471947536744747 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441076,2643.5047783412665,0.1439482302906283 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441058,2655.955903167149,0.1459889906926537 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441069,1968.3477613839957,0.01586996116128292 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441064,1729.3871542588638,0.040339640723393355 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,fruit,2441063,1404.259703096773,0.13078443604343937 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441074,5640.146361682949,0.014160135988884992 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441076,4390.284043346958,0.09463761886394595 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441058,5278.2846346976085,0.014637431964992675 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441069,5677.895759932559,0.017057177009194735 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441064,5774.615134365533,0.024392806665251676 +1017361 Sl10g086080 #2,log2-1,0.4,m_64,leaf,2441063,4088.026091973307,0.12561657903800105 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441074,51.67631769150619,0.3484432503649282 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441076,144.26412969167768,0.09742355024988392 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441058,99.35770037244107,0.06453327862482228 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441069,86.7910981363386,0.12325962648267552 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441064,162.4481300663532,0.14897990670820382 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,fruit,2441063,131.19212920237908,0.056172970713375125 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441074,1424.353566700009,0.06538200061487753 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441076,1532.7787627576313,0.033520333580506545 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441058,1826.9269600269029,0.04272137670225007 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441069,700.9619110101157,0.3733053881997881 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441064,1855.15970028526,0.0493814934958019 +1017361 Sl10g086080 #2,log2-1,0.4,m_65,leaf,2441063,1778.7597004572071,0.031117473482897395 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441074,1394.6642980268111,0.03930369631261543 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441076,1929.9519676854193,0.1017731206303587 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441058,3712.206409281121,0.38585873636694723 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441069,1527.396346205085,1.783674955762038e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441064,1526.14198109544,1.7844078233730798e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,fruit,2441063,972.5218169585028,0.19587402706179713 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441074,4833.333728984157,0.07759224345084625 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441076,2922.3030692888783,0.1409292854111226 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441058,3699.950120501397,0.038458670288025854 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441069,4385.13385920327,0.03532831542452186 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441064,4699.006934182241,0.06535154628335471 +1017361 Sl10g086080 #2,log2-1,0.4,m_66,leaf,2441063,2636.4844643737156,0.1856293230438193 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441074,799.7384384065389,0.01577399292754933 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441076,1333.090763636391,0.20613775615373164 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441058,1045.1376405774568,0.1004515258579799 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441069,845.4140050582025,0.00834747478290021 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441064,813.2253236842056,0.008511069230651369 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,fruit,2441063,560.6516593121685,0.17002885142188662 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441074,854.3074083590409,0.38618004009436513 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441076,177.17230925367568,0.2970382866089749 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441058,1063.4464554172669,0.4812814956524871 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441069,125.54180609071484,0.44664576010744916 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441064,473.7240644858303,0.1300913144216982 +1017361 Sl10g086080 #2,log2-1,0.4,m_67,leaf,2441063,228.48127594779095,0.18658351697846065 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441074,136.78407518786707,0.01042277551593207 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441076,143.42894409050098,0.01017848721739023 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441058,417.0469543907296,0.47372664000066766 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441069,126.80397663444232,0.04332544053174958 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441064,149.3176245540727,0.02765275828097158 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,fruit,2441063,101.64815268800147,0.1393588236221257 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441074,1682.6632200931886,0.07839883593724828 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441076,1456.057993035546,0.01558030672615729 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441058,1743.1704161869282,0.09374148075121003 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441069,1143.9420237926215,0.0891943515161957 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441064,1270.8265305387822,0.043512093178806666 +1017361 Sl10g086080 #2,log2-1,0.4,m_68,leaf,2441063,1353.4376419621751,0.016160115058177826 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441074,81.67656283150964,0.022123416532918716 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441076,73.56357952493134,0.023311183271471192 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441058,0.3363461930824716,2.363187520149348 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441069,119.80465663700276,0.18849966213595426 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441064,43.708505280273634,0.24940808167890327 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,fruit,2441063,223.0985392395788,0.45852269005010804 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441074,213.18586785437452,0.07731857593335878 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441076,196.70575844930983,0.11225991392033885 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441058,117.12343790295968,0.33743317608165313 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441069,327.86666520464615,0.1096202756604514 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441064,296.27048641690595,0.06561140276254607 +1017361 Sl10g086080 #2,log2-1,0.4,m_69,leaf,2441063,320.125783979741,0.09924366730374601 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441074,100.31165271696044,0.008482136419532882 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441076,117.62367484971604,0.07762549428428756 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441058,41.328820741428984,0.3766162359208043 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441069,96.4313272186432,0.008651105257766467 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441064,366.66775600790487,0.5714034712857283 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,fruit,2441063,44.683007321990914,0.34272685445150364 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441074,542.304611127225,0.06833784793397557 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441076,384.3874551931163,0.08113624358873617 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441058,853.2895667949075,0.26519098627741355 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441069,143.87985673111177,0.5079054525555917 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441064,575.5677411913719,0.0941909958194409 +1017361 Sl10g086080 #2,log2-1,0.4,m_7,leaf,2441063,330.20745167343455,0.1471185796464085 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441074,743.6541717196116,0.03370243866341838 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441076,632.5997691380271,0.036539550817882294 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441058,523.0945170336819,0.11908841203729104 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441069,448.0148890151213,0.18637613262685626 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441064,1107.9881681457712,0.2068665428186538 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,fruit,2441063,860.9326186031838,0.09730058256564567 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441074,812438.2559095537,0.04851844308926179 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441076,872701.4097390628,0.01744313074898507 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441058,875724.8565696947,0.015941131369334727 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441069,941207.6877325288,0.015376657547632178 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441064,1035410.7571890976,0.0568038644190727 +1017361 Sl10g086080 #2,log2-1,0.4,m_70,leaf,2441063,1024530.9800136876,0.05221628697231662 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441074,234.38933641257017,0.01645205041906639 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441076,252.48837720577524,0.01585149113797879 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441058,305.5215008452186,0.09865187889617832 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441069,158.1970493946973,0.18719152089173674 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441064,354.5193957769728,0.16325010054117062 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,fruit,2441063,220.7682586635368,0.04245326779579495 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441074,2387.4116205102155,0.026226198034533077 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441076,2664.0043601425755,0.021381429844349764 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441058,2408.0453008918685,0.02248884871428336 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441069,3316.206238960643,0.1164880305693754 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441064,2958.4034204543173,0.06690389448024048 +1017361 Sl10g086080 #2,log2-1,0.4,m_71,leaf,2441063,2343.5618556057757,0.034277080750571454 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441074,117.20711071551142,7.041817649335869e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441076,117.587507255223,7.030418256470661e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441058,85.05156971250949,0.13997580863830184 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441069,198.16676552087816,0.22737267887651313 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441064,124.40432631399412,0.025177341740471704 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,fruit,2441063,84.88165151555575,0.1408443210971666 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441074,209.19519540729675,0.050336789422054995 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441076,213.59665612971816,0.04129404577678342 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441058,256.20927029853885,0.03770634428760511 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441069,204.7656343891009,0.0596314240642597 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441064,402.58289347749735,0.23396682165906801 +1017361 Sl10g086080 #2,log2-1,0.4,m_72,leaf,2441063,475.4879721244824,0.30625104028481953 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441074,186.54994338723273,0.04786236895484297 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441076,129.02274321915206,0.11226648121023697 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441058,181.81170898587692,0.03668909647048224 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441069,103.72029191267166,0.20706902223863777 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441064,152.35466661215816,0.04007699145536847 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,fruit,2441063,352.0992256108097,0.32373231728034657 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441074,1961.0749162658544,0.04492000726090328 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441076,1629.0666880011904,0.03563531439067358 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441058,2676.1471497658695,0.17993581224638788 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441069,1649.5347265312737,0.03021271459897701 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441064,1881.8542454944304,0.027011805674140632 +1017361 Sl10g086080 #2,log2-1,0.4,m_73,leaf,2441063,1654.8942149042848,0.02880393970415218 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441074,207.1761527467286,0.037273222997005195 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441076,361.73699157767817,0.20477993543699347 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441058,227.9907267762856,0.004304196028389384 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441069,256.34294309522403,0.05520837920761368 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441064,150.96684766242055,0.1747314003291196 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,fruit,2441063,223.49391624700635,0.004347281322993446 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441074,889.2285085172812,0.013712266241622029 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441076,935.9074742509802,0.008507271709155884 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441058,1147.7599178284106,0.09712541030588318 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441069,566.8355739284486,0.20926854566282138 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441064,965.7252210080268,0.02212792974547062 +1017361 Sl10g086080 #2,log2-1,0.4,m_74,leaf,2441063,899.5978118111071,0.008677253516717887 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441074,156.8688562380015,0.013665237666472319 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441076,144.27913386406564,0.022667965867824602 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441058,175.77107418982266,0.06307591447226324 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441069,147.1506770907677,0.014109227588844586 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441064,164.7628894979528,0.03498790734131152 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,fruit,2441063,141.41911445419785,0.0313633789390515 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441074,9738.503566419196,0.01046442600255304 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441076,9274.809417108014,0.010722807334897055 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441058,11314.70596680398,0.07561547086776921 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441069,8610.226291819978,0.0430132360153852 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441064,11006.791893616,0.06363295367091437 +1017361 Sl10g086080 #2,log2-1,0.4,m_75,leaf,2441063,8138.538701368172,0.06748136860461873 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441074,68.08717296493553,0.01650332029156565 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441076,73.3614156031188,0.015899080432453916 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441058,12.100709863291362,0.7667577745248757 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441069,88.12798196215958,0.09554520276793821 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441064,80.11147173761218,0.05412608770420624 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,fruit,2441063,30.295882108876423,0.36818502044736645 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441074,104.06547343639627,0.1489319102191904 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441076,194.5298723288139,0.12274772719246307 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441058,555.9382362893069,0.5787879703786456 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441069,99.40964909601448,0.1688100337756313 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441064,87.26725049807797,0.22538728156695398 +1017361 Sl10g086080 #2,log2-1,0.4,m_76,leaf,2441063,189.2051552852384,0.11069439090809219 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441074,624.1746015930245,3.6500278408224673e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441076,625.2242176559146,3.6469627509072566e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441058,610.7656370622286,0.009796500747813575 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441069,643.452986763331,0.012845725601985158 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441064,694.4483130944025,0.0459688317761211 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,fruit,2441063,613.1183294954741,0.00812679573023356 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441074,16713.884419355607,0.006316980746623457 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441076,14160.754304427115,0.06567402619890483 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441058,15840.385646472609,0.016994663223028894 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441069,20925.01382721893,0.10390533980539463 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441064,16360.272335401613,0.00296988511846763 +1017361 Sl10g086080 #2,log2-1,0.4,m_77,leaf,2441063,16584.79575704511,0.0029497136794276457 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441074,61.862289088690886,0.011694791607006483 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441076,62.11741203037472,0.009907424140057408 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441058,1927.8146120305144,1.4819444899595988 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441069,61.47947320163996,0.014390640248842734 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441064,64.98411649616622,0.009686441021928172 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,fruit,2441063,66.04913951854198,0.016746386284121728 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441074,97.39724654990462,0.003249141110162057 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441076,99.44262377358692,0.005776754033303355 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441058,99.47581805505943,0.005921698798359243 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441069,97.02839449555536,0.004896975245243684 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441064,97.43294240069996,0.0030900024131848003 +1017361 Sl10g086080 #2,log2-1,0.4,m_78,leaf,2441063,98.82435598273511,0.0030681722958203483 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441074,148.71998564113542,0.03495191070334158 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441076,146.03095520707896,0.02702750186481584 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441058,139.04175260683363,0.005727809246361293 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441069,133.7732724233062,0.011048073018972815 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441064,135.3982531683753,0.0058043627658355135 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,fruit,2441063,130.84127805189414,0.020672646486306956 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441074,260.0395728858153,0.009483178344761534 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441076,269.3461905237324,0.0057882151307357965 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441058,254.851761193368,0.018234983189719944 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441069,262.2142076298664,0.005866402887669597 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441064,270.5408097680722,0.007710163213375143 +1017361 Sl10g086080 #2,log2-1,0.4,m_79,leaf,2441063,271.2876900365743,0.008907465255676428 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441074,427.2412665646776,0.45978970756882687 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441076,447.66025425541864,0.4800650507360986 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441058,153.65522208123667,0.015663838346549053 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441069,118.66421972932032,0.09656369840495582 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441064,142.76885882489816,0.016249998156669943 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,fruit,2441063,138.1303153276619,0.03059448306901924 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441074,431.665092033392,0.02053391931988724 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441076,341.37330547959743,0.081383452768367 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441058,583.2861559099965,0.15126865857105276 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441069,380.6933792679385,0.034037686197773365 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441064,424.26045589011886,0.0130195441442722 +1017361 Sl10g086080 #2,log2-1,0.4,m_8,leaf,2441063,399.2004881400849,0.013421946487335745 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441074,48.81791931717409,0.0023128951494897354 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441076,51.576258513961406,0.021557673575358427 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441058,49.33927949461364,0.0023006427305802823 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441069,48.1769156463482,0.008053168021909807 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441064,57.27750951327575,0.06709196569378428 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,fruit,2441063,47.262808308889895,0.016372637025274583 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441074,147.4407129873891,0.07975426612955605 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441076,125.19798983510432,0.008734199717941316 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441058,114.78232989764234,0.028988120245399873 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441069,114.8506269166243,0.028729786078036668 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441064,126.5501980724215,0.01339967301006606 +1017361 Sl10g086080 #2,log2-1,0.4,m_80,leaf,2441063,120.2125167295296,0.008913466735598341 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441074,2694.337274622378,0.08378092962287464 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441076,4658.6327749002685,0.321587448010038 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441058,3405.416116049583,0.18549915724225974 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441069,1748.91554757303,0.10390219116832311 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441064,1560.9078385966109,0.1532937681750104 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,fruit,2441063,903.3274463484752,0.39082582387757814 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441074,7954.734408148114,0.04429147568831926 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441076,6694.406190728753,0.030622148222855472 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441058,7245.990838763877,0.003763572255588876 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441069,7120.946712548385,0.0037964724864592014 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441064,9032.12557853783,0.09945575883350477 +1017361 Sl10g086080 #2,log2-1,0.4,m_81,leaf,2441063,6297.659387715307,0.05715504047118136 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441074,8685.838619632601,0.16722589960356293 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441076,5909.294409639001,5.022873065074762e-5 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441058,4867.178675479698,0.08430856682475385 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441069,4520.082826457895,0.11643946349124512 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441064,6357.1980074467765,0.03167988216587636 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,fruit,2441063,5910.661378525561,5.022292207179646e-5 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441074,117529.51097378916,0.1001567040015745 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441076,83763.22710679987,0.046936824253056564 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441058,101138.24141594378,0.034925172775532864 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441069,66947.54333782311,0.1442555800459857 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441064,131379.4343844196,0.14853716270119044 +1017361 Sl10g086080 #2,log2-1,0.4,m_82,leaf,2441063,85508.41774230498,0.0379813548341863 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441074,368.5797784356559,0.11115890588118793 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441076,519.772881178774,0.03812320619920673 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441058,470.8499108604241,0.004807917980357956 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441069,618.0696223196344,0.1133469883357976 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441064,405.81676858258777,0.06936042215085791 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,fruit,2441063,481.33305130050735,0.00475527352598526 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441074,2112.9604556196605,0.005281937851372209 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441076,1716.65010320149,0.08492764743020853 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441058,2061.875614359507,0.005346969096419407 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441069,2367.6190013263436,0.05470238535529148 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441064,2329.06341672033,0.04757188245998334 +1017361 Sl10g086080 #2,log2-1,0.4,m_83,leaf,2441063,1855.873780910362,0.051060995130039366 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441074,5829.2635259118,0.03546768105977405 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441076,6821.343518813874,0.032788550742257616 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441058,42905.49367776955,0.8314315332491096 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441069,1978.712336437315,0.5046987087292893 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441064,15701.919377886255,0.39487137297525754 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,fruit,2441063,1015.0941160276664,0.7945750597486567 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441074,2771608.0533065917,0.03441206786799178 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441076,2433675.2215221,0.02205712634458834 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441058,2791846.8565997286,0.037571845202792886 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441069,2155436.884112279,0.07478443641288468 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441064,2687265.426467721,0.020990817967669884 +1017361 Sl10g086080 #2,log2-1,0.4,m_84,leaf,2441063,1510579.1665813357,0.22917625594680846 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441074,49.10502790357176,0.01088620657358419 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441076,48.66880364529633,0.014761497994403072 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441058,52.058690562832254,0.014481071323475314 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441069,51.597915465865746,0.010619987929832986 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441064,98.43898671414068,0.29115496588827416 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,fruit,2441063,41.86954281904422,0.08011394995821064 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441074,1545.5097591690865,6.548950057658764e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441076,1540.8521643147506,6.5588404727146e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441058,1801.2903010919017,0.06716685383172605 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441069,1418.5557262401978,0.03657045556946681 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441064,1641.2019145072766,0.026745158143526293 +1017361 Sl10g086080 #2,log2-1,0.4,m_85,leaf,2441063,1233.690857117176,0.09721051057843777 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441074,1690.8562438479769,0.240610209916015 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441076,1549.816064418431,0.20278368255478885 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441058,658.6808909431337,0.16882141138507079 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441069,796.0939090636957,0.08653217451605588 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441064,903.0311057107092,0.031793765417525766 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,fruit,2441063,1040.2090277560044,0.02962414295698501 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441074,21519.94750106329,3.13970248688733e-5 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441076,16714.734909219947,0.10977311133799983 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441058,24064.962790635935,0.048512589967184994 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441069,24199.1644000191,0.05092776546156852 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441064,21523.0591535429,3.139475520796964e-5 +1017361 Sl10g086080 #2,log2-1,0.4,m_86,leaf,2441063,13098.100929454116,0.21566427190908222 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441074,255.6626146810504,0.012661019507415716 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441076,196.6389216467589,0.12665876176677182 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441058,346.78548674268376,0.1197326679268893 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441069,236.26847093688977,0.046922475004081754 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441064,416.9961833664612,0.19980383435558124 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,fruit,2441063,270.78873245645536,0.01230234367956129 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441074,39499.570475299704,0.09094506918056844 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441076,43564.51909464849,0.04840451799104972 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441058,61802.12882395503,0.10346599272418011 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441069,53837.38297964751,0.04354649854943915 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441064,54445.3135032259,0.048423060630010006 +1017361 Sl10g086080 #2,log2-1,0.4,m_87,leaf,2441063,42755.84060020562,0.056541992953786036 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441074,72.14494352842921,0.04798553285213436 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441076,54.257545423443155,0.07576022228606494 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441058,123.04224254150682,0.27983387293529716 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441069,41.41478354784106,0.19306496906830328 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441064,228.84036714880145,0.5493122709189471 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,fruit,2441063,57.05144106489445,0.05395374619574733 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441074,2072.015802453315,0.03318311376786909 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441076,2056.51510631905,0.036444273041089215 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441058,2437.340704398408,0.037340064364361325 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441069,2604.9641209620654,0.06622556894659803 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441064,2401.0591220203687,0.030826676908175976 +1017361 Sl10g086080 #2,log2-1,0.4,m_88,leaf,2441063,1915.6445749966217,0.0672612429922923 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441074,51072.20347381242,0.062226296104547885 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441076,68070.03285839477,0.06254506855476905 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441058,61951.11104687701,0.02163820783874293 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441069,55929.09528697436,0.022773097483520743 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441064,81238.27874308219,0.139349821414112 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,fruit,2441063,29673.016081089685,0.2980491997446535 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441074,167273.72149043484,0.06317331605521481 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441076,237726.10290404403,0.08947583572451911 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441058,117481.7920202899,0.216630472756151 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441069,240765.28774727636,0.09499283762933342 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441064,125343.46618240472,0.18849933493025173 +1017361 Sl10g086080 #2,log2-1,0.4,m_89,leaf,2441063,219655.05571487657,0.055140168491491615 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441074,40.420444889078425,0.10435580985812876 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441076,57.26679564715605,0.046945983785105394 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441058,68.75104776226564,0.1263224220357182 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441069,45.53173208825692,0.05264272737356057 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441064,28.348819389013084,0.2584219221035551 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,fruit,2441063,181.2350350253088,0.5472852569332236 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441074,137.9255585963331,2.2856056694653404e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441076,136.4021827382759,0.004594870898555925 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441058,138.4502234270877,0.0018774699822312613 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441069,133.2494494055328,0.014750767779898588 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441064,137.78042182246557,2.2868091717809236e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_9,leaf,2441063,138.1224482380437,8.480767186420657e-4 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441074,72.19232924392632,0.04710188182253727 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441076,33.81480533286485,0.3764860445276943 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441058,19.21738735102616,0.6218985921330342 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441069,172.21307641007803,0.33047318891031163 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441064,88.73245361262966,0.042489554588645895 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,fruit,2441063,109.12989719794037,0.1323508099678652 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441074,4416.7089993614145,0.008320188333243106 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441076,4385.542223608452,0.005244698904181888 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441058,6313.180191486032,0.16346958737648976 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441069,2782.761499122551,0.1923026117599358 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441064,4280.2564163735515,0.005308810832930444 +1017361 Sl10g086080 #2,log2-1,0.4,m_90,leaf,2441063,4131.576871409588,0.02066276023265079 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441074,253.2909480145279,0.07330271823837142 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441076,383.80140314600567,0.10718417044002981 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441058,516.4839375620741,0.23613443197915407 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441069,326.58978534428354,0.03708020960139802 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441064,0.10439721519973603,3.4582334737102998 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,fruit,2441063,273.1355326185514,0.04054418585944264 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441074,669593.0069611162,0.09510447980699333 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441076,360370.521297409,0.17395717155728185 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441058,642419.5354648089,0.07711230946577174 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441069,362699.2839499864,0.17115973136763696 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441064,624477.0012346982,0.064810018887611065 +1017361 Sl10g086080 #2,log2-1,0.4,m_91,leaf,2441063,451335.10024349985,0.07620731972241312 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441074,44.97754785990825,0.12430232181677603 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441076,30.78311911658644,0.28898547331865343 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441058,13.505592946879624,0.6467844400514784 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441069,91.2122554281465,0.18275509859488737 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441064,113.6724527943935,0.27835713501576853 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,fruit,2441063,74.78694831453677,0.09652771600271248 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441074,43360.51561487056,0.16707497699563234 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441076,24102.254952170853,0.08796178483118311 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441058,52601.79699710869,0.25098111998401773 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441069,19914.171939438376,0.17085720839370744 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441064,34924.57453796257,0.0731116631967712 +1017361 Sl10g086080 #2,log2-1,0.4,m_92,leaf,2441063,19645.438267275615,0.17675773904167258 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441074,145.9409204617782,0.29911025427854687 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441076,10.126504238898567,0.8596072779411126 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441058,23.431490184222337,0.4952669172598505 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441069,188.67887141031431,0.4106564430539237 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441064,123.1559707577784,0.22538864505432477 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,fruit,2441063,6.56410044513605,1.0478916086887569 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441074,18.661190279579227,0.48599954743828033 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441076,94.4882968007512,0.2184391320458341 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441058,140.82799637264804,0.391750111776513 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441069,19.79134864315682,0.4604634992650485 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441064,11.105041711880284,0.7114186944867373 +1017361 Sl10g086080 #2,log2-1,0.4,m_93,leaf,2441063,106.43861864142988,0.2701603410126614 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441074,379.06968936902473,0.009882369891849319 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441076,396.51892485235607,0.00966249066374747 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441058,62.162328933565185,0.7950741521758333 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441069,720.9442591803165,0.2693002586592126 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441064,795.5074997214607,0.3120428490844569 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,fruit,2441063,64.35626802280483,0.7800105775604329 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441074,6327.533533132412,0.037408049592681625 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441076,7351.373823998273,0.027726002579788744 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441058,5758.781460911187,0.0783119071281062 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441069,9438.743549953417,0.13627168149934565 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441064,7235.031453084818,0.0207979184835545 +1017361 Sl10g086080 #2,log2-1,0.4,m_94,leaf,2441063,6558.405706785728,0.02184422612476178 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441074,154.13637758473396,0.0909895743673288 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441076,182.11733431841137,0.018543437781716854 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441058,563.1511790964577,0.47173027512918475 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441069,198.00616471519317,0.017783989153130175 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441064,281.0767608840307,0.1699302174797901 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,fruit,2441063,160.35861528890015,0.07380242520145153 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441074,57.166595707692686,0.4473992958216264 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441076,235.9743624361615,0.16832319496532389 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441058,87.13,0.26437391237186847 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441069,134.49346799022968,0.0758404341469694 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441064,781.6200450758272,0.6884540621683759 +1017361 Sl10g086080 #2,log2-1,0.4,m_97,leaf,2441063,185.81736146922003,0.06454466257367697 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441074,7137.694385006356,0.29217418888004243 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441076,7691.825571835203,0.3246456672156346 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441058,1410.9505483960545,0.41187196724998953 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441069,4198.660331497347,0.061726982027389354 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441064,2435.260978669896,0.17483825001738307 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,fruit,2441063,3086.0746302928555,0.07197733556817454 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441074,66724.7207092465,0.06775591114272217 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441076,81989.44467161459,0.02171526909969046 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441058,82254.5344072455,0.023117172658140284 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441069,73991.90412448332,0.022858472074135605 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441064,101192.48603579692,0.11310558975153828 +1017361 Sl10g086080 #2,log2-1,0.4,m_98,leaf,2441063,68247.45493576908,0.057956215341246065 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441074,29641.558743211088,0.061955831695785335 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441076,27927.37261126087,0.08782679010669892 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441058,38949.63282100759,0.05664649833283786 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441069,38731.79224444733,0.054210724059839954 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441064,53627.789366456935,0.1955330253435319 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,fruit,2441063,12584.319665006562,0.4340271279531569 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441074,154330.70832474082,0.0608431394568143 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441076,120969.5804696823,0.044933035506868 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441058,147554.1789116138,0.0413423037553482 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441069,103928.2460848533,0.1108756118940617 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441064,147341.86915049772,0.04071696493345822 +1017361 Sl10g086080 #2,log2-1,0.4,m_99,leaf,2441063,109230.14403151735,0.08926670367901046 diff --git a/runs/GC-MS analysis/mean_values_se_n.csv b/runs/GC-MS analysis/mean_values_se_n.csv new file mode 100644 index 0000000000000000000000000000000000000000..86cb0e38b9beaae423cba483cc87d6196f91696f --- /dev/null +++ b/runs/GC-MS analysis/mean_values_se_n.csv @@ -0,0 +1,3649 @@ +tissue,treatment,alias,genotype,met,mean_fc,sd,n,se,group,treatment2,group1,tissue2,p.signif,mean1,mean2,se1,se2,p.value,adj.p.value,tot_val1,tot_val2,y.position,na,n_treat,percent_na,RT_mean,Compound_Name,component,mean_rt,median_rt,sd_rt,max_rt,min_rt,rt_span,exclude,Compound_Class +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.3948111662593383,0.3314358018704425,6,0.13530809951212777,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,69.34508353878805,22.542113554114998,16.189030557315558,7.725542752228915,0.0415204090050328,0.9964898161207872,85.53411409610361,30.267656306343913,131.21556933317382,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.8,967514 MM WT,MoneyMaker,m_16,1.2145362164277778,0.63401661470163,5,0.2835408498674274,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,1.2990132037167517,1.9356423664155828,6,0.7902226870385881,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,69.34508353878805,74.16837629978032,16.189030557315558,45.11850491219586,0.9230059264051158,1,85.53411409610361,119.28688121197618,131.21556933317382,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_16,0.9049848654770313,0.7397992480187688,5,0.33084828165463875,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,69.34508353878805,51.67095904511086,16.189030557315558,18.890092711673113,0.4980823553633217,1,85.53411409610361,70.56105175678397,131.21556933317382,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.8058771242094865,0.8711487343193749,6,0.35564498152564283,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,117.66848915359355,46.01230967378751,86.60668508648298,20.30588353024463,0.45364235996093133,1,204.27517424007652,66.31819320403214,224.7026916640842,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.6,967514 MM WT,MoneyMaker,m_16,2.0608907555708775,3.7155390940911897,6,1.5168624833143787,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.5729079528746129,0.41959714454743113,6,0.1712998169450072,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,117.66848915359355,32.71071649800286,86.60668508648298,9.780523590452354,0.37339093878695434,1,204.27517424007652,42.491240088455214,224.7026916640842,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_16,0.7738946214777371,0.47236708075246386,6,0.19284305318859893,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,117.66848915359355,44.186238706356164,86.60668508648298,11.01055485407466,0.4372124778723329,1,204.27517424007652,55.19679356043083,224.7026916640842,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,1.0447213144083827,1.1405499492468556,6,0.4656275669686746,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,57.09593719876665,59.64934255767396,18.102859284587307,26.58544232165795,0.9385736831895525,1,75.19879648335396,86.23478487933191,94.85826336726511,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,1,967514 MM WT,MoneyMaker,m_16,1,0.7089685524651453,5,0.3170603754443382,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.9036485447490732,0.9579215825205344,6,0.39106984846244647,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,57.09593719876665,51.59466056074995,18.102859284587307,22.328499508143032,0.8525129417794228,1,75.19879648335396,73.92316006889298,94.85826336726511,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_16,1.050272030834934,1.0365771587491746,6,0.4231808529932389,fruit_1_log2-1,1,967514 MM WT,fruit,ns,57.09593719876665,59.966265914172496,18.102859284587307,24.16190740622247,0.9264008254280169,1,75.19879648335396,84.12817332039496,94.85826336726511,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,1.4080955948511558,1.7546083132265315,6,0.7163158443084139,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,16.490691474938743,80.39653765348156,5.270368557591953,40.8987244611147,0.18004095055866237,1,21.761060032530697,121.29526211459626,133.4247883260559,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.4,967514 MM WT,MoneyMaker,m_16,0.2888242541238987,0.2064052704875767,5,0.09230724314489053,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.3092174917105171,0.2663409389011466,6,0.10873323298693328,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,16.490691474938743,17.65506248746383,5.270368557591953,6.208225842040805,0.8894647314883589,1,21.761060032530697,23.863288329504634,133.4247883260559,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_16,0.7089489052138779,0.6695165398531845,6,0.2733289828323434,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,16.490691474938743,40.47810216922594,5.270368557591953,15.605974438398244,0.19473636501787522,1,21.761060032530697,56.08407660762418,133.4247883260559,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,1.9945478491071207,1.3885306779754156,6,0.5668652755400921,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,93.67793470084389,100.13796051833079,30.985495839360514,28.45995026224001,0.8810435190765464,1,124.6634305402044,128.5979107805708,204.54778930586903,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.8,967514 MM WT,MoneyMaker,m_16,1.8658770580030188,1.5117493582662833,6,0.6171690911220522,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,2.6574823072276437,2.562950620683423,6,1.0463202094373043,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,93.67793470084389,133.4211452878673,30.985495839360514,52.531390444740914,0.532671317760807,1,124.6634305402044,185.9525357326082,204.54778930586903,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_16,1.8049894281978356,2.6616836446551106,6,1.0866277976860732,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,93.67793470084389,90.62101978540797,30.985495839360514,54.555066979977354,0.9623458515317255,1,124.6634305402044,145.17608676538532,204.54778930586903,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,3.406666663874998,6.462591549901021,6,2.638341952213299,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,47.12936719750331,171.03457910971724,13.250491954272666,132.4601875873081,0.3939004925161391,1,60.37985915177598,303.49476669702534,389.6098366307304,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.6,967514 MM WT,MoneyMaker,m_16,0.9387227130150348,0.6464773974389195,6,0.26392329232796624,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,1.604972345677538,1.3634320708139887,6,0.5566188120734156,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,47.12936719750331,80.57899310684242,13.250491954272666,27.94551790377947,0.31462678228848734,1,60.37985915177598,108.5245110106219,389.6098366307304,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_16,4.914547236366499,5.2424571301139125,6,2.1402241611990944,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,47.12936719750331,246.73899768363455,13.250491954272666,107.4517628897567,0.12283138671180355,1,60.37985915177598,354.19076057339123,389.6098366307304,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,2.753641256111093,2.0027965191508104,6,0.8176382550902939,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,50.205845180981015,138.2488865882756,21.882677396281615,41.05021964911075,0.09682371559593332,1,72.08852257726264,179.29910623738635,197.22901686112502,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,1,967514 MM WT,MoneyMaker,m_16,0.9999999999999999,1.0676325362834524,6,0.43585915778131773,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,1.759241210689256,2.5261002367472516,6,1.0312761031924251,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,50.205845180981015,88.32419185986639,21.882677396281615,51.7760883757243,0.5203075306297489,1,72.08852257726264,140.10028023559067,197.22901686112502,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_16,1.7937449474371259,1.3511727356807768,6,0.5516139594630582,leaf_1_log2-1,1,967514 MM WT,leaf,ns,50.205845180981015,90.05648112519526,21.882677396281615,27.694245048470233,0.2866079807610343,1,72.08852257726264,117.7507261736655,197.22901686112502,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,1.0963725146198116,1.6242120063263072,6,0.6630817749335961,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,79.00242850020761,55.044308729685106,47.937337518501764,33.29058093464622,0.6911311973900247,1,126.93976601870938,88.33488966433133,166.22018256238078,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.4,967514 MM WT,MoneyMaker,m_16,1.573570332606119,2.3388116687334866,6,0.9548158654773806,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,1.9976178502219055,2.479315354583951,6,1.0121762550297044,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,79.00242850020761,100.29209251900511,47.937337518501764,50.8171643558865,0.7668261592069701,1,126.93976601870938,151.1092568748916,166.22018256238078,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_16,2.0586841669643734,2.278528273031441,6,0.930205272238664,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,79.00242850020761,103.3579785631502,47.937337518501764,46.701741884546664,0.7234996388872525,1,126.93976601870938,150.05972044769686,166.22018256238078,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,1.2033423376479064,0.20417288445253054,6,0.08335323103682143,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,184.64393780493563,234.19902348297876,19.754059372029673,16.222520144293753,0.08754542364418684,1,204.3979971769653,250.4215436272725,277.48731155385997,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.8,967514 MM WT,MoneyMaker,m_26,0.9487224346469333,0.22695798860759056,5,0.10149869811263906,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,1.0523304458184572,0.3385482867118345,6,0.1382117592895762,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,184.64393780493563,204.8085196385753,19.754059372029673,26.89929378098083,0.5611481260608107,1,204.3979971769653,231.70781341955612,277.48731155385997,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_26,1.231643540184991,0.1442361371792206,5,0.0645043615089444,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,184.64393780493563,239.70711024284023,19.754059372029673,12.55408207885064,0.05206028678051175,1,204.3979971769653,252.26119232169088,277.48731155385997,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,1.1877731581324582,0.12396744661796794,6,0.050609498154955614,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,169.54097585575812,231.16889105526383,18.306753485230818,9.849811376222245,0.018889086594477574,0.43444899167298423,187.84772934098893,241.01870243148608,348.2509266186245,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.6,967514 MM WT,MoneyMaker,m_26,0.8711216262957767,0.23040456296525166,6,0.09406226894563749,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,1.1862370350085882,0.2530710677539326,6,0.10331583077640745,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,169.54097585575812,230.86992498027047,18.306753485230818,20.10771658334779,0.04796695543671756,1,187.84772934098893,250.97764156361825,348.2509266186245,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_26,1.4716223886240927,0.3798265747493364,6,0.1550635498141613,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,169.54097585575812,286.4126986715356,18.306753485230818,30.17905279994116,0.010245851707539472,0.24590044098094732,187.84772934098893,316.59175147147675,348.2509266186245,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,0.9045033036222219,0.2617767554353476,6,0.10686991288965744,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,194.62377093849457,176.03784377728292,28.013901164407145,20.79942544645356,0.6091951292463667,1,222.63767210290172,196.83726922373648,293.0261820963826,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,1,967514 MM WT,MoneyMaker,m_26,1,0.32185681644392156,5,0.14393874411805613,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,1.2231421437084165,0.3566165178671532,6,0.14558808377044097,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,194.62377093849457,238.05253640232607,28.013901164407145,28.334901867112663,0.30433864511647485,1,222.63767210290172,266.38743826943875,293.0261820963826,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_26,1.0500726512369198,0.14933419029281708,6,0.06096542789484779,fruit_1_log2-1,1,967514 MM WT,fruit,ns,194.62377093849457,204.36909914311198,28.013901164407145,11.865321473774161,0.7606965412466706,1,222.63767210290172,216.23442061688615,293.0261820963826,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,1.259173834453902,0.19398754390464,6,0.07919508317035286,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,342.1843940518575,245.06515992850214,90.82676453449538,15.413245726401781,0.34822843829589156,1,433.0111585863529,260.4784056549039,543.6335487077008,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.4,967514 MM WT,MoneyMaker,m_26,1.7581839690075443,1.0435252523171037,5,0.46667868008373276,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,1.8699798344172744,1.6395454316423979,6,0.6693416196058454,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,342.1843940518575,363.94252695323166,90.82676453449538,130.26979005376904,0.8942040942713052,1,433.0111585863529,494.2123170070007,543.6335487077008,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_26,1.9449615062469598,0.8662119410585291,6,0.35362954411652897,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,342.1843940518575,378.5357426759977,90.82676453449538,68.82471539121961,0.7580631558544737,1,433.0111585863529,447.36045806721734,543.6335487077008,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,1.0301375510428286,0.07660595128772639,6,0.031274248652572265,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,3667.535086571359,3840.5080581752836,252.42850722598908,116.59511280022028,0.5534917346808254,1,3919.963593797348,3957.103170975504,5396.759024345265,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.8,967514 MM WT,MoneyMaker,m_26,0.9837410975878322,0.16585194236504114,6,0.06770877194063919,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,1.1291786577277076,0.10552205633563264,6,0.04307919910525347,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,3667.535086571359,4209.748231906278,252.42850722598908,160.60574739361667,0.10540910263022941,1,3919.963593797348,4370.353979299895,5396.759024345265,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_26,1.2151458208508747,0.24697440067720644,6,0.10082687686480667,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,3667.535086571359,4530.246773463926,252.42850722598908,375.8977941226782,0.09006745982475012,1,3919.963593797348,4906.144567586604,5396.759024345265,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,1.2700552270399528,0.1470916730999063,6,0.06004992408450614,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,4005.4248717955033,4734.957315978656,204.09018209241341,223.87516803546922,0.03699359480206298,0.8138590856453857,4209.515053887917,4958.832484014125,6160.74711308914,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.6,967514 MM WT,MoneyMaker,m_26,1.0743731052807324,0.13409243468432147,6,0.05474300722401146,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,1.276142391875899,0.5538908200980006,6,0.22612498040863588,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,4005.4248717955033,4757.651183977379,204.09018209241341,843.0280097400203,0.4215081218974326,1,4209.515053887917,5600.679193717399,6160.74711308914,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_26,1.2875035568961397,0.38526053100474944,6,0.15728195316588905,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,4005.4248717955033,4800.007319588903,204.09018209241341,586.3708277866972,0.24646536190561893,1,4209.515053887917,5386.3781473756,6160.74711308914,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,1.0507216373874482,0.10825823858403116,6,0.044196240830559744,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,3728.1507253933823,3917.2486346125374,174.35338699194574,164.7702473121119,0.44888319085055495,1,3902.504112385328,4082.0188819246496,5327.059858071127,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,1,967514 MM WT,MoneyMaker,m_26,1,0.11455460481985022,6,0.04676672158246726,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,1.110986803037106,0.46047982552427863,6,0.1879901015633847,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,3728.1507253933823,4141.926255645261,174.35338699194574,700.8554335103082,0.5888769910702553,1,3902.504112385328,4842.781689155569,5327.059858071127,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_26,1.1395436649091326,0.17118979499585943,6,0.06988794115191879,leaf_1_log2-1,1,967514 MM WT,leaf,ns,3728.1507253933823,4248.390540948416,174.35338699194574,260.55277850177606,0.1324480554245229,1,3902.504112385328,4508.943319450192,5327.059858071127,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,1.017679787368497,0.11858113219548017,6,0.04841054450007413,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,4609.031241393571,3794.0636374960454,333.99771206969797,180.48180659463995,0.06546794746514442,1,4943.028953463268,3974.5454440906856,6056.558281792772,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.4,967514 MM WT,MoneyMaker,m_26,1.2362781391858133,0.21944498226837347,6,0.08958803886193621,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,1.3200842811895779,0.3840240591731826,6,0.1567771656544452,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,4609.031241393571,4921.4731704973265,333.99771206969797,584.4889038597382,0.6550025707120857,1,4943.028953463268,5505.962074357065,6056.558281792772,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_26,1.0648860561425515,0.1386908615146393,6,0.05662030711631187,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,4609.031241393571,3970.0557226691517,333.99771206969797,211.08903904767416,0.14250522105258465,1,4943.028953463268,4181.144761716826,6056.558281792772,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,2.063986358833593,1.8530123801860932,6,0.7564891364193463,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,88.82681214690514,70.03385487579287,34.66326608523606,25.668701814989966,0.6749631782339625,1,123.4900782321412,95.70255669078284,257.105341091664,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_3,2.6178385995607485,2.2843007053777282,5,1.021570331655064,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,4.248174471556717,6.467160526766566,6,2.6402072292078267,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,88.82681214690514,144.14631819378133,34.66326608523606,89.58581007136776,0.5842691220104909,1,123.4900782321412,233.73212826514907,257.105341091664,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_3,0.8271164363503254,0.5938764544198474,5,0.2655896244638668,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,88.82681214690514,28.065181836510337,34.66326608523606,9.011815963129825,0.1564846325150938,1,123.4900782321412,37.07699779964016,257.105341091664,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,2.46527875648739,1.8722411092902962,6,0.76433923220393,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,43.59527500577515,83.6502498775153,7.937766566894656,25.935066205716506,0.190771744534205,1,51.53304157266981,109.5853160832318,153.13873729235476,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_3,1.2848079415462892,0.5730239037991962,6,0.23393602912095096,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,2.3083322827298973,2.339217158939707,6,0.9549814061608699,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,43.59527500577515,78.32484328296238,7.937766566894656,32.40381358234703,0.34073412777941586,1,51.53304157266981,110.7286568653094,153.13873729235476,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_3,2.495969872296397,3.93616431165904,6,1.6069323512196714,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,43.59527500577515,84.69164103852995,7.937766566894656,54.525392863610726,0.48801525697470194,1,51.53304157266981,139.21703390214068,153.13873729235476,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,2.546307646876601,2.0343724137515293,6,0.8305290600809045,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,33.931355493730415,86.39966996257411,8.730479323522687,28.180976785478954,0.12616685759253357,1,42.6618348172531,114.58064674805306,312.7464300862574,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_3,1,0.5753364390986452,5,0.2572982775514477,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,5.583208358676126,6.848559557978923,6,2.795912731684845,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,33.931355493730415,189.44582761380676,8.730479323522687,94.86910882824539,0.16256110763942203,1,42.6618348172531,284.31493644205216,312.7464300862574,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_3,2.040569360503685,3.8831848270021196,6,1.5853035671788271,fruit_1_log2-1,1,967514 MM WT,fruit,ns,33.931355493730415,69.23928438086467,8.730479323522687,53.791498903423715,0.5442524581600434,1,42.6618348172531,123.03078328428839,312.7464300862574,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,1.682182741371535,0.647575206507331,6,0.26437147100340097,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,77.74641135651298,57.078740602895515,18.987698141593402,8.97048236501684,0.36457624227742386,1,96.73410949810638,66.04922296791236,326.2344849856906,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_3,2.2912851616222167,1.2512846352010403,5,0.5595915007021104,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,5.521568816743193,7.88472388909649,6,3.2189250485032237,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,77.74641135651298,187.3543144040097,18.987698141593402,109.2224901284363,0.36576802948045795,1,96.73410949810638,296.576804532446,326.2344849856906,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_3,2.4284429129605796,1.5129059268763752,6,0.6176412582799263,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,77.74641135651298,82.40035977589565,18.987698141593402,20.957405102291148,0.8729213335295368,1,96.73410949810638,103.3577648781868,326.2344849856906,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.7783971886833133,0.7114365741649742,6,0.290442765176318,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,132.13528223496579,59.41759830437589,38.453165199193755,22.170444347120736,0.1400284716456088,1,170.58844743415955,81.58804265149664,187.6472921775755,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_3,1.7310314646292042,1.233939549735143,6,0.5037537117151211,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,1.5002729928544651,0.7612133572876152,6,0.3107640517909267,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,132.13528223496579,114.52073482834432,38.453165199193755,23.721634488412672,0.7064244396135234,1,170.58844743415955,138.242369316757,187.6472921775755,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_3,1.5148418697124435,1.0132610531212072,6,0.4136620927303464,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,132.13528223496579,115.63282475554142,38.453165199193755,31.576177839458982,0.7472431450034664,1,170.58844743415955,147.2090025950004,187.6472921775755,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.909609557232719,0.8521453293145941,6,0.3478868739194486,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,46.62277463490239,69.43346670726937,12.898264216147403,26.55534068009152,0.46420992987546195,1,59.521038851049795,95.9888073873609,106.61609634117748,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_3,0.6107792596819083,0.4138977443545151,6,0.16897304655957981,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.448025363412442,0.3698850350787875,6,0.151004933239081,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,46.62277463490239,34.19923846133384,12.898264216147403,11.526699473768485,0.4892778221482108,1,59.521038851049795,45.72593793510232,106.61609634117748,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_3,0.908191554218656,0.8856196379681691,6,0.36155270320173033,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,46.62277463490239,69.32522590847293,12.898264216147403,27.59849803805205,0.4801215641417972,1,59.521038851049795,96.92372394652497,106.61609634117748,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,1.7034134825034721,3.0666586045019932,6,1.2519581327242346,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,76.3332642617619,130.02711150698568,20.016562629227533,95.56605098990096,0.6042049129292622,1,96.34982689098943,225.59316249688663,248.15247874657533,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_3,1,0.6423197713376317,6,0.2622259485797276,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.8775124810434682,0.47211830231053814,6,0.1927414898149785,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,76.3332642617619,66.98339210848539,20.016562629227533,14.71258707625244,0.7151887124659594,1,96.34982689098943,81.69597918473784,248.15247874657533,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_3,1.9416377931539712,0.9317839094458098,6,0.38039918811298684,leaf_1_log2-1,1,967514 MM WT,leaf,ns,76.3332642617619,148.21155076544628,20.016562629227533,29.037111751188295,0.07242364666152995,1,96.34982689098943,177.24866251663457,248.15247874657533,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.9671865264311724,0.884375783085274,6,0.36104490157220326,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,47.13773895217496,73.82850471248624,23.31259242606545,27.559735882072804,0.4771125077143755,1,70.4503313782404,101.38824059455904,114.13261319749495,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_3,0.6175255232179029,0.7480874370773839,6,0.3054054173043347,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.8147284982388368,1.3338297290975076,6,0.5445337066739351,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,47.13773895217496,62.19088575765353,23.31259242606545,41.566035330978224,0.7603283319855874,1,70.4503313782404,103.75692108863176,114.13261319749495,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_3,0.6372636382805346,0.38194328770908575,6,0.15592769426138164,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,47.13773895217496,48.64441370527989,23.31259242606545,11.90246989178126,0.9556138362758386,1,70.4503313782404,60.54688359706115,114.13261319749495,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.9956692870476603,0.28345909105320943,6,0.11572168933891325,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,10591.387819563437,1500.3520502909798,8491.23855051692,174.37845690470053,0.34467793993340556,1,19082.626370080357,1674.7305071956803,20990.889007088394,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_17,7.02869673627919,12.600215675787016,5,5.6349877564436435,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,1.4147240207951108,0.7440869551089577,6,0.3037722273796932,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,10591.387819563437,2131.816369961244,8491.23855051692,457.74765788147084,0.3758251691804977,1,19082.626370080357,2589.564027842715,20990.889007088394,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_17,1.6845850178283077,2.3013995738051025,5,1.0292171780834507,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,10591.387819563437,2538.463944069799,8491.23855051692,1550.9046260842283,0.4005723099692902,1,19082.626370080357,4089.368570154027,20990.889007088394,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,2.1786413222199514,1.764991954054369,6,0.7205549479251693,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,7851.66608672626,3282.9464734557887,2250.017703206182,1085.78833105564,0.10892112338242028,1,10101.683789932442,4368.734804511429,11111.852168925687,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_17,5.210552265510526,3.6574929284585385,6,1.4931652354268665,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,1.963407100734923,1.1728037397208733,6,0.4787951217906719,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,7851.66608672626,2958.6147804943807,2250.017703206182,721.4857905058266,0.08365735092317736,1,10101.683789932442,3680.1005710002073,11111.852168925687,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_17,1.856594025348439,1.6666040050753437,6,0.6803882359522364,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,7851.66608672626,2797.6605171272868,2250.017703206182,1025.2620002287333,0.08029174240003135,1,10101.683789932442,3822.92251735602,11111.852168925687,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.7494868600040415,0.3210295225838043,6,0.13105975378326823,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,1506.8779059558976,1129.385190144351,746.5677399146275,197.49104733602675,0.647551570271083,1,2253.4456458705254,1326.8762374803778,3529.319121531911,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_17,0.9999999999999999,1.1078377416374094,5,0.49544009966821934,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,1.4940810198524654,1.555762115522355,6,0.6351372240304445,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,1506.8779059558976,2251.397678523735,746.5677399146275,957.0742501416382,0.5550773139755049,1,2253.4456458705254,3208.4719286653735,3529.319121531911,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_17,0.448010898639621,0.15916994807772794,6,0.06498085919595428,fruit_1_log2-1,1,967514 MM WT,fruit,ns,1506.8779059558976,675.097724787492,746.5677399146275,97.91822103241462,0.32935675477263193,1,2253.4456458705254,773.0159458199066,3529.319121531911,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,7.958354326324979,4.7625244793496195,6,1.9442924769867815,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,*,32896.69984242266,11992.268302107643,7137.1078980457705,2929.8113762876465,0.03951855425442778,0.6718154223252722,40033.80774046843,14922.07967839529,44037.18851451528,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_17,21.831032038096296,10.590810549217823,5,4.736354464974586,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,10.18504569691391,2.551356028996692,6,1.0415867372025698,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,32896.69984242266,15347.62033183076,7137.1078980457705,1569.5440414272443,0.06858192796871339,1,40033.80774046843,16917.164373258005,44037.18851451528,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_17,16.47233016831366,11.56286928088726,6,4.720521616779341,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,32896.69984242266,24821.790390242648,7137.1078980457705,7113.249728912002,0.44383282851039674,1,40033.80774046843,31935.040119154648,44037.18851451528,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,1.5470203940157146,0.2921936648009397,6,0.11928756413935468,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,18175.558131964863,25003.14211897931,1852.3903292828065,1927.9409183876915,0.028715705222647978,0.5870691862871826,20027.94846124767,26931.083037367003,35297.7787662325,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_17,1.1245770219185416,0.28074341583434403,6,0.11461301957335637,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,1.7284745259423662,0.23780052089736498,6,0.0970816561277654,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,18175.558131964863,27935.82708304838,1852.3903292828065,1569.046183681881,0.002570974445994383,0.05913241225787081,20027.94846124767,29504.87326673026,35297.7787662325,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_17,1.771340224495109,0.5244281928910011,6,0.2140969132188042,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,18175.558131964863,28628.628003507783,1852.3903292828065,3460.2617839763047,0.029822147929995952,0.5870691862871826,20027.94846124767,32088.889787484088,35297.7787662325,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,2.8621828741838753,0.936752210057604,6,0.3824274883442624,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,27932.670478349937,46258.96688276055,1569.0286141512981,6180.842139033085,0.030322171736800168,0.5870691862871826,29501.699092501236,52439.80902179363,57683.789923973,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_17,1.728279217215923,0.23779785810542933,6,0.09708056904750981,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,2.970136560952815,0.5243953386083205,6,0.21408350051406547,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,27932.670478349937,48003.72822074467,1569.0286141512981,3460.0450061212223,0.0011585668669061627,0.027805604805747904,29501.699092501236,51463.773226865895,57683.789923973,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_17,2.823554810257727,0.8392611444884478,6,0.342626927490154,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,27932.670478349937,45634.65515690188,1569.0286141512981,5537.580367372014,0.022767175937307732,0.5008778706207702,29501.699092501236,51172.23552427389,57683.789923973,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,1.356904386731563,0.25192103265088867,6,0.10284633091161632,leaf_1_panK4-1,1,967514 MM WT,leaf,*,16162.128318216166,21930.462813905935,1504.5160778513555,1662.2155972512644,0.027955675537484886,0.5870691862871826,17666.64439606752,23592.678411157198,39943.227288650734,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_17,1,0.22802050744737704,6,0.09308898235609422,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,1.8929491292800862,0.8665956860690026,6,0.35378620736102884,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,16162.128318216166,30594.086727280315,1504.5160778513555,5717.938080583981,0.05262627920778143,0.8420204673245029,17666.64439606752,36312.0248078643,39943.227288650734,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_17,1.3584326951000765,0.36135566797435603,6,0.14752283369995817,leaf_1_log2-1,1,967514 MM WT,leaf,ns,16162.128318216166,21955.163529867652,1504.5160778513555,2384.282968125588,0.07214292865376827,1,17666.64439606752,24339.446497993238,39943.227288650734,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,2.4002260428572497,0.49583351531901576,6,0.20242318498367584,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,52622.90803874885,38792.761297383084,6480.037786899388,3271.5894902881764,0.0962209041101132,1,59102.94582564824,42064.35078767126,96000.56521510758,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_17,3.2559392551931494,0.9820975170681826,6,0.4009396324118901,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,4.614186222575791,1.9245015085612307,6,0.7856744508652479,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,52622.90803874885,74575.06981341507,6480.037786899388,12698.171291228158,0.16498236100096883,1,59102.94582564824,87273.24110464324,96000.56521510758,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_17,3.59399185986114,0.8954489242875281,6,0.3655654925380885,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,52622.90803874885,58086.55761370011,6480.037786899388,5908.31639911248,0.547313867788985,1,59102.94582564824,63994.874012812594,96000.56521510758,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,1.0307045406585296,0.158289294505981,6,0.0646213338807977,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,47.405647205874274,43.71094894767554,2.8013767462564423,2.740513614492796,0.37083986412598835,1,50.20702395213072,46.45146256216834,56.45612777568407,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_85,1.117825556394133,0.1477067953657103,5,0.06605648703527582,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.9690354089088261,0.0755508475791641,6,0.03084350436728963,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,47.405647205874274,41.095634700746444,2.8013767462564423,1.3080361942566243,0.08966384916503957,1,50.20702395213072,42.40367089500307,56.45612777568407,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_85,1.0697971613442985,0.3139827422934509,5,0.14041735110599088,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,47.405647205874274,45.368820315870664,2.8013767462564423,5.954932207478488,0.7679616526374704,1,50.20702395213072,51.32375252334915,56.45612777568407,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,1.0479643446814046,0.14490439111616962,6,0.05915696995388323,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,41.383975932095495,44.44291662874228,1.227112838554013,2.508776464593104,0.308374840125633,1,42.61108877064951,46.951693093335386,70.35650311887709,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_85,0.975834497548295,0.07087679640296023,6,0.02893533096506379,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,1.3018601131788086,0.5053983323323632,6,0.2063280051779746,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,41.383975932095495,55.21033302891667,1.227112838554013,8.750124351880672,0.17620199235019524,1,42.61108877064951,63.960457380797344,70.35650311887709,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_85,1.2171674558570411,0.4180084797427488,6,0.17065124725437553,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,41.383975932095495,51.618618551682,1.227112838554013,7.237115645020163,0.2189916410223513,1,42.61108877064951,58.85573419670216,70.35650311887709,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,1.1020874038413544,0.2715480492320943,6,0.11085902687779942,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,42.4088060383901,46.738210946860896,2.6339619358896953,4.70139896846527,0.44588724595554163,1,45.04276797427979,51.439609915326166,56.58357090685879,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_85,1,0.13887959810669273,5,0.062108844410883206,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.9104570306835708,0.11146715339220507,6,0.045506274815240916,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,42.4088060383901,38.61139562054814,2.6339619358896953,1.9298667821692284,0.2797152337844531,1,45.04276797427979,40.541262402717365,56.58357090685879,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_85,1.0183156499644141,0.1756574798062435,6,0.07171186583808946,fruit_1_log2-1,1,967514 MM WT,fruit,ns,42.4088060383901,43.185550885197976,2.6339619358896953,3.041214608978588,0.8512005823898302,1,45.04276797427979,46.22676549417656,56.58357090685879,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,1.5033014012656523,0.11299601771758355,6,0.04613043106242787,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,50.25814193787295,63.75321754351509,4.99638000726153,1.9563365033938283,0.051456728822099555,1,55.25452194513448,65.70955404690892,99.81440458768417,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_85,1.1850874059594447,0.26344163821882005,5,0.11781468223223765,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,1.8702390700730502,0.6599404473302857,6,0.2694195594305462,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,50.25814193787295,79.31460596814705,4.99638000726153,11.425761838838547,0.05375059274172163,1,55.25452194513448,90.7403678069856,99.81440458768417,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_85,1.3430346156621167,0.48685122737740866,6,0.19875618128706057,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,50.25814193787295,56.9564945184585,4.99638000726153,8.42901234113405,0.5137469047204553,1,55.25452194513448,65.38550685959255,99.81440458768417,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,1.0371292021873784,0.05639509761224084,6,0.023023202190740007,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,381.04398548029735,400.19861847670063,11.072679330866846,8.883997953399861,0.20835813888047316,1,392.1166648111642,409.0826164301005,503.99561200789606,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_85,0.9874892776085075,0.07028871854414437,6,0.028695249184542568,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,1.1472781084492114,0.09824001019603976,6,0.040106316217685706,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,381.04398548029735,442.7019440216128,11.072679330866846,15.47588507647446,0.010073336781264668,0.24176008275035205,392.1166648111642,458.1778290980873,503.99561200789606,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_85,1.0700495512772434,0.1201778636212365,6,0.04906240737496908,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,381.04398548029735,412.9016435171184,11.072679330866846,18.931785556893715,0.1841276188884157,1,392.1166648111642,431.8334290740121,503.99561200789606,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,2.361073260209758,0.5845447558764634,6,0.23863939728618233,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,664.203282239165,911.0709204459462,82.01569892594517,92.08414622461677,0.07352640763858913,1,746.2189811651101,1003.155066670563,1103.4705733376193,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_85,1.721306842140058,0.5206308433349832,6,0.2125466517542662,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,2.0680296873897146,0.45265830006756347,6,0.18479697716686114,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,664.203282239165,797.9937524819981,82.01569892594517,71.30788989922458,0.24700160490648246,1,746.2189811651101,869.3016423812227,1103.4705733376193,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_85,1.7448826599831726,0.43844833333437006,6,0.17899578254048656,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,664.203282239165,673.3005188326133,82.01569892594517,69.06937412887207,0.9341087060400686,1,746.2189811651101,742.3698929614853,1103.4705733376193,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,1.0689538206055889,0.0968159867255611,6,0.03952496107028238,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,385.8715169071063,412.47883226072537,13.806584195577056,15.251556683884187,0.2252495025137596,1,399.67810110268334,427.73038894460956,470.5034278390705,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_85,1,0.08764338617426344,6,0.03578026257610722,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,1.0175367625777212,0.12171010156200197,6,0.049687940894870455,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,385.8715169071063,392.6384540846114,13.806584195577056,19.17316112509431,0.7809887875858381,1,399.67810110268334,411.8116152097057,470.5034278390705,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_85,1.0539449188285106,0.08851433168754924,6,0.03613582459299332,leaf_1_log2-1,1,967514 MM WT,leaf,ns,385.8715169071063,406.6873245648944,13.806584195577056,13.943785450387448,0.31373070792734054,1,399.67810110268334,420.6311100152819,470.5034278390705,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,3.843721025794143,0.4121502111306137,6,0.16825961910839327,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1290.5036601316474,1483.1824627909245,101.28415180242543,64.92659445956765,0.14563522978045573,1,1391.7878119340728,1548.1090572504922,2325.1918891095766,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_85,3.3443869360337364,0.6429458513421736,6,0.26248154467127544,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,4.8025279970125085,1.654603884706456,6,0.6754892073262774,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1290.5036601316474,1853.1587631960635,101.28415180242543,260.6520450853695,0.08739963512919675,1,1391.7878119340728,2113.810808281433,2325.1918891095766,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_85,3.965525794712744,0.500564251451932,6,0.2043544999225745,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1290.5036601316474,1530.1834537400648,101.28415180242543,78.85458087191698,0.09320507636843116,1,1391.7878119340728,1609.0380346119819,2325.1918891095766,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,1.284268367671739,0.6514183075222758,6,0.2659404104228321,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,516.6174457020956,806.7653356000371,121.61915874489958,167.06126995353003,0.19510675958310877,1,638.2366044469951,973.8266055535671,1662.4955013973308,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_5,0.8223896273494562,0.4329079420550231,5,0.19360231728691432,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,2.162897800592388,0.5952148085938382,6,0.24299542806720992,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,516.6174457020956,1358.7120993464446,121.61915874489958,152.6474473784014,0.0020069080467059095,0.04615888507423592,638.2366044469951,1511.359546724846,1662.4955013973308,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_5,1.480715329704481,0.6587262462313208,5,0.29459133302729956,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,516.6174457020956,930.171473477025,121.61915874489958,185.05951064223316,0.10459268687033314,1,638.2366044469951,1115.2309841192582,1662.4955013973308,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,1.477552929708269,0.9153502851299647,6,0.3736901890799177,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,269.3893985537138,928.1848834788062,31.089885393957992,234.74866966478143,0.03737621449333198,0.7101480753733076,300.47928394767183,1162.9335531435877,1279.2269084579466,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_5,0.42883384781441236,0.12122810110342813,6,0.049491165031654884,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,1.5424672459014481,0.5756906964001335,6,0.2350247426413053,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,269.3893985537138,968.9634476848063,31.089885393957992,147.6403375994304,0.004560718638118546,0.100335810038608,300.47928394767183,1116.6037852842367,1279.2269084579466,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_5,1.1192751680196809,0.24308688286179972,6,0.09923980436251907,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,269.3893985537138,703.1181560542741,31.089885393957992,62.34151372626037,3.58269124409958e-4,0.008598458985838992,300.47928394767183,765.4596697805345,1279.2269084579466,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,1.248304706315605,0.8123715272882992,6,0.33164928723696563,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,628.1906149122311,784.173301058232,197.66179291584712,208.3389696845926,0.6002673539060989,1,825.8524078280782,992.5122707428246,2224.65744496035,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_5,1,0.703584541096771,5,0.3146525723620749,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,2.673969796366981,1.3360997497719684,6,0.5454604387336013,fruit_1_transp1-1,1,967514 MM WT,fruit,*,628.1906149122311,1679.762730636507,197.66179291584712,342.65312841835635,0.029524552879118995,0.5904910575823799,825.8524078280782,2022.4158590548634,2224.65744496035,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_5,1.2339621935203102,0.8621647260149213,6,0.3519772754938365,fruit_1_log2-1,1,967514 MM WT,fruit,ns,628.1906149122311,775.1634691259692,197.66179291584712,221.10882112760493,0.6320794975094031,1,825.8524078280782,996.272290253574,2224.65744496035,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,0.7869457003806292,0.5905132878847126,6,0.2410760402751289,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,489.8310188956316,494.35190342464387,151.71731415621852,151.44170598103904,0.9836402035742877,1,641.5483330518501,645.7936094056829,1254.4504811788804,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_5,0.7797490240507163,0.5400434514043079,5,0.2415147736287273,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,1.5419678631272498,0.6697391357156337,6,0.2734198572126526,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,489.8310188956316,968.6497401128061,151.71731415621852,171.75978823163067,0.06625819666463781,1,641.5483330518501,1140.4095283444367,1254.4504811788804,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_5,0.9745866423867627,0.6660616373567392,6,0.2719185247944503,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,489.8310188956316,612.2261821661872,151.71731415621852,170.81666529665247,0.6051319990739366,1,641.5483330518501,783.0428474628396,1254.4504811788804,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,1.4990390125952817,0.17871023754497087,6,0.07295814896612524,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,14569.968625724923,15816.63999078849,1404.8743723332368,769.7950266108721,0.4595244807652663,1,15974.84299805816,16586.435017399363,25547.14163662881,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_5,1.3808843973796554,0.32614582339647546,6,0.1331484748435401,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,1.6172230675469046,0.28364889156403145,6,0.11579917507298551,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,14569.968625724923,17063.6219799931,1404.8743723332368,1221.8186771461915,0.21066027138702878,1,15974.84299805816,18285.44065713929,25547.14163662881,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_5,1.8676264995632228,0.8169462231610072,6,0.33351689900639075,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,14569.968625724923,19705.67525771475,1404.8743723332368,3518.998957402351,0.22013675679278538,1,15974.84299805816,23224.6742151171,25547.14163662881,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,2.4934470331649417,0.3953328970172846,6,0.16139397937143285,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,19199.883087461036,26308.82433899483,1023.9920150059218,1702.8979545897193,0.006929524968744525,0.14552002434363503,20223.87510246696,28011.72229358455,30812.894522943006,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_5,1.8196895043532968,0.23772283519618823,6,0.0970499410730665,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,1.8750501233669667,0.6042916859617592,6,0.2467010477354138,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,19199.883087461036,19784.00329597413,1023.9920150059218,2602.988731177767,0.8409651398572902,1,20223.87510246696,22386.992027151897,30812.894522943006,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_5,2.1593265101926846,0.8093142781333049,6,0.3304011704959171,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,19199.883087461036,22783.45643263405,1023.9920150059218,3486.1243252245813,0.36297089324606036,1,20223.87510246696,26269.580757858632,30812.894522943006,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,1.1804815794119625,0.16541503085633666,6,0.0675304035641266,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,10551.186365326936,12455.481145211106,795.4324475164594,712.5258733308381,0.10523966050213913,1,11346.618812843395,13168.007018541944,15517.662875628364,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_5,1,0.18466204214450088,6,0.07538796301905831,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,1.1808572242857482,0.38247711071446805,6,0.15614562659073927,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,10551.186365326936,12459.444644281599,795.4324475164594,1647.521606289639,0.33062559555030746,1,11346.618812843395,14106.966250571239,15517.662875628364,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_5,1.0488441311644696,0.15689782870766597,6,0.06405327034739665,leaf_1_log2-1,1,967514 MM WT,leaf,ns,10551.186365326936,11066.549896095728,795.4324475164594,675.8379927440516,0.6324206889386129,1,11346.618812843395,11742.38788883978,15517.662875628364,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,3.0222562855283974,0.5461582840972723,6,0.22296818580538827,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,37488.7107258936,31888.389312390857,2838.4084596088287,2352.578881971495,0.1607442874051112,1,40327.11918550243,34240.96819436235,46684.358916016456,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_5,3.5530327517565357,0.6589450860699866,6,0.26901320489763514,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,3.714597478277383,0.7537813489141596,6,0.3077299470777503,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,37488.7107258936,39193.41026547814,2838.4084596088287,3246.916021809539,0.7010840185639202,1,40327.11918550243,42440.32628728768,46684.358916016456,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_5,3.5323558129944903,0.7918263709427066,6,0.32326176228156467,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,37488.7107258936,37270.54449155081,2838.4084596088287,3410.795098616802,0.9617866750759856,1,40327.11918550243,40681.33959016761,46684.358916016456,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,1.5762330272735436,0.8130816301577883,6,0.33193918551948803,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,46.86535158575682,70.31385856717075,6.831135811865268,14.807407622901348,0.19385217144848632,1,53.696487397622086,85.1212661900721,97.08447706078758,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_9,1.050585425257068,0.34241865260218,5,0.15313427679647196,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,1.1694378766833413,1.0106984425373282,6,0.4126159113403532,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,46.86535158575682,52.16721642131594,6.831135811865268,18.406299278434634,0.7957231203698741,1,53.696487397622086,70.57351569975057,97.08447706078758,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_9,1.3455457244824809,1.4153343688687228,5,0.6329567719364452,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,46.86535158575682,60.0231755900795,6.831135811865268,28.235439919727394,0.6717355376560281,1,53.696487397622086,88.25861550980689,97.08447706078758,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,3.481895605920767,5.036605938117338,6,2.0561857639765444,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,56.086167734335305,155.32317299799763,17.10036636482229,91.72397259443176,0.33317180666951257,1,73.1865340991576,247.0471455924294,271.75186015167236,0,23,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_9,1.2572894128916279,0.9389890596853027,6,0.3833406783807951,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.9479005786473956,0.5445883920904817,6,0.22232728007740313,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,56.086167734335305,42.2847041455791,17.10036636482229,9.917752423971603,0.504807009919964,1,73.1865340991576,52.202456569550705,271.75186015167236,0,23,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_9,1.4182626986514209,0.8053801453342443,5,0.36017695053920606,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,56.086167734335305,63.266992302885974,17.10036636482229,16.0670603401673,0.766557606326002,1,73.1865340991576,79.33405264305327,271.75186015167236,0,23,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.8239284418297914,0.40026040112485173,6,0.1634056244996008,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,44.60879663763593,36.75445630554941,4.56691891534069,7.289328272748594,0.38746454908568595,1,49.17571555297663,44.043784578298,54.093287108274296,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_9,1,0.22892213895354646,5,0.10237709285095649,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.7917006029114604,0.4238015687963026,6,0.1730162659569938,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,44.60879663763593,35.3168111931711,4.56691891534069,7.718047423078668,0.33080255611852355,1,49.17571555297663,43.034858616249764,54.093287108274296,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_9,0.8374977989949565,0.2845610827063831,6,0.11617157554742684,fruit_1_log2-1,1,967514 MM WT,fruit,ns,44.60879663763593,37.35976899983371,4.56691891534069,5.182274188668923,0.32133835274760325,1,49.17571555297663,42.54204318850263,54.093287108274296,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,1.6272366095533133,1.688669167797107,6,0.6893963009122033,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,46.97439971609506,72.58906699687994,21.907378608349745,30.753139390130944,0.5153734119504696,1,68.88177832444481,103.34220638701088,113.67642702571197,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_9,1.0530299684538742,1.0981329125512773,5,0.4910999681588976,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.6560193918609399,0.5844898354659652,6,0.2386169761224849,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,46.97439971609506,29.26423564187027,21.907378608349745,10.644416162135558,0.49520233765258637,1,68.88177832444481,39.90865180400583,113.67642702571197,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_9,1.575002789343043,1.25795675779719,6,0.5135586958481666,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,46.97439971609506,70.25897913351315,21.907378608349745,22.909235424580388,0.4813801579209116,1,68.88177832444481,93.16821455809354,113.67642702571197,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.9931375564537746,0.042033567303261465,6,0.017160131993654223,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,133.19324921762612,135.35551505737482,2.2317096492479345,2.338768168980947,0.5187514860691049,1,135.42495886687405,137.69428322635576,152.7484912336935,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_9,0.9772724665711701,0.040109455476245344,6,0.016374616629613592,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.9804856594445619,0.018970888989737613,6,0.007744832998640102,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,133.19324921762612,133.6311778545308,2.2317096492479345,1.0555495084764508,0.8641369385846647,1,135.42495886687405,134.68672736300724,152.7484912336935,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_9,1.0028103800625825,0.039331661324782566,6,0.016057083496946123,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,133.19324921762612,136.67383195428522,2.2317096492479345,2.1884328036179492,0.2915313212956138,1,135.42495886687405,138.86226475790318,152.7484912336935,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,1.0430174801121832,0.06584819056594313,6,0.026882411228684955,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,140.44444451760862,142.15368990629935,4.166353908477347,3.663825412902074,0.7644488934844658,1,144.61079842608595,145.81751531920142,160.39926685112158,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_9,1.0304763155502172,0.07487989606832031,6,0.030569589560003507,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,1.0336946979533435,0.06720179722838293,6,0.027435018834586503,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,140.44444451760862,140.88308043968797,4.166353908477347,3.739140747253656,0.939110412429184,1,144.61079842608595,144.62222118694163,160.39926685112158,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_9,1.0354870227219002,0.05717900222974325,6,0.023343229910722095,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,140.44444451760862,141.12735782162923,4.166353908477347,3.181467549118479,0.8991096688914291,1,144.61079842608595,144.3088253707477,160.39926685112158,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,1.025665643940071,0.03664280132902736,6,0.014959361000382388,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,136.29080299882398,139.78879422089815,1.9478848588652713,2.038823323091407,0.24315389985064065,1,138.23868785768926,141.82761754398956,156.01037929838853,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_9,1,0.03500840758825313,6,0.014292122549766473,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,1.009361186493066,0.06841278553617863,6,0.027929402741015824,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,136.29080299882398,137.56664662298567,1.9478848588652713,3.8065207268506023,0.7735670800901345,1,138.23868785768926,141.37316734983628,156.01037929838853,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_9,0.9950905443016835,0.07279774319019537,6,0.029719554207024587,leaf_1_log2-1,1,967514 MM WT,leaf,ns,136.29080299882398,135.62168933941328,1.9478848588652713,4.0505019076424595,0.8857408789865862,1,138.23868785768926,139.67219124705574,156.01037929838853,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,1.000851659539082,0.030956125220913278,6,0.01263778520082312,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,141.34954949170626,136.40687636128706,2.7717305986798673,1.7224138931468362,0.16672003694403342,1,144.12128009038614,138.1292902544339,162.89864236806613,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_9,1.0371172990515432,0.04981499500948124,6,0.020336886552086587,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,1.0518924935975633,0.08494537855433415,6,0.03467880557761261,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,141.34954949170626,143.3632726208472,2.7717305986798673,4.726402259212917,0.7226747486396269,1,144.12128009038614,148.0896748800601,162.89864236806613,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_9,1.0051183035865243,0.014397461461151088,6,0.005877739028534283,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,141.34954949170626,136.98838070462313,2.7717305986798673,0.8010817720164654,0.1828157622719011,1,144.12128009038614,137.78946247663959,162.89864236806613,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,1.3351070776034386,0.5468931024113863,6,0.22326817412592684,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,253.150013869321,158.05917884303292,129.34959524156886,26.432025457818156,0.5082984322825238,1,382.4996091108899,184.49120430085108,420.7495700219789,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_12,2.138328047041078,2.4431293051443568,5,1.0926006408249216,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,1.7514475438014996,0.8697683162030759,6,0.3550814281895384,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,253.150013869321,207.34843309859104,129.34959524156886,42.03698707282267,0.7503933092024682,1,382.4996091108899,249.38542017141373,420.7495700219789,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_12,1.6789037046858055,1.883171623276481,5,0.8421799525889673,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,253.150013869321,198.76019337378187,129.34959524156886,99.70306799902605,0.7482100177766824,1,382.4996091108899,298.4632613728079,420.7495700219789,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,1.7910660027280474,0.8910610254705833,6,0.36377414034734235,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,144.40246858092212,212.03873935941704,26.196060912639513,43.06609025760066,0.21540390235888637,1,170.59852949356164,255.10482961701769,280.61531257871945,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_12,1.2197504709122775,0.542010866565413,6,0.22127500968816682,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,1.4761675876713765,0.5282541458226817,6,0.21565885196255802,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,144.40246858092212,174.75889436588037,26.196060912639513,25.531181448472402,0.42599158968793904,1,170.59852949356164,200.29007581435278,280.61531257871945,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_12,1.3609583501033418,0.7366619798794493,6,0.30074099393550985,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,144.40246858092212,161.11963067639203,26.196060912639513,35.60379189301498,0.7138773066483796,1,170.59852949356164,196.723422569407,280.61531257871945,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,0.6953045253890597,0.2537238605816692,6,0.10358233233235797,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,118.38689307733607,82.31494250342251,42.51833221062219,12.262790502531953,0.45454774254680913,1,160.90522528795827,94.57773300595447,176.99574781675412,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_12,1,0.8030777617481967,5,0.3591472932974696,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,0.9129903708267767,0.6579270065777411,6,0.26859757568536957,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,118.38689307733607,108.08609341170703,42.51833221062219,31.798432473495538,0.8511371664542204,1,160.90522528795827,139.88452588520255,176.99574781675412,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_12,0.3684824998757589,0.0511603028403022,6,0.02088610617416689,fruit_1_log2-1,1,967514 MM WT,fruit,ns,118.38689307733607,43.623498313660974,42.51833221062219,2.4726412184429845,0.1535573394225404,1,160.90522528795827,46.09613953210396,176.99574781675412,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,2.99115999470197,0.8050923789601894,6,0.3286775873759819,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,469.9959426691561,354.1141384699872,79.52337454843953,38.91111839359715,0.23942508286576136,1,549.5193172175956,393.02525686358433,617.0259160675239,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_12,3.9699998070067766,1.5020216061783715,5,0.6717244830176513,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,3.7585979522479693,1.4532874298893128,6,0.5933021088049332,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,469.9959426691561,444.9687338934747,79.52337454843953,70.23919331764763,0.8190946252956344,1,549.5193172175956,515.2079272111223,617.0259160675239,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_12,4.133808462151933,1.480282745148429,6,0.6043229001100004,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,469.9959426691561,489.38874041096796,79.52337454843953,71.54391055950826,0.8603420095946304,1,549.5193172175956,560.9326509704762,617.0259160675239,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,2.112648044225099,1.8325811496692526,6,0.7481481214887731,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,63.24945076096688,90.85187652090627,24.287513890069793,32.17320600970099,0.5102132100619414,1,87.53696465103667,123.02508253060726,279.66558062489764,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_12,1.4707877653767525,1.383413269844838,6,0.564776102419178,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,1.6064346283028843,1.195716101177597,6,0.48814905418586946,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,63.24945076096688,69.08278020488449,24.287513890069793,20.992260265934984,0.8595151847923265,1,87.53696465103667,90.07504047081947,279.66558062489764,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_12,3.746800587709428,5.3038057785008395,6,2.165269642025326,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,63.24945076096688,161.12663217781417,24.287513890069793,93.11480475391092,0.35046815077245963,1,87.53696465103667,254.2414369317251,279.66558062489764,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,4.840350498232131,2.1396847307336513,6,0.8735226334536442,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,131.9396798879633,208.1534247909197,46.174685286655645,37.56478541216569,0.23047870302847073,1,178.11436517461897,245.7182102030854,270.29003122339395,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_12,3.0680941037783507,2.6301033792753112,6,1.073735208332375,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,2.703794049517031,1.5105316770941242,6,0.6166719748651882,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,131.9396798879633,116.27339622240903,46.174685286655645,26.519233181078807,0.7761080466673942,1,178.11436517461897,142.79262940348784,270.29003122339395,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_12,3.3598344713449815,1.2479793848432494,6,0.5094854503964,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,131.9396798879633,144.48562189793458,46.174685286655645,21.909806205126788,0.8129937316544157,1,178.11436517461897,166.39542810306136,270.29003122339395,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,2.0136221036991286,1.2823690086730801,6,0.5235249555346237,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,43.003791743375764,86.59338559733551,6.804887600258875,22.513558160271014,0.11404409417077165,1,49.80867934363464,109.10694375760653,126.64539314541388,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_12,1,0.3876054111017812,6,0.15823924645684503,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,2.064703308493396,1.500442452897646,6,0.6125530663348694,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,43.003791743375764,88.79007109030891,6.804887600258875,26.34210449643096,0.14631327809187436,1,49.80867934363464,115.13217558673988,126.64539314541388,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_12,1.3117883480997032,0.44645814077258067,6,0.18226577273408076,leaf_1_log2-1,1,967514 MM WT,leaf,ns,43.003791743375764,56.411872933066554,6.804887600258875,7.838119332601866,0.22606182869516064,1,49.80867934363464,64.24999226566842,126.64539314541388,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,8.011136347645861,5.220428041086331,6,2.131230823263108,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1217.3018534016187,344.50923912195054,388.11712345421853,91.65100648066998,0.07481289000126219,1,1605.4189768558372,436.16024560262053,2398.410612465347,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_12,28.306849327748637,22.107095080657935,6,9.025183773800679,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,29.819251393066427,51.15179571306563,6,20.882633154015803,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1217.3018534016187,1282.3408768507963,388.11712345421853,898.0324072086098,0.9489059755573478,1,1605.4189768558372,2180.373284059406,2398.410612465347,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_12,9.517030845529463,5.776420770261977,6,2.358213904459403,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1217.3018534016187,409.2684124964324,388.11712345421853,101.4121396337052,0.09328971756050472,1,1605.4189768558372,510.6805521301376,2398.410612465347,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,2.125060950256116,1.2587032690952484,6,0.513863457809411,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,4657.011589311893,2613.393592453395,1888.6081109547733,631.9477414862893,0.35281198959052756,1,6545.619700266666,3245.341333939684,7200.181670293333,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_13,3.786813246161795,3.4339456846608916,5,1.535707196388762,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,2.104587278556675,0.9814960257176573,6,0.40069407459630935,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,4657.011589311893,2588.215132312351,1888.6081109547733,492.77237293256496,0.34221104884510845,1,6545.619700266666,3080.987505244916,7200.181670293333,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_13,2.2932990844885652,2.719561463447881,5,1.2162248602516543,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,4657.011589311893,2820.292346089806,1888.6081109547733,1495.709690764928,0.4688194587931922,1,6545.619700266666,4316.002036854734,7200.181670293333,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,4.7234564864925686,1.17484377643383,6,0.47962796329122,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,3242.9918126710536,5808.892641194294,547.0979451312567,589.845032856906,0.00973071921405673,0.2335372611373615,3790.0897578023105,6398.7376740512,7038.611441456321,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_13,2.63701391287101,1.0897008199323492,6,0.44486849685445146,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,3.238595486913311,1.0613661467372952,6,0.4333009149617184,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,3242.9918126710536,3982.8150308007253,547.0979451312567,532.8721675623805,0.35555080882273904,1,3790.0897578023105,4515.687198363105,7038.611441456321,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_13,2.316713694131465,1.321193004476853,6,0.5393747854504902,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,3242.9918126710536,2849.087562906141,547.0979451312567,663.3214958174957,0.6570097407437921,1,3790.0897578023105,3512.409058723637,7038.611441456321,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,1.2576021410068485,0.7114311137683831,6,0.2904405359787445,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,1229.7970051816276,1546.5953467202253,399.5945692233763,357.18290133000676,0.5697244938274169,1,1629.391574405004,1903.778248050232,2094.1560728552554,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_13,0.9999999999999999,0.7265594374180896,5,0.3249272583521705,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,1.2394641752165778,0.5006037746561531,6,0.20437063520313145,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,1229.7970051816276,1524.2893307112633,399.5945692233763,251.33439511987794,0.5527221701395071,1,1629.391574405004,1775.6237258311412,2094.1560728552554,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_13,0.735661236150628,0.25715964736658065,6,0.10498498641369641,fruit_1_log2-1,1,967514 MM WT,fruit,ns,1229.7970051816276,904.7139850462563,399.5945692233763,129.1102218805977,0.474973747441018,1,1629.391574405004,1033.824206926854,2094.1560728552554,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,9.815656005112931,1.72035935445806,6,0.702333765441018,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,14139.754847965227,12071.264358980941,3788.8220977174606,863.7279613772995,0.6201863717658749,1,17928.57694568269,12934.99232035824,19721.434640250958,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_13,11.497633177173773,6.888993654605918,5,3.080851621652708,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,11.281630701541545,1.6648692540772243,6,0.6796800268228737,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,14139.754847965227,13874.115650320895,3788.8220977174606,835.8684614685385,0.9484219131048044,1,17928.57694568269,14709.984111789434,19721.434640250958,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_13,9.948013988310787,2.7992563457571147,6,1.1427916177254624,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,14139.754847965227,12234.037810329544,3788.8220977174606,1405.401709025441,0.6567119350966153,1,17928.57694568269,13639.439519354986,19721.434640250958,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,1.7932971776204616,0.2944795135759741,6,0.12022075799402136,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,67954.86845850368,89813.82545027474,5654.844614625991,6021.024461936651,0.024542970363162706,0.5399453479895795,73609.71307312968,95834.8499122114,113642.72738973887,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_13,1.3568431497183444,0.27657019199805044,6,0.11290930807646647,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,1.6356321048107476,0.15368325796433016,6,0.06274092733685466,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,67954.86845850368,81917.47480318,5654.844614625991,3142.2581637571975,0.06373430771460474,1,73609.71307312968,85059.7329669372,113642.72738973887,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_13,1.903906615271469,0.3892183087216693,6,0.15889770915285756,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,67954.86845850368,95353.48549676099,5654.844614625991,7958.084857547058,0.020443892120801083,0.4702095187784249,73609.71307312968,103311.57035430805,113642.72738973887,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,2.373944992813832,0.5503987109375537,6,0.2246993328137702,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,116500.2187851441,118894.44977326578,12927.350676052998,11253.632085066682,0.8917291462613908,1,129427.5694611971,130148.08185833246,143162.89004416572,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_13,2.3261397952059517,0.632257842992663,6,0.2581181835341242,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,2.238277392175493,0.33085777149368795,6,0.13507211959898155,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,116500.2187851441,112099.80003252538,12927.350676052998,6764.8262230350065,0.7711009471519655,1,129427.5694611971,118864.62625556039,143162.89004416572,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_13,2.359576222646095,0.5395385312789585,6,0.2202656830340183,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,116500.2187851441,118174.81767219224,12927.350676052998,11031.581299287454,0.9234998307300792,1,129427.5694611971,129206.39897147969,143162.89004416572,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,1.292258109855398,0.23711086765185813,6,0.09680010636927437,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,50083.06853493704,64720.25148071609,6711.322448359777,4848.046361481564,0.1104922360558496,1,56794.39098329682,69568.29784219766,84540.70511562808,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_13,1,0.3282409800090423,6,0.13400381894887456,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,1.1682547695676555,0.3274644177498326,6,0.13368678873411344,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,50083.06853493704,58509.78369052397,6711.322448359777,6695.444602386252,0.39494049936786324,1,56794.39098329682,65205.22829291022,84540.70511562808,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_13,1.3583140030860532,0.4316987159843091,6,0.17624026279603894,leaf_1_log2-1,1,967514 MM WT,leaf,ns,50083.06853493704,68028.53330852347,6711.322448359777,8826.653160229333,0.13882303333570614,1,56794.39098329682,76855.1864687528,84540.70511562808,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,3.6415913017239046,0.7534767552006402,6,0.30760559721492,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,193088.67571119935,182382.0667404689,21770.810752621834,15405.83220704508,0.6974558195764009,1,214859.48646382117,197787.89894751398,276267.53821126884,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_13,3.8553683182671645,1.0647785607110054,6,0.43469402713284055,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,4.304032013572323,1.7408103157108992,6,0.7106828354108323,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,193088.67571119935,215559.13031230573,21770.810752621834,35593.177152484095,0.6043621545478399,1,214859.48646382117,251152.30746478983,276267.53821126884,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_13,3.4453719026574348,0.5317650744318944,6,0.21709218256520976,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,193088.67571119935,172554.79712913872,21770.810752621834,10872.64265781246,0.4253919113004745,1,214859.48646382117,183427.43978695117,276267.53821126884,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,1.4560508899562583,0.405640601363767,6,0.16560208204949123,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,252.38138876651848,150.47674687613596,105.72407447783985,17.114279970991262,0.3927236509710085,1,358.10546324435836,167.59102684712724,393.9160095687942,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_47,2.4421058625381815,2.2875260820614653,5,1.0230127639586397,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,1.5941849591437596,0.6357299790464138,6,0.2595356771423259,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,252.38138876651848,164.7523230304301,105.72407447783985,26.821922684203415,0.46191097912283624,1,358.10546324435836,191.5742457146335,393.9160095687942,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_47,1.7852623010127444,1.9245862309059485,5,0.8607011281731615,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,252.38138876651848,184.49936415688956,105.72407447783985,88.94984831471673,0.6367783479805696,1,358.10546324435836,273.4492124716063,393.9160095687942,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,1.736532540208906,0.6884550461679982,6,0.2810605956593052,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,183.71193195612364,179.46334794866888,23.99727646814883,29.046432649858694,0.9125281380229308,1,207.70920842427248,208.50978059852758,229.36075865838035,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_47,1.7776429087776826,0.5687805548426269,6,0.23220368916358994,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,1.6947365667471574,0.6736656875531754,6,0.2750228652877467,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,183.71193195612364,175.1439095537415,23.99727646814883,28.422458562761605,0.8226038856857095,1,207.70920842427248,203.5663681165031,229.36075865838035,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_47,1.347532454832932,0.7264546191164346,6,0.2965738563538612,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,183.71193195612364,139.26182217392468,23.99727646814883,30.649663016915667,0.2815872887710984,1,207.70920842427248,169.91148519084035,229.36075865838035,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,0.7791351987731802,0.33441026081821257,6,0.13652241729260983,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,103.34580193186551,80.52035193055774,24.5687162311936,14.109018696781549,0.44887749726669834,1,127.91451816305911,94.62937062733928,140.70596997936502,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_47,1,0.5315873367461096,5,0.23773308418847458,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,0.8612663811288563,0.4564503874360469,6,0.1863450903523341,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,103.34580193186551,89.00826483471738,24.5687162311936,19.257982798527898,0.6582388868681277,1,127.91451816305911,108.26624763324529,140.70596997936502,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_47,0.60764249580261,0.10755227415113686,6,0.04390803205770235,fruit_1_log2-1,1,967514 MM WT,fruit,ns,103.34580193186551,62.79730101660095,24.5687162311936,4.537710784253308,0.17535242482968563,1,127.91451816305911,67.33501180085426,140.70596997936502,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,4.0760989284868865,1.0873372348691046,6,0.4439035672930159,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,571.1451956066917,421.247712518095,105.29522992727715,45.87557014231255,0.24375640234933457,1,676.4404255339689,467.12328266040754,744.0844680873658,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_47,5.526544716187312,2.278247276837517,5,1.018863156112494,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,4.898619191153523,1.9916944566299999,6,0.81310585704555,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,571.1451956066917,506.25172866858725,105.29522992727715,84.03107685186917,0.6427723179396878,1,676.4404255339689,590.2828055204565,744.0844680873658,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_47,5.833940636001153,1.254871192729947,6,0.5122990191843496,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,571.1451956066917,602.9132734504367,105.29522992727715,52.94395296651477,0.7965775297391242,1,676.4404255339689,655.8572264169514,744.0844680873658,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,1.7088861718784545,0.6299974449073967,6,0.2571953798800465,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,258.95508700861023,361.96852778241134,20.26642976279649,54.477960287597185,0.12394141704824868,1,279.22151677140675,416.4464880700085,506.7350497965691,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_47,1.222550396957741,0.23436631805878771,6,0.09567964868981008,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,1.3808199401336785,0.6264465896980619,6,0.2557457493111508,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,258.95508700861023,292.4790246932459,20.26642976279649,54.170906107227324,0.5820698814646263,1,279.22151677140675,346.6499308004732,506.7350497965691,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_47,1.7910029462454327,0.9402450560718446,6,0.38385343675842964,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,258.95508700861023,379.36213094509736,20.26642976279649,81.3060961426927,0.20399544032814962,1,279.22151677140675,460.66822708779006,506.7350497965691,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,2.3245287660191996,0.3233038795272971,6,0.1319882561173538,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,544.0912951545876,492.37115325179207,112.1122990547292,27.957154512433174,0.6711641471499467,1,656.2035942093167,520.3283077642252,721.8239536302485,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_47,2.5687042357672443,1.296496079778037,6,0.5292923081624837,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,2.525841019861716,0.4851733519545315,6,0.19807119151405964,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,544.0912951545876,535.0122029291007,112.1122990547292,41.954542536699506,0.9418672912450845,1,656.2035942093167,576.9667454658002,721.8239536302485,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_47,2.2639769631536524,0.3751862695150798,6,0.1531691531350455,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,544.0912951545876,479.5453446645997,112.1122990547292,32.44359617061405,0.6007795015541673,1,656.2035942093167,511.9889408352138,721.8239536302485,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,1.5651901807115776,0.3899593090978186,6,0.1592002212896536,leaf_1_panK4-1,1,967514 MM WT,leaf,*,211.8154700640626,331.53149386707787,33.88275703559322,33.72106970677076,0.031213910595664137,0.7491338542959393,245.6982270996558,365.25256357384865,401.7778199312335,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_47,1,0.39182910384590214,6,0.159963561799077,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,1.0808539982347298,0.46951109379709405,6,0.1916771013964821,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,211.8154700640626,228.94159770671075,33.88275703559322,40.600175332812846,0.7529251371292183,1,245.6982270996558,269.5417730395236,401.7778199312335,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_47,1.4205476959439178,0.4079449158657663,6,0.16654281450562353,leaf_1_log2-1,1,967514 MM WT,leaf,ns,211.8154700640626,300.89397796478204,33.88275703559322,35.276344540300634,0.09863697456700891,1,245.6982270996558,336.17032250508265,401.7778199312335,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,5.315934672186991,2.3673504326735,6,0.966466767067843,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1790.5832878371598,1125.997201419136,363.94657171478934,204.71261256777004,0.15074214111881648,1,2154.529859551949,1330.709813986906,2864.468855837934,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_47,8.45350572031215,4.20877376929482,6,1.7182246962637593,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,9.13563919639441,7.736409481907094,6,3.1583759453169917,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1790.5832878371598,1935.069710719957,363.94657171478934,668.9928854963466,0.8544218787361093,1,2154.529859551949,2604.0625962163035,2864.468855837934,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_47,4.623442837002772,0.98298662029937,6,0.40130260728606826,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1790.5832878371598,979.3167178340652,363.94657171478934,85.00210040023245,0.076723860024159235,1,2154.529859551949,1064.3188182342976,2864.468855837934,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,1.8450041383569205,1.5762444306861205,6,0.6434990941807938,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,61.08471527662082,109.10940751134858,13.038172838579207,38.05509344964584,0.2766325237817256,1,74.12288811520003,147.16450096099442,257.6749833141624,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_53,1.0329224128909087,0.4929886074645111,5,0.22047120768472142,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,3.049653776728685,2.2325538692265394,6,0.9114363004802176,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,61.08471527662082,180.3496858223539,13.038172838579207,53.90029900870277,0.07848493138166723,1,74.12288811520003,234.24998483105668,257.6749833141624,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_53,1.2888921938712228,0.8821815083223428,5,0.39452356422041096,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,61.08471527662082,76.22219413801992,13.038172838579207,23.331238909680494,0.5908052200799955,1,74.12288811520003,99.55343304770041,257.6749833141624,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,2.2645317075002476,0.989357364132796,6,0.4039034525650476,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,78.21432607771254,133.91932720327372,12.735767518661639,23.885944472952207,0.07529894691257977,1,90.95009359637419,157.80527167622594,173.58579884384855,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_53,1.322578488726262,0.5275163139033213,6,0.21535763334282948,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,1.7896378204163843,0.7826397980767009,6,0.3195113596137961,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,78.21432607771254,105.83516762159057,12.735767518661639,18.895185336360825,0.25711136101336657,1,90.95009359637419,124.7303529579514,173.58579884384855,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_53,1.7018062060173191,1.2762240486850833,6,0.5210162861245552,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,78.21432607771254,100.64100289934682,12.735767518661639,30.81173483623707,0.5238043277967379,1,90.95009359637419,131.4527377355839,173.58579884384855,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,1.7333495012821323,1.337144480090177,6,0.5458869481000057,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,59.13775760336051,102.50640264872857,10.719792940622634,32.282530015576384,0.24894175638423038,1,69.85755054398315,134.78893266430495,237.93212831838758,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_53,1,0.4053279443012305,5,0.18126816732755996,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,2.675663366809811,2.4052301511623906,6,0.9819310973841848,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,59.13775760336051,158.23273161459008,10.719792940622634,58.06920322030771,0.15043325066885802,1,69.85755054398315,216.3019348348978,237.93212831838758,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_53,1.6760624413295264,1.1073662453711315,6,0.45208037659015116,fruit_1_log2-1,1,967514 MM WT,fruit,ns,59.13775760336051,99.11857438344218,10.719792940622634,26.735019728024294,0.21066400243559644,1,69.85755054398315,125.85359411146648,237.93212831838758,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,1.909324371636758,0.7897406473828268,6,0.3224102692038635,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,105.27113846800427,112.91316187604322,20.441906158730305,19.06662034901229,0.7909297503224315,1,125.71304462673457,131.97978222505552,214.84409410833425,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_53,1.7801002732308915,0.7729324481183087,5,0.34566589920157353,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,2.9115130801005242,0.9581479071965444,6,0.39116224512451736,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,105.27113846800427,172.18035478999838,20.441906158730305,23.132458035759996,0.058362187563634725,1,125.71304462673457,195.31281282575839,214.84409410833425,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_53,2.080128257738661,1.0918480083609254,6,0.4457450828597215,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,105.27113846800427,123.01412069004955,20.441906158730305,26.360364663048053,0.6079155078556513,1,125.71304462673457,149.3744853530976,214.84409410833425,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,0.9848236230339769,0.4431877472014265,6,0.18093064014951307,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,342.94834754763644,235.17356877783234,34.27814032731295,43.205812035797145,0.08069786985790425,1,377.2264878749494,278.3793808136295,509.8652668819559,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_53,1.436146229785049,0.35161130121404766,6,0.14354471262840937,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,1.2143558274704485,0.3069084869630893,6,0.125294865131532,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,342.94834754763644,289.98532024706543,34.27814032731295,29.920119596382772,0.2719091904781531,1,377.2264878749494,319.9054398434482,509.8652668819559,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_53,1.6238202043929,0.7770069883341791,6,0.3172117746659034,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,342.94834754763644,387.7644520184833,34.27814032731295,75.74942696511289,0.6066660157058316,1,377.2264878749494,463.5138789835962,509.8652668819559,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,1.4978340069383915,0.5226477838133927,6,0.21337006425654426,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,414.5629919813485,357.6792438866479,82.22217425907724,50.95227034357574,0.5720503673489726,1,496.7851662404257,408.6315142302236,546.4636828644683,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_53,1.736042999477419,0.8434018124619944,6,0.34431734811173287,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,1.2329631412100972,0.34593820159214356,6,0.14122867940613584,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,414.5629919813485,294.4287030774253,82.22217425907724,33.72507703196661,0.22069877686743433,1,496.7851662404257,328.15378010939196,546.4636828644683,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_53,1.2452351622293596,0.5034932617747314,6,0.20555026337960838,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,414.5629919813485,297.35923288166106,82.22217425907724,49.084920255348244,0.2551265006291822,1,496.7851662404257,346.4441531370093,546.4636828644683,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,1.3841783437186355,0.508359047859433,6,0.20753671223045064,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,238.79765196261823,330.5385383775161,28.706434147883378,49.559279576673205,0.14778916110423754,1,267.5040861105016,380.0978179541893,496.98118704174107,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_53,1,0.29445899245327795,6,0.12021238028076227,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,1.0319609824730145,0.45581539388760234,6,0.18608585532172603,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,238.79765196261823,246.42985953159248,28.706434147883378,44.436865314283665,0.8886296105641713,1,267.5040861105016,290.86672484587615,496.98118704174107,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_53,1.6019093293446784,0.7105322878292614,6,0.29007359182567344,leaf_1_log2-1,1,967514 MM WT,leaf,ns,238.79765196261823,382.5321865045217,28.706434147883378,69.26889262433374,0.098840088941349,1,267.5040861105016,451.80107912885546,496.98118704174107,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,1.7082112788664607,0.5014641134952743,6,0.20472186706342232,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,536.4000380099042,407.9168424493721,97.29360347310492,48.88710116014852,0.2746700503125397,1,633.6936414830091,456.8039436095206,697.06300563131,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_53,2.246253401578141,0.9979984383727996,6,0.4074311563513004,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,1.882181545875243,0.7376510276111093,6,0.3011447709811472,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,536.4000380099042,449.460533722379,97.29360347310492,71.91266421111837,0.4902235134627012,1,633.6936414830091,521.3731979334974,697.06300563131,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_53,2.0279126997851393,0.5048295961182104,6,0.20609581959082185,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,536.4000380099042,484.2607910938652,97.29360347310492,49.21519779759963,0.6463127962258072,1,633.6936414830091,533.4759888914648,697.06300563131,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,1.2956844295504595,0.29977427655840994,6,0.12238233593001215,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,1020.5238026526524,707.6005138029833,452.4731966016774,66.83556721796155,0.5299683913209581,1,1472.9969992543297,774.4360810209448,1620.2966991797628,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_59,1.8686769939949879,1.8526311422682442,5,0.8285218342689755,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,1.7698088844140685,0.2270188295122278,6,0.09268004905147417,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,1020.5238026526524,966.5298489223751,452.4731966016774,50.614523747006885,0.9111832346007447,1,1472.9969992543297,1017.1443726693819,1620.2966991797628,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_59,1.5404532726470865,1.2132983899858727,5,0.5426035353998923,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,1020.5238026526524,841.2739262389317,452.4731966016774,296.32720104037224,0.750175605307136,1,1472.9969992543297,1137.601127279304,1620.2966991797628,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,2.1001453597496704,0.5939582898729475,6,0.24248245644747043,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,701.7699791897305,1146.9335447176834,82.0890654111628,132.4247686066351,0.020339005323680718,0.48813612776833726,783.8590446008933,1279.3583133243185,1407.2941446567504,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_59,1.2850081612790518,0.3681900404426291,6,0.15031295457652394,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,1.9870782960628692,0.53976509135185,6,0.22035817579646363,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,701.7699791897305,1085.1852435617195,82.0890654111628,120.34223369371236,0.027710138823446667,0.6373331929392734,783.8590446008933,1205.527477255432,1407.2941446567504,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_59,1.6269889938235065,0.7821155352264418,6,0.31929733020142415,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,701.7699791897305,888.532903324881,82.0890654111628,174.3749864963934,0.3643188740155041,1,783.8590446008933,1062.9078898212745,1407.2941446567504,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,0.8769634696199439,0.18375670092421667,6,0.07501835901359082,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,546.121028905539,478.9281923414152,125.15459234255006,40.96910341130734,0.6322106412468526,1,671.275621248089,519.8972957527225,838.1557742460155,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_59,1,0.5124398464110822,5,0.22917006619094626,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,1.2612907062151966,0.3280620770834103,6,0.1339307821353263,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,546.121028905539,688.817378227237,125.15459234255006,73.14241654186799,0.35970611019027376,1,671.275621248089,761.959794769105,838.1557742460155,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_59,0.7267409134821046,0.1095704815594357,6,0.04473196178194186,fruit_1_log2-1,1,967514 MM WT,fruit,ns,546.121028905539,396.8884954185982,125.15459234255006,24.429064993317333,0.3025525030335274,1,671.275621248089,421.31756041191557,838.1557742460155,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,3.5468459856619674,0.44372845886518547,6,0.18115138476187653,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,2072.5352766906994,1937.0071790591944,302.9534872980538,98.93058063381923,0.688839972411679,1,2375.4887639887534,2035.9377596930137,2613.037640387629,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_59,3.795010935294308,1.240429420886189,5,0.5547369012784432,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,4.106097578987328,0.31480334833525303,6,0.12851792879016705,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,2072.5352766906994,2242.4262346231026,302.9534872980538,70.18634350369483,0.6112084656168814,1,2375.4887639887534,2312.6125781267974,2613.037640387629,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_59,3.7688019677171316,0.9382092671519299,6,0.38302232941212916,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,2072.5352766906994,2058.2220083509,302.9534872980538,209.17654863234827,0.9700179040855454,1,2375.4887639887534,2267.3985569832485,2613.037640387629,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,1.5655047735258116,0.6378259986364999,6,0.26039137355675734,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1569.867622955555,1923.584758290293,230.93299840246655,319.9510380514301,0.3931284337398464,1,1800.8006213580215,2243.535796341723,2467.8893759758957,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_59,1.2776329438817753,0.4603675337990237,6,0.1879442586585161,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,0.9553635574009962,0.2605066088382632,6,0.10635137771275924,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1569.867622955555,1173.8851319524576,230.93299840246655,130.67726949863854,0.17440408033302046,1,1800.8006213580215,1304.562401451096,2467.8893759758957,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_59,0.994374082311251,0.37968814824134417,6,0.15500703742891858,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1569.867622955555,1221.818586004639,230.93299840246655,190.4620028429984,0.2728914679782031,1,1800.8006213580215,1412.2805888476373,2467.8893759758957,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,1.1718063479206982,0.3305395958251628,6,0.13494222492623895,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1627.1081887387763,1439.8351692352107,224.5790385343272,165.8077391442805,0.51879456883441,1,1851.6872272731034,1605.6429083794912,2036.855950000414,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_59,1.3242180390208105,0.4477008432238838,6,0.18277310388538054,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,1.0504916724197118,0.2197265063372188,6,0.08970297058176674,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1627.1081887387763,1290.7720269842537,224.5790385343272,110.22085010691542,0.2192074286959033,1,1851.6872272731034,1400.992877091169,2036.855950000414,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_59,1.0900385978470384,0.2935447551695936,6,0.11983914447261981,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1627.1081887387763,1339.3645731557485,224.5790385343272,147.2501110519796,0.313008129826674,1,1851.6872272731034,1486.614684207728,2036.855950000414,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,1.343567831192522,0.5178269654976634,6,0.21140197342051087,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1228.731327313693,1650.8838845571677,127.19410598432803,259.7562273977184,0.18623315532158968,1,1355.925433298021,1910.6401119548862,2199.0646723509462,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_59,1,0.253562883134294,6,0.10351661356466381,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,1.181421539817367,0.4245376642324087,6,0.17331677566040235,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1228.731327313693,1451.6496567367806,127.19410598432803,212.9597518029357,0.3945569232786834,1,1355.925433298021,1664.6094085397162,2199.0646723509462,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_59,1.4167588352147369,0.514991216979269,6,0.21024428393569092,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1228.731327313693,1740.8159640768054,127.19410598432803,258.33373806041845,0.11687802074825185,1,1355.925433298021,1999.1497021372238,2199.0646723509462,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,1.44844048996181,0.33594100762140067,6,0.1371473420581444,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,2644.0763350298016,1779.7442057656706,709.6544667375447,168.5172356446489,0.2841624388672803,1,3353.7308017673463,1948.2614414103195,3689.1038819440814,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_59,2.151875089577474,1.4147041737710155,6,0.5775505604541089,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,1.7766161360793185,0.9694002099123421,6,0.39575597847202365,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,2644.0763350298016,2182.983903011666,709.6544667375447,486.27776872025896,0.6051820899921506,1,3353.7308017673463,2669.2616717319247,3689.1038819440814,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_59,1.6003848716825573,0.1857235536134035,6,0.0758213232615456,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,2644.0763350298016,1966.443027595263,709.6544667375447,93.16403516983951,0.3858648629806102,1,3353.7308017673463,2059.6070627651025,3689.1038819440814,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,4.456440844793704,4.899292519347647,6,2.0001277955060695,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,41.6065427621918,152.6528165932689,6.209985708878686,68.51322662280762,0.166466203923806,1,47.816528471070484,221.16604321607653,243.2826475376842,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_60,1.2146326593508998,0.4053768345146849,5,0.18129003169570368,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,2.121956469251054,1.4499760741004042,6,0.5919502534649936,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,41.6065427621918,72.68639773327375,6.209985708878686,20.276915283212688,0.19379217893266135,1,47.816528471070484,92.96331301648644,243.2826475376842,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_60,2.9855211218858155,2.5556350358027253,5,1.1429147331470004,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,41.6065427621918,102.26730795428368,6.209985708878686,39.14988647154597,0.19732313954789396,1,47.816528471070484,141.41719442582965,243.2826475376842,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,3.5021957679929487,3.292179831027846,6,1.3440267879167276,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,97.50404477377417,119.96570062625808,41.25652894914217,46.03886417385849,0.7240019747862187,1,138.76057372291635,166.00456480011658,182.60502128012826,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_60,2.846465708000576,2.9502012037409258,6,1.2044145979516638,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,1.94511799519654,1.1772088896789552,6,0.4805935167302958,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,97.50404477377417,66.628897569659,41.25652894914217,16.4624543487551,0.5108923178826328,1,138.76057372291635,83.0913519184141,182.60502128012826,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_60,1.1754635755099072,0.37871119958136995,6,0.15460819980861312,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,97.50404477377417,40.26482833582601,41.25652894914217,5.29601491216299,0.22546462040922485,1,138.76057372291635,45.560843247989,182.60502128012826,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,1.3595059127461466,0.5228087966022651,6,0.21343579745234423,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,34.254424530644805,46.56909268712826,6.77112935625499,7.311120415969317,0.24785373580503417,1,41.02555388689979,53.880213103097574,168.5922815117805,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_60,1,0.4420072948966147,5,0.19767167158792526,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,3.159467120477442,3.220751085111559,6,1.314866124506426,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,34.254424530644805,108.2257280354482,6.77112935625499,45.039982429806784,0.1627632741387204,1,41.02555388689979,153.26571046525498,168.5922815117805,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_60,1.3406183044819426,0.4224824944665481,6,0.17247775611687674,fruit_1_log2-1,1,967514 MM WT,fruit,ns,34.254424530644805,45.9221085352777,6.77112935625499,5.9081262801205146,0.22836066228199564,1,41.02555388689979,51.830234815398214,168.5922815117805,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,4.471808494739914,5.173221898485191,6,2.1119589962467993,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,99.21683767097284,153.17922659856472,23.532091797146432,72.34394004875233,0.5046095903210261,1,122.74892946811927,225.52316664731705,248.0754833120488,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_60,2.8964678003044875,1.5361331457812148,5,0.6869796272914781,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,2.007785521264502,0.807274475540622,6,0.3295684245745706,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,99.21683767097284,68.77553761187622,23.532091797146432,11.289176727273134,0.2891342054762506,1,122.74892946811927,80.06471433914935,248.0754833120488,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_60,3.5988116179220593,1.6848336167778004,6,0.6878304437655844,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,99.21683767097284,123.2752209661189,23.532091797146432,23.56123602584813,0.48856917912983855,1,122.74892946811927,146.83645699196703,248.0754833120488,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,2.1557306457123353,3.034455287568715,6,1.238811183638958,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,85.80837164187824,131.23523649366743,20.580275567991507,75.41558078195689,0.5832460420746945,1,106.38864720986975,206.65081727562432,227.31589900318676,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_60,1.4095279693879788,0.8280772403977051,6,0.33806111776439646,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,1.051491601735751,0.8329699457876919,6,0.3400585563756019,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,85.80837164187824,64.01205516995302,20.580275567991507,20.701874399944145,0.47244780856089863,1,106.38864720986975,84.71392956989716,227.31589900318676,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_60,1.0740308806565957,1.23335766932498,6,0.5035161600324176,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,85.80837164187824,65.38418744698727,20.580275567991507,30.652745263730562,0.5939879735728034,1,106.38864720986975,96.036932710717835,227.31589900318676,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,1.1214933751968357,0.8932731211966566,6,0.3646772246458542,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,70.38131587295561,68.27357982444246,4.979076302913864,22.200594455268178,0.9294703046954389,1,75.36039217586948,90.47417427971064,213.1930655699383,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_60,1.1561160216312152,0.20034035749546103,6,0.08178860845844114,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,2.5110280244004364,1.6475646490157234,6,0.6726154513893636,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,70.38131587295561,152.86481049005394,4.979076302913864,40.947067300799056,0.1003465197436255,1,75.36039217586948,193.811877790853,213.1930655699383,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_60,1.6653403026500835,0.625163801552879,6,0.25522205324385255,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,70.38131587295561,101.38155659447042,4.979076302913864,15.537250250848775,0.106032388147202,1,75.36039217586948,116.9188068453192,213.1930655699383,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,0.8162722506282064,0.6168632823087047,6,0.251833380452456,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,60.87738129746832,49.69251704403595,7.393009328649157,15.330956725234572,0.5315092603571216,1,68.27039062611748,65.02347376927052,75.09742968872924,1,24,4.166666666666666,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_60,1,0.2974684543400285,6,0.12144098795124433,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,0.8249949034354198,0.30869532298666674,6,0.12602433788349673,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,60.87738129746832,50.22352930490611,7.393009328649157,7.672031670094612,0.34094915664363945,1,68.27039062611748,57.89556097500072,75.09742968872924,1,24,4.166666666666666,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_60,0.9128512396290539,0.4658968215727327,6,0.19020158093961556,leaf_1_log2-1,1,967514 MM WT,leaf,ns,60.87738129746832,55.571992982764534,7.393009328649157,11.57897416624226,0.7088508877015958,1,68.27039062611748,67.15096714900679,75.09742968872924,1,24,4.166666666666666,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,2.443239134734077,1.9902178297441282,6,0.81250302664374,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,110.20583817619577,148.73800040610297,19.738689491379642,49.46305655833802,0.49436516280634735,1,129.94452766757541,198.201056964441,218.02116266088512,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_60,1.810292030100494,0.7942148038343305,6,0.3242368359264578,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,2.584241691094136,1.2902176369611509,6,0.526729144615715,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,110.20583817619577,157.32186679355206,19.738689491379642,32.06589097726022,0.24489418900945537,1,129.94452766757541,189.38775777081227,218.02116266088512,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_60,2.18931730154018,1.1222477580416341,6,0.4581557286974002,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,110.20583817619577,133.27990414700594,19.738689491379642,27.891320989531074,0.5164587576020041,1,129.94452766757541,161.171225136537,218.02116266088512,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,1.1041673530737146,0.7288833320198891,6,0.297565374244724,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,1296.3503287956537,677.8466191592211,656.5514143191607,182.67492001927423,0.40893626168226416,1,1952.9017431148145,860.5215391784952,2148.191917426296,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_64,2.111669027689455,2.3914274571641885,5,1.0694788714957184,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,1.586839637664967,0.5729540636063918,6,0.2339075169816329,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,1296.3503287956537,974.1583832783647,656.5514143191607,143.59546054369065,0.6545988483956193,1,1952.9017431148145,1117.7538438220554,2148.191917426296,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_64,1.250004123034242,0.7191623691652976,5,0.3216191888626808,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,1296.3503287956537,767.3755852092115,656.5514143191607,197.4415193678932,0.47722317457983454,1,1952.9017431148145,964.8171045771047,2148.191917426296,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,2.0079521844431447,1.0578887290940067,6,0.43188126515361697,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,844.7979261896141,1232.67872018608,74.42524749838012,265.1312363543883,0.2103999006039518,1,919.2231736879943,1497.8099565404682,1647.5909521945152,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_64,1.3761200007163306,0.29696097514262243,6,0.12123381043645734,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,1.7009067258945878,0.8021065978406039,6,0.32745864733821184,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,844.7979261896141,1044.183991170634,74.42524749838012,201.02635383554937,0.38631723439847926,1,919.2231736879943,1245.2103450061834,1647.5909521945152,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_64,1.3696265209303422,0.46265024148392475,6,0.1888761701685057,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,844.7979261896141,840.8115890576039,74.42524749838012,115.95078683685372,0.9775847035667466,1,919.2231736879943,956.7623758944576,1647.5909521945152,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,1.1422335348876682,0.3827530379770054,6,0.1562582734239625,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,613.8984432679271,701.215388915961,203.0080676763367,95.92671080270468,0.7113370351098003,1,816.9065109442638,797.1420997186656,1228.6940627656024,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_64,1,0.73943800360323,5,0.3306867282407113,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,1.4970671274234786,0.789821490578734,6,0.32244327330038824,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,613.8984432679271,919.047178992861,203.0080676763367,197.9474235213231,0.31034705746680863,1,816.9065109442638,1116.994602514184,1228.6940627656024,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_64,0.8048502221073508,0.3631462144180646,6,0.14825382122459832,fruit_1_log2-1,1,967514 MM WT,fruit,ns,613.8984432679271,494.096298415548,203.0080676763367,91.01279005830249,0.6109905959107714,1,816.9065109442638,585.1090884738505,1228.6940627656024,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,2.8115352013669854,0.43885136163348715,6,0.17916031815460967,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,1784.5499331911153,1725.9970833121702,186.45855594491564,109.98624041050141,0.795023672061084,1,1971.008489136031,1835.9833237226717,2508.901889568768,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_64,2.9069139248692872,0.6791579464835265,5,0.3037286671592659,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,3.487327873656023,0.5584274084968354,6,0.22797703486699836,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,1784.5499331911153,2140.865152802283,186.45855594491564,139.95474680568822,0.16592623699951387,1,1971.008489136031,2280.819899607971,2508.901889568768,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_64,3.3199153583266137,0.8289044816243197,6,0.3383988375809631,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,1784.5499331911153,2038.0908702579904,186.45855594491564,207.74251959462933,0.38741197217375034,1,1971.008489136031,2245.83338985262,2508.901889568768,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,1.250875534888207,0.3811443598795124,6,0.15560153334075433,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,7136.435739764695,7962.779054877851,886.9563181954921,990.5227147186706,0.5483413754829098,1,8023.392057960187,8953.30176959652,9848.631946556174,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_64,1.1210649964857549,0.34129292858844296,6,0.13933225464363713,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.9863812152005665,0.18769314311402738,6,0.07662540480809087,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,7136.435739764695,6279.0705081828855,886.9563181954921,487.77928055962235,0.4223106272703838,1,8023.392057960187,6766.849788742508,9848.631946556174,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_64,0.8915048066166756,0.3423057368888046,6,0.1397457319008274,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,7136.435739764695,5675.1096359755975,886.9563181954921,889.5884170345802,0.2717210754570821,1,8023.392057960187,6564.698053010177,9848.631946556174,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.9131537505519893,0.1641217844509775,6,0.06700243792999018,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,5390.205684907195,5812.92171441212,140.10620081760564,426.5217397687462,0.38237382794254604,1,5530.311885724801,6239.443454180867,6863.387799598954,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_64,0.8467491528771511,0.05391162406703982,6,0.022009328361499464,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.7988889100724321,0.1101472304664425,6,0.04496741853725428,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,5390.205684907195,5085.538651027726,140.10620081760564,286.2519958969182,0.36980825509814186,1,5530.311885724801,5371.790646924644,6863.387799598954,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_64,0.7603600734045185,0.14448008879108254,6,0.05898374925502659,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,5390.205684907195,4840.273150927038,140.10620081760564,375.47665618711477,0.21638956203152782,1,5530.311885724801,5215.749807114153,6863.387799598954,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,1.2406689971073765,0.22580750629388294,6,0.0921855284183857,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,6365.76448478505,7897.806639160023,747.4761443222375,586.8313628169027,0.13972308094527822,1,7113.2406291072875,8484.638001976926,9333.101802174619,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_64,1,0.28762219414001194,6,0.1174212690571252,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,1.2369748447939233,0.16438613487842302,6,0.06711035854007821,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,6365.76448478505,7874.290535561655,747.4761443222375,427.2087369556209,0.11807158357120541,1,7113.2406291072875,8301.499272517276,9333.101802174619,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_64,1.0133430193429673,0.3838675333914086,6,0.15671326427162244,leaf_1_log2-1,1,967514 MM WT,leaf,ns,6365.76448478505,6450.7030034383115,747.4761443222375,997.599731995028,0.9471231124294852,1,7113.2406291072875,7448.30273543334,9333.101802174619,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.8261999912339312,0.08785149670991393,6,0.035865223346514055,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,6529.2174902471115,5259.394561526678,1210.1742985955702,228.30956501812275,0.3467911658241281,1,7739.391788842682,5487.7041265448015,8513.330967726952,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_64,1.0256768854475742,0.4656643421971919,6,0.19010667163198292,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.8571778078220113,0.17175656724543217,6,0.07011932495388921,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,6529.2174902471115,5456.592046179264,1210.1742985955702,446.3631084885701,0.4358623453586524,1,7739.391788842682,5902.955154667834,8513.330967726952,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_64,0.8076864949405624,0.11393210220749667,6,0.04651258595516463,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,6529.2174902471115,5141.542004333152,1210.1742985955702,296.08816776889887,0.310891971429743,1,7739.391788842682,5437.630172102051,8513.330967726952,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.9816317141618669,0.5174975754579555,6,0.2112675004999043,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,944.7832053219098,687.9135501293243,368.36216405552665,148.05326091152864,0.5446627154203136,1,1313.1453693774365,835.9668110408529,1585.6303725698697,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_66,1.3481768998112296,1.1753703603967347,5,0.5256416049171051,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,1.7539477878127006,0.7422037436248732,6,0.3030034095107338,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,944.7832053219098,1229.1416750791248,368.36216405552665,212.34048180257497,0.5265746075901644,1,1313.1453693774365,1441.4821568816997,1585.6303725698697,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_66,1.184023891374694,0.611063403546085,5,0.2732758617782864,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,944.7832053219098,829.7471106553866,368.36216405552665,191.50783896693946,0.7909930873036367,1,1313.1453693774365,1021.254949622326,1585.6303725698697,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,1.5210372326780437,0.7982267955603884,6,0.3258747246899761,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,695.4609106403511,1065.9212691633747,67.67769875357844,228.36837433507407,0.17193608236052269,1,763.1386093939295,1294.2896434984489,1425.9117988477735,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_66,0.9924015680693004,0.2365570660309823,6,0.0965740178042957,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,1.6202918154095935,0.5620727717640798,6,0.22946524818897066,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,695.4609106403511,1135.4774697103003,67.67769875357844,160.8059837876755,0.041057554533909635,0.9443237542799217,763.1386093939295,1296.2834534979759,1425.9117988477735,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_66,1.3609770926420646,0.3379758376058616,6,0.13797805792068518,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,695.4609106403511,953.7533984865814,67.67769875357844,96.69306145554775,0.05655247488274934,1,763.1386093939295,1050.4464599421292,1425.9117988477735,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,1.1645238739640147,0.5168231638151197,6,0.21099217309964768,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,700.7857837159185,816.0817756717695,218.5592760870946,147.8603153835613,0.6748298114894458,1,919.3450598030131,963.9420910553308,1862.8224264526873,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_66,1,0.6973791560845937,5,0.3118774398193175,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,1.9777068010857244,1.0749106223337501,6,0.43883042396920063,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,700.7857837159185,1385.9488105591615,218.5592760870946,307.526122579645,0.104338735821589,1,919.3450598030131,1693.4749331388066,1862.8224264526873,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_66,0.8501914591840051,0.4164988996033878,6,0.1700349637431632,fruit_1_log2-1,1,967514 MM WT,fruit,ns,700.7857837159185,595.8020880328432,218.5592760870946,119.15808532586041,0.6872585158149878,1,919.3450598030131,714.9601733587036,1862.8224264526873,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,1.6135162218447292,0.3667279364928021,6,0.1497160531385266,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,1412.2647002970136,1130.7292300638062,156.74035156108582,104.91888163353643,0.1778404772726162,1,1569.0050518580995,1235.6481116973425,2461.741784025205,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_66,2.015258775382794,0.5001272700615742,5,0.22366371465181506,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,2.6477622053389394,1.0155586796938485,6,0.4146000948507515,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,1412.2647002970136,1855.5141121618371,156.74035156108582,290.54585239867805,0.2184174239229737,1,1569.0050518580995,2146.0599645605153,2461.741784025205,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_66,2.6310662203104385,1.3776326979971807,6,0.5624161938444684,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,1412.2647002970136,1843.81380320873,156.74035156108582,394.13327317781966,0.3452971152869597,1,1569.0050518580995,2237.9470763865497,2461.741784025205,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,1.5182457942001901,0.561495603717905,6,0.2292296203208094,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,6043.594493860634,7118.386703888918,821.141448222232,1074.7568593060098,0.446513025627303,1,6864.735942082866,8193.143563194928,9012.457919514422,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_66,1.2890086340971731,0.4289968556284038,6,0.1751372329246685,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,1.1936356139512625,0.30651477408466576,6,0.125134132521982,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,6043.594493860634,5596.4323537711725,821.141448222232,586.6989051113414,0.6681070604457159,1,6864.735942082866,6183.131258882514,9012.457919514422,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_66,1.0102464493187304,0.4751412917814101,6,0.19397562009855224,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,6043.594493860634,4736.601227517196,821.141448222232,909.4663593094572,0.311454055150044,1,6864.735942082866,5646.0675868266535,9012.457919514422,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.9610714685357564,0.2964059335726645,6,0.12100721566438563,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,4151.407218192035,4506.041373041249,220.7166844567231,567.3496072576004,0.5798967941754916,1,4372.123902648757,5073.390980298849,5688.470994934868,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_66,0.8854332886395438,0.11531114867195812,6,0.047075579316751257,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.9854964350196961,0.287748253606651,6,0.11747273261887739,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,4151.407218192035,4620.559297165518,220.7166844567231,550.7779709570889,0.4567380402466904,1,4372.123902648757,5171.3372681226065,5688.470994934868,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_66,0.7899143579981635,0.12376109976994586,6,0.050525257407007994,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,4151.407218192035,3703.560967970422,220.7166844567231,236.89070762489965,0.1968546249441875,1,4372.123902648757,3940.451675595322,5688.470994934868,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,1.4243244502264654,0.3982680315540421,6,0.16259224302834557,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,4688.560133729121,6678.030834827453,546.0154586116898,762.3235087162976,0.06266329436502646,1,5234.5755923408105,7440.3543435437505,8184.389777898126,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_66,1,0.28526012829585223,6,0.11645695971428392,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,1.359277251842095,0.22208165489493573,6,0.09066445595424312,leaf_1_transp1-1,1,967514 MM WT,leaf,*,4688.560133729121,6373.053133671725,546.0154586116898,425.0857537333041,0.036550947021919876,0.877222728526077,5234.5755923408105,6798.138887405029,8184.389777898126,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_66,0.9436285411130468,0.346991714678486,6,0.14165877432261645,leaf_1_log2-1,1,967514 MM WT,leaf,ns,4688.560133729121,4424.259158911602,546.0154586116898,664.1756818819499,0.7650796019200219,1,5234.5755923408105,5088.434840793552,8184.389777898126,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.9063893658005955,0.07039560109913164,6,0.028738883804896528,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,5220.552698897576,4249.661046128693,843.3552458213373,134.74398489551137,0.3047846188966473,1,6063.907944718913,4384.405031024204,6670.2987391908055,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_66,1.1134660855347347,0.44060222440160796,6,0.1798751048865318,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.9388986541089157,0.20915457909389656,6,0.08538699935777211,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,5220.552698897576,4402.082799266989,843.3552458213373,400.34208112760433,0.40914524468620905,1,6063.907944718913,4802.424880394594,6670.2987391908055,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_66,0.8238567746277394,0.1984563602777174,6,0.08101946981505863,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,5220.552698897576,3862.7020294222766,843.3552458213373,379.86465623075384,0.1858545209809379,1,6063.907944718913,4242.566685653031,6670.2987391908055,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,1.1994583416302085,0.3361946023673465,6,0.13725087167964742,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,499.27300846807753,461.3733059232892,122.38052433788152,52.79373714774228,0.7865809272087301,1,621.653532805959,514.1670430710315,720.8360215446048,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_67,1.2979883471138987,0.7114264657023526,5,0.3181595876605766,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,1.5441411487837327,0.39067804942553824,6,0.15949364579973258,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,499.27300846807753,593.9560232315065,122.38052433788152,61.349450899952345,0.5151813370810794,1,621.653532805959,655.3054741314588,720.8360215446048,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_67,1.2279390514893125,0.6637200487504616,5,0.2968246294071013,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,499.27300846807753,472.32845026359007,122.38052433788152,114.17400321121788,0.8761127575906751,1,621.653532805959,586.5024534748079,720.8360215446048,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,1.3783880308608965,0.48719234415995866,6,0.19889544163038514,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,469.8270779661186,530.1988577436127,48.487243039112734,76.50540602632654,0.5228345836196573,1,518.3143210052314,606.7042637699393,817.9382844443413,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_67,1.2214360921086853,0.3087705147261111,6,0.12605503478258193,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,1.7245444269048802,0.5109227265911729,6,0.20858332968998203,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,469.8270779661186,663.3483930515607,48.487243039112734,80.23186553420413,0.07192362943396545,1,518.3143210052314,743.5802585857648,817.9382844443413,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_67,1.6185789019155332,0.7202188503323382,6,0.29402811440802595,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,469.8270779661186,622.5886076706154,48.487243039112734,113.09831985865235,0.25568825876651385,1,518.3143210052314,735.6869275292677,817.9382844443413,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.9961510454550845,0.22591574962166683,6,0.09222971857190759,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,384.65137963543384,383.170873959578,109.09527297023884,35.47628849207205,0.9902173852583918,1,493.7466526056727,418.64716245165005,609.276085945123,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_67,1,0.6341962080483265,5,0.2836211664537315,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,1.2591367613254068,0.44295491828200284,6,0.18083558814118783,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,384.65137963543384,484.3286923935097,109.09527297023884,69.558658465693,0.4663007393440948,1,493.7466526056727,553.8873508592027,609.276085945123,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_67,0.819369624455111,0.13164389055594794,6,0.053743393269477635,fruit_1_log2-1,1,967514 MM WT,fruit,ns,384.65137963543384,315.17165647802574,109.09527297023884,20.672470367394265,0.5632597415280394,1,493.7466526056727,335.84412684542,609.276085945123,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,2.1432553346438485,0.8233587357899245,6,0.33613479632472415,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,915.5565266024303,824.4061213817597,145.25653011500953,129.29471314978068,0.6509814884675573,1,1060.8130567174398,953.7008345315404,1288.3652018030664,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_67,2.3802242109990077,0.8444100104898882,5,0.3776316368673401,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,2.8236755912804505,0.5419894886999496,6,0.22126628221113764,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,915.5565266024303,1086.1307118289246,145.25653011500953,85.11038071931733,0.34668584546383835,1,1060.8130567174398,1171.241092548242,1288.3652018030664,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_67,2.338592864613491,0.6822570414060316,6,0.27853027081094545,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,915.5565266024303,899.5429717791606,145.25653011500953,107.13705293766117,0.9315645615712619,1,1060.8130567174398,1006.6800247168217,1288.3652018030664,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.7858863327110963,0.3377113485162294,6,0.13787008070199652,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,400.8655003794621,607.1388766762487,97.11198493555541,106.51195018993366,0.18315624145731849,1,497.97748531501753,713.6508268661823,1074.795835541937,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_67,0.5188841138427106,0.3079074163151852,6,0.12570267633181934,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,1.0239690444853151,0.5897925857011699,6,0.24078181484076405,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,400.8655003794621,791.0703998062899,97.11198493555541,186.0167234136529,0.10227529550965477,1,497.97748531501753,977.0871232199428,1074.795835541937,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_67,1.0726435831149346,0.4362043628420583,6,0.17807968542314895,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,400.8655003794621,828.6740626723621,97.11198493555541,137.5760026182013,0.031708839121728054,0.6975944606780172,497.97748531501753,966.2500652905634,1074.795835541937,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,2.478700757991986,0.9994915906775982,6,0.40804073322713663,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,737.8354071599811,1914.9278097664157,287.8014055469501,315.23310954530695,0.020357348159720366,0.46821900767356844,1025.636812706931,2230.160919311723,3098.0304572548835,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_67,0.955061164015294,0.9125154557663188,6,0.3725328748384525,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,1.3760603767294055,0.7762861756422038,6,0.3169175041166598,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,737.8354071599811,1063.0796294472707,287.8014055469501,244.83558173693694,0.41003591084370294,1,1025.636812706931,1307.9152111842077,3098.0304572548835,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_67,3.323192011489268,0.7896461445271276,6,0.3223716885745804,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,737.8354071599811,2567.342096247896,287.8014055469501,249.04922852927058,7.586704975168109e-4,0.01820809194040346,1025.636812706931,2816.3913247771666,3098.0304572548835,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.840629876685014,1.24786443602542,6,0.5094385227380304,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,772.5530415852671,649.4311680804556,402.7400480909105,393.5682802419706,0.8313263623920587,1,1175.2930896761777,1042.9994483224261,1292.8223986437956,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_67,0.9999999999999999,1.2769448357647912,6,0.5213105462176344,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.4866021634927294,0.2968848409807446,6,0.1212027287950248,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,772.5530415852671,375.9259814482795,402.7400480909105,93.63553677903066,0.37741608439321767,1,1175.2930896761777,469.56151822731016,1292.8223986437956,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_67,0.8864423230718435,0.9102276911507421,6,0.37159889884515956,leaf_1_log2-1,1,967514 MM WT,leaf,ns,772.5530415852671,684.8237128790627,402.7400480909105,287.0798595525641,0.8631216549559946,1,1175.2930896761777,971.9035724316268,1292.8223986437956,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.5104858289283504,0.3046232580569324,6,0.12436192433727486,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,361.4769054097859,394.3773798247734,108.26056998429472,96.07618290415857,0.8248335050167004,1,469.7374753940806,490.45356272893196,949.0059177179602,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_67,0.46789914213274053,0.34325559728590094,6,0.14013351078412128,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.7414359958132652,0.9192772105204967,6,0.37529334965738154,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,361.4769054097859,572.7986337063395,108.26056998429472,289.9340187645333,0.5187831953310285,1,469.7374753940806,862.7326524708728,949.0059177179602,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_67,0.6305226873823098,0.5049387047399531,6,0.20614036299912314,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,361.4769054097859,487.1122199257199,108.26056998429472,159.25436442846362,0.5307851187123054,1,469.7374753940806,646.3665843541835,949.0059177179602,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,1.3112738861060718,0.37568445177213916,6,0.1533725351898294,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,236.99732148815616,207.46551682942209,74.5193152199253,24.26610688868911,0.7222288318196682,1,311.5166367080815,231.7316237181112,342.6683003788896,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_74,1.4979279616863654,1.0531769551823216,5,0.47099505282478404,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,1.4842224069548209,0.2895939864777978,6,0.11822624990817604,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,236.99732148815616,234.82887290854052,74.5193152199253,18.70537520795259,0.9786905679572608,1,311.5166367080815,253.5342481164931,342.6683003788896,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_74,1.1672194010628276,0.5825022001170598,5,0.2605029033009863,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,236.99732148815616,184.67368172330043,74.5193152199253,41.21592753547159,0.5606601774845184,1,311.5166367080815,225.88960925877203,342.6683003788896,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,1.5248742969722635,0.5209201390865498,6,0.21266475625028172,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,171.27157496819638,241.26068357900732,13.558072267957394,33.64713049985863,0.09765384789844174,1,184.82964723615376,274.90781407886595,302.3985954867526,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_74,1.0825121548884047,0.20990416676392457,6,0.08569301724261383,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,1.444837847100147,0.2566571970772548,6,0.10477986194203606,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,171.27157496819638,228.59757512100242,13.558072267957394,16.577931156452202,0.02396514859809818,0.5751635663543564,184.82964723615376,245.17550627745462,302.3985954867526,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_74,1.1061626492932755,0.1985318469254074,6,0.08105028710993092,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,171.27157496819638,175.01347976548368,13.558072267957394,12.82351450951922,0.8451123088856258,1,184.82964723615376,187.8369942750029,302.3985954867526,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,1.0536916709389956,0.06982289855938531,6,0.028505078972100778,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,158.21676846284709,166.7116911321855,28.180775691084932,4.509981479744039,0.7800954104306673,1,186.39754415393202,171.22167261192953,228.72830920543322,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_74,1,0.3982771909460196,5,0.1781149745685927,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,1.2007967442042489,0.2778784129525299,6,0.11344338704468171,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,158.21676846284709,189.98618044870426,28.180775691084932,17.948646101689555,0.37341235193975447,1,186.39754415393202,207.9348265503938,228.72830920543322,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_74,0.7307597069358936,0.1457600544771766,6,0.0595062930582269,fruit_1_log2-1,1,967514 MM WT,fruit,ns,158.21676846284709,115.61843935425428,28.180775691084932,9.414893390875807,0.21232177847164294,1,186.39754415393202,125.03333274513008,228.72830920543322,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,1.6857366350059872,0.11919681893319432,6,0.048661897558207205,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,248.74137171022352,266.71180287008127,13.098576473801355,7.699128178929652,0.27769600523561383,1,261.8399481840249,274.4109310490109,308.35332470121324,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_74,1.5721555567520877,0.18512138560570535,5,0.08278880046066164,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,1.6049901435889298,0.40848653971228105,6,0.16676393151503766,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,248.74137171022352,253.93635393336137,13.098576473801355,26.384850340468798,0.8648591435385331,1,261.8399481840249,280.3212042738302,308.35332470121324,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_74,1.503957294346039,0.4422755025655931,6,0.18055821783644926,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,248.74137171022352,237.9512630175572,13.098576473801355,28.567337745493795,0.7415106841837276,1,261.8399481840249,266.518600763051,308.35332470121324,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.8480744360121892,0.1759168075612266,6,0.07181773595073114,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1132.137598379313,906.1206371614178,113.41010955420668,76.73327941019512,0.13404381563283527,1,1245.5477079335196,982.8539165716129,1370.1024787268716,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_74,1.0596127224753737,0.26000119597774235,6,0.10614504377647314,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.8716819550326806,0.1234151147562263,6,0.050384009616630865,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1132.137598379313,931.3439657612444,113.41010955420668,53.83252808708927,0.1528864233174313,1,1245.5477079335196,985.1764938483336,1370.1024787268716,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_74,0.9080760324584349,0.6131641045675557,6,0.25032319746350995,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1132.137598379313,970.2290249324566,113.41010955420668,267.4564938526916,0.595312264430085,1,1245.5477079335196,1237.6855187851481,1370.1024787268716,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.9888392257148738,0.07299120881746116,6,0.029798536218619363,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1020.7131815647399,1056.520030798436,73.38850452345004,31.838088118605754,0.6683157329747087,1,1094.10168608819,1088.3581189170418,1203.511854697009,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_74,0.9553261677137118,0.16824865986038717,6,0.06868722776083903,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.8806351926881844,0.1963289695453034,6,0.08015096618540195,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1020.7131815647399,940.9100050905397,73.38850452345004,85.63687509615703,0.4957281139963142,1,1094.10168608819,1026.5468801866966,1203.511854697009,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_74,0.7872330390599537,0.10324984470480086,6,0.04215157259139429,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1020.7131815647399,841.114968989906,73.38850452345004,45.03662437163828,0.06923377329593751,1,1094.10168608819,886.1515933615442,1203.511854697009,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.850600231715225,0.1000820589168821,6,0.04085832945892074,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1068.4447009417866,908.8193101959879,93.15541902815689,43.65486559971756,0.16412390699112978,1,1161.6001199699435,952.4741757957055,1277.760131966938,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_74,1,0.21356579633274964,6,0.08718787125439859,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.920817495599025,0.202703111509779,6,0.08275319874557308,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1068.4447009417866,983.8425737072652,93.15541902815689,88.41721668569006,0.5249939494666687,1,1161.6001199699435,1072.2597903929552,1277.760131966938,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_74,0.8674101815571101,0.1402038978781815,6,0.05723800162513763,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1068.4447009417866,926.7798120276473,93.15541902815689,61.15563952887566,0.23680820290450422,1,1161.6001199699435,987.9354515565229,1277.760131966938,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.9781946617508659,0.08161174515405203,6,0.0333178554409142,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1248.8175020786064,1045.146902837256,184.0652702151626,35.598286092589255,0.32362324334097325,1,1432.882772293769,1080.7451889298452,1576.171049523146,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_74,1.168818096975753,0.42198345969354933,6,0.17227402602391798,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,1.0797273049174092,0.33164050018815144,6,0.13539166725039328,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1248.8175020786064,1153.6289174011624,184.0652702151626,144.65850942535636,0.693335157898441,1,1432.882772293769,1298.2874268265189,1576.171049523146,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_74,0.8431343401269682,0.17664465732252901,6,0.07211487937149738,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1248.8175020786064,900.842417890709,184.0652702151626,77.05076072353252,0.12661532551256385,1,1432.882772293769,977.8931786142416,1576.171049523146,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,1.4623622888844754,0.547213456346758,6,0.22339895807238572,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,449.7440386741406,382.1854085189345,185.5959818386941,58.384863109899264,0.7431394712467418,1,635.3400205128347,440.5702716288337,698.8740225641183,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_81,1.7208629820703387,1.5879413160782556,5,0.7101489454062918,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,1.9213855431322815,0.3275654224149106,6,0.13372802371596043,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,449.7440386741406,502.1502019752894,185.5959818386941,34.949546882326395,0.7942842209359293,1,635.3400205128347,537.0997488576159,698.8740225641183,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_81,1.5484062571605999,1.2619988768527919,5,0.5643830552342457,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,449.7440386741406,404.6728245417356,185.5959818386941,147.50036305326557,0.8541885901443255,1,635.3400205128347,552.1731875950012,698.8740225641183,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,2.501418090008125,0.9774170257520995,6,0.39902882983356824,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,414.496548283176,653.7405278247923,52.97166550570133,104.2853727150661,0.07779923349692963,1,467.46821378887734,758.0259005398584,833.8284905938443,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_81,1.5859949322269058,0.49647813878156377,6,0.20268635141025396,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,2.2051766868613663,0.7818725807876611,6,0.3191981444671313,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,414.496548283176,576.3184399178122,52.97166550570133,83.42178553764232,0.13805698277576126,1,467.46821378887734,659.7402254554545,833.8284905938443,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_81,1.8137801960858193,0.9102540531395259,6,0.3716096610820138,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,414.496548283176,474.0277634849307,52.97166550570133,97.11942875561387,0.6056249003717857,1,467.46821378887734,571.1471922405445,833.8284905938443,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.9773944020048587,0.22063326333487213,6,0.09007315257592487,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,261.347965154705,255.44003811756954,68.4359137390703,23.540435140787235,0.9381378768433248,1,329.7838788937753,278.98047325835677,459.4204613389905,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_81,1,0.5855310759059802,5,0.26185745773287217,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,1.3899973803670582,0.509696323975764,6,0.20808265291882097,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,261.347965154705,363.2729869293011,68.4359137390703,54.38197792432658,0.2768980018127065,1,329.7838788937753,417.6549648536277,459.4204613389905,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_81,0.7426063971239623,0.23754827805428017,6,0.09697867841829427,fruit_1_log2-1,1,967514 MM WT,fruit,ns,261.347965154705,194.0786707992143,68.4359137390703,25.345180268013713,0.3981897275218951,1,329.7838788937753,219.42385106722801,459.4204613389905,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,5.093947409368397,1.1068590186371225,6,0.45187330214311444,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,1458.9173011281637,1331.2927900435116,150.94363437177657,118.09616802284017,0.5242015878169417,1,1609.8609354999403,1449.3889580663517,3364.1931712004343,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_81,5.582279166644964,1.2914591740799324,5,0.5775581006816927,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,5.525502162003099,0.7681483523140915,6,0.313595251654861,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,1458.9173011281637,1444.078746497433,150.94363437177657,81.95748090217556,0.9338480128346245,1,1609.8609354999403,1526.0362273996086,3364.1931712004343,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_81,9.547639542061571,5.277679375230989,6,2.15460358255444,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,1458.9173011281637,2495.2561663483907,150.94363437177657,563.1012620156404,0.12831158720386773,1,1609.8609354999403,3058.357428364031,3364.1931712004343,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.874822530742078,0.10896254083151022,6,0.04448377101906292,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,8979.148599273423,6596.929963179095,334.47362095667904,335.44668958391634,5.149694726975727e-4,0.011329328399346599,9313.622220230103,6932.3766527630105,10244.984442253115,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_81,1.1907298615218462,0.10864646071112286,6,0.044354731850265165,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.7922375987424048,0.06328281790861472,6,0.025835102226927895,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,8979.148599273423,5974.167067539434,334.47362095667904,194.81935363283847,5.26275578595493e-5,0.0012630613886291833,9313.622220230103,6168.9864211722725,10244.984442253115,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_81,0.9265250770217515,0.16610766342024666,6,0.06781316962426245,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,8979.148599273423,6986.812556207087,334.47362095667904,511.3708379378002,0.01041792191167865,0.19794051632189433,9313.622220230103,7498.183394144888,10244.984442253115,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.7973134584140362,0.06212898621726139,6,0.025364052411449872,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,8521.753117668031,6012.44350599407,374.6557179559137,191.26722444928737,4.449743437513621e-4,0.01023440990628133,8896.408835623944,6203.7107304433575,9786.04971918634,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_81,1.130074393751018,0.12169873852732567,6,0.04968330195538937,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.8672878791190364,0.09155874124077397,6,0.03737869958856917,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,8521.753117668031,6540.112074627463,374.6557179559137,281.8682128492208,0.00206728977333205,0.043413085239973045,8896.408835623944,6821.980287476684,9786.04971918634,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_81,0.878432453879145,0.13237458135029964,6,0.0540416965371294,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,8521.753117668031,6624.151953092283,374.6557179559137,407.5218397089155,0.006526449190836885,0.1305289838167377,8896.408835623944,7031.673792801199,9786.04971918634,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.830205136507962,0.14375906485209056,6,0.05868939246454959,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,7540.877985370558,6260.475637234449,405.7580027358975,442.5695476106947,0.058974869165736306,1,7946.635988106455,6703.045184845144,8741.2995869171,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_81,1,0.13180163737988518,6,0.053807793140676116,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.8574076511537104,0.12494817929650323,6,0.05100988059436969,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,7540.877985370558,6465.606481073294,405.7580027358975,384.65928561046314,0.08345135061934325,1,7946.635988106455,6850.265766683758,8741.2995869171,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_81,0.9455516315622639,0.06712000407500825,6,0.02740162691954964,leaf_1_log2-1,1,967514 MM WT,leaf,ns,7540.877985370558,7130.289482479089,405.7580027358975,206.63232520096915,0.39549792756210056,1,7946.635988106455,7336.921807680058,8741.2995869171,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.9985539163254544,0.10556553002489434,6,0.04309694716457472,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,9445.259149577016,7529.973244824174,1060.6298320810727,324.9888201100197,0.135572514566622,1,10505.888981658089,7854.962064934193,11556.477879823899,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_81,1.25254103937247,0.34452246802197345,6,0.14065070859636158,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.9955923272300018,0.2715045218120072,6,0.11084125688296055,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,9445.259149577016,7507.640262812561,1060.6298320810727,835.84039389952,0.1834790655407608,1,10505.888981658089,8343.480656712081,11556.477879823899,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_81,0.9801215721050444,0.12973735357176178,6,0.0529650528049775,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,9445.259149577016,7390.977186073711,1060.6298320810727,399.4030006910441,0.11683351722555195,1,10505.888981658089,7790.380186764755,11556.477879823899,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,1.0115344203718497,0.8836295805961699,6,0.36074026568168666,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,1734.5601178275288,439.57751104705005,1105.720455485062,156.76511340515168,0.3084049259384964,1,2840.2805733125906,596.3426244522018,3124.30863064385,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_84,3.9914855043596558,5.689518920114193,5,2.5444302129293064,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,1.3120996128674498,0.7062950381469547,6,0.2883437418866032,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,1734.5601178275288,570.1926404620473,1105.720455485062,125.30411405863161,0.3530855130154059,1,2840.2805733125906,695.4967545206789,3124.30863064385,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_84,0.9894379789733561,0.8167188965148373,5,0.36524779422315845,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,1734.5601178275288,429.9751697748902,1105.720455485062,158.72392779379635,0.3053342705622358,1,2840.2805733125906,588.6990975686865,3124.30863064385,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,4.3180666367526905,3.4396880631221163,6,1.4042467714985603,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,562.292579486503,1876.4808655955426,81.27331064762268,610.2365755228343,0.08399996225807774,1,643.5658901341257,2486.717441118377,2735.389185230215,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_84,1.29392037621641,0.4581089493784083,6,0.18702219542993156,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,2.897226400149874,2.0410073863189964,6,0.8332377762888475,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,562.292579486503,1259.0333499966468,81.27331064762268,362.09602010061604,0.11394413399784754,1,643.5658901341257,1621.1293700972628,2735.389185230215,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_84,1.1773677611325821,0.5010877074213427,6,0.20456819992721953,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,562.292579486503,511.6428858994674,81.27331064762268,88.89819105742909,0.6830809837896771,1,643.5658901341257,600.5410769568965,2735.389185230215,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,1.1465016680622329,0.6102475173678514,6,0.24913250572524193,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,434.5650550234931,498.22956046599074,138.2699598944567,108.26428105863044,0.7263456032795517,1,572.8350149179498,606.4938415246212,1025.1922050753813,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_84,1,0.7114723698928349,5,0.3181801166386507,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,1.686275966170958,1.1227992263196869,6,0.4583808646791602,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,434.5650550234931,732.7966080238764,138.2699598944567,199.1963056810156,0.25164772699694893,1,572.8350149179498,931.992913704892,1025.1922050753813,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_84,0.6840389069057325,0.33287464771613,6,0.13589550586887073,fruit_1_log2-1,1,967514 MM WT,fruit,ns,434.5650550234931,297.25940521769974,138.2699598944567,59.055437985351226,0.3997397153159756,1,572.8350149179498,356.31484320305094,1025.1922050753813,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,23.130675000611802,6.181372247812587,6,2.523534652890255,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,9807.420358442967,10051.783054371404,4843.7217295217515,1096.6399752869452,0.9629052123517567,1,14651.14208796472,11148.42302965835,20724.654485774183,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_84,22.56835943219771,24.923520485829116,5,11.146137208984497,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,28.98119188972064,22.484137339174303,6,9.17911063127262,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,9807.420358442967,12594.213248202863,4843.7217295217515,3988.9207165457165,0.6683919324731774,1,14651.14208796472,16583.13396474858,20724.654485774183,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_84,28.477449538148868,36.44255959301391,6,14.877612653975381,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,9807.420358442967,12375.304425474409,4843.7217295217515,6465.290561593028,0.7580444899107313,1,14651.14208796472,18840.594987067438,20724.654485774183,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,3.2290634423352147,0.8255806965469797,6,0.3370419080052698,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,15754.750123365417,31753.003085088178,3810.1189355762835,3314.302408674798,0.010254105090239623,0.23584441707551132,19564.869058941702,35067.30549376298,50450.848247973154,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_84,1.6021504337766546,0.9490867932047385,6,0.3874630608276644,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,3.844333476918052,2.0080019653466916,6,0.819763369600864,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,15754.750123365417,37803.26244206832,3810.1189355762835,8061.145056089085,0.04205848346376924,0.9252866362029233,19564.869058941702,45864.40749815741,50450.848247973154,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_84,1.7725450612920564,0.6407779391634317,6,0.26159649823042824,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,15754.750123365417,17430.326100672995,3810.1189355762835,2572.409791165925,0.7241309067373805,1,19564.869058941702,20002.735891838922,50450.848247973154,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,67.79792392602077,35.74250789337853,6,14.591817744362917,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,414853.8934497313,666691.0471194226,145359.11651901342,143488.67469718194,0.24578551260911485,1,560213.0099687447,810179.7218166045,993916.7463137924,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_84,42.187806226052764,36.208428160061636,6,14.782028896728761,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,76.3516907845298,38.051000968606886,6,15.534256095872559,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,414853.8934497313,750804.5339857378,145359.11651901342,152756.1444813462,0.14227271920620072,1,560213.0099687447,903560.678467084,993916.7463137924,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_84,29.16778467014123,18.922697048678554,6,7.725158721088606,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,414853.8934497313,286821.4803318923,145359.11651901342,75965.36676471336,0.45882004339203586,1,560213.0099687447,362786.8470966057,993916.7463137924,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,1.2618496502000036,0.254253280086635,6,0.1037984669401985,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,9833.502392298877,12408.401553963236,1004.0789776783865,1020.7024729733977,0.10232930788272351,1,10837.581369977263,13429.104026936635,14772.014429630299,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_84,1,0.25011242776465625,6,0.10210797105868735,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,1.0111544977986997,0.2765915654938469,6,0.1129180337695866,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,9833.502392298877,9943.190173087283,1004.0789776783865,1110.3797552069152,0.943050459167965,1,10837.581369977263,11053.569928294199,14772.014429630299,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_84,1.0217732156602821,0.17407043370725575,6,0.07106395698129037,leaf_1_log2-1,1,967514 MM WT,leaf,ns,9833.502392298877,10047.6093605823,1004.0789776783865,698.8075909817431,0.8649696070124844,1,10837.581369977263,10746.416951564044,14772.014429630299,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,244.9642934432077,54.15043099320637,6,22.106820880857885,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,2091807.4870880158,2408856.9656015867,172063.90288127508,217387.47601803875,0.2807975542468366,1,2263871.3899692907,2626244.4416196253,3686247.5054059345,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_84,212.7225279088983,42.8604934840915,6,17.497723193317896,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,318.0164007519113,55.777424409900355,6,22.771038161819167,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,2091807.4870880158,3127215.0375841986,172063.90288127508,223919.05823937783,0.004834169946488598,0.11602007871572634,2263871.3899692907,3351134.0958235767,3686247.5054059345,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_84,243.22313380137925,50.35121587988508,6,20.55579780574,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,2091807.4870880158,2391735.2680982924,172063.90288127508,202135.48689835626,0.2855545907185258,1,2263871.3899692907,2593870.7549966485,3686247.5054059345,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,1.0173397504025359,0.4142541846628614,6,0.1691185627061146,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,2621.145687680179,1344.2058387280904,1530.4056291246839,223.4554968848048,0.4536284744462231,1,4151.551316804863,1567.661335612895,4566.70644848535,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_98,1.983770359304802,2.5899524639058518,5,1.1582619535573109,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,1.2537533414589126,0.30895442721302874,6,0.126130116740961,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,2621.145687680179,1656.577914356626,1530.4056291246839,166.65508184023165,0.5641821039341958,1,4151.551316804863,1823.2329961968576,4566.70644848535,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_98,1.7038453659881034,2.0081618226754596,5,0.8980772690644412,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,2621.145687680179,2251.2822175136544,1530.4056291246839,1186.6249286216737,0.8535792395417525,1,4151.551316804863,3437.907146135328,4566.70644848535,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,1.4653761778624625,0.8215502613873861,6,0.3353964897415402,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,1724.000575268397,1936.1940919308297,189.11469575816338,443.15767630341537,0.6733811784553312,1,1913.1152710265603,2379.351768234245,2617.2869450576695,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_98,1.304781056893,0.350591304269635,6,0.14312830061957452,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,1.430612002724214,0.6705300283374996,6,0.27374273777346986,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,1724.000575268397,1890.2603641069538,189.11469575816338,361.69488735588635,0.6950651706521302,1,1913.1152710265603,2251.9552514628404,2617.2869450576695,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_98,0.9826409884983618,0.21364608410258276,6,0.08722064859917812,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,1724.000575268397,1298.3585410777514,189.11469575816338,115.24419945084848,0.08967634055481652,1,1913.1152710265603,1413.6027405286,2617.2869450576695,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.8889504400406532,0.17860830881952813,6,0.07291653673821408,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,1321.2949146990686,1174.5656958452143,431.09233064565666,96.34424918967008,0.7549866625466166,1,1752.3872453447252,1270.9099450348845,2204.7779466615953,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_98,1,0.7295507953438607,5,0.3262650342855819,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,1.2895041247871524,0.5571361026684444,6,0.22744986147009172,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,1321.2949146990686,1703.8152425647377,431.09233064565666,300.5283453094398,0.48897333563419165,1,1752.3872453447252,2004.3435878741775,2204.7779466615953,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_98,0.6012323918173033,0.24212574970578327,6,0.0988474233946672,fruit_1_log2-1,1,967514 MM WT,fruit,ns,1321.2949146990686,794.4053018605607,431.09233064565666,130.60659786247956,0.2975928228855786,1,1752.3872453447252,925.0118997230403,2204.7779466615953,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,2.4372344739402516,0.8806834902776779,6,0.3595375293456102,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,2664.5190429494905,3220.3055163465137,521.5345880998374,475.05510916782185,0.45187569767807756,1,3186.053631049328,3695.3606255143354,5910.666492414543,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_98,2.0165967592150675,0.8826090062370323,5,0.394714747099908,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,2.6070763382377375,0.9276040520415038,6,0.37869276847329614,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,2664.5190429494905,3444.7167079457918,521.5345880998374,500.3648292170779,0.3090888828594744,1,3186.053631049328,3945.0815371628696,5910.666492414543,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_98,3.2746242791691382,1.940224261751643,6,0.792093237976619,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,2664.5190429494905,4326.744407616286,521.5345880998374,1046.5887673060258,0.19681362906962568,1,3186.053631049328,5373.333174922312,5910.666492414543,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,1.34657929567854,0.607853580391305,6,0.2481551850470886,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,24376.98461298013,31448.04877401319,3233.9952180922737,5795.422807947367,0.31838660590590523,1,27610.979831072404,37243.471581960555,47067.69675480581,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_98,1.0438022087411183,0.3391979562888867,6,0.13847698578377415,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,1.0773559682096843,0.25430683196100573,6,0.10382032940136147,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,24376.98461298013,25160.600006225315,3233.9952180922737,2424.622740915475,0.8504591740750834,1,27610.979831072404,27585.22274714079,47067.69675480581,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_98,1.508255035416318,0.7934545136789171,6,0.32392644877025373,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,24376.98461298013,35223.82831047657,3233.9952180922737,7564.986921165068,0.23022773607609626,1,27610.979831072404,42788.81523164164,47067.69675480581,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,2.4889315945574824,0.6895747888127975,6,0.281517728679804,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,66837.37176624076,58126.574819632086,12862.895890833614,6574.572541463872,0.564417432385312,1,79700.26765707438,64701.14736109596,87670.29442278182,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_98,2.8619206757387565,1.3491262985544066,6,0.5507785050046758,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,2.555743932857859,0.6696929963343543,6,0.27340102088912227,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,66837.37176624076,59686.911949661524,12862.895890833614,6385.014731311183,0.633139334038046,1,79700.26765707438,66071.92668097271,87670.29442278182,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_98,2.0898168397528933,0.6565099060428282,6,0.268019046814576,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,66837.37176624076,48805.638194657164,12862.895890833614,6259.32396527908,0.24657441447531148,1,79700.26765707438,55064.96215993624,87670.29442278182,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.9171032957213514,0.31939546714568945,6,0.13039265344413464,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,23354.026662177774,21418.054820247547,1695.0913344743365,3045.1935050864276,0.594078774924508,1,25049.11799665211,24463.248325333974,27554.02979631732,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_98,1,0.177789847418473,6,0.07258240127042266,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,0.6464452345978581,0.12724184452400547,6,0.05194626550239389,leaf_1_transp1-1,1,967514 MM WT,leaf,*,23354.026662177774,15097.099244436142,1695.0913344743365,1213.1544695434725,0.003257264592353173,0.07817435021647616,25049.11799665211,16310.253713979615,27554.02979631732,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_98,0.6903286773453736,0.17575828654741527,6,0.07175302001784006,leaf_1_log2-1,1,967514 MM WT,leaf,*,23354.026662177774,16121.954336389772,1695.0913344743365,1675.7219425884127,0.012589631582067667,0.28956152638755633,25049.11799665211,17797.676278978186,27554.02979631732,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,3.2834335057293513,0.2704492485434745,6,0.11041044337510987,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,96360.09401886453,76681.3936362911,6166.802974972647,2578.5284383651856,0.02271156513855304,0.49965443304816687,102526.89699383717,79259.9220746563,112779.5866932209,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_98,4.126059090911345,0.6468058314510671,6,0.2640573749519557,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,3.442741889999909,0.9766837233259626,6,0.39872946037170487,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,96360.09401886453,80401.88589005418,6166.802974972647,9311.938448516554,0.18804413261049746,1,102526.89699383717,89713.82433857073,112779.5866932209,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_98,3.3855728018304676,0.5427704823950095,6,0.22158512155200888,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,96360.09401886453,79066.75748069266,6166.802974972647,5174.904836667518,0.058049578906696715,1,102526.89699383717,84241.66231736017,112779.5866932209,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,1.624790873018039,0.7481746429194388,6,0.3054410189402721,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,696.9365653924843,360.7227584989879,395.55403255459765,67.8115126940729,0.44684128797228356,1,1092.490597947082,428.5342711930608,1201.7396577417903,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_107,3.1391869346813763,3.9839579506957774,5,1.7816801594513028,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,1.7017183915376557,0.4105950654440866,6,0.16762473354044632,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,696.9365653924843,377.80157593063285,395.55403255459765,37.21467007200273,0.46610854400106705,1,1092.490597947082,415.01624600263557,1201.7396577417903,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_107,1.8592230884602843,1.5566854986724366,5,0.6961709189239453,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,696.9365653924843,412.76947838132986,395.55403255459765,154.5581640267084,0.5320013264389831,1,1092.490597947082,567.3276424080383,1201.7396577417903,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,2.1881093818767887,0.8359561648736161,6,0.341277675212381,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,374.072621588788,485.7861188387827,31.620660501719627,75.7676735271549,0.21767109609689209,1,405.69328209050764,561.5537923659376,617.7091716025315,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_107,1.6849221932447012,0.3488755144938493,6,0.14242783237681464,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,1.837604376235578,0.6208549694110151,6,0.2534629798880409,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,374.072621588788,407.9698690048897,31.620660501719627,56.271774294717204,0.6139435693149583,1,405.69328209050764,464.2416432996069,617.7091716025315,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_107,1.5882924739502895,0.5510144871166478,6,0.22495072238619376,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,374.072621588788,352.61968295175757,31.620660501719627,49.941716471339966,0.7255649818397358,1,405.69328209050764,402.56139942309755,617.7091716025315,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,1.2380862556057557,0.23495538186475032,6,0.09592013298156844,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,222.01180748199775,274.8697674256525,60.93701870098342,21.295402097151598,0.45028051067272995,1,282.9488261829812,296.16516952280415,390.3385923791999,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_107,1,0.6137480601009193,5,0.2744764766888564,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,1.3765616977503503,0.5432758208282168,6,0.22179142510347147,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,222.01180748199775,305.61295062804277,60.93701870098342,49.24031517122983,0.3165199343355447,1,282.9488261829812,354.8532657992726,390.3385923791999,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_107,0.7798693086918363,0.2544760479879193,6,0.10388941155506802,fruit_1_log2-1,1,967514 MM WT,fruit,ns,222.01180748199775,173.14019482241065,60.93701870098342,23.064676037581794,0.486084855976361,1,282.9488261829812,196.20487085999244,390.3385923791999,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,3.1609058624566293,0.4911050088744643,6,0.20049278031124035,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,709.7323516050236,701.7584238044392,79.95670323260008,44.511764543989564,0.9332372050886949,1,789.6890548376236,746.2701883484287,1006.259353359433,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_107,3.196822545857493,0.805311328765108,5,0.36014617483389266,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,3.4779104831859526,1.1013364261788672,6,0.44961871321310304,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,709.7323516050236,772.1371926327015,79.95670323260008,99.820663198171,0.6373942984996219,1,789.6890548376236,871.9578558308725,1006.259353359433,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_107,3.6099497867271375,1.2503842534399983,6,0.510467233889813,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,709.7323516050236,801.4514770705441,79.95670323260008,113.32975325621307,0.5258125055693272,1,789.6890548376236,914.7812303267572,1006.259353359433,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,1.6389768559204927,0.15372806577311457,6,0.06275922004819032,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,5883.783335525771,7097.513527655217,454.4545681055833,271.7759019403319,0.05043538088972694,1,6338.237903631354,7369.289429595549,8531.983382663107,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_107,1.3586990253139075,0.25705892699775007,6,0.10494386749530644,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,1.5395478499592177,0.1472639144562828,6,0.060120241323794024,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,5883.783335525771,6666.940812548071,454.4545681055833,260.3479265373007,0.17337250554328743,1,6338.237903631354,6927.288739085372,8531.983382663107,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_107,1.6073723035494483,0.450080262458167,6,0.18374449772007348,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,5883.783335525771,6960.651474247517,454.4545681055833,795.6970554462171,0.27391783451744833,1,6338.237903631354,7756.348529693734,8531.983382663107,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,2.462704504385096,0.3978138028163434,6,0.1624068049227005,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,12323.844257895526,10664.628039957248,2013.9564244013764,703.295162929406,0.465317611740653,1,14337.800682296902,11367.923202886654,15771.580750526593,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_107,2.845855162650509,1.1391798296470526,6,0.46506821798432396,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,2.4473156869459785,0.3311669141065083,6,0.13519832654217498,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,12323.844257895526,10597.987477246306,2013.9564244013764,585.4701047688154,0.44287482427532837,1,14337.800682296902,11183.457582015122,15771.580750526593,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_107,2.3099465126585357,0.45925655662949605,6,0.18749070412831206,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,12323.844257895526,10003.116616644445,2013.9564244013764,811.9198291625238,0.3227989851909876,1,14337.800682296902,10815.036445806969,15771.580750526593,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,1.208030598614319,0.21481198235577778,6,0.0876966245678998,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,4330.453784028004,5231.320676990992,145.75796551983885,379.7661797065449,0.0656541975653998,1,4476.211749547842,5611.086856697537,6172.195542367291,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_107,1,0.0824469349578632,6,0.03365882025053296,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,1.018624753595725,0.2317462812473928,6,0.09461002314060571,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,4330.453784028004,4411.1074187132,145.75796551983885,409.70433271621295,0.8587374392513266,1,4476.211749547842,4820.811751429413,6172.195542367291,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_107,1.0104607487074684,0.1462565579272632,6,0.059708989742934156,leaf_1_log2-1,1,967514 MM WT,leaf,ns,4330.453784028004,4375.753572852026,145.75796551983885,258.56702057277846,0.8825327654085006,1,4476.211749547842,4634.320593424804,6172.195542367291,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,3.5985070449352454,0.515598568442737,6,0.21049223413236245,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,18134.541593068476,15583.168449591263,1240.3054645539994,911.5268918069975,0.13111673045986616,1,19374.847057622475,16494.69534139826,21312.331763384725,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_107,4.1876769727814755,0.7015697811043304,6,0.2864146637769495,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,3.763483503983849,0.7650695946070201,6,0.3123383540841967,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,18134.541593068476,16297.591380953829,1240.3054645539994,1352.5668073409877,0.34061434647204325,1,19374.847057622475,17650.158188294816,21312.331763384725,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_107,3.726135454962924,0.4141923881989446,6,0.16909333440536387,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,18134.541593068476,16135.857380745101,1240.3054645539994,732.2508698296208,0.20218637661366387,1,19374.847057622475,16868.10825057472,21312.331763384725,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,1.4426433695785201,0.3440997527091735,6,0.1404781357925581,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,407.13277716960454,356.2465030061606,159.41151803095573,34.68968539296332,0.7693977851357497,1,566.5442952005603,390.9361883991239,623.1987247206164,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_110,1.6487106443586959,1.443487654101486,5,0.6455473038505252,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,1.922861055152317,0.4161715703975057,6,0.16990133215444292,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,407.13277716960454,474.8315079872311,159.41151803095573,41.955452548048534,0.6998916561821051,1,566.5442952005603,516.7869605352796,623.1987247206164,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_110,1.3238073464180915,0.48915662795834713,5,0.21875749435188765,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,407.13277716960454,326.9011231466667,159.41151803095573,54.01999829799809,0.6540647449144408,1,566.5442952005603,380.9211214446648,623.1987247206164,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,2.1719499020231843,0.6887168355911065,6,0.28116747074375065,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,279.95384215221173,536.341533615747,29.092523707974905,69.43152432802026,0.01213059703097666,0.26687313468148655,309.04636586018665,605.7730579437673,666.3503637381441,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_110,1.1336912805062278,0.28857944660491425,6,0.11781206573946389,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,1.9908191445246746,0.21304792413580403,6,0.08697645081531678,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,279.95384215221173,491.6130856109202,29.092523707974905,21.47797376693067,2.227722926460415e-4,0.005346535023504996,309.04636586018665,513.0910593778509,666.3503637381441,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_110,1.7220106595465265,0.6840243999268653,6,0.27925179190571253,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,279.95384215221173,425.2334905070888,29.092523707974905,68.9584663974706,0.09507856744303426,1,309.04636586018665,494.1919569045594,666.3503637381441,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,1.181719854155892,0.3289468731017933,6,0.13429199859724042,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,246.94010350613598,291.8140231005119,42.21046137158135,33.16208003364842,0.4273821780232647,1,289.15056487771733,324.9761031341603,435.85508314507786,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_110,1,0.38222005923043456,5,0.17093400696064953,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,1.4489211604434609,0.3812524183712794,6,0.1556456480352883,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,246.94010350613598,357.7967413321389,42.21046137158135,38.435152436113704,0.08542357840064914,1,289.15056487771733,396.2318937682526,435.85508314507786,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_110,0.8198411023157903,0.13846840149842946,6,0.05652948819499764,fruit_1_log2-1,1,967514 MM WT,fruit,ns,246.94010350613598,202.4516466644459,42.21046137158135,13.959397666021605,0.36402561428304003,1,289.15056487771733,216.4110443304675,435.85508314507786,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,3.162675234356173,0.2646760428182819,6,0.1080535420073038,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,803.0077798452246,780.9913497282062,157.5872318286452,26.68275284748821,0.8967496248495963,1,960.5950116738697,807.6741025756944,1143.1924535958585,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_110,3.251832199160277,1.4269685553367937,5,0.6381597382975481,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,3.7326592786352295,0.6455991416543355,6,0.2635647459053198,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,803.0077798452246,921.7432686193224,157.5872318286452,65.0847056344281,0.5152390500106306,1,960.5950116738697,986.8279742537505,1143.1924535958585,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_110,3.5144832389917107,1.700169863446718,6,0.6940914402503021,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,803.0077798452246,867.8668548071931,157.5872318286452,171.39901209813263,0.786878298229952,1,960.5950116738697,1039.2658669053258,1143.1924535958585,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,1.0070168162219013,0.36493660681599377,6,0.1489847458603124,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,6196.556547397691,6450.223303986008,792.5311049415176,954.2888104808588,0.8422070846407036,1,6989.087652339209,7404.512114466867,8144.963325913554,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_110,0.9674140493776828,0.3030776522337615,6,0.12373093340223433,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.7358366713594878,0.3667547540666293,6,0.14972700136719594,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,6196.556547397691,4713.238914259191,792.5311049415176,959.0431638251998,0.2616360579763814,1,6989.087652339209,5672.28207808439,8144.963325913554,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_110,0.7685508259627185,0.30150869294276833,6,0.12309040845387899,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,6196.556547397691,4922.782189994779,792.5311049415176,788.4283641708453,0.2810848122292729,1,6989.087652339209,5711.210554165625,8144.963325913554,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.5464839143349715,0.09338947887657521,6,0.03812609509867288,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,4225.880915172431,3500.381744092133,226.8797444479429,244.20826259693402,0.05471052121528344,1,4452.760659620374,3744.590006689067,4898.036725582412,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_110,0.6597497395632904,0.0867627527272288,6,0.03542074547683003,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.3974917528092462,0.10937899733228192,6,0.04465378867355553,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,4225.880915172431,2546.045434207997,226.8797444479429,286.01995882655257,0.0011160214108340933,0.025668492449184146,4452.760659620374,2832.0653930345497,4898.036725582412,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_110,0.5761502451965479,0.10145105636227392,6,0.041417220325651344,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,4225.880915172431,3690.402859514037,226.8797444479429,265.288836717868,0.15676784175314726,1,4452.760659620374,3955.691696231905,4898.036725582412,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,1.4248555131426364,0.6817200444953248,6,0.278311042740165,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,6405.278640912654,9126.596584719167,1032.0987172419457,1782.6597775937075,0.2229415062984895,1,7437.377358154599,10909.256362312875,12000.181998544163,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_110,1,0.39469246587898693,6,0.161132524454063,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,1.4732239405578091,0.5139495554736149,6,0.2098190274067656,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,6405.278640912654,9436.409839736109,1032.0987172419457,1343.9493347056225,0.10593927160454465,1,7437.377358154599,10780.359174441732,12000.181998544163,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_110,1.2153826085413773,0.6910945395988287,6,0.28213816434013234,leaf_1_log2-1,1,967514 MM WT,leaf,ns,6405.278640912654,7784.864263026788,1032.0987172419457,1807.173557834154,0.5261468045802867,1,7437.377358154599,9592.037820860942,12000.181998544163,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.3451537135822601,0.0737080479297932,6,0.030091184560766555,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,3836.947745696641,2210.8057094401347,607.6429152205377,192.7424217468386,0.043463351419697926,0.8692670283939585,4444.590660917179,2403.5481311869735,4889.049727008897,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_110,0.5990290135371745,0.23237319897382308,6,0.09486596123068237,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.3192388479936,0.07207825960757468,6,0.029425826264402873,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,3836.947745696641,2044.8137744029673,607.6429152205377,188.48061646258634,0.030735641647650993,0.6454484746006709,4444.590660917179,2233.2943908655534,4889.049727008897,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_110,0.3827159479514767,0.05207745317683806,6,0.021260531231156014,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,3836.947745696641,2451.4022869502323,607.6429152205377,136.17962658937998,0.07176346246702846,1,4444.590660917179,2587.5819135396123,4889.049727008897,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,4.02167497662098,2.035370917559034,6,0.83093669755334,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,684.4018700084052,1715.6120636281876,277.90714401344087,354.4704708165252,0.048277481645427674,0.6758847430359874,962.3090140218461,2070.082534444713,2547.7107665078447,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_112,1.6043498019852611,1.4567082866931391,5,0.6514597504866223,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,4.567509591029355,2.1109919398108214,6,0.861808850610762,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,684.4018700084052,1948.460430208932,277.90714401344087,367.6402666163812,0.023283972913092144,0.44061183269232734,962.3090140218461,2316.100696825313,2547.7107665078447,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_112,1.9031708961895828,0.38498183164242394,5,0.1721691091309679,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,684.4018700084052,811.8763867368177,277.90714401344087,73.44586579629106,0.6776849026942231,1,962.3090140218461,885.3222525331088,2547.7107665078447,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,3.681993287298111,2.16388708569188,6,0.8834032034905408,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,311.1792135019354,1570.7067673564452,47.59696940692736,376.8522324072916,0.0201348563276224,0.40269712655244805,358.7761829088628,1947.5589997637367,2142.3148997401104,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_112,0.72945491741223345,0.27330199627531465,6,0.11157507275975827,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,2.2798682583780865,0.8155984045419538,6,0.33296665435930684,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,311.1792135019354,972.5722516847377,47.59696940692736,142.04071993025713,0.0043050180100407285,0.09471039622089603,358.7761829088628,1114.6129716149949,2142.3148997401104,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_112,1.3027346335976302,0.4411263721358476,6,0.18008908730298565,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,311.1792135019354,555.7354251894772,47.59696940692736,76.82446057945324,0.025817449775639534,0.44061183269232734,358.7761829088628,632.5598857689304,2142.3148997401104,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,4.194528664056754,1.9455691901901895,6,0.7942752958743073,fruit_1_panK4-1,1,967514 MM WT,fruit,*,426.591426110135,1789.34996465981,112.55012389174729,338.8310311910702,0.008596640183037482,0.1805294438437871,539.1415500018823,2128.18099585088,2855.2492500727885,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_112,1,0.5899549604004358,5,0.2638358790237142,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,4.864052717309002,2.9899646405915727,6,1.2206479530689083,fruit_1_transp1-1,1,967514 MM WT,fruit,*,426.591426110135,2074.9631853517244,112.55012389174729,520.7179510780827,0.02404665650572175,0.44061183269232734,539.1415500018823,2595.6811364298073,2855.2492500727885,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_112,1.914655768962117,0.87867571499669,6,0.3587178585195112,fruit_1_log2-1,1,967514 MM WT,fruit,ns,426.591426110135,816.7757349915466,112.55012389174729,153.02596283701192,0.07125084382480965,0.9262609697225254,539.1415500018823,969.8016978285585,2855.2492500727885,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,3.88216576654826,3.277440132784585,6,1.3380093313069632,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,852.8399339333798,1656.0986307477676,146.38245740412296,570.7833087909055,0.22465409324414568,1,999.2223913375028,2226.881939538673,2576.474793738089,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_112,1.9991961435089844,0.767294196354946,5,0.3431443963581461,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,5.08852213432348,0.9849253900382611,6,0.4020941067175736,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,852.8399339333798,2170.7199140740413,146.38245740412296,171.52989841513056,2.4755991661059705e-4,0.005941437998654329,999.2223913375028,2342.2498124891717,2576.474793738089,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_112,2.9193297128944655,1.8624143669244042,6,0.7603274814322258,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,852.8399339333798,1245.361025509341,146.38245740412296,324.34918461490037,0.3070515778511594,1,999.2223913375028,1569.7102101242415,2576.474793738089,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,40.17610877727504,24.94983191839044,6,10.185726228043622,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,49795.27330558879,244513.34073149657,43597.69541217024,61990.7209431917,0.03029014972263636,0.45435224583954537,93392.96871775902,306504.06167468824,364887.2958966118,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_112,8.181886153673469,17.54706439951954,6,7.163559043763165,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,49.48323600733571,12.299230227149945,6,5.021139714255435,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,49795.27330558879,301156.8744358467,43597.69541217024,30558.849106527643,0.0011013471431236244,0.025330984291843363,93392.96871775902,331715.7235423743,364887.2958966118,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_112,34.19224723402186,40.951432977031416,6,16.718352504918542,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,49795.27330558879,208095.32960635843,43597.69541217024,101748.5353090404,0.1971505530088317,1,93392.96871775902,309843.8649153988,364887.2958966118,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,36.10408400255068,34.024130001875015,6,13.890292907785708,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,351518.5860881546,219730.84159179757,88922.78209468091,84536.8560068912,0.3080657365263272,1,440441.3681828355,304267.69759868877,507059.10379649885,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_112,57.75819392783108,35.789363847068024,6,14.610946607354705,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,58.94350136158202,41.14537599196728,6,16.797529409213514,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,351518.5860881546,358732.4126443057,88922.78209468091,102230.40898887503,0.9586080012859719,1,440441.3681828355,460962.8216331807,507059.10379649885,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_112,55.9571624843684,27.5229518633251,6,11.236198046721666,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,351518.5860881546,340557.4395658557,88922.78209468091,68383.93276848785,0.9242159670219755,1,440441.3681828355,408941.37233434356,507059.10379649885,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,15.69299571127476,35.50312358381324,6,14.494089509219014,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,6086.038398766024,95508.17449048873,657.5402643854702,88211.58530825871,0.3572366507262689,1,6743.578663151495,183719.75979874743,202091.73577862218,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_112,1,0.2646447537047603,6,0.10804076828019848,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,1.69313733628744,0.5316195966733634,6,0.217032791518989,leaf_1_transp1-1,1,967514 MM WT,leaf,*,6086.038398766024,10304.498843029784,657.5402643854702,1320.869902975948,0.023190096457490914,0.44061183269232734,6743.578663151495,11625.368746005732,202091.73577862218,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_112,1.5125072012234273,0.7526807755138119,6,0.3072806398685284,leaf_1_log2-1,1,967514 MM WT,leaf,ns,6086.038398766024,9205.176905055909,657.5402643854702,1870.1217734372576,0.16495399915418357,1,6743.578663151495,11075.298678493167,202091.73577862218,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,27.994651614026658,7.650016018044617,6,3.1231059613878838,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,284066.7372462544,170376.5246830435,87182.17337534636,19007.342804421747,0.25403178231603496,1,371248.91062160075,189383.86748746526,408373.80168376083,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_112,46.675147055242114,35.088809081414,6,14.324946321900137,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,38.62754969450681,13.903941684875553,6,5.676260423559689,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,284066.7372462544,235088.75069101126,87182.17337534636,34545.93889918016,0.6187098902709336,1,371248.91062160075,269634.6895901914,408373.80168376083,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_112,29.074142858397273,5.4167059706624645,6,2.211360952468351,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,284066.7372462544,176946.3498474148,87182.17337534636,13458.427670254194,0.27651812575118523,1,371248.91062160075,190404.777517669,408373.80168376083,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,1.2540377011312225,0.6391570471415462,6,0.26093477183346697,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,279.92626143888253,266.7564712312267,88.76006280717606,55.50553934146624,0.9034770784003934,1,368.6863242460586,322.262010572693,455.95942350543555,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_122,1.3159496516086056,0.9330356385337809,5,0.4172662226382912,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,1.7153107563504297,0.5715104100958645,6,0.23331814790393796,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,279.92626143888253,364.87758224194494,88.76006280717606,49.63098458117827,0.4336191933898019,1,368.6863242460586,414.5085668231232,455.95942350543555,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_122,1.3176715249220914,0.47943406053662463,5,0.2144094300177284,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,279.92626143888253,280.2925349955694,88.76006280717606,45.608758730805484,0.997190965379941,1,368.6863242460586,325.9012937263749,455.95942350543555,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,1.2716828392413209,0.7024771327153604,6,0.2867850885210021,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,239.18088458876,270.5099108386576,22.27116486832287,61.00436864584534,0.6457952865728294,1,261.45204945708286,331.51427948450294,364.66570743295324,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_122,1.1244032629455079,0.25645678147668216,6,0.10469804261572,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,1.376843847941693,0.40367331843995957,6,0.1647989421589881,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,239.18088458876,292.8795569559334,22.27116486832287,35.05571182853187,0.23017723559640113,1,261.45204945708286,327.9352687844653,364.66570743295324,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_122,1.3915179498531118,0.29693240528209747,6,0.12122214683973923,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,239.18088458876,296.001003496852,22.27116486832287,25.7861403184869,0.12699892058894938,1,261.45204945708286,321.7871438153389,364.66570743295324,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,1.2436976739904384,0.48235463596653605,6,0.19692045553065735,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,212.71806341276286,264.55696068220374,60.467462348200975,41.88853794684051,0.5025613751357219,1,273.18552576096386,306.44549862904427,456.6728769588148,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_122,1,0.6356270552121529,5,0.2842610607584772,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,1.6835220028806068,0.656845321876717,6,0.26815597975535554,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,212.71806341276286,358.1155401655385,60.467462348200975,57.041620706111296,0.11517929935795648,1,273.18552576096386,415.1571608716498,456.6728769588148,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_122,0.9789606423665106,0.49661142492366966,6,0.20274076524991122,fruit_1_log2-1,1,967514 MM WT,fruit,ns,212.71806341276286,208.24261200151844,60.467462348200975,43.126622958782676,0.9535157288461866,1,273.18552576096386,251.36923496030113,456.6728769588148,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,1.141363765713507,0.4893992389582228,6,0.19979640265901005,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,402.446246456714,242.78868989207558,93.48425236509856,42.5003038504612,0.17420418035597263,1,495.93049882181253,285.2889937425368,593.964145314189,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_122,1.8919232339747205,0.9826957793823345,5,0.4394749127802072,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,2.1387253998563964,0.9790434279809543,6,0.39969280576310484,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,402.446246456714,454.94552522913955,93.48425236509856,85.02187960194127,0.6879448289277639,1,495.93049882181253,539.9674048310808,593.964145314189,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_122,2.2880463629716705,0.5332972472248114,6,0.2177176894886134,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,402.446246456714,486.70879132994924,93.48425236509856,46.31248527871909,0.45050659313826547,1,495.93049882181253,533.0212766086684,593.964145314189,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,1.3182956398503516,0.38529663734412384,6,0.15729669351721356,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,11959.054449636922,14497.257003499193,1451.2868125364178,1729.78694822851,0.28799541754778185,1,13410.34126217334,16227.043951727703,17849.748346900473,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_122,1.0874863661369853,0.32326289041827405,6,0.13197152238366747,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,1.0087784009752108,0.20343133649881945,6,0.08305049535242191,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,11959.054449636922,11093.505353758674,1451.2868125364178,913.3037681355376,0.6266609475723726,1,13410.34126217334,12006.809121894212,17849.748346900473,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_122,1.0526187017291748,0.3660327100090426,6,0.14943222811504656,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,11959.054449636922,11575.615806018885,1451.2868125364178,1643.301661708648,0.8647061764835486,1,13410.34126217334,13218.917467727533,17849.748346900473,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.9341906069417828,0.14982273262718535,6,0.06116487446767285,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,9753.747613536536,10273.265654301415,270.1511161693212,672.6282617799426,0.4982152423531977,1,10023.898729705857,10945.893916081357,12040.483307689494,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_122,0.8869486791896136,0.06017406752976082,6,0.024565960199281908,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.8567885383423225,0.19972414534148822,6,0.08153704090001869,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,9753.747613536536,9422.077463148607,270.1511161693212,896.6603556138438,0.7355244021138521,1,10023.898729705857,10318.73781876245,12040.483307689494,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_122,0.8209478903751855,0.2013881937872084,6,0.082216385833233,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,9753.747613536536,9027.938948960313,270.1511161693212,904.1310911553427,0.4715217802532936,1,10023.898729705857,9932.070040115656,12040.483307689494,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,1.3959704658866148,0.4208635891764683,6,0.17181684079977877,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,10996.969545575432,15351.44469987785,882.7556887761259,1889.4645656921496,0.07472689989149273,1,11879.725234351557,17240.90926557,18965.000192127,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_122,1,0.1966269885607357,6,0.0802726319389779,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,1.2571027049284724,0.13435718022212184,6,0.054851089137226396,leaf_1_transp1-1,1,967514 MM WT,leaf,*,10996.969545575432,13824.32016175891,882.7556887761259,603.1957567837219,0.027133547355353886,0.6512051365284932,11879.725234351557,14427.515918542631,18965.000192127,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_122,1.1658150456088943,0.4899195347760391,6,0.20000881253716907,leaf_1_log2-1,1,967514 MM WT,leaf,ns,10996.969545575432,12820.432552334643,882.7556887761259,2199.490820317954,0.46841574790582186,1,11879.725234351557,15019.923372652596,18965.000192127,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.9094549477385566,0.08270466142686116,6,0.033764036640908664,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,12390.455737275557,10001.248363353803,1784.8595212672717,371.3020826757656,0.24269059333866896,1,14175.315258542829,10372.550446029569,15592.846784397112,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_122,1.1267154724694848,0.3975636261911921,6,0.16230467074316848,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.9426324718781656,0.16792737835713892,6,0.06855606513638028,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,12390.455737275557,10366.100585914677,1784.8595212672717,753.9089604692597,0.33218777784243836,1,14175.315258542829,11120.009546383937,15592.846784397112,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_122,0.8893638873843801,0.11687928187233482,6,0.04771576701502467,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,12390.455737275557,9780.307584500606,1784.8595212672717,524.7288367079991,0.2113333380501137,1,14175.315258542829,10305.036421208606,15592.846784397112,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,1.3042871402478502,0.5757216440064747,6,0.23503737694868806,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,92.60275567830311,64.78033166413577,35.54580834781078,11.673655870984968,0.4914266102970831,1,128.1485640261139,76.45398753512075,140.9634204287253,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_8,1.8644638006630012,1.6003075061613203,5,0.7156792737359752,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,1.3613492248845571,0.4247451589949962,6,0.1734014850425089,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,92.60275567830311,67.61444744596463,35.54580834781078,8.61237174352024,0.5282421433241768,1,128.1485640261139,76.22681918948487,140.9634204287253,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_8,1.3589806999123102,0.6683805405776627,5,0.29890886471394207,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,92.60275567830311,67.49680936726074,35.54580834781078,14.845975856083253,0.5415114448944032,1,128.1485640261139,82.342785223344,140.9634204287253,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,1.346022296695104,0.3669863071663283,6,0.14982153252429967,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,68.72795682159015,66.85320135155287,11.879131137155024,7.441220777128054,0.8967527461861706,1,80.60708795874518,74.29442212868092,88.66779675461972,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_8,1.3837686216654144,0.5858552781781072,6,0.2391744157754432,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,1.305017423360983,0.5040310437426027,6,0.2057698119486341,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,68.72795682159015,64.81660280475936,11.879131137155024,10.22001693734888,0.808059142418342,1,80.60708795874518,75.03661974210823,88.66779675461972,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_8,1.3486030994899822,0.4130065718323907,6,0.16860922690091415,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,68.72795682159015,66.98138268206893,11.879131137155024,8.37435354779252,0.9069927449363108,1,80.60708795874518,75.35573622986145,88.66779675461972,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,1.136455578550905,0.3969819012594253,6,0.16206718253425445,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,49.66723175069083,56.444602594253226,12.095813156113396,8.04942831411033,0.6546748049730033,1,61.763044906804225,64.49403090836356,104.57377948932834,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_8,1,0.5445654913076493,5,0.24353709135289492,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,1.6466345158338673,0.6551058240942976,6,0.2674458327594172,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,49.66723175069083,81.78377810660729,12.095813156113396,13.283294156418476,0.1074730638062206,1,61.763044906804225,95.06707226302576,104.57377948932834,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_8,1.1685511562298532,1.1462919382991952,6,0.4679717241831544,fruit_1_log2-1,1,967514 MM WT,fruit,ns,49.66723175069083,58.03870108900584,12.095813156113396,23.2428600777751,0.7581839634840073,1,61.763044906804225,81.28156116678093,104.57377948932834,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,2.0277416178245384,1.1254269650628406,6,0.4594536345288384,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,*,260.4210704881606,100.7123128630121,22.683766456162946,22.819790144841026,8.028737535177447e-4,0.019268970084425872,283.10483694432355,123.53210300785312,331.4407203301448,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_8,5.24331760214396,1.0212456380962758,5,0.4567149337016843,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,3.765756926554796,0.636320791387472,6,0.2597768752705479,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,260.4210704881606,187.0347219879663,22.683766456162946,12.902398267532606,0.02832243161580021,0.6514159271634049,283.10483694432355,199.9371202554989,331.4407203301448,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_8,4.7922949278100555,3.1213240952525476,6,1.2742752258705166,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,260.4210704881606,238.02002279720222,22.683766456162946,63.28972295747485,0.7499050465558712,1,283.10483694432355,301.30974575467707,331.4407203301448,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,1.1084938929946264,0.33842837364476214,6,0.13816280498493963,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,307.6241012562848,353.53080083177997,19.12088234807718,44.0641192524166,0.37186346874643483,1,326.744983604362,397.5949200841966,532.2553010151685,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_8,0.9645536874814185,0.14685529236710454,6,0.05995342205444122,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.9853623091603335,0.15349547799176094,6,0.06266426648406992,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,307.6241012562848,314.2605732592822,19.12088234807718,19.9854491338697,0.8152344062657724,1,326.744983604362,334.24602239315186,532.2553010151685,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_8,1.3437946585449028,0.4246735184454589,6,0.17337223791063242,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,307.6241012562848,428.57502850595387,19.12088234807718,55.293426962381005,0.0828444082249347,1,326.744983604362,483.8684554683349,532.2553010151685,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,1.5617396392534446,0.23965257876521415,6,0.09783775558615497,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,462.61573765775836,498.0839938273633,34.606995769746426,31.20329331767008,0.4643102619090904,1,497.2227334275048,529.2872871450334,582.2160158595367,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_8,1.4505291159647429,0.2657942447004459,6,0.10851004601409073,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,1.2357587551634341,0.2719946220625795,6,0.11104133947241261,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,462.61573765775836,394.1192505513697,34.606995769746426,35.41429855158063,0.19668206602298677,1,497.2227334275048,429.53354910295036,582.2160158595367,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_8,1.4480153057643272,0.2871542663904735,6,0.11723023835331553,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,462.61573765775836,461.81401079312843,34.606995769746426,37.388117614960095,0.987755778287573,1,497.2227334275048,499.2021284080885,582.2160158595367,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,0.9342783864920524,0.1239503256924678,6,0.05060250856638902,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,318.9289567276793,297.96843109712984,29.43931337288151,16.138605264881903,0.5503272533011251,1,348.3682701005608,314.10703636201174,423.1699443774342,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_8,1,0.2261045747659277,6,0.0923068061142487,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.934667812036104,0.16343553308025613,6,0.0667222769810647,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,318.9289567276793,298.0926301796173,29.43931337288151,21.279666188066223,0.5801229533073122,1,348.3682701005608,319.37229636768353,423.1699443774342,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_8,1.1111336398510674,0.23292430215241625,6,0.09509094816121223,leaf_1_log2-1,1,967514 MM WT,leaf,ns,318.9289567276793,354.3726925427298,29.43931337288151,30.32725689130125,0.4213106660011485,1,348.3682701005608,384.69994943403105,423.1699443774342,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,1.2800160214019436,0.24289256936612844,6,0.0991604762100972,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,512.5015882285733,408.23417430043673,40.30357908553947,31.62514722630617,0.07078107830130805,1,552.8051673141127,439.8593215267429,608.0856840455241,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_8,1.606945927666825,0.30954606499332493,6,0.12637165185334076,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,1.4377191385959769,0.6507952921897473,6,0.2656860654783946,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,512.5015882285733,458.5302649398327,40.30357908553947,84.73497968010626,0.5827959856980177,1,552.8051673141127,543.2652446199389,608.0856840455241,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_8,1.338061252989026,0.26121997411647696,6,0.10664260786806627,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,512.5015882285733,426.7464794535214,40.30357908553947,34.011415670081384,0.13585085517625578,1,552.8051673141127,460.75789512360274,608.0856840455241,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,1.9703707463821303,0.9340688045748143,6,0.38133199264329215,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,78.71265911723815,83.3625660025005,25.496794538282444,16.133417258635248,0.8818999271041887,1,104.20945365552059,99.49598326113575,114.63039902107266,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_7,1.8604648145056215,1.3475579892435978,5,0.602646253514323,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,1.6124039887657735,0.5966843086990099,6,0.2435953489729827,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,78.71265911723815,68.21768653588903,25.496794538282444,10.306046917286174,0.7175640092752089,1,104.20945365552059,78.5237334531752,114.63039902107266,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_7,1.1273307290737253,0.6060006194436409,5,0.27101171589659234,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,78.71265911723815,47.69517740841939,25.496794538282444,11.465980245272629,0.31292741864035506,1,104.20945365552059,59.161157653692015,114.63039902107266,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,2.755063981039896,2.321772845232772,6,0.9478597949116985,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,95.45141044703405,116.5614153489916,14.391314009084958,40.10211015339487,0.6371642713864265,1,109.84272445611902,156.66352550238648,172.32987805262513,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_7,2.256104578643946,0.8332070792709347,6,0.3401553657147475,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,1.2926588267679566,0.5927487887318293,6,0.24198867967429485,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,95.45141044703405,54.68988867349941,14.391314009084958,10.238071854368712,0.04630491321336788,1,109.84272445611902,64.92796052786812,172.32987805262513,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_7,1.5648667469933926,0.8082393410033718,6,0.3299623292502658,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,95.45141044703405,66.20647800465032,14.391314009084958,13.960066399163601,0.17538090749378232,1,109.84272445611902,80.16654440381393,172.32987805262513,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,1.3184861519591657,0.500319807092604,6,0.20425470593076533,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,42.30806113801961,55.7825927267206,9.48547205178768,8.641620586247036,0.3221680784601018,1,51.79353318980729,64.42421331296764,70.86663464426441,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_7,1,0.5013266913196222,5,0.22420011214514576,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,1.0727720933720286,0.6101969652577716,6,0.24911186791272247,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,42.30806113801961,45.386907313545066,9.48547205178768,10.539440137857728,0.8329451031470427,1,51.79353318980729,55.92634745140279,70.86663464426441,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_7,0.9568726216863215,0.9079897805441135,6,0.3706852756657925,fruit_1_log2-1,1,967514 MM WT,fruit,ns,42.30806113801961,40.483425379602,9.48547205178768,15.682975305832004,0.9231519472507599,1,51.79353318980729,56.166400685434,70.86663464426441,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,3.653360423877897,1.3602557748081345,6,0.5553220946590184,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,148.51093397482484,154.5665961726473,33.14004875750468,23.494601132126864,0.8854228109669793,1,181.6509827323295,178.06119730477417,253.43504923586167,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_7,3.510227837913549,1.751519682211242,5,0.7833034146706332,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,4.6180112541620275,2.0273277137432295,6,0.8276530733456854,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,148.51093397482484,195.37910247714967,33.14004875750468,35.01639682817908,0.35646795079754123,1,181.6509827323295,230.39549930532877,253.43504923586167,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_7,3.02167096224029,2.8615696635407497,6,1.1682309231837629,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,148.51093397482484,127.84103980944074,33.14004875750468,49.42558532138373,0.73688509865226,1,181.6509827323295,177.26662513082448,253.43504923586167,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,1.401901907733028,0.4651124102999601,6,0.18988134637848555,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,273.43390468143775,287.8213452293091,76.99170171329676,38.98411454263873,0.8720543617283643,1,350.42560639473453,326.8054597719478,385.468167034208,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_7,1.3318244771123526,0.9185740493810678,6,0.37500628532428903,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,1.1553334923228191,0.43902650563798373,6,0.17923182039503038,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,273.43390468143775,237.1989353281877,76.99170171329676,36.79768418135252,0.683558118119624,1,350.42560639473453,273.9966195095402,385.468167034208,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_7,1.079983543943759,0.22030064965719326,6,0.08993736361062757,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,273.43390468143775,221.7290059516809,76.99170171329676,18.46483897197031,0.5397110226442606,1,350.42560639473453,240.19384492365123,385.468167034208,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,1.0922443208951833,0.3106397873723719,6,0.12681816214482874,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,396.90247784911963,224.2462386455303,70.19879111813373,26.03675323265509,0.05823626729518502,1,467.10126896725336,250.28299187818538,513.8113958639788,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_7,1.933207352767199,0.8375290633159678,6,0.34191980831254437,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,1.7577358645689451,1.1813320130942304,6,0.48227677481595344,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,396.90247784911963,360.87681906085294,70.19879111813373,99.01516599320769,0.7733359630087833,1,467.10126896725336,459.8919850540606,513.8113958639788,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_7,1.684541528189702,0.6697216100290652,6,0.2734127023810718,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,396.90247784911963,345.8494535628582,70.19879111813373,56.13375042006644,0.5831586226924955,1,467.10126896725336,401.98320398292464,513.8113958639788,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,1.366144167335595,0.735034694351222,6,0.3000766574005145,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,205.3077634331321,280.48000352288955,35.245546160597875,61.60806738938985,0.32064566064425987,1,240.55330959372998,342.0880709122794,398.74941571268977,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_7,1,0.42050822801590754,6,0.17167176521348257,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,1.3692482171625837,0.9709560480384382,6,0.39639114672724085,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,205.3077634331321,281.1172890504536,35.245546160597875,81.38217977926432,0.42170287262994965,1,240.55330959372998,362.49946882971796,398.74941571268977,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_7,1.1359539893535455,0.1795246175071363,6,0.0732906181934673,leaf_1_log2-1,1,967514 MM WT,leaf,ns,205.3077634331321,233.22017291712035,35.245546160597875,15.047132901932393,0.4908428576646393,1,240.55330959372998,248.26730581905275,398.74941571268977,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,2.684354851901511,1.6569768462764423,6,0.6764579648305608,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1086.30495066497,551.1188909047758,355.0254296831319,138.88207181589078,0.2063214270018768,1,1441.330380348102,690.0009627206665,1585.4634183829123,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_7,5.291105082924812,4.235744103847575,6,1.7292352892381602,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,4.064828509980252,4.477983923767351,6,1.8281292816026826,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1086.30495066497,834.5408501232764,355.0254296831319,375.3291340724653,0.6365745740438162,1,1441.330380348102,1209.8699841957418,1585.4634183829123,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_7,2.297069072786401,1.1860892883621554,6,0.48421892431134983,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1086.30495066497,471.6061137851945,355.0254296831319,99.41390436236031,0.14839193771604578,1,1441.330380348102,571.0200181475548,1585.4634183829123,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,0.977426966349609,0.04701272427191841,6,0.01919286431405965,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,128.8243674230666,107.4746588814869,15.345759341781458,2.110384321414778,0.23774158702437598,1,144.17012676484805,109.58504320290169,158.58713944133288,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_79,1.171591628693461,0.31206971663329724,5,0.1395618200222299,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,0.9872050397268292,0.027866932493409137,6,0.011376627550906156,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,128.8243674230666,108.54982371416966,15.345759341781458,1.250936599203696,0.257419225018686,1,144.17012676484805,109.80076031337336,158.58713944133288,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_79,1.1543659178748256,0.23338063556724953,5,0.10437099315209503,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,128.8243674230666,126.93028483893438,15.345759341781458,11.47629160267224,0.9238841718831052,1,144.17012676484805,138.40657644160663,158.58713944133288,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,1.118786938815976,0.09303882635999916,6,0.037982941808233854,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,115.0844034525808,123.01813716003178,2.152213664238878,4.176479527059791,0.13238940939040963,1,117.23661711681967,127.19461668709158,143.84738987266036,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_79,1.046633694970368,0.04794455045197014,6,0.019573280759075242,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,1.1432728564217483,0.11271701143313574,6,0.04601652722377337,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,115.0844034525808,125.71052823648107,2.152213664238878,5.059826193210164,0.09609511064563138,1,117.23661711681967,130.77035442969122,143.84738987266036,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_79,1.0864167976445551,0.10218202182724748,6,0.041715635727114925,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,115.0844034525808,119.4588227558703,2.152213664238878,4.586914290425274,0.4161493642352204,1,117.23661711681967,124.04573704629557,143.84738987266036,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,1.0366267925904953,0.10609577797732504,6,0.04331341998467652,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,109.95671552102958,113.98407733435042,5.464244983955764,4.762601399497952,0.5928371371289956,1,115.42096050498535,118.74667873384837,130.62134660723322,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_79,0.9999999999999999,0.11112030012846758,5,0.04969450895348642,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,1.0052090038543977,0.058722958354685606,6,0.023973547359281023,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,109.95671552102958,110.52948047599553,5.464244983955764,2.636052527014393,0.9279472863442482,1,115.42096050498535,113.16553300300993,130.62134660723322,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_79,0.9620354660217058,0.0990323391456895,6,0.04042978315686524,fruit_1_log2-1,1,967514 MM WT,fruit,ns,109.95671552102958,105.78226005848981,5.464244983955764,4.445526165156346,0.5694578054125097,1,115.42096050498535,110.22778622364616,130.62134660723322,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,1.3265261713736902,0.04519199807823091,6,0.018449555958083955,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,136.09893195858092,145.86046085693738,6.1559164492465674,2.028652575972353,0.19393042502456015,1,142.2548484078275,147.88911343290974,175.411996529625,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_79,1.2377500665937184,0.12518605688701068,5,0.055984906606902314,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,1.3849814028177496,0.15989090349816404,6,0.06527518801384798,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,136.09893195858092,152.28800611154776,6.1559164492465674,7.1774452790204,0.12109431557206303,1,142.2548484078275,159.46545139056815,175.411996529625,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_79,1.2638389769217198,0.06440591326218387,6,0.026293603985050408,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,136.09893195858092,138.96758284977062,6.1559164492465674,2.891158333406799,0.6885226658527086,1,142.2548484078275,141.85874118317741,175.411996529625,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,1.021811322200736,0.050327243040118916,6,0.020546010934887896,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,240.87337315832247,248.8615238737326,3.958802596366331,5.003968423221385,0.24054331389595804,1,244.8321757546888,253.865492296954,279.2520415266494,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_79,0.9890124277899092,0.03981552311373716,6,0.01625461924510762,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,1.0118750741181322,0.03438721495498448,6,0.0140385217191858,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,240.87337315832247,246.44155671766458,3.958802596366331,3.4190733964922155,0.31265364861337347,1,244.8321757546888,249.8606301141568,279.2520415266494,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_79,1.0077705146629772,0.03527591827035098,6,0.014401333328413741,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,240.87337315832247,245.44189376752206,3.958802596366331,3.507435942482686,0.408242793628666,1,244.8321757546888,248.94932971000475,279.2520415266494,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,1.1161174573853803,0.06410203883100903,6,0.0261695477680076,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,262.45427409314215,271.82972553952146,9.500952101765945,6.373577386680596,0.4342841660211503,1,271.9552261949081,278.20330292620207,306.0236332188223,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_79,1.0776223847460507,0.09555550417128374,6,0.03901037122233912,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,1.0906567663233648,0.06388011489908955,6,0.02607894770218846,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,262.45427409314215,265.6287897709445,9.500952101765945,6.35151179594683,0.7876562515931619,1,271.9552261949081,271.9803015668913,306.0236332188223,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_79,1.0826064005365692,0.047902841680002035,6,0.019556253224221918,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,262.45427409314215,263.6681280969986,9.500952101765945,4.762913536873467,0.9121207885023586,1,271.9552261949081,268.43104163387204,306.0236332188223,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,1.0409084571001141,0.0300987954384951,6,0.012287781782787143,leaf_1_panK4-1,1,967514 MM WT,leaf,*,243.54938966397899,253.5126194228069,2.4108377240581493,2.9926817535219716,0.027745258726047328,0.6658862094251359,245.96022738803714,256.5053011763289,282.1558312939618,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_79,1,0.02424691880666443,6,0.009898763151836843,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,1.0234698221820773,0.07272539607804612,6,0.02969001862216966,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,243.54938966397899,249.26545053194602,2.4108377240581493,7.230985914541593,0.4812275441058471,1,245.96022738803714,256.4964364464876,282.1558312939618,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_79,1.0137297627248842,0.07007162634762616,6,0.028606621666440964,leaf_1_log2-1,1,967514 MM WT,leaf,ns,243.54938966397899,246.89326499585582,2.4108377240581493,6.967125247210056,0.6656341908992611,1,245.96022738803714,253.86039024306586,282.1558312939618,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,1.082144119185256,0.09431641773658697,6,0.0385045163036372,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,265.16216253369726,263.5555397560333,4.915774644308353,9.377751445057566,0.8833660060486264,1,270.0779371780056,272.93329120109087,323.68616983088384,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_79,1.088740821315697,0.04944023709392129,6,0.020183892273721436,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,1.147036870675456,0.14985649323939743,6,0.06117865717989345,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,265.16216253369726,279.36012977508767,4.915774644308353,14.900024616624854,0.3999735599151061,1,270.0779371780056,294.26015439171255,323.68616983088384,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_79,1.0868981128281976,0.027481326734701314,6,0.011219204659120668,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,265.16216253369726,264.7133720062381,4.915774644308353,2.732430447244108,0.93840272164038,1,270.0779371780056,267.4458024534822,323.68616983088384,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,1.9786008865670057,1.3359704373908008,6,0.5454076471750539,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,24341.25906786465,10790.502943205689,12746.519688117112,2974.4365637582077,0.3536297224298782,1,37087.77875598176,13764.939506963896,40796.55663157994,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_89,4.463335678172393,5.226285554611063,5,2.3372659539871052,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,1.5345223961622976,0.4429909300875304,6,0.18085028989923096,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,24341.25906786465,8368.675332463807,12746.519688117112,986.2856115581583,0.27890275895079225,1,37087.77875598176,9354.960944021965,40796.55663157994,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_89,2.9785262309285656,5.077806601387659,5,2.270864147459996,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,24341.25906786465,16243.698402973305,12746.519688117112,12384.390623266581,0.6607757398159377,1,37087.77875598176,28628.089026239886,40796.55663157994,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,4.087764395338415,3.7507289912131916,6,1.531228698656035,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,10542.092483765766,22293.042542582945,2068.40267131752,8350.712815173612,0.22417690207453367,1,12610.495155083285,30643.755357756556,33708.130893532216,0,23,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_89,1.933051095434255,0.9290246277798913,6,0.3792727160899673,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,2.0052136068742277,0.7056327761767797,6,0.28807337456944,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,10542.092483765766,10935.638143918166,2068.40267131752,1571.037705104894,0.8827952442687517,1,12610.495155083285,12506.67584902306,33708.130893532216,0,23,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_89,1.8487568574026763,0.5660708272261995,5,0.2531545699514641,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,10542.092483765766,10082.385207907215,2068.40267131752,1380.6044213832593,0.8577424273150334,1,12610.495155083285,11462.989629290474,33708.130893532216,0,23,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,0.6857974424759804,0.2535098554956264,6,0.10349496512183043,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,5453.602601951663,3740.066716698803,1102.8507421581069,564.4204110773111,0.21559667442479055,1,6556.45334410977,4304.487127776114,7212.098678520748,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_89,1,0.4521871886336388,5,0.20222425846786732,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,0.997441056271222,0.4706900529701911,6,0.19215840946342566,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,5453.602601951663,5439.647139774152,1102.8507421581069,1047.9556018366313,0.9928863671127753,1,6556.45334410977,6487.602741610783,7212.098678520748,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_89,0.5971507918219029,0.22989815018668908,6,0.09385552679452025,fruit_1_log2-1,1,967514 MM WT,fruit,ns,5453.602601951663,3256.623112037426,1102.8507421581069,511.8507451341397,0.12339569328756876,1,6556.45334410977,3768.4738571715657,7212.098678520748,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,7.734770775466211,2.334797220068046,6,0.9531769736725596,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,44343.62828894802,42182.36602658221,7139.39059847449,5198.248423741084,0.8131074681831097,1,51483.01888742251,47380.61445032329,101248.91385732123,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_89,8.131070693174252,2.92726915789552,5,1.3091145650985896,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,15.393771076135538,3.6349578380707688,6,1.483965323300611,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,44343.62828894802,83951.50999466103,7139.39059847449,8092.957148358251,0.0051555109803408964,0.12373226352818151,51483.01888742251,92044.46714301928,101248.91385732123,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_89,10.633146652016672,3.188374343911165,6,1.301648375260574,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,44343.62828894802,57988.95624837174,7139.39059847449,7098.672966147222,0.2087879748921613,1,51483.01888742251,65087.62921451896,101248.91385732123,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,1.641099123951171,0.6465552596794019,6,0.26395507945453484,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,68731.01767022567,105314.84673772214,12284.973237248538,16938.884636943305,0.11389810098477127,1,81015.99090747422,122253.73137466544,141942.48552976386,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_89,1.0710210039785266,0.4689160019568481,6,0.1914341561700327,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,1.7096525032580914,0.7376129936964031,6,0.30112924370048877,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,68731.01767022567,109714.14750492919,12284.973237248538,19324.475703947024,0.10918533021323568,1,81015.99090747422,129038.62320887622,141942.48552976386,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_89,1.7106673576325013,0.7061791457366469,6,0.2882964290082173,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,68731.01767022567,109779.27412119646,12284.973237248538,18500.950852336435,0.09878185149191539,1,81015.99090747422,128280.2249735329,141942.48552976386,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,2.210314906099726,0.9181762730291635,6,0.37484389380863714,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,111139.06279218901,141843.33668861393,14133.326681650136,24054.99256619077,0.3027901428508803,1,125272.38947383915,165898.3292548047,219835.52976703257,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_89,1.7318566587220439,0.5394674383021898,6,0.2202366594477885,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,2.3810232414470422,0.42148502730390475,6,0.17207054185293374,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,111139.06279218901,152798.26434141136,14133.326681650136,11042.345022821246,0.043997942773937836,0.9679547410266324,125272.38947383915,163840.6093642326,219835.52976703257,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_89,2.758831215223573,0.8705409128784697,6,0.355396839461486,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,111139.06279218901,177043.4718818113,14133.326681650136,22807.009724581927,0.03835742795047626,0.8822208428609539,125272.38947383915,199850.48160639324,219835.52976703257,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,1.2592796127288468,0.2478699917900478,6,0.10119250040557878,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,64173.361133824874,80812.20535611142,9780.050581406758,6493.862872561926,0.19122543332228298,1,73953.41171523163,87306.06822867334,116496.21582565819,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_89,1,0.373303395050467,6,0.15240047285370928,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,1.4023662002805242,0.5248073506802163,6,0.2142517037380674,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,64173.361133824874,89994.55261247186,9780.050581406758,13749.251957520255,0.1601832396527476,1,73953.41171523163,103743.80456999212,116496.21582565819,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_89,1.4279751939912755,0.5445958009467932,6,0.22233030473032656,leaf_1_log2-1,1,967514 MM WT,leaf,ns,64173.361133824874,91637.96781414576,9780.050581406758,14267.682936452584,0.14738147672494578,1,73953.41171523163,105905.65075059835,116496.21582565819,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,2.417649743501783,0.7830948777861843,6,0.3196971451272175,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,261063.91404717226,155148.71008483903,64316.94512787667,20516.040347701746,0.16766629626463384,1,325380.85917504894,175664.75043254078,453469.99274553655,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_89,4.068104107914166,2.4549703271634207,6,1.002237439203977,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,4.608511242661204,4.4468598606728715,6,1.815422936052072,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,261063.91404717226,295743.65626458946,64316.94512787667,116501.79168589828,0.8011579390228378,1,325380.85917504894,412245.4479504877,453469.99274553655,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_89,2.878259261264266,0.8682313353569892,6,0.3544539583866478,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,261063.91404717226,184707.57100988773,64316.94512787667,22746.501876860082,0.3043102000591047,1,325380.85917504894,207454.0728867478,453469.99274553655,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,1.6314593998228133,0.49031265474222574,6,0.20016930309131198,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,88.65323973882525,129.61898535134435,15.19957977413323,15.90339420521249,0.09562528268488406,1,103.85281951295848,145.52237955655684,229.4901701274807,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_97,1.115840869334129,0.42778370371535496,5,0.1913106882348326,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,1.9485409018011386,1.0545531384310085,6,0.4305195159677607,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,88.65323973882525,154.81102050991126,15.19957977413323,34.20465310981912,0.12149336535940242,1,103.85281951295848,189.01567361973036,229.4901701274807,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_97,2.117001350511109,1.1379437708947329,5,0.5089039252586138,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,88.65323973882525,168.19515525208755,15.19957977413323,40.43227213653124,0.12367322236590997,1,103.85281951295848,208.6274273886188,229.4901701274807,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,1.399838537266693,0.39779592022519117,6,0.16239950438543355,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,75.16000097668704,111.21677369104307,9.53632409387356,12.902594439240879,0.050587475445037174,1,84.6963250705606,124.11936813028396,172.08847530543463,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_97,0.946007174425364,0.2940114746961919,6,0.12002968192147967,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,1.626595742312855,0.8389493649012634,6,0.3424996440066844,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,75.16000097668704,129.23256914533536,9.53632409387356,27.21149931415063,0.10821695663298307,1,84.6963250705606,156.444068459486,172.08847530543463,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_97,1.514061654339776,0.330693268848315,6,0.13500496167523127,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,75.16000097668704,120.29176785901855,9.53632409387356,10.726105811545864,0.010599031460999817,0.2543767550639956,84.6963250705606,131.01787367056443,172.08847530543463,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,0.8998536211029073,0.17115124945624446,6,0.06987220500126598,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,79.44971561377609,71.49311429065261,15.112049812857602,5.551326816658046,0.641787624136066,1,94.5617654266337,77.04444110731066,118.77545780513486,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,1,967514 MM WT,MoneyMaker,m_97,0.9999999999999999,0.4253202217259205,5,0.19020898559688823,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,1.2122191754557838,0.3597084759007243,6,0.14685037035183238,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,79.44971561377609,96.31046875152818,15.112049812857602,11.667220162230777,0.4031245067509368,1,94.5617654266337,107.97768891375895,118.77545780513486,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_97,0.7058639622717009,0.15312430163656574,6,0.06251273437160088,fruit_1_log2-1,1,967514 MM WT,fruit,ns,79.44971561377609,56.08069106449982,15.112049812857602,4.966618968063215,0.20332234608769423,1,94.5617654266337,61.04731003256303,118.77545780513486,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,1.4711740992975395,0.2958625907689663,6,0.12078539689364001,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,243.8821830174072,116.88436380754271,68.82043204807117,9.596365433496773,0.13892052410037148,1,312.70261506547837,126.48072924103948,381.1456194274577,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_97,3.069641988436765,1.936912714055192,5,0.8662136990222044,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,3.314270886893535,2.5644395935933084,6,1.046928080082312,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,243.8821830174072,263.31787943070884,68.82043204807117,83.1781382306163,0.8611397393818065,1,312.70261506547837,346.49601766132514,381.1456194274577,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_97,3.228134969814166,1.976651728548071,6,0.8069646890221899,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,243.8821830174072,256.47440531462115,68.82043204807117,64.11311505317225,0.896541406635435,1,312.70261506547837,320.5875203677934,381.1456194274577,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,2.6106984152655244,2.6540299621477246,6,1.0835031948866798,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,142.38458126721986,110.61995037775387,41.666550010911735,45.90996376742048,0.619636977238387,1,184.0511312781316,156.52991414517436,238.65532785188077,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_97,3.360363111745991,2.4087205276071533,6,0.9833560376008346,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,1.526255763872769,0.5378577706846552,6,0.21957951539471499,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,142.38458126721986,64.67018016180741,41.666550010911735,9.303975884347476,0.12305536026542115,1,184.0511312781316,73.97415604615489,238.65532785188077,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_97,3.4731387140609877,4.034886271875729,6,1.6472354227093762,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,142.38458126721986,147.16308477377575,41.666550010911735,69.79630418247947,0.9545368804950733,1,184.0511312781316,216.95938895625522,238.65532785188077,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,3.3761926846466928,3.814361842336781,6,1.557206701344582,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,103.88139588397615,143.05530851726823,18.90195609817099,65.98162661125441,0.5895247925978242,1,122.78335198214714,209.03693512852266,229.94062864137493,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_97,2.4516644121041584,1.0927117712810468,6,0.44609771259522707,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,2.0322953101807077,0.87242331226066006,6,0.35616532579123544,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,103.88139588397615,86.1119787144265,18.90195609817099,15.091360394186275,0.48023149360076445,1,122.78335198214714,101.20333910861277,229.94062864137493,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_97,2.889362438385581,1.7173021296615196,6,0.7010856586442666,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,103.88139588397615,122.42744228465448,18.90195609817099,29.706250372046874,0.6118831985492581,1,122.78335198214714,152.13369265670136,229.94062864137493,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,1.8221020548148972,1.7831649788529131,6,0.7279740542317323,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,42.37178439720435,77.20571541631985,16.836480380605856,30.845559672665708,0.3515483966179766,1,59.20826477781021,108.05127508898556,143.3703373965107,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,1,967514 MM WT,MoneyMaker,m_97,1,0.9733077467368896,6,0.39735122370056974,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,2.472001855234301,1.0732321499563615,6,0.4381451904905409,leaf_1_transp1-1,1,967514 MM WT,leaf,*,42.37178439720435,104.74312963947695,16.836480380605856,18.564993546137227,0.032271056731781184,0.7422343048309672,59.20826477781021,123.30812318561418,143.3703373965107,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_97,2.3667330756994835,1.7374034238655311,6,0.7092919776391655,leaf_1_log2-1,1,967514 MM WT,leaf,ns,42.37178439720435,100.28270360927085,16.836480380605856,30.053966751193414,0.1319418065260559,1,59.20826477781021,130.33667036046427,143.3703373965107,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,3.2769114769246084,1.7979557509610922,6,0.734012361659537,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,158.54028310382807,138.848586588974,36.43878682961163,31.101413533120688,0.6899233462257766,1,194.9790699334397,169.95000012209468,392.8929561189861,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_97,3.7416475458675373,2.1065063897683167,6,0.8599776324741193,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,3.4421941016462068,2.3161260201695395,6,0.9455544882330853,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,158.54028310382807,145.85190632828161,36.43878682961163,40.06483091122119,0.8195293942104889,1,194.9790699334397,185.91673723950282,392.8929561189861,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_97,5.830144807310835,6.36723598245535,6,2.599413204817392,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,158.54028310382807,247.03363877985518,36.43878682961163,110.14177587376852,0.4741277740032942,1,194.9790699334397,357.1754146536237,392.8929561189861,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.9753151393462965,0.1732684084808874,6,0.07073653155371659,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,146.49153813784983,144.20522537143546,9.212241858892028,10.458750267666591,0.8733240503731992,1,155.70377999674184,154.66397563910206,283.6433539395536,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_123,0.9907783477607008,0.1393202681281191,5,0.062305918035594335,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,1.108717704148333,0.23429346234220833,6,0.09564990546806602,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,146.49153813784983,163.92946233478145,9.212241858892028,14.142317306818224,0.33075642888959467,1,155.70377999674184,178.07177964159968,283.6433539395536,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_123,1.4558308577082597,0.6443425731126456,5,0.28815875885540077,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,146.49153813784983,215.25187959167812,9.212241858892028,42.60571489882511,0.18377616454989856,1,155.70377999674184,257.85759449050323,283.6433539395536,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,1.8301334733648864,1.7291950685324338,6,0.7059409306069085,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,132.69697966006234,270.594394918631,20.20021180856966,104.37690023485298,0.24749826147478496,1,152.897191468632,374.971295153484,412.4684246688324,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_123,0.8974804683715887,0.3346536117100133,6,0.13662176487817035,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,1.2445591020239124,0.1841780187815712,6,0.0751903613085977,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,132.69697966006234,184.0142929758277,20.20021180856966,11.117271290932068,0.057629210263798046,1,152.897191468632,195.13156426675977,412.4684246688324,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_123,1.6346282271731596,1.6679870266232257,6,0.6809528521348339,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,132.69697966006234,241.6879656518074,20.20021180856966,100.68228775290194,0.3336510497354217,1,152.897191468632,342.37025340470933,412.4684246688324,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.96980069583112,0.22553404396189095,6,0.09207388788884371,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,147.8550055811589,143.38988729472206,21.608779187098346,13.613585207683988,0.8662089344672539,1,169.46378476825726,157.00347250240605,189.40910901898607,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_123,1,0.32679785836950914,5,0.1461484452431142,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,1.004282136232294,0.39266647341587657,6,0.16030541649450553,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,147.8550055811589,148.48814085768402,21.608779187098346,23.70195825048512,0.9846816293278182,1,169.46378476825726,172.19009910816914,189.40910901898607,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_123,1.0123040074472027,0.19289211641415363,6,0.07874787677003468,fruit_1_log2-1,1,967514 MM WT,fruit,ns,147.8550055811589,149.6742146709357,21.608779187098346,11.643267759337888,0.9432388079406764,1,169.46378476825726,161.31748243027357,189.40910901898607,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,1.1513589530515547,0.6341003876660091,6,0.258870399247121,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,449.1976332776138,170.23418442935488,360.6977123937079,38.275284325479916,0.48385230973341564,1,809.8953456713217,208.5094687548348,890.884880238454,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_123,3.038095541723444,5.4549698948019705,5,2.4395366999984165,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,0.8190740082058998,0.3749633516041687,6,0.1530781472790023,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,449.1976332776138,121.10419205466552,360.6977123937079,22.63337032029035,0.41494461538700245,1,809.8953456713217,143.73756237495587,890.884880238454,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_123,0.6395983631371,0.2489676991360044,6,0.10164063755299518,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,449.1976332776138,94.56781955133602,360.6977123937079,15.028077032670653,0.38137735977992293,1,809.8953456713217,109.59589658400667,890.884880238454,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,1.9231610393326846,0.89328130198169,6,0.36468056443735875,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,154.13281223721808,177.3138188344072,34.085385822860964,33.62323914252781,0.6386991942923135,1,188.21819806007903,210.937057976935,240.19338851042977,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_123,1.6717378336666788,0.9055593275034,6,0.36969304736686853,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,2.148416060657605,0.5386664707962369,6,0.2199096658327661,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,154.13281223721808,198.08214100081634,34.085385822860964,20.27548491775616,0.29944379823342165,1,188.21819806007903,218.3576259185725,240.19338851042977,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_123,1.9693550746942057,0.8045511062020515,6,0.32845661369779744,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,154.13281223721808,181.57286976659802,34.085385822860964,30.28342156743292,0.5608703346778565,1,188.21819806007903,211.85629133403094,240.19338851042977,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,2.6703712614606463,1.2014255357109054,6,0.490479921073608,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,261.16782414230795,246.20596839853695,32.89807659567065,45.22183326745081,0.7949908929791247,1,294.0659007379786,291.4278016659878,333.8826577612567,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_123,2.8326488449659024,0.8740156345289192,6,0.35681538863511975,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,2.75721908436121,1.3102080956134217,6,0.534890215186093,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,261.16782414230795,254.2132641064911,32.89807659567065,49.3164247673786,0.9092715220192289,1,294.0659007379786,303.5296888738697,333.8826577612567,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_123,3.0282194214819045,0.5929984691317258,6,0.24209061127071493,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,261.16782414230795,279.19926564121215,32.89807659567065,22.320549299013095,0.6611250223721389,1,294.0659007379786,301.5198149402253,333.8826577612567,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,2.2682414294611544,1.1716802464447211,6,0.47833645758133514,leaf_1_panK4-1,1,967514 MM WT,leaf,*,92.19915296117537,209.12993850776405,15.325111171239467,44.102216219448295,0.04504892705263391,1,107.52426413241484,253.23215472721233,303.0968992288255,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_123,1,0.4071480205113201,6,0.16621748333949227,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,1.9820798103411421,0.9728805870182622,6,0.3971768364756851,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,92.19915296117537,182.74607961490042,15.325111171239467,36.619367898857426,0.05820743987375596,1,107.52426413241484,219.36544751375786,303.0968992288255,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_123,2.7361409297242365,0.6182961990061088,6,0.2524183662445484,leaf_1_log2-1,1,967514 MM WT,leaf,*,92.19915296117537,252.2698761029775,15.325111171239467,23.2727595595911,3.2292832860983866e-4,0.007750279886636128,107.52426413241484,275.5426356625686,303.0968992288255,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,2.3657271279252754,0.8842916030586504,6,0.361010535220243,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,304.86585603148745,218.11803733198457,30.489782946877565,33.28486555736697,0.08378316572222108,1,335.355638978365,251.40290288935154,368.89120287620153,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_123,3.3066014842876594,0.8100335869626838,6,0.3306948270958266,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,2.874798556565519,1.0886182017105543,6,0.44442651981617864,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,304.86585603148745,265.0539918493505,30.489782946877565,40.9757486805347,0.4552018899208774,1,335.355638978365,306.0297405298852,368.89120287620153,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_123,2.969328150506425,0.8642301777517141,6,0.3528204926344178,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,304.86585603148745,273.7695403404658,30.489782946877565,32.52975056823793,0.5014714892830039,1,335.355638978365,306.29929090870377,368.89120287620153,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.9296840849680749,0.5832182439941442,6,0.23809785107794554,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,79532.364127079,50849.93353699915,18955.515427275448,13022.982858775744,0.25057692761508166,1,98487.87955435444,63872.9163957749,126784.2175293852,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_44,1.4540820021924192,0.7749355901159295,5,0.3465617315366265,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.6970114101152922,0.32072766974022854,6,0.13093652287590676,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,79532.364127079,38123.685725038275,18955.515427275448,7161.6945943893015,0.09489972457144522,1,98487.87955435444,45285.380319427575,126784.2175293852,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_44,1.3245368505789359,1.7502155824837995,5,0.7827202035426332,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,79532.364127079,72446.77187472551,18955.515427275448,42811.60769744284,0.8850975294358807,1,98487.87955435444,115258.37957216836,126784.2175293852,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,2.003927605231645,2.081253968111377,6,0.849668374502601,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,69848.89080575254,109606.67950176453,12127.749491211818,46473.4000189226,0.44119356436540974,1,81976.64029696435,156080.07952068714,171688.08747275587,0,23,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_44,1.2770400592073856,0.5431263204880205,6,0.22173039184516255,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,1.053290912264003,0.6690796820524554,6,0.2731506363820199,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,69848.89080575254,57610.723631553825,12127.749491211818,14940.227471024959,0.5396622052659206,1,81976.64029696435,72550.95110257878,171688.08747275587,0,23,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_44,0.7797873745141771,0.506478306308762,5,0.22650398440707048,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,69848.89080575254,42651.19389281426,12127.749491211818,12388.845565061534,0.15174135643288264,1,81976.64029696435,55040.0394578758,171688.08747275587,0,23,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.7711964820846852,0.2259146078514467,6,0.09222925244616713,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,54695.927744901994,42181.307061226544,10263.966494484275,5044.564527761882,0.3165545751502769,1,64959.89423938627,47225.871588988426,73260.87020040711,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_44,1,0.419609425174916,5,0.18765503973814474,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.9897824532631171,0.5581724149989831,6,0.22787293420742075,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,54695.927744901994,54137.069546851286,10263.966494484275,12463.721544427892,0.9731489033140024,1,64959.89423938627,66600.79109127918,73260.87020040711,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_44,0.9520326735289708,0.22208884319240296,6,0.09066739056439546,fruit_1_log2-1,1,967514 MM WT,fruit,ns,54695.927744901994,52072.310322126454,10263.966494484275,4959.137043128984,0.8258298678866002,1,64959.89423938627,57031.44736525544,73260.87020040711,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,4.066401195781932,1.3519160269329396,6,0.5519174068460704,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,192060.23236008408,222415.5859862716,38083.560295550684,30187.63460600634,0.5494787876726239,1,230143.79265563475,252603.22059227794,461241.94565213,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_44,3.511417399405668,1.5569244943285658,5,0.6962778010306317,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,6.7520763725390225,2.2391784744485337,6,0.9141407842370948,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,192060.23236008408,369311.08140045434,38083.560295550684,49999.778283300184,0.020508390861131973,0.47169298980603536,230143.79265563475,419310.8596837545,461241.94565213,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_44,3.6824079777736296,1.4262587691256712,6,0.5822677042546488,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,192060.23236008408,201412.7206795571,38083.560295550684,31847.672280102233,0.8550967411284532,1,230143.79265563475,233260.39295965934,461241.94565213,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,2.0138617335591773,0.8800133638406346,6,0.3592639513732926,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,150322.29374910297,195772.7448046761,46900.62688175075,34924.98451987513,0.45644551326979665,1,197222.92063085374,230697.72932455124,291706.8100476143,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_44,1.5463251301103975,1.1817665489574147,6,0.4824541733392437,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,1.9297470644741312,0.7202738757739482,6,0.2940505784504952,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,150322.29374910297,187595.7387219332,46900.62688175075,28585.42267095745,0.5159285988980875,1,197222.92063085374,216181.16139289064,291706.8100476143,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_44,2.3440424098920016,0.9402991869975675,6,0.3838755356163172,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,150322.29374910297,227870.4684020652,46900.62688175075,37317.54073212954,0.22622301020711716,1,197222.92063085374,265188.00913419476,291706.8100476143,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,4.1942751308263295,1.3661981835990493,6,0.5577480728891467,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,435369.2858404519,407736.4106703871,50302.39775287875,54220.142981736724,0.7165314162727827,1,485671.6835933307,461956.55365212384,611545.5948907583,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_44,4.478527108540246,1.2674818003303348,6,0.5174472781789186,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,5.075226101826048,1.5767072645543754,6,0.6436880453162777,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,435369.2858404519,493375.94925288606,50302.39775287875,62574.591556894185,0.4872892572091536,1,485671.6835933307,555950.5408097802,611545.5948907583,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_44,3.9038615654076074,0.7671659367378824,6,0.3131941821753486,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,435369.2858404519,379504.5515099007,50302.39775287875,30446.42225410357,0.3691257493299521,1,485671.6835933307,409950.9737640043,611545.5948907583,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,1.6126417458577673,0.6420470283081391,6,0.26211460170420126,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,97212.60478924697,156769.1047067124,25827.71977625757,25480.8431849614,0.1317293500344712,1,123040.32456550453,182249.94789167377,303273.25690392713,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_44,1,0.6507873624883991,6,0.2656828281913753,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,1.862527125416398,0.47488758660672936,6,0.19387204539470698,leaf_1_transp1-1,1,967514 MM WT,leaf,*,97212.60478924697,181061.1133523565,25827.71977625757,18846.806528638594,0.02733581294838298,0.6013878848644256,123040.32456550453,199907.9198809951,303273.25690392713,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_44,2.4890742695153287,0.849992939959903,6,0.3470081646449834,leaf_1_log2-1,1,967514 MM WT,leaf,*,97212.60478924697,241969.3932534772,25827.71977625757,33733.56756827472,0.007350587453146781,0.17641409887552273,123040.32456550453,275702.9608217519,303273.25690392713,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,3.852376186574254,1.249568292302789,6,0.5101341191504624,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,520758.58072309656,374499.5237249493,58468.97701071167,49591.46651448452,0.08631002496046714,1,579227.5577338082,424090.9902394338,637150.313507189,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_44,5.356903889697024,1.4732570922182064,6,0.6014546893118446,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,4.126493855902416,1.8339449514651547,6,0.7487048912404817,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,520758.58072309656,401147.2163790973,58468.97701071167,72783.55269593708,0.23034470730582446,1,579227.5577338082,473930.7690750344,637150.313507189,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_44,4.549204691936516,1.231544358131908,6,0.502775878837767,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,520758.58072309656,442240.03782261244,58468.97701071167,48876.152807022154,0.32787158749570966,1,579227.5577338082,491116.1906296346,637150.313507189,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.8425868218804139,0.402201681442064,6,0.16419814887041384,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,100.92285155092736,80.99889302799234,27.882744658975327,15.784567180943437,0.5553971354567719,1,128.8055962099027,96.78346020893578,149.06832289528836,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_72,1.0498447764467234,0.6485688745435301,5,0.2900488183139732,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,1.1873820066731642,0.5445780425524752,6,0.22232305489620488,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,100.92285155092736,114.14447228980352,27.882744658975327,21.372184887731347,0.7165655156778592,1,128.8055962099027,135.51665717753485,149.06832289528836,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_72,0.5815850004401272,0.3585374714070088,5,0.16034283170939176,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,100.92285155092736,55.9084714050045,27.882744658975327,15.413950866748419,0.20560018768086719,1,128.8055962099027,71.32242227175291,149.06832289528836,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,1.2689332689546244,0.47818477760201167,6,0.1952181179818638,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,154.30284514237644,121.98409403358062,36.906141399236986,18.766554430853887,0.4592120053123211,1,191.20898654161343,140.7506484644345,210.32988519577478,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_72,1.6051274163794973,0.9403939909250323,6,0.38391423915763395,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.8657276560899073,0.20070269421659503,6,0.08193653180541638,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,154.30284514237644,83.22344948441801,36.906141399236986,7.876658170347639,0.11349051023236834,1,191.20898654161343,91.10010765476565,210.32988519577478,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_72,0.9581883780882325,0.3211306133821871,6,0.13110102392888964,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,154.30284514237644,92.11181082113994,36.906141399236986,12.602900422033334,0.1606837553041385,1,191.20898654161343,104.71471124317327,210.32988519577478,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.9126850980246553,0.3304153364218119,6,0.13489149623724692,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,96.13121274223809,87.73752532487856,13.997748142591036,12.96728312190159,0.6707480987366619,1,110.12896088482913,100.70480844678015,176.7225299729455,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_72,1,0.32559577150744123,5,0.14561085565542556,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,1.3976041471438512,0.6702304383438665,6,0.27362043067072905,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,96.13121274223809,134.35338159851977,13.997748142591036,26.303463831430662,0.23786965377423208,1,110.12896088482913,160.65684542995044,176.7225299729455,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_72,0.9966938892793339,0.43717554986188495,6,0.17847617086371384,fruit_1_log2-1,1,967514 MM WT,fruit,ns,96.13121274223809,95.81339230920034,13.997748142591036,17.157130750719713,0.9888638335649582,1,110.12896088482913,112.97052305992005,176.7225299729455,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,1.6049635694049313,0.6599936975693401,6,0.26944129874960693,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,224.19809380208912,154.28709433400726,55.70944547442985,25.901718811643395,0.3006815577560726,1,279.90753927651895,180.18881314565067,323.05135943483566,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_72,2.3322091483776846,1.2958341366571526,5,0.5795146434260291,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,2.5715700932817267,1.1842126325542408,6,0.48345278278597964,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,224.19809380208912,247.20815171884271,55.70944547442985,46.474902312826025,0.7589592743937921,1,279.90753927651895,293.68305403166875,323.05135943483566,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_72,1.260948291900118,0.4311403670339485,6,0.17601231779157192,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,224.19809380208912,121.21648850561199,55.70944547442985,16.92027756687602,0.14037459088543874,1,279.90753927651895,138.136766072488,323.05135943483566,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,1.1193002371131957,0.3878824832581386,6,0.15835236069101308,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,400.8957323197124,549.3609772667938,47.01565764889891,77.720529967976,0.1397598026257746,1,447.91138996861133,627.0815072347698,689.7896579582468,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_72,0.8168084498386257,0.23464263622988166,6,0.09579245511078328,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.8762589995425503,0.3584783854329818,6,0.14634818802126062,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,400.8957323197124,430.0745093819147,47.01565764889891,71.828791710024,0.7420745199008808,1,447.91138996861133,501.9033010919387,689.7896579582468,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_72,0.8951357414679254,0.41639190585903363,6,0.16999128372994027,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,400.8957323197124,439.33935633529603,47.01565764889891,83.43300095921677,0.6987678043622405,1,447.91138996861133,522.7723572945129,689.7896579582468,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.8164097158188499,0.16116529304563298,6,0.06579545536798719,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,308.13689831179255,400.7000306629894,48.74576699102877,32.29290449709405,0.14911512098652924,1,356.88266530282135,432.99293516008345,591.4257524492755,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_72,0.6278161675400846,0.243277151565919,6,0.09931748123570454,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.911973034807088,0.38010965037389266,6,0.15517911495395836,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,308.13689831179255,447.60322657907096,48.74576699102877,76.16307708677931,0.15932792760107548,1,356.88266530282135,523.7663036658503,591.4257524492755,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_72,0.9890290977284438,0.2607002327069046,6,0.1064304243261251,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,308.13689831179255,485.42292198089245,48.74576699102877,52.23685297299427,0.03257319590130056,0.7491835057299129,356.88266530282135,537.6597749538868,591.4257524492755,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,1.1484964642665725,0.18328975711224846,6,0.07482773000061212,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,490.807523353751,563.6907052072163,31.75080086381418,36.7260128397836,0.16481705595517915,1,522.5583242175652,600.4167180469999,858.9734665707706,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_72,1,0.15845979806835359,6,0.0646909416686543,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.9274635986002182,0.20269221982090113,6,0.08274875223220843,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,490.807523353751,455.2061118297305,31.75080086381418,40.613710143703386,0.5064275670231885,1,522.5583242175652,495.8198219734339,858.9734665707706,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_72,1.465797584476805,0.30673293785176825,6,0.12522319750694275,leaf_1_log2-1,1,967514 MM WT,leaf,*,490.807523353751,719.4244821749712,31.75080086381418,61.460487434820166,0.01182947355078974,0.28390736521895377,522.5583242175652,780.8849696097914,858.9734665707706,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.469075698360535,0.11864826614411311,6,0.048437951819835616,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,279.1508889906329,230.22588177776532,27.87764715085642,23.773711169021844,0.21207582148130413,1,307.0285361414893,253.99959294678717,413.3722276960636,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_72,0.5687583741242574,0.13912991855207182,6,0.05679955140125983,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.6393540281325245,0.30939140068722715,6,0.12630851041478056,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,279.1508889906329,313.7997670939688,27.87764715085642,61.993167175179906,0.6260292665489965,1,307.0285361414893,375.7929342691487,413.3722276960636,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_72,0.5982785301074751,0.23721270811571363,6,0.09684168256454342,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,279.1508889906329,293.6396036377724,27.87764715085642,47.53062637691368,0.7991809163885718,1,307.0285361414893,341.17023001468607,413.3722276960636,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.9525612993840218,0.26182490133868086,6,0.10688956837238607,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,161.42864013408035,125.24024604535403,38.83329677869409,14.053558391775951,0.42062361057910386,1,200.26193691277444,139.29380443712998,220.2881306040519,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_71,1.2278055981160345,0.6604474761313842,5,0.29536109043958897,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.9704508385893383,0.20956342402780348,6,0.08555390960310441,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,161.42864013408035,127.59231545354926,38.83329677869409,11.248402276854566,0.44331652701373875,1,200.26193691277444,138.84071773040384,220.2881306040519,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_71,1.2162616648947733,0.5392730736599207,5,0.2411702502277668,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,161.42864013408035,159.91087425602421,38.83329677869409,31.708428105232503,0.9766191966056494,1,200.26193691277444,191.61930236125673,220.2881306040519,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,1.2804544013411205,0.4522450498915763,6,0.18462826848898048,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,168.24207082530216,168.3507658536189,29.273101114060356,24.274437547945862,0.9977775552855612,1,197.51517193936252,192.62520340156476,217.2666891332988,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_71,1.279627680852465,0.5453726805270367,6,0.22264746449085726,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,1.0412207572211494,0.3347865069249577,6,0.13667601912248223,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,168.24207082530216,136.8969576091661,29.273101114060356,17.969802336572137,0.38721400304750353,1,197.51517193936252,154.86675994573824,217.2666891332988,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_71,1.0811302872265294,0.2116169138767908,6,0.08639224332343838,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,168.24207082530216,142.14415730188966,29.273101114060356,11.358624182227622,0.4354708704687541,1,197.51517193936252,153.5027814841173,217.2666891332988,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.9034591401429694,0.10340923915990524,6,0.042216645105200075,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,131.47736122215045,118.78442371803064,18.812179957294028,5.55053309808372,0.5478201421797799,1,150.28954117944448,124.33495681611436,165.31849529738895,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_71,1,0.3199433940447966,5,0.14308303560723332,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.9139058329132613,0.21704868551314216,6,0.08860975480816892,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,131.47736122215045,120.15792731696713,18.812179957294028,11.65017674071981,0.6250333265701482,1,150.28954117944448,131.80810405768693,165.31849529738895,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_71,0.9173971507587017,0.12948821181280232,6,0.052863341107799146,fruit_1_log2-1,1,967514 MM WT,fruit,ns,131.47736122215045,120.61695657447342,18.812179957294028,6.950332594239862,0.6109937372887401,1,150.28954117944448,127.56728916871329,165.31849529738895,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,2.226299395610883,0.7043130027408574,6,0.28753457932042514,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,499.2222044164429,292.70796982538735,159.31570841435484,37.80428774917061,0.2692714876439098,1,658.5379128307977,330.51225757455796,724.3917041138776,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_71,3.7970202609476864,2.7095216285647172,5,1.2117349095953287,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,3.341584831511669,0.9187067994445317,6,0.37506048031075717,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,499.2222044164429,439.3427559471184,159.31570841435484,49.31196224997067,0.734907513767526,1,658.5379128307977,488.6547181970891,724.3917041138776,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_71,1.93427966624176,0.5206266939017254,6,0.21254495775523233,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,499.2222044164429,254.31398638312848,159.31570841435484,27.944850186731394,0.2004898628687578,1,658.5379128307977,282.25883656985985,724.3917041138776,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.9851640132555999,0.1842005323694444,6,0.07519955244235914,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,2717.345902716852,2959.6321798608637,149.68739548525824,225.91468255529645,0.3954170908094775,1,2867.03329820211,3185.5468624161604,3504.1015486577767,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_71,0.9045148965267857,0.12204827780784586,6,0.04982600076911171,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.8501168144548978,0.11182548893133384,6,0.04565256468650268,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,2717.345902716852,2553.9230492057573,149.68739548525824,137.14954842173844,0.4396971384920413,1,2867.03329820211,2691.0725976274957,3504.1015486577767,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_71,0.9415247890373843,0.20261306011403116,6,0.08271643541720514,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,2717.345902716852,2828.531113883452,149.68739548525824,248.4969210914806,0.7112597287787243,1,2867.03329820211,3077.0280349749323,3504.1015486577767,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.6843788247008208,0.04315788017877214,6,0.017619130803027967,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,2147.6154464917763,2056.0125680051506,184.36888554810469,52.93143659754255,0.6503755130353144,1,2331.984332039881,2108.944004602693,2922.4784517735857,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_71,0.7148704040294019,0.15032598362441338,6,0.06137032582696544,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.7803152283754948,0.10398300798214316,6,0.04245088524600017,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,2147.6154464917763,2344.2249506290177,184.36888554810469,127.53105508031375,0.4035433674685248,1,2331.984332039881,2471.7560057093315,2922.4784517735857,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_71,0.8145813500289001,0.1709237833872075,6,0.0697793423674431,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,2147.6154464917763,2447.1673185595173,184.36888554810469,209.6312739619239,0.3088811375434908,1,2331.984332039881,2656.798592521441,2922.4784517735857,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,1.3872308781143232,0.36913083562987015,6,0.1506970326033917,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,3004.2024881525895,4167.522455673152,196.27300355723474,452.7244003043213,0.051481024936036617,1,3200.4754917098244,4620.246855977473,5082.271541575221,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_71,1,0.1600320587226255,6,0.0653328143929244,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,1.3788286453785492,0.36415648422024555,6,0.14866626214424597,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,3004.2024881525895,4142.280447182302,196.27300355723474,446.6235546380889,0.053115456227905936,1,3200.4754917098244,4588.9040018203905,5082.271541575221,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_71,1.4017175320534316,0.31295177914450717,6,0.12776202883336948,leaf_1_log2-1,1,967514 MM WT,leaf,*,3004.2024881525895,4211.043297482026,196.27300355723474,383.8230049126315,0.02492690679947285,0.5733188563878756,3200.4754917098244,4594.866302394657,5082.271541575221,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.8765199938032806,0.14685659849686122,6,0.05995395527968152,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,2374.2728786293014,2633.243546299308,128.423389505072,180.11382162580827,0.2716529863045164,1,2502.6962681343734,2813.3573679251163,3596.3415713269083,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_71,0.7903171933291826,0.10471057678923834,6,0.04274791396769161,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,1.0380689047322085,0.12298173346778403,6,0.050207082446505284,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,2374.2728786293014,3118.569186470334,128.423389505072,150.83224200867343,0.003907659819322167,0.09378383566373202,2502.6962681343734,3269.4014284790073,3596.3415713269083,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_71,0.8919523489716682,0.12937182543494202,6,0.0528158265680044,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,2374.2728786293014,2679.6054660942327,128.423389505072,158.6694375894345,0.16689294844887967,1,2502.6962681343734,2838.274903683667,3596.3415713269083,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.9083463747624412,0.5153930675546744,6,0.2104083387461221,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,392563.02776640607,278422.7559598261,84103.81699862266,64493.53592229063,0.31328292455998363,1,476666.84476502874,342916.29188211676,524333.5292415316,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_29,1.2807257866121917,0.6135464785725718,5,0.2743863266887777,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.7559615527392785,0.4248150311098805,6,0.1734300102139615,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,392563.02776640607,231714.36002965842,84103.81699862266,53159.08419025767,0.15031269868654779,1,476666.84476502874,284873.44421991607,524333.5292415316,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_29,0.8805706646319278,0.80099516239114,5,0.35821592655101436,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,392563.02776640607,269909.05460300465,84103.81699862266,109798.93603375668,0.4027481855789634,1,476666.84476502874,379707.9906367613,524333.5292415316,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,1.2582012352168903,0.7852302800742947,6,0.3205689194607912,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,284061.4228530423,385658.89091896324,47909.709438701844,98259.52358171676,0.3825923252248249,1,331971.1322917442,483918.41450068,532310.255950748,0,23,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_29,0.9267423661866657,0.3828652245554949,6,0.15630407340284383,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.8815047068092471,0.4975978173669526,6,0.20314345827860794,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,284061.4228530423,270195.35353523743,47909.709438701844,62266.7333526068,0.8636585711922045,1,331971.1322917442,332462.08688784426,532310.255950748,0,23,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_29,1.041763122775294,0.5901183752740343,5,0.2639089603768944,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,284061.4228530423,319317.13249394385,47909.709438701844,80892.3359107853,0.7193429603426497,1,331971.1322917442,400209.46840472915,532310.255950748,0,23,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.6605737827610788,0.12602200493953236,6,0.05144826807739259,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,306516.0644612488,202476.4761782058,64129.353892514686,15769.720654429675,0.18259643566334055,1,370645.4183537635,218246.19683263547,453018.72679800243,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_29,0.9999999999999999,0.4678306010122108,5,0.20922020516357703,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,1.0956763872678197,0.6072881202292495,6,0.24792433690260404,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,306516.0644612488,335842.41414845124,64129.353892514686,75992.79203155094,0.7747610048536641,1,370645.4183537635,411835.2061800022,453018.72679800243,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_29,0.9864489010026217,0.2870382192976067,6,0.11718286232603936,fruit_1_log2-1,1,967514 MM WT,fruit,ns,306516.0644612488,302362.43492744764,64129.353892514686,35918.42978248192,0.9566592892320662,1,370645.4183537635,338280.86470992956,453018.72679800243,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,3.4017097553800846,1.5600841230031908,6,0.6369016761958677,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,840829.3783393475,1042678.686658541,189171.55722401093,195220.59523633003,0.47681688608954576,1,1030000.9355633585,1237899.281894871,2080193.4041571342,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_29,2.7431820900390336,1.3800270537398134,5,0.6171668605901955,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,5.591074201102931,1.417120193609972,6,0.5785368964230897,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,840829.3783393475,1713754.0602328912,189171.55722401093,177330.85263723062,0.008674062803376405,0.1908293816742809,1030000.9355633585,1891084.912870122,2080193.4041571342,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_29,2.572388864595699,1.2999416185210613,6,0.5306989434640504,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,840829.3783393475,788478.5110398139,189171.55722401093,162667.75156434355,0.8387899037222069,1,1030000.9355633585,951146.2626041574,2080193.4041571342,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,1.3883352140629819,0.36214684810011794,6,0.14784583163374942,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,441052.22347842244,466374.93039054686,84998.98503846534,49664.94311912944,0.8034506360229701,1,526051.2085168877,516039.8735096763,771159.6464264466,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_29,1.3129529337760504,0.6197956262539835,6,0.2530305048551682,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,1.4059325504706144,0.4725606882415388,6,0.19292209311503478,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,441052.22347842244,472286.29564227944,84998.98503846534,64807.13507511828,0.7765053641804865,1,526051.2085168877,537093.4307173977,771159.6464264466,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_29,1.7481276481004682,0.8299266715725148,6,0.3388161448798431,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,441052.22347842244,587237.7952661085,84998.98503846534,113816.42875793386,0.32958193178008344,1,526051.2085168877,701054.2240240424,771159.6464264466,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,2.1784088882110306,0.44981764136874397,6,0.18363728310927677,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,1207671.3606646094,731779.5322848298,86178.87694177101,61688.14581642734,0.00148561856477249,0.03427840653476772,1293850.2376063804,793467.6781012571,1441434.145241814,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_29,3.595074622947653,0.6283991624113908,6,0.25654288378337375,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,3.541112206744576,0.881218299443304,6,0.35975586427320144,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1207671.3606646094,1189544.0972735405,86178.87694177101,120850.58021901759,0.9054708216598129,1,1293850.2376063804,1310394.677492558,1441434.145241814,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_29,2.1841069677215925,0.35264165028946065,6,0.14396535087702775,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,1207671.3606646094,733693.6531744967,86178.87694177101,48361.397027042905,0.001428266938948655,0.03427840653476772,1293850.2376063804,782055.0502015396,1441434.145241814,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,1.3059796374763653,0.3812329686428833,6,0.15563770771692062,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,335923.8645439917,438709.7268368219,77249.95941119082,52282.42024503621,0.2997660809989719,1,413173.8239551825,490992.1470818581,599904.8681170195,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_29,1,0.563291278709818,6,0.2299627015664866,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,1.422322358123017,0.34806949984013286,6,0.1420987782723461,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,335923.8645439917,477792.02316800726,77249.95941119082,47734.370744226304,0.1553453891977722,1,413173.8239551825,525526.3939122335,599904.8681170195,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_29,1.4863032714153614,0.3360303901467957,6,0.13718383232133427,leaf_1_log2-1,1,967514 MM WT,leaf,ns,335923.8645439917,499284.73881822557,77249.95941119082,46083.32310633757,0.10616174087155725,1,413173.8239551825,545368.0619245631,599904.8681170195,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,3.2959014416864405,0.9098904405081265,6,0.37146121684685396,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,1584621.3921934753,1107171.9494474228,160222.73761358723,124782.68749140885,0.042002810773118154,0.8820590262354813,1744844.1298070624,1231954.6369388315,1919328.5427877689,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_29,4.7172039841365825,1.1683122093093397,6,0.47696146217859686,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,4.057504350142545,0.8256711075878672,6,0.33707881815815116,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1584621.3921934753,1363012.5417039413,160222.73761358723,113232.81925160757,0.28788899495477843,1,1744844.1298070624,1476245.360955549,1919328.5427877689,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_29,3.718359363789974,0.5476184314312839,6,0.22356428845832385,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1584621.3921934753,1249085.6472476665,160222.73761358723,75100.57975294787,0.09919371251877128,1,1744844.1298070624,1324186.2270006144,1919328.5427877689,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,1.243104332801392,0.5849574947405275,6,0.2388078972218445,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,153.5003270717614,162.44174875762465,13.303852083333304,31.206047166151485,0.8000220254145649,1,166.80417915509472,193.64779592377613,221.4447147434222,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_30,1.1746790657495978,0.22765245271592235,5,0.10180927190347179,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,1.2315358778460193,0.6568169793693719,6,0.2681444089751845,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,153.5003270717614,160.9300493742433,13.303852083333304,35.03957436569228,0.8490315943514819,1,166.80417915509472,195.9696237399356,221.4447147434222,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_30,1.1638659688228044,0.8423447185542751,5,0.37670801023505746,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,153.5003270717614,152.08733354585544,13.303852083333304,49.22604349361928,0.9790594297395284,1,166.80417915509472,201.31337703947472,221.4447147434222,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,1.5625783647460236,0.4361384855139531,6,0.17805279111656966,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,133.76145724135475,204.18878403243974,11.812719700129358,23.266918147547496,0.029063055284656348,0.6393872162624397,145.5741769414841,227.45570217998724,250.20127239798597,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_30,1.0236250737897294,0.2214294840057411,6,0.09039820830363912,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,1.114720629329342,0.24179624972816524,6,0.09871290559209678,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,133.76145724135475,145.66530228109863,11.812719700129358,12.899236682081774,0.511706558587657,1,145.5741769414841,158.5645389631804,250.20127239798597,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_30,1.1065518416222606,0.360940490039004,6,0.14735333801761238,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,133.76145724135475,144.59785192688923,11.812719700129358,19.255289585318007,0.6438323374965509,1,145.5741769414841,163.85314151220723,250.20127239798597,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,1.0581326170872147,0.5136477175994464,6,0.20969580261063908,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,130.67426801703346,138.27070520281973,18.878124563815085,27.4018455123896,0.8248272561961096,1,149.55239258084853,165.67255071520933,246.01794037479783,2,24,8.333333333333332,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_30,1,0.3230381195393162,5,0.1444670389227228,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,1.5022168587166382,0.5127055775516086,6,0.2093111755467318,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,130.67426801703346,196.30108841564405,18.878124563815085,27.351584652353974,0.08165696362815851,1,149.55239258084853,223.65267306799802,246.01794037479783,2,24,8.333333333333332,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_30,0.9555622745773253,0.6447652305351387,6,0.2632243031165089,fruit_1_log2-1,1,967514 MM WT,fruit,ns,130.67426801703346,124.86740077508352,18.878124563815085,34.39664313404354,0.8861948572780766,1,149.55239258084853,159.26404390912705,246.01794037479783,2,24,8.333333333333332,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,1.5623377326273216,0.2028949909397156,6,0.08283153319481988,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,337.38926398860315,204.157339606467,92.57929012915056,10.8239499689617,0.22429156291195873,1,429.9685541177537,214.9812895754287,472.9654095295291,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_30,2.581910494762628,1.584195489891488,5,0.7084737610091896,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,2.6979314495369158,0.4734434937888758,6,0.1932824969705471,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,337.38926398860315,352.55021732837054,92.57929012915056,25.257048812130733,0.8811683923118037,1,429.9685541177537,377.80726614050127,472.9654095295291,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_30,1.4175521409583987,0.9141733224236759,6,0.37320969606713555,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,337.38926398860315,185.23758839571738,92.57929012915056,48.76890385043247,0.19499172979990256,1,429.9685541177537,234.00649224614986,472.9654095295291,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,1.3006044094543046,0.17964358518565446,6,0.07333918654484278,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,5768.45735214601,7080.76884014429,483.74560906534924,399.274232098086,0.06388175395563662,1,6252.202961211359,7480.043072242376,8228.047379466614,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_30,1.0595574064521105,0.21764939618985726,6,0.08885499391500126,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,1.2903189172127065,0.10635563427211017,6,0.043419505872788824,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,5768.45735214601,7024.772418449541,483.74560906534924,236.38508527546776,0.05107805615653192,1,6252.202961211359,7261.157503725009,8228.047379466614,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_30,1.258273517611101,0.12698037914965388,6,0.05183952271029935,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,5768.45735214601,6850.310402697784,483.74560906534924,282.22545950697577,0.08925885255503575,1,6252.202961211359,7132.535862204761,8228.047379466614,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,1.4554146621786757,0.1917334641306945,6,0.07827485895607043,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,7907.402766392693,7923.588997955006,656.4670665296335,426.1450893399463,0.983972983403064,1,8563.869832922326,8349.734087294952,9420.25681621456,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_30,1.4524415550743963,0.2953611525792681,6,0.12058068560992241,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,1.4697352460478585,0.2095385149214472,6,0.08554374050301748,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,7907.402766392693,8001.553322307964,656.4670665296335,465.7184366130941,0.909445258827059,1,8563.869832922326,8467.271758921059,9420.25681621456,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_30,1.4450330290773736,0.06710909714251943,6,0.027397174183006877,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,7907.402766392693,7867.069164838068,656.4670665296335,149.15608147479247,0.9543360421638298,1,8563.869832922326,8016.225246312861,9420.25681621456,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,1.2374238402484283,0.1638728673436763,6,0.06690081794646725,leaf_1_panK4-1,1,967514 MM WT,leaf,*,5444.214081294075,6736.800295609484,388.99489029479935,364.22237511424834,0.03581576582154454,0.7521310822524353,5833.208971588874,7101.0226707237325,9625.04833521744,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_30,1,0.17501864907297904,6,0.07145106428333846,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,1.3098846941809632,0.10920787341175575,6,0.04458392762554325,leaf_1_transp1-1,1,967514 MM WT,leaf,*,5444.214081294075,7131.292696931583,388.99489029479935,242.72444657837852,0.005741514745226896,0.13205483914021862,5833.208971588874,7374.017143509962,9625.04833521744,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_30,1.5356576436234937,0.17528864176408898,6,0.07156128833792183,leaf_1_log2-1,1,967514 MM WT,leaf,*,5444.214081294075,8360.448967461902,388.99489029479935,389.59497364485946,3.490498276920573e-4,0.008377195864609374,5833.208971588874,8750.043941106762,9625.04833521744,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,1.4163471759941952,0.2024624519650334,6,0.08265494989784687,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,8037.742033674774,7710.897239548695,317.6192843395805,449.9912421225142,0.5675345079333141,1,8355.361318014355,8160.88848167121,9752.442297746395,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_30,1.4763824334704017,0.1429049569841688,6,0.0583407043875988,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,1.4096512975778526,0.2277062998651691,6,0.09296070764780706,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,8037.742033674774,7674.44344398781,317.6192843395805,506.09799358325296,0.5592323147798541,1,8355.361318014355,8180.5414375710625,9752.442297746395,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_30,1.5809594704188623,0.11642934432808251,6,0.047532080781768155,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,8037.742033674774,8607.081810809594,317.6192843395805,258.77482350530977,0.19598333820102254,1,8355.361318014355,8865.856634314903,9752.442297746395,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,1.2317680063278273,0.22823450502110754,6,0.09317634649973312,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,569.6195574885154,587.7362574667691,83.69920786736944,44.458954035866704,0.8545273305528398,1,653.3187653558848,632.1952115026357,759.7588669428513,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_37,1.1937993237258107,0.39224081846197373,5,0.17541542672622554,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,1.2312580209474744,0.5297719586928166,6,0.21627849647203465,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,569.6195574885154,587.4929187071393,83.69920786736944,103.19696033181646,0.8959823336211666,1,653.3187653558848,690.6898790389557,759.7588669428513,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_37,0.8805665237380649,0.25511023616584727,5,0.11408876596457196,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,569.6195574885154,420.1609965948351,83.69920786736944,54.4372836301559,0.1788744644568073,1,653.3187653558848,474.598280224991,759.7588669428513,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,1.3830309455764747,0.3827181356037641,6,0.15624402458975362,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,671.4142285388855,659.9111421453067,85.13355504952595,74.55160208105582,0.9210771655232575,1,756.5477835884114,734.4627442263625,832.2025619472527,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_37,1.4071389253269604,0.4370416537856587,6,0.17842150801949466,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,1.3877053852650425,0.2690063971405205,6,0.1098214017564605,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,671.4142285388855,662.1415440344607,85.13355504952595,52.401117196185766,0.9282935964206341,1,756.5477835884114,714.5426612306464,832.2025619472527,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_37,1.0796748123198767,0.1757575781893029,6,0.07175273083185166,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,671.4142285388855,515.1652179746056,85.13355504952595,34.23670793971671,0.1351466207693364,1,756.5477835884114,549.4019259143223,832.2025619472527,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,1.1286373450403415,0.17988312610359192,6,0.07343697871508689,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,477.14850073021523,538.5276170541296,40.434268654435684,35.04034429206043,0.28274925128052925,1,517.5827693846509,573.56796134619,630.924757480809,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_37,1,0.18948770287120328,5,0.08474147690405852,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,0.9513121731730572,0.21674687713781474,6,0.08848654205489383,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,477.14850073021523,453.9171771559271,40.434268654435684,42.22122087629373,0.7003829899630174,1,517.5827693846509,496.13839803222083,630.924757480809,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_37,0.74225160584374406,0.10747348719470873,6,0.043875867417429715,fruit_1_log2-1,1,967514 MM WT,fruit,*,477.14850073021523,354.1642408929372,40.434268654435684,20.93530435646429,0.035051917046752396,0.7711421750285528,517.5827693846509,375.0995452494015,630.924757480809,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,1.4212498039830388,0.6393548177228233,6,0.2610155113351774,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,630.933410607765,678.1472131336193,126.62823171945234,124.54315990091038,0.7964588360906776,1,757.5616423272174,802.6903730345297,1035.9613704795904,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_37,1.3222998912124875,0.593419728998344,5,0.2653853706459601,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,1.7362551272428952,0.5817988063242862,6,0.23751836807580598,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,630.933410607765,828.4515308490966,126.62823171945234,113.33153322325826,0.2764449992184892,1,757.5616423272174,941.7830640723548,1035.9613704795904,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_37,0.9376758481154369,0.37393227089674397,6,0.15265721034286586,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,630.933410607765,447.41062509921375,126.62823171945234,72.84015904075557,0.25218589496442106,1,757.5616423272174,520.2507841399693,1035.9613704795904,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,1.9358710360904516,0.2909180482946364,6,0.11876679588136886,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,203.851551099135,397.11923984971156,36.69693185673012,24.36349261934581,0.0019050239262496371,0.04572057422999129,240.54848295586513,421.4827324690574,475.1591004275123,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_37,0.9937325463865078,0.43818839773752644,6,0.17888966427744443,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,1.7156082604146672,0.9555894058282256,6,0.39011774131475174,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,203.851551099135,351.9351421423537,36.69693185673012,80.02767642811202,0.13636729554674926,1,240.54848295586513,431.96281857046574,475.1591004275123,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_37,1.4387337387579702,0.4215962283727147,6,0.17211593949917317,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,203.851551099135,295.13786715645807,36.69693185673012,35.30738865640892,0.1033354943322689,1,240.54848295586513,330.445255812867,475.1591004275123,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,2.2989758964723004,0.7416840743987103,6,0.3027912554375461,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,267.57829794057477,471.605568459588,75.68230207878146,62.113762203568534,0.0648289722651357,1,343.2606000193562,533.7193306631566,587.0912637294723,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_37,1.304386755639375,0.9037024352461416,6,0.3689349742772672,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,1.8514688192952171,0.6274665135290634,6,0.25616213147156053,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,267.57829794057477,379.80520211141044,75.68230207878146,52.54839244545363,0.2544696806530998,1,343.2606000193562,432.3535945568641,587.0912637294723,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_37,2.1150781856399687,0.5518885115197394,6,0.2253075413545796,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,267.57829794057477,433.8812997586509,75.68230207878146,46.21896701127023,0.09638078055855376,1,343.2606000193562,480.1002667699212,587.0912637294723,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,1.3261627382355,1.0545175069685726,6,0.4305049694841346,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,205.1372392304115,272.0453628918733,41.431878377928655,88.31260091494791,0.5145469463407606,1,246.56911760834015,360.3579638068212,499.2014197150579,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_37,1,0.49472714701490916,6,0.2019715120149009,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,2.016354963097862,0.4798979898235995,6,0.19591753394252884,leaf_1_transp1-1,1,967514 MM WT,leaf,*,205.1372392304115,413.62949043843366,41.431878377928655,40.189982029800795,0.004759366734622128,0.10946543489630894,246.56911760834015,453.81947246823444,499.2014197150579,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_37,0.9983765795603489,1.0721601287320324,6,0.43770753965836756,leaf_1_log2-1,1,967514 MM WT,leaf,ns,205.1372392304115,204.80421524331123,41.431878377928655,89.79011627585338,0.9974064666704999,1,246.56911760834015,294.5943315191646,499.2014197150579,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,1.3749906819932698,0.6006399158025689,6,0.2452102188107574,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,250.24465111006373,282.06179247164005,40.38957298522776,50.3017473179239,0.6330026216292504,1,290.6342240952915,332.36353978956396,587.8781245672358,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_37,1.2198889487295248,0.48228125285231505,6,0.1968904969997277,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,2.012660846642871,1.451551395808846,6,0.5925933758593956,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,250.24465111006373,412.8716895874611,40.38957298522776,121.56296911002597,0.2505917568283908,1,290.6342240952915,534.4346586974871,587.8781245672358,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_37,1.709807472887002,0.4575510908587151,6,0.1867944506429461,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,250.24465111006373,350.74518460356626,40.38957298522776,38.31849790845533,0.1012821948752899,1,290.6342240952915,389.0636825120216,587.8781245672358,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,1.108065750244754,0.21840241930618726,6,0.08916241431492275,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,174.0566813877081,183.96900197925305,4.002371956823377,14.80338181371802,0.5430752142574063,1,178.05905334453146,198.77238379297108,221.2978397689389,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_52,1.0483627413966903,0.05390428974232593,5,0.02410673122853708,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,1.1332232031079443,0.19229823123422926,6,0.07850542416059873,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,174.0566813877081,188.14582225779603,4.002371956823377,13.034032077602935,0.34179314203792693,1,178.05905334453146,201.17985433539897,221.2978397689389,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_52,1.026743718349505,0.27729586928943456,5,0.12401048272221439,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,174.0566813877081,170.46733653801962,4.002371956823377,20.589107402996543,0.8718737285158845,1,178.05905334453146,191.05644394101617,221.2978397689389,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,1.0863500234961974,0.2807117187303946,6,0.11460007928485635,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,167.7025608127359,180.3636016893301,10.377501714734212,19.026724910612415,0.5757321383113436,1,178.08006252747012,199.3903265999425,224.2630103701382,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_52,1.0100911668036716,0.15310498029252761,6,0.06250484646592784,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,1.0977138316339066,0.09389480894018323,6,0.03833239523326085,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,167.7025608127359,182.2503024029983,10.377501714734212,6.36421845272233,0.2651234835895894,1,178.08006252747012,188.61452085572063,224.2630103701382,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_52,1.11321133616807,0.2810869029725002,6,0.11475324761030496,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,167.7025608127359,184.82330896121857,10.377501714734212,19.0521550116343,0.4535536635225501,1,178.08006252747012,203.87546397285288,224.2630103701382,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.9842588872492999,0.23272600385809958,6,0.09500999322155555,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,166.02715311669658,163.4137009798089,6.6149249137682515,15.774238692211506,0.8830934767682896,1,172.64207803046483,179.1879396720204,238.7699599286262,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_52,1,0.08909037766157565,5,0.03984242811848238,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,1.1982787741539898,0.2672868966324433,6,0.10911941861358626,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,166.02715311669658,198.94681351295193,6.6149249137682515,18.1167864221628,0.13648863084250043,1,172.64207803046483,217.06359993511472,238.7699599286262,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_52,0.9203223346291531,0.24331548410449996,6,0.09933313042904936,fruit_1_log2-1,1,967514 MM WT,fruit,ns,166.02715311669658,152.79849716819007,6.6149249137682515,16.49199685530457,0.48252589901860454,1,172.64207803046483,169.29049402349463,238.7699599286262,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,1.056112579876391,0.15345249255556384,6,0.06264671775322761,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,164.69033579859368,175.34336500760702,7.858106343973116,10.401056200673596,0.43545158556070096,1,172.54844214256678,185.7444212082806,255.8928505220429,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_52,0.9919482006827927,0.10583365208458281,5,0.0473302480736379,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,1.3206200294829673,0.1972708882199157,6,0.08053550287406841,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,164.69033579859368,219.25878384394494,7.858106343973116,13.371080267003112,0.008062203805623103,0.19349289133495448,172.54844214256678,232.62986411094806,255.8928505220429,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_52,1.103452195008173,0.1569503078602054,6,0.06407469487170586,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,164.69033579859368,183.20302653757687,7.858106343973116,10.638139176370322,0.1962015716933309,1,172.54844214256678,193.8411657139472,255.8928505220429,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.9344176890042942,0.06031156313854356,6,0.024622092546513746,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1661.828926022163,1676.3102911814774,51.51428135920491,44.17111064124349,0.8353975721151174,1,1713.3432073813678,1720.481401822721,2978.720099910177,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_52,0.9263454103593562,0.07033798307601075,6,0.02871536134545752,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,1.004486652057988,0.060376917894352115,6,0.024648773513846273,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1661.828926022163,1802.0113831465526,51.51428135920491,44.21897529603813,0.06648680328035236,1,1713.3432073813678,1846.2303584425906,2978.720099910177,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_52,1.17893802798941,0.8096275644425828,6,0.3305290690961055,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1661.828926022163,2114.970609224803,51.51428135920491,592.9567543299033,0.48031395911486585,1,1713.3432073813678,2707.927363554706,2978.720099910177,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,1.002109330157373,0.12274853305714052,6,0.0501118787775246,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1614.4172016560733,1797.7465568120908,127.80386887185506,89.8988312118919,0.27088412711995685,1,1742.2210705279283,1887.6453880239828,2486.030433944885,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_52,0.8999169178857789,0.17450435352236437,6,0.07124110400400685,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,1.0922667630124487,0.41036236088782563,6,0.16752973230316964,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1614.4172016560733,1959.48561023531,127.80386887185506,300.5420569873123,0.3270355373106214,1,1742.2210705279283,2260.0276672226223,2486.030433944885,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_52,0.9661611834881821,0.17654740279180642,6,0.07207517537559001,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1614.4172016560733,1733.2569298288108,127.80386887185506,129.30016163280928,0.528068623771935,1,1742.2210705279283,1862.55709146162,2486.030433944885,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,1.0226525230946077,0.12611606432991082,6,0.05148666766271667,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1793.9624976146763,1834.600274522753,99.91816829149131,92.36515091406397,0.7713548364990739,1,1893.8806659061677,1926.965425436817,2380.748415387714,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_52,1,0.1364290104576426,6,0.05569691028900909,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,1.0945166831151196,0.2741667941998781,6,0.111928125034058,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1793.9624976146763,1963.5218825221314,99.91816829149131,200.79485873942647,0.47322479358775305,1,1893.8806659061677,2164.316741261558,2380.748415387714,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_52,1.0150457603806675,0.16336967587375983,6,0.06669539088909786,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1793.9624976146763,1820.9540274856906,99.91816829149131,119.64903001879313,0.8660942606894282,1,1893.8806659061677,1940.6030575044838,2380.748415387714,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.8683218179222807,0.0945555672450597,6,0.038602148681636465,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1813.8662527903357,1557.736777213171,182.121936697681,69.25080706220164,0.2336994832422137,1,1995.9881894880168,1626.9875842753727,2262.512087674139,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_52,1.0110948557743678,0.24867064750235132,6,0.10151936673137682,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,1.0390790381661805,0.26319640810766903,6,0.1074494836661851,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1813.8662527903357,1864.0688265276567,182.121936697681,192.7603440851968,0.8536497806473732,1,1995.9881894880168,2056.8291706128534,2262.512087674139,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_52,0.884195871985413,0.12021940990480322,6,0.049079368574210316,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1813.8662527903357,1586.2142348875382,182.121936697681,88.0465466287416,0.296459572301403,1,1995.9881894880168,1674.2607815162798,2262.512087674139,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.5219263107948522,0.6794748086818931,6,0.2773944290576433,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,253.40112834502855,201.248843806041,135.57962327586364,106.96013397192043,0.7703209113741605,1,388.9807516208922,308.2089777779614,427.87882678298143,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_43,0.6571800044517999,0.7862401571778177,5,0.3516172876179439,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.34430329352304945,0.2535478211569534,6,0.10351046453816351,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,253.40112834502855,132.75943041576411,135.57962327586364,39.912456757366975,0.4347008027450806,1,388.9807516208922,172.6718871731311,427.87882678298143,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_43,0.2244240949228481,0.19160964603322736,5,0.08569043873499385,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,253.40112834502855,86.53537614660112,135.57962327586364,33.04125767177168,0.2913002337044838,1,388.9807516208922,119.57663381837281,427.87882678298143,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.9654921025695482,1.1154325481076024,6,0.45537343089267934,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,295.4450076895346,372.2827635381618,127.76728266678951,175.58681095723315,0.7314862419982797,1,423.2122903563241,547.869574495395,809.4485695597074,3,24,12.5,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_43,0.7662181803875129,0.8116542745600248,6,0.33135647003681706,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,1.3473901984778032,1.374219652662869,6,0.56102282392146,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,295.4450076895346,519.5383217724622,127.76728266678951,216.32401419090814,0.39810771524975785,1,423.2122903563241,735.8623359633702,809.4485695597074,3,24,12.5,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_43,0.38665008216950675,0.6527935085812561,6,0.2665018339042049,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,295.4450076895346,149.08787003977852,127.76728266678951,102.76007328262824,0.3939740495928501,1,423.2122903563241,251.84794332240676,809.4485695597074,3,24,12.5,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.6389119332691692,0.5694167614188985,6,0.2324634194107347,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,385.5886159476326,246.35716806168514,281.0315290136118,89.63524814903921,0.6575358834656408,1,666.6201449612445,335.99241621072434,734.2949584672313,1,24,4.166666666666666,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_43,0.9999999999999999,1.6297306940734089,5,0.7288377233932112,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,1.1404229766754974,1.4471648917507314,6,0.5908025930765575,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,385.5886159476326,439.7341171711843,281.0315290136118,227.8067541626622,0.8846566486955743,1,666.6201449612445,667.5408713338466,734.2949584672313,1,24,4.166666666666666,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_43,0.2259748688567176,0.21676419759438212,6,0.08849361310167751,fruit_1_log2-1,1,967514 MM WT,fruit,ns,385.5886159476326,87.13333692140954,281.0315290136118,34.122129796081126,0.34964757485574216,1,666.6201449612445,121.25546671749066,734.2949584672313,1,24,4.166666666666666,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.9154737582720327,0.8054187185799285,6,0.32881081496785103,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,2525.1080246002184,352.99625938849067,1820.6282891675442,126.7857070520668,0.2992003261088581,1,4345.736313767762,479.7819664405575,4780.309945144539,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_43,6.54870999859383,10.558010397513053,5,4.721685791197753,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,1.7658150220804187,0.9593131676118818,6,0.39163796069702406,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,2525.1080246002184,680.8781703835269,1820.6282891675442,151.01113921771883,0.3691213667995557,1,4345.736313767762,831.8893096012457,4780.309945144539,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_43,2.2917689481096724,1.7317047830641434,6,0.7069655172740313,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,2525.1080246002184,883.6800167733705,1820.6282891675442,272.59785532839595,0.4209502080737652,1,4345.736313767762,1156.2778721017664,4780.309945144539,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.8229777878201682,0.13286109248881117,6,0.054240313877718355,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,333.9562473577739,353.98647015630274,24.26051679391336,23.33032256022319,0.5650150832642479,1,358.2167641516873,377.3167927165259,467.3094147470229,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_43,0.7764098259401573,0.1381583455291775,6,0.05640290837560241,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.9390362438746984,0.11913587402682435,6,0.04863701690436919,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,333.9562473577739,403.906557670877,24.26051679391336,20.920183008234716,0.054486126247995384,1,358.2167641516873,424.8267406791117,467.3094147470229,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_43,0.8508611076895658,0.32242031418098216,6,0.13162754207520758,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,333.9562473577739,365.9798898121974,24.26051679391336,56.61680021518934,0.619678781211856,1,358.2167641516873,422.5966900273868,467.3094147470229,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.8283781215418019,0.1604579573032589,6,0.06550668676037898,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,301.094161850299,356.30930936299694,36.92572785282825,28.176314307778327,0.26385670991600385,1,338.0198897031272,384.4856236707753,422.93418603785284,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_43,0.700009260624321,0.21028395688946497,6,0.08584806591210076,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.6382256633691419,0.0788589514532039,6,0.03219403211854326,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,301.094161850299,274.51925566255323,36.92572785282825,13.847581257238017,0.5240551781529033,1,338.0198897031272,288.36683691979124,422.93418603785284,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_43,0.5706602804436388,0.10086372105147236,6,0.041177441689087546,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,301.094161850299,245.45743678903585,36.92572785282825,17.71160467428338,0.2154057975477061,1,338.0198897031272,263.1690414633192,422.93418603785284,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.8983358146966144,0.11416058212567755,6,0.0466058624911673,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,430.1288265554666,386.40012982820383,36.090508376366124,20.04652494393122,0.32113219793206277,1,466.21933493183275,406.44665477213505,571.605205480574,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_43,1,0.2055275643524889,6,0.08390627679010519,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,1.068794133199974,0.3412423040159425,6,0.13931158724845835,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,430.1288265554666,459.71916634267194,36.090508376366124,59.9219295487589,0.6831533887240726,1,466.21933493183275,519.6410958914308,571.605205480574,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_43,0.965508325805044,0.20327317120723767,6,0.08298592464252293,leaf_1_log2-1,1,967514 MM WT,leaf,ns,430.1288265554666,415.2929632080567,36.090508376366124,35.69463838710877,0.7760536733473724,1,466.21933493183275,450.9876015951654,571.605205480574,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.8017878929593858,0.2255620003845061,6,0.09208530105058384,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,298.9200070222308,344.8720855450007,38.106212417427,39.6085424838945,0.4226790470263364,1,337.0262194396578,384.4806280288952,531.613653761683,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_43,0.6949546009646111,0.21700655871007465,6,0.08859255661283391,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.8423662882535923,0.22331797409869183,6,0.0911691811556442,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,298.9200070222308,362.3260230964016,38.106212417427,39.21449290849999,0.2731748192339564,1,337.0262194396578,401.54051600490163,531.613653761683,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_43,0.8583177342032289,0.6497628532358991,6,0.26526457404047776,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,298.9200070222308,369.18719982458174,38.106212417427,114.09793995876639,0.5800699166260161,1,337.0262194396578,483.28513978334814,531.613653761683,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.8854152299812575,0.0655936528530813,6,0.026778496642550536,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,49.79770295664674,46.7987228571543,1.2062399601896334,1.4153804909505427,0.14135515881279567,1,51.00394291683637,48.21410334810484,59.297411594408835,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_80,0.9421548692788152,0.05103072054044262,5,0.022821632013844902,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.954235520460121,0.1608355301172168,6,0.06566083021620292,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,49.79770295664674,50.436227151198764,1.2062399601896334,3.4705106619001684,0.8675957741366959,1,51.00394291683637,53.906737813098935,59.297411594408835,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_80,0.886105123123603,0.07250586870835042,5,0.03242561023990928,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,49.79770295664674,46.83518723779339,1.2062399601896334,1.7138593235218482,0.19933835089257176,1,51.00394291683637,48.54904656131524,59.297411594408835,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,1.0407404411782322,0.10016243822534515,6,0.040891144174189445,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,47.50816131333528,55.00845459137131,1.0437073978332585,2.161306084107385,0.016099879724034264,0.38639711337682237,48.55186871116854,57.1697606754787,62.886736743026574,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_80,0.8988375538287341,0.04836902950929526,6,0.019746573608565934,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.9479649669673617,0.07615880031815966,6,0.03109170003366739,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,47.50816131333528,50.10479633192675,1.0437073978332585,1.6433553475968286,0.21702046455135915,1,48.55186871116854,51.74815167952358,62.886736743026574,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_80,0.9071742528803703,0.05858755973224932,6,0.023918271103140248,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,47.50816131333528,47.94879849152035,1.0437073978332585,1.26420294419584,0.7937519804041565,1,48.55186871116854,49.21300143571619,62.886736743026574,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.9685107987344467,0.09562559788924006,6,0.039038986862867046,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,52.85511393128503,51.19074861078904,4.069464220841183,2.063410098398778,0.7277827752210723,1,56.924578152126216,53.25415870918782,62.61703596733884,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_80,1,0.17216117709317877,5,0.07699281901334547,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.9451720423466053,0.1062772144564877,6,0.04338749111712246,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,52.85511393128503,49.95717598289519,4.069464220841183,2.2932507861881235,0.5563517868360266,1,56.924578152126216,52.25042676908331,62.61703596733884,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_80,0.9668945614622158,0.1790296876946682,6,0.07308856394362759,fruit_1_log2-1,1,967514 MM WT,fruit,ns,52.85511393128503,51.10532220562529,4.069464220841183,3.8631043743144486,0.7624483086070233,1,56.924578152126216,54.96842657993974,62.61703596733884,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,1.0443043326891095,0.09092657932507225,6,0.03712062056718758,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,54.222126009134534,55.19682448321747,5.197182507313685,1.962014629278702,0.8674266561872928,1,59.41930851644822,57.15883911249617,81.31342860278467,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_80,1.0258633834301578,0.21986999011930156,5,0.09832884882379307,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,1.228214286572324,0.4172716909830793,6,0.17035045450280747,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,54.222126009134534,64.91740604881215,5.197182507313685,9.003892680992076,0.3344151753637788,1,59.41930851644822,73.921298729804235,81.31342860278467,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_80,0.9537099575879194,0.06930660152196624,6,0.02829430158920289,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,54.222126009134534,50.4084484657105,5.197182507313685,1.495498534103458,0.5143362102605165,1,59.41930851644822,51.903946999813954,81.31342860278467,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,1.0046695191686963,0.07623682019024211,6,0.03112355151306726,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,138.05533092624532,146.59968531149357,6.216624982431891,4.541496253780132,0.29537602657323386,1,144.2719559086772,151.1411815652737,166.2552997218011,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_80,0.946113783570802,0.10435673498163626,6,0.04260345865464342,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.9794771232327153,0.07118896951578904,6,0.029062775104704938,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,138.05533092624532,142.92365329699268,6.216624982431891,4.240791228695619,0.5341432457451853,1,144.2719559086772,147.1644445256883,166.2552997218011,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_80,0.9219278703799263,0.06522056863895759,6,0.026626185649935474,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,138.05533092624532,134.52616317993278,6.216624982431891,3.8852481963977232,0.6425312362245562,1,144.2719559086772,138.4114113763305,166.2552997218011,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.9433500816211902,0.10641406158821233,6,0.043443358724703916,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,132.88471926631746,137.6520561892521,5.537390804048632,6.339181787047456,0.58383959632001,1,138.4221100703661,143.99123797629957,164.02396421418115,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_80,0.9106788103022714,0.09295462188259543,6,0.03794856547428438,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.9140181657743213,0.042994571695409656,6,0.017552460393876985,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,132.88471926631746,133.37199239644167,5.537390804048632,2.561225478716601,0.9385639610920216,1,138.4221100703661,135.93321787515828,164.02396421418115,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_80,0.9808708963853735,0.1004796648255145,6,0.041020651391398245,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,132.88471926631746,143.12703032961565,5.537390804048632,5.985664410549022,0.2378069088196837,1,138.4221100703661,149.11269474016467,164.02396421418115,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,1.1167760096095627,0.10023996372923448,6,0.040922793828619616,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,145.91831693350866,162.9580757139473,5.856099056910434,5.9713851996891485,0.06896301374802863,1,151.7744159904191,168.92946091363643,189.74014449776917,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_80,1,0.09830468767783805,6,0.04013272068906137,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,1.1157025572052226,0.16265660830905576,6,0.0664042822748222,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,145.91831693350866,162.80143934579775,5.856099056910434,9.689601106719676,0.17323724175648517,1,151.7744159904191,172.4910404525174,189.74014449776917,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_80,0.9701032109588242,0.06506487583861868,6,0.026562624330359583,leaf_1_log2-1,1,967514 MM WT,leaf,ns,145.91831693350866,141.55582779490413,5.856099056910434,3.87597343562314,0.5504349162494104,1,151.7744159904191,145.43180123052727,189.74014449776917,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.8625499288176405,0.04282349866689864,6,0.01748262012244289,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,125.86971456698815,125.8618338841878,4.109876571137474,2.551034503854758,0.9987383424733681,1,129.9795911381256,128.41286838804257,152.58886736890165,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_80,0.8626039363128334,0.06899134198274413,6,0.028165597421263035,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.9208739801858897,0.0729344462883164,6,0.02977536301313361,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,125.86971456698815,134.37238129658624,4.109876571137474,4.344770856960703,0.18563504004392756,1,129.9795911381256,138.71715215354695,152.58886736890165,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_80,0.8555407232618911,0.08315799226124371,6,0.0339491081790599,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,125.86971456698815,124.83906240645186,4.109876571137474,4.953796726882033,0.8760808009977357,1,129.9795911381256,129.7928591333339,152.58886736890165,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,1.079735445966522,0.1567559172018174,6,0.06399533521773682,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,232.09232504108763,233.96102948023207,27.83168071732963,13.866743530005857,0.9540494122619559,1,259.92400575841725,247.82777301023793,286.27849145511345,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_68,1.0711113326880766,0.28720914945057535,5,0.12844383638627657,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,1.1163701556046732,0.2074819039393305,6,0.08470413258541913,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,232.09232504108763,241.89917248893812,27.83168071732963,18.354001561165,0.7769902255930778,1,259.92400575841725,260.2531740501031,286.27849145511345,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_68,0.9558233398706739,0.16692702054382424,5,0.07465203304349897,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,232.09232504108763,207.111300673471,27.83168071732963,16.175875830412313,0.4653312674705967,1,259.92400575841725,223.2871765038833,286.27849145511345,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.9728919436394649,0.2462406880604641,6,0.10052733994332984,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,166.15857604840284,210.8097882284126,7.899546580548829,21.782632062243085,0.10000844771104203,1,174.05812262895165,232.5924202906557,278.7541883052257,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_68,0.7668255888998088,0.0893000340730964,6,0.036456586248706326,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,1.1095179449119392,0.14694076624780178,6,0.05998831662011519,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,166.15857604840284,240.4144103892254,7.899546580548829,12.998488070070664,0.0011178599028079355,0.025710777764582516,174.05812262895165,253.41289845929606,278.7541883052257,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_68,0.8382986959923028,0.10432426064313194,6,0.042590201061465084,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,166.15857604840284,181.6456305653009,7.899546580548829,9.228600694117992,0.2318415528241419,1,174.05812262895165,190.8742312594189,278.7541883052257,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.911041978945685,0.3094036666689857,6,0.12631351798086435,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,216.68366112664066,197.4079114380109,18.354333977785934,27.370075525879443,0.5739962680483013,1,235.03799510442659,224.77798696389033,269.27357597429443,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_68,1,0.18940762881090856,5,0.08470566669564783,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,1.041694101839572,0.2156444707680452,6,0.08803648653903894,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,216.68366112664066,225.7180917606261,18.354333977785934,19.076068216005176,0.7407664258514212,1,235.03799510442659,244.79415997663128,269.27357597429443,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_68,0.7815969271063764,0.20526205432368555,6,0.08379788277474522,fruit_1_log2-1,1,967514 MM WT,fruit,ns,216.68366112664066,169.35928369074173,18.354333977785934,18.15763203429285,0.10051927243103193,1,235.03799510442659,187.51691572503458,269.27357597429443,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.8634925920482869,0.13709042744627326,6,0.055966932643901304,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,175.88898513024054,187.10473620075555,50.57142935437055,12.12711986730864,0.8387550354190041,1,226.46041448461108,199.2318560680642,260.33262275357765,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_68,0.8117316470273332,0.52187208379136,5,0.2333882909833894,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,0.9938204160929478,0.2410264238716401,6,0.09839862550221551,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,175.88898513024054,215.3446462614213,50.57142935437055,21.32137442364929,0.5020369900422381,1,226.46041448461108,236.66602068507058,260.33262275357765,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_68,0.8268810870464551,0.5433292492360495,6,0.2218132371596314,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,175.88898513024054,179.17162125760234,50.57142935437055,48.06330431410075,0.9635269985611227,1,226.46041448461108,227.2349255717031,260.33262275357765,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,1.271271161591799,0.34441083761249786,6,0.14060513567252939,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,596.0870145939413,782.8944435752147,78.19331596465737,86.58969288529212,0.140740221239757,1,674.2803305585986,869.4841364605069,958.108193772313,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_68,0.9679315489736579,0.31101421600792745,6,0.126971021995195,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,1.1479754377290403,0.23358244691183447,6,0.09535963463412248,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,596.0870145939413,706.9645082120363,78.19331596465737,58.72588819126304,0.28530860317786605,1,674.2803305585986,765.6903964032994,958.108193772313,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_68,1.296493193246277,0.2886887108254985,6,0.11785667267072629,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,596.0870145939413,798.4270766078433,78.19331596465737,72.58037227607764,0.08727530297676643,1,674.2803305585986,871.0074488839209,958.108193772313,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,1.725205897036433,0.43291657416281926,6,0.17673745131544313,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1278.2002101207167,1062.4437583574381,198.18850412298667,108.84127068001133,0.3687324983715918,1,1476.3887142437034,1171.2850290374495,1624.027585668074,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_68,2.075553197754856,0.7882955399852213,6,0.32182030657925437,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,2.192407258440252,0.39952593672552283,6,0.16310578066416823,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1278.2002101207167,1350.1631379238197,198.18850412298667,100.44639826257405,0.7549796357539711,1,1476.3887142437034,1450.6095361863938,1624.027585668074,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_68,1.8002110932243474,0.27154181872344907,6,0.11085648328329628,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1278.2002101207167,1108.6346522508074,198.18850412298667,68.2694042143693,0.4486167171393529,1,1476.3887142437034,1176.9040564651768,1624.027585668074,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,1.2700899435718946,0.2964147159448275,6,0.1210108010528074,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,615.8359185894908,782.1670070908723,73.05920331425853,74.52279782560576,0.14207723160016067,1,688.8951219037493,856.689804916478,1273.9239436755215,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_68,1,0.29059326312773615,6,0.11863420289221381,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,1.583597603846672,0.29854273114486113,6,0.12187955962030224,leaf_1_transp1-1,1,967514 MM WT,leaf,*,615.8359185894908,975.2362850410317,73.05920331425853,75.05781055605144,0.006432024702735912,0.14150454346019006,688.8951219037493,1050.294095597083,1273.9239436755215,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_68,1.7643831084747221,0.28455931182662725,6,0.11617085258879391,leaf_1_log2-1,1,967514 MM WT,leaf,*,615.8359185894908,1086.5704923513117,73.05920331425853,71.54218371734423,9.758984623303328e-4,0.023421563095927987,688.8951219037493,1158.112676068656,1273.9239436755215,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,1.9074085859698908,0.534081758119605,6,0.21803796472026316,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1426.2529480152073,1174.6507186662493,116.4309613623059,134.27561029088625,0.18784380245241208,1,1542.6839093775131,1308.9263289571356,1696.9523003152647,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_68,2.3159625883496595,0.463104598141281,6,0.18906166049713227,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,2.1111461092038644,0.3992366619764563,6,0.16298768474238745,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1426.2529480152073,1300.1196034381915,116.4309613623059,100.3736705521025,0.4314500872473064,1,1542.6839093775131,1400.493273990294,1696.9523003152647,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_68,2.3410180007637438,0.3806796294910704,6,0.15541180795414627,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1426.2529480152073,1441.6829709348735,116.4309613623059,95.70817351109523,0.92055654526695,1,1542.6839093775131,1537.3911444459688,1696.9523003152647,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,1.6260416952839631,1.9453323917632888,6,0.7941786233213406,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,236.98549676744128,55.71517557926619,101.4501620591981,27.21197221939699,0.15036696620278742,1,338.4356588266394,82.92714779866319,372.2792247093034,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_93,6.916397461104756,6.620578227599758,5,2.9608125934536265,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,4.383793886080851,6.960024401950444,6,2.8414180636830397,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,236.98549676744128,150.20761569318478,101.4501620591981,97.35919243113423,0.5527735935768241,1,338.4356588266394,247.566808124319,372.2792247093034,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_93,0.5037280776371469,0.22521648670630318,5,0.10071987478579432,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,236.98549676744128,17.259888458677374,101.4501620591981,3.4510957033191274,0.0962336338032689,1,338.4356588266394,20.7109841619965,372.2792247093034,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,3.439459497846724,4.366828616487676,6,1.7827503174297699,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,64.11225039958765,117.85066174876881,36.30412302098442,61.08468635070663,0.47081353988465813,1,100.41637342057207,178.93534809947545,196.82888290942302,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_93,1.8711094642410258,2.595313044489257,6,1.059532113631303,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.9515766197003896,1.154134715189543,6,0.47117352444112837,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,64.11225039958765,32.6051039143084,36.30412302098442,16.144429579313286,0.4541695042613686,1,100.41637342057207,48.74953349362168,196.82888290942302,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_93,2.5701894824833462,3.3738973770462244,6,1.3773878363796328,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,64.11225039958765,88.06573577040749,36.30412302098442,47.19522590792797,0.696483020356302,1,100.41637342057207,135.26096167833546,196.82888290942302,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,7.990780151679504,12.951607488251781,6,5.287471615837757,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,34.2642969985689,273.798464367416,27.16798308634431,181.17149781656792,0.24562146487498548,1,61.43228008491322,454.9699621839839,500.4669584023823,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_93,1,1.7729666829343593,5,0.7928948049767087,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,6.329442703103332,7.339222320347788,6,2.9962249656162108,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,34.2642969985689,216.87390461455738,27.16798308634431,102.66354209640075,0.1390070240485239,1,61.43228008491322,319.53744671095814,500.4669584023823,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_93,1.4865943724790456,2.4045455166274388,6,0.9816515965056982,fruit_1_log2-1,1,967514 MM WT,fruit,ns,34.2642969985689,50.937111095023184,27.16798308634431,33.63560185179057,0.708827171150323,1,61.43228008491322,84.57271294681375,500.4669584023823,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.9795618352544702,0.5612903442815108,6,0.2291458235067999,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,82.18938974393983,33.56399765162239,77.96563887092974,7.851520552618644,0.5678793240341597,1,160.15502861486956,41.41551820424103,443.8916957095372,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_93,2.3986889253082464,5.087991982788389,5,2.2754191884977555,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,7.095615557617905,11.4675235669095,6,4.6815968920448645,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,82.18938974393983,243.126278853886,77.96563887092974,160.41162633660235,0.3962829957689634,1,160.15502861486956,403.53790519048835,443.8916957095372,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_93,2.421849666232869,2.314400438037856,6,0.9448500222777704,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,82.18938974393983,82.98297624968798,77.96563887092974,32.37462178242997,0.9928389476367766,1,160.15502861486956,115.35759803211795,443.8916957095372,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,1.2183478401880625,0.916971420295067,6,0.37435201473968155,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,45.5802909052258,90.96290019513373,11.839144014251962,27.949444182834224,0.18016429656222238,1,57.419434919477766,118.91234437796795,150.49175650825433,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_93,0.6104977838261175,0.3884212018961728,6,0.15857229165403156,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,1.3898762826187565,1.0840269866823276,6,0.44255216412975307,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,45.5802909052258,103.76936159702822,11.839144014251962,33.04132613774842,0.14633238927401676,1,57.419434919477766,136.81068773477665,150.49175650825433,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_93,0.8202698937686252,0.5145946900808818,6,0.2100824025073014,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,45.5802909052258,61.2420574968402,11.839144014251962,15.684933302032873,0.4453326448710835,1,57.419434919477766,76.92699079887306,150.49175650825433,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.9818381914801441,0.5253723551677661,6,0.214482365854214,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,66.44262619543163,73.30488590646907,17.616324020438586,16.013438359115487,0.7790957008748401,1,84.05895021587021,89.31832426558455,99.5661245391504,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_93,0.889925782357119,0.5779601752266978,6,0.23595125349249413,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.5716678050263315,0.8064246561013073,6,0.3292214872412674,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,66.44262619543163,42.68121120923448,17.616324020438586,24.5799600887365,0.4520702057830809,1,84.05895021587021,67.26117129797098,99.5661245391504,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_93,0.8681212280310499,0.8431704891195557,6,0.3442229107526379,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,66.44262619543163,64.81467936978991,17.616324020438586,25.699979302164984,0.9594914998043798,1,84.05895021587021,90.51465867195489,99.5661245391504,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,1.829767875021841,1.4994764764728303,6,0.61215870811081,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,74.66086218948179,136.6120471557466,15.371479528281878,45.70429694435239,0.24538065833206582,1,90.03234171776367,182.316344100099,241.8155343909742,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_93,1,0.5043108307585619,6,0.20588403451959345,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,1.6119032163042515,0.591011237554175,6,0.241279327376424,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,74.66086218948179,120.34608389527418,15.371479528281878,18.01412261042205,0.08326619071246878,1,90.03234171776367,138.36020650569623,241.8155343909742,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_93,2.3017229320869035,1.5742591454961814,6,0.642688604895918,leaf_1_log2-1,1,967514 MM WT,leaf,ns,74.66086218948179,171.84861863091027,15.371479528281878,47.98368536088444,0.101878003110162,1,90.03234171776367,219.8323039917947,241.8155343909742,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.9118304222889774,0.42471353666961664,6,0.1733885752822322,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,64.83609418598816,68.07804549869432,19.800379345310304,12.945340524377327,0.8941470337456487,1,84.63647353129846,81.02338602307165,187.56593325353703,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_93,0.8684080559027118,0.6496151355239275,6,0.2652042685370941,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,1.6331042389809707,1.5940040780279985,6,0.6507494398473566,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,64.83609418598816,121.92897052761678,19.800379345310304,48.58551424832596,0.31454897443616753,1,84.63647353129846,170.51448477594275,187.56593325353703,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_93,0.8735332921290889,0.7441052693887732,6,0.30377970415311895,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,64.83609418598816,65.21874874157425,19.800379345310304,22.68045462773756,0.9901139244514603,1,84.63647353129846,87.8992033693118,187.56593325353703,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,1.025788541201779,0.5687339834904673,6,0.2321846764886862,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,462.79551764146515,356.6652504575642,60.72395456786439,80.73028939787706,0.3215750233549601,1,523.5194722093296,437.39553985544126,629.7183467598281,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_94,1.3310249268947043,0.39051893269124077,5,0.17464537599965585,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,1.2386969651339712,0.9988069335440255,6,0.40776122312280166,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,462.79551764146515,430.6932136256215,60.72395456786439,141.778010701495,0.8412873787007356,1,523.5194722093296,572.4712243271165,629.7183467598281,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_94,1.1117900021338074,0.7180578580393777,5,0.32112523647078844,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,462.79551764146515,386.5678389258483,60.72395456786439,111.6547985220364,0.5700088925605755,1,523.5194722093296,498.2226374478847,629.7183467598281,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,1.2484848547712963,0.5749057849750097,6,0.23470430389383293,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,294.78535160368045,434.0964492523889,36.50884000678513,81.60636034566086,0.1635927211303372,1,331.2941916104656,515.7028095980497,567.2730905578547,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_94,0.8478186069466018,0.257199846111552,6,0.10500139748260975,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,0.7937921409839058,0.16269617576024983,6,0.06642043561913019,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,294.78535160368045,276.0004244574416,36.50884000678513,23.09429317454,0.6745750745611306,1,331.2941916104656,299.0947176319816,567.2730905578547,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_94,0.8102344756314573,0.3663056076654999,6,0.14954363811676688,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,294.78535160368045,281.71740136800986,36.50884000678513,51.996115184484474,0.8416301465154358,1,331.2941916104656,333.71351655249435,567.2730905578547,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,1.1673641972610047,0.37937613681420473,6,0.1548796592971837,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,347.6986105145094,405.89090935203706,57.415017951173766,53.851442334591404,0.479159254775148,1,405.1136284656832,459.74235168662847,675.2640406353847,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_94,1,0.3692389879793258,5,0.16512869541300004,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,1.5256237950745106,0.5876764802104655,6,0.23991791839174278,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,347.6986105145094,530.45727371528,57.415017951173766,83.41912686234244,0.10664965024698964,1,405.1136284656832,613.8764005776225,675.2640406353847,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_94,1.2315228874287103,0.8071516048275013,6,0.32951826281599095,fruit_1_log2-1,1,967514 MM WT,fruit,ns,347.6986105145094,428.19879677577916,57.415017951173766,114.57304212027499,0.5491614363156986,1,405.1136284656832,542.7718388960542,675.2640406353847,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,1.170426983086799,0.28121811975350125,6,0.1148068166368288,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,742.4765295769716,406.95583572796926,239.82282139457666,39.918170622219435,0.23615030805396087,1,982.2993509715483,446.87400635018867,1167.222901821168,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_94,2.135402636433568,1.54231312687885,5,0.6897433988582733,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,2.784064414767079,0.6558515645581915,6,0.2677502800289316,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,742.4765295769716,968.0153285974043,239.82282139457666,93.0964003309303,0.4192879554192347,1,982.2993509715483,1061.1117289283345,1167.222901821168,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_94,1.1593177237131935,0.8972322520245823,6,0.36629353303807766,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,742.4765295769716,403.09316167992137,239.82282139457666,127.35975247779014,0.25660080908858973,1,982.2993509715483,530.4529141577115,1167.222901821168,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,1.70884972091962,0.14074614965374999,6,0.05745937498551446,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,3073.969513289624,4308.559268236164,165.64235649234777,144.8735483349975,2.3943569455390113e-4,0.005746456669293627,3239.611869781972,4453.432816571161,4898.776098228278,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_94,1.2191899003517352,0.1609232614497913,6,0.06569664638274657,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,1.6103570093232638,0.10713038442066307,6,0.04373579629647217,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,3073.969513289624,4060.2274926521636,165.64235649234777,110.2719965249172,8.663385805242294e-4,0.017326771610484588,3239.611869781972,4170.499489177081,4898.776098228278,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_94,1.2732790319380995,0.23940532130384143,6,0.09773681315024511,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,3073.969513289624,3210.345595021294,165.64235649234777,246.4259127009346,0.6572140486800667,1,3239.611869781972,3456.7715077222283,4898.776098228278,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,1.79290780845284,0.3127012301226339,6,0.12765974262351232,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,3695.4163100041114,4520.49671813466,241.42487242695174,321.87123333769694,0.06962391961124632,1,3936.8411824310633,4842.367951472357,6086.31584943463,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_94,1.46566653419103,0.23454675898576513,6,0.09575331338977833,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,2.1328922035640607,0.15088311334900453,6,0.06159777308459637,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,3695.4163100041114,5377.706628801239,241.42487242695174,155.3077797756972,2.9562559531237333e-4,0.0067993886921845865,3936.8411824310633,5533.014408576936,6086.31584943463,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_94,1.4847706337743858,0.12505200980396253,6,0.051052269221537945,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,3695.4163100041114,3743.5838839654302,241.42487242695174,128.71917584453968,0.8648340231229096,1,3936.8411824310633,3872.30305980997,6086.31584943463,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,1.2310164268608064,0.1371713948855559,6,0.05599998746257169,leaf_1_panK4-1,1,967514 MM WT,leaf,*,2521.321340016667,3103.7879869552175,72.36684315595276,141.19396343004783,0.007117255569825107,0.135227855826677,2593.6881831726196,3244.9819503852655,3569.4801454237922,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_94,1,0.07030513612633507,6,0.028701951634405472,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,1.2053898382666102,0.06603025174864181,6,0.026956737395281524,leaf_1_transp1-1,1,967514 MM WT,leaf,*,2521.321340016667,3039.1751222608427,72.36684315595276,67.96659725194856,3.970986902299316e-4,0.008736171185058495,2593.6881831726196,3107.1417195127915,3569.4801454237922,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_94,1.1287231920315015,0.07045337570120751,6,0.028762470187426233,leaf_1_log2-1,1,967514 MM WT,leaf,*,2521.321340016667,2845.873871040755,72.36684315595276,72.51942987515096,0.010023270209625432,0.18041886377325778,2593.6881831726196,2918.393300915906,3569.4801454237922,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,3.0365128041306026,0.5054634990365438,6,0.20635460937355146,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,5788.555293205857,7656.0245322883375,326.00193592165215,520.2862802243387,0.01513274672681588,0.25725669435586995,6114.557229127509,8176.310812512676,10373.792213453706,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_94,2.2958419465753592,0.3167142503788379,6,0.12929805128270447,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,3.5418925867603392,0.48621258530111633,6,0.19849545675119593,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,5788.555293205857,8930.249363045677,326.00193592165215,500.4708310031458,6.052807764521859e-4,0.012710896305495904,6114.557229127509,9430.720194048823,10373.792213453706,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_94,2.820602359738867,0.5091315464804759,6,0.2078520834718771,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,5788.555293205857,7111.644921310973,326.00193592165215,524.0618936245693,0.0629218586868259,1,6114.557229127509,7635.706814935542,10373.792213453706,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.7145056072750983,0.6689400281624905,6,0.2730936229201852,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,14137.872767013083,3732.4613060090514,7787.233492399158,1426.5967545793708,0.2549027442788307,1,21925.10625941224,5159.058060588422,24117.61688535347,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_104,2.7064150271858867,3.3333316517351035,5,1.490711232966269,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.786897226340351,0.7332307128875107,6,0.29934018505192583,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,14137.872767013083,4110.623372603402,7787.233492399158,1563.7045345254091,0.2705917172210319,1,21925.10625941224,5674.327907128811,24117.61688535347,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_104,0.8181017730291799,1.213021968910673,5,0.5424799161369802,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,14137.872767013083,4273.630859041173,7787.233492399158,2833.827020602698,0.286926779955044,1,21925.10625941224,7107.457879643871,24117.61688535347,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,1.5449711136184254,1.3606642476296256,6,0.5554888529900931,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,5054.0355383011565,8070.678300866373,1385.8933493961717,2901.783594969881,0.378725438527154,1,6439.928887697328,10972.461895836255,15463.371321656954,0,23,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_104,0.967494753574557,0.649853950108439,6,0.2653017641829588,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.8198576742129905,0.5307508701732068,6,0.2166781354104194,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,5054.0355383011565,4282.803401788238,1385.8933493961717,1131.891405809778,0.6759652960626232,1,6439.928887697328,5414.694807598016,15463.371321656954,0,23,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_104,1.6088758799720115,2.419815723382065,5,1.082174490101025,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,5054.0355383011565,8404.506426574102,1385.8933493961717,5653.10386584131,0.5925422633799221,1,6439.928887697328,14057.610292415411,15463.371321656954,0,23,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.6537745534516411,0.18677574902165553,6,0.07625088023819841,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,5223.837669019135,3415.2121393668476,1989.1328043068156,398.3222204841677,0.41949707830824334,1,7212.970473325951,3813.5343598510153,7955.810298948683,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_104,1,0.8514499202537402,5,0.3807799802248276,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.7436932029377977,0.5849528937921334,6,0.23880601889252812,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,5223.837669019135,3884.9325676999597,1989.1328043068156,1247.4838770792835,0.5865658335996953,1,7212.970473325951,5132.416444779243,7955.810298948683,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_104,1.0707410744606296,0.7686203393308965,6,0.3137879395475928,fruit_1_log2-1,1,967514 MM WT,fruit,ns,5223.837669019135,5593.377558533461,1989.1328043068156,1639.1772586926147,0.8894423177651795,1,7212.970473325951,7232.554817226075,7955.810298948683,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,3.4176674525966777,3.009272597253322,6,1.2285303933684177,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,37433.00742808753,17853.339979055196,18307.776667962677,6417.643346412838,0.3593148932265546,1,55740.78409605021,24270.983325468034,66674.026671826,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_104,7.165806022283272,7.836658744056233,5,3.504660333635573,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,9.408589596850044,5.3754497898187745,6,2.1945181871678465,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,37433.00742808753,49148.94474836683,18307.776667962677,11463.806771474983,0.6046133695577606,1,55740.78409605021,60612.75151984181,66674.026671826,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_104,4.066306590907412,4.363399706775713,6,1.781350470901706,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,37433.00742808753,21241.72554336292,18307.776667962677,9305.485691621308,0.46040905039274727,1,55740.78409605021,30547.21123498423,66674.026671826,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,1.2727345928240523,0.09898343629486396,6,0.040409818651616906,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,777523.3317061171,835405.9422669389,21433.927319209717,26524.463794594976,0.1218267244505931,1,798957.2590253268,861930.4060615338,948123.4466676873,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_104,1.1845508763139523,0.07998667930780448,6,0.03265442508729243,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,1.1970890950239115,0.08655183947082677,6,0.03533464050046774,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,777523.3317061171,785753.2505554985,21433.927319209717,23193.184822970838,0.7997208564224756,1,798957.2590253268,808946.4353784694,948123.4466676873,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_104,1.2172535893097458,0.14295339944207622,6,0.05836048093822537,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,777523.3317061171,798988.9545617953,21433.927319209717,38307.03812423989,0.638199375172186,1,798957.2590253268,837295.9926860352,948123.4466676873,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,1.258632139426828,0.22561310212477553,6,0.09210616324868856,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,765336.4244533308,826149.2807170689,68354.4053708883,60457.25207062119,0.5204478376377044,1,833690.8298242191,886606.5327876902,1062535.3673255574,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_104,1.165984215897257,0.2550835327680163,6,0.10413741617802545,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,1.3440859054337253,0.31235458240269576,6,0.1275182242844544,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,765336.4244533308,882239.9883270881,68354.4053708883,83701.25469614583,0.30573123689301795,1,833690.8298242191,965941.243023234,1062535.3673255574,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_104,1.1057178339184095,0.30646536263746793,6,0.12511396038313413,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,765336.4244533308,725778.3784098548,68354.4053708883,82123.12806922347,0.7191844785494816,1,833690.8298242191,807901.5064790783,1062535.3673255574,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,1.2134670617410581,0.10466199304309469,6,0.042728079736384136,leaf_1_panK4-1,1,967514 MM WT,leaf,*,656386.6079991342,796503.5285748892,18956.774766306207,28046.139324481723,0.0026634842973652846,0.06126013883940155,675343.3827654404,824549.6678993709,916577.6213075466,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_104,1,0.07074249349459498,6,0.028880502032319354,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,1.1383434964306312,0.10641330438594196,6,0.0434430495981715,leaf_1_transp1-1,1,967514 MM WT,leaf,*,656386.6079991342,747193.4263599765,18956.774766306207,28515.435966881956,0.0271566985597301,0.5974473683140622,675343.3827654404,775708.8623268584,916577.6213075466,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_104,1.2248963559294228,0.10914266341942597,6,0.04455730575765345,leaf_1_log2-1,1,967514 MM WT,leaf,*,656386.6079991342,804005.564219014,18956.774766306207,29246.81878784644,0.0024434481560469488,0.05864275574512677,675343.3827654404,833252.3830068605,916577.6213075466,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,1.31883099487217,0.2729828027242356,6,0.11144476253820315,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,853933.294184607,865663.0032482671,61728.221635565416,73150.84966172016,0.9049605368523563,1,915661.5158201724,938813.8529099873,1199618.233308985,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_104,1.3009608724158084,0.23035607962428684,6,0.09404247570457262,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,1.5978038556327407,0.15593229948666593,6,0.06365909469353047,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,853933.294184607,1048777.0530467131,61728.221635565416,41784.97723418215,0.028636656277328528,0.6013697818238991,915661.5158201724,1090562.0302808953,1199618.233308985,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_104,1.0446305373201985,0.3782809577928352,6,0.15443255433395772,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,853933.294184607,685681.4950039181,61728.221635565416,101367.46050390849,0.1928926852720599,1,915661.5158201724,787048.9555078265,1199618.233308985,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.9942090623661319,0.28382689712884135,6,0.1158718455405122,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,137.71404956433514,99.88469418428464,35.65034857279615,11.641237536940192,0.36071898559016274,1,173.36439813713127,111.52593172122484,190.70083795084443,1,24,4.166666666666666,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_108,1.370746110904572,0.7934646003794852,5,0.35484815683764687,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.7558726631373159,0.2803415241053223,6,0.11444894796203169,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,137.71404956433514,75.93987286743075,35.65034857279615,11.498284012513608,0.1620443359814443,1,173.36439813713127,87.43815687994436,190.70083795084443,1,24,4.166666666666666,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_108,0.3586776304036731,0.42867691295568705,5,0.1917101435507353,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,137.71404956433514,36.0350823380658,35.65034857279615,19.260445096947464,0.04498421975246475,1,173.36439813713127,55.29552743501326,190.70083795084443,1,24,4.166666666666666,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,1.2690253965336522,0.26173149573462096,6,0.10685143569420887,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,147.290577999341,127.4945264964549,19.463827897081728,10.734988627107674,0.39983502610943944,1,166.75440589642272,138.22951512356258,183.429846486065,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_108,1.466066734688268,0.47455073919319085,6,0.1937345280139827,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,1.4039679497241633,0.4876431406464641,6,0.1990794785253481,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,147.290577999341,141.05173108057187,19.463827897081728,20.000816310753276,0.8276129000976755,1,166.75440589642272,161.05254739132513,183.429846486065,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_108,0.618255023293204,0.23964213580516744,6,0.09783349226556852,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,147.290577999341,62.11391171849686,19.463827897081728,9.828987509599044,0.005253987465053225,0.12609569916127739,166.75440589642272,71.9428992280959,183.429846486065,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.848361136083697,0.4433227743941878,6,0.180985764770124,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,100.4664893584531,85.23186505047792,12.774853407226981,18.183004410309163,0.5111452643681287,1,113.24134276568009,103.41486946078709,124.5654770422481,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_108,1,0.28432804613323415,5,0.12715536781272155,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.7221186329043836,0.24773288066914012,6,0.10113652502486464,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,100.4664893584531,72.54872394822895,12.774853407226981,10.16083161516149,0.12521613523007688,1,113.24134276568009,82.70955556339044,124.5654770422481,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_108,0.803819184465284,0.5547143570575457,6,0.22646118796450396,fruit_1_log2-1,1,967514 MM WT,fruit,ns,100.4664893584531,80.75689154220191,12.774853407226981,22.751760530738487,0.4725193265679869,1,113.24134276568009,103.50865207294041,124.5654770422481,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,3.0910062735057275,0.7087515761407588,6,0.28934661932303324,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,304.76931137951135,310.54254888407496,81.09130867244677,29.069639051121897,0.9491507539819769,1,385.8606200519581,339.61218793519686,424.44668205715396,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_108,3.0335419633518677,1.8048374112990018,5,0.807147827999863,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,3.1947196794676227,0.7844296806426684,6,0.3202420761114834,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,304.76931137951135,320.9622706804746,81.09130867244677,32.17359713178328,0.8597028966639498,1,385.8606200519581,353.13586781225786,424.44668205715396,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_108,2.792737803907089,1.2717306970033362,6,0.519181882982029,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,304.76931137951135,280.5765628571813,81.09130867244677,52.16038112171566,0.8090545925283312,1,385.8606200519581,332.73694397889693,424.44668205715396,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,1.036459960977592,0.3843680124589975,6,0.15691758399537853,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,304.323723836296,227.87648315465017,75.42561072527938,34.499959990991265,0.38732878019221195,1,379.7493345615754,262.3764431456414,510.6880715397065,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_108,1.3841680833640957,0.8403253827120946,6,0.34306140092560405,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,1.4238052639277992,0.9445216258492404,6,0.3855993390591009,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,304.323723836296,313.03836950432856,75.42561072527938,84.77801806127383,0.9403187359570158,1,379.7493345615754,397.8163875656024,510.6880715397065,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_108,1.6404561937805515,1.1541142858011215,6,0.4711651841782301,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,304.323723836296,360.6713257455561,75.42561072527938,103.5905574723589,0.6703467800293645,1,379.7493345615754,464.261883217915,510.6880715397065,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,2.432259375905,1.1875954424606605,6,0.48483380914723967,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,439.0473932520628,534.7574759939412,87.67731802440326,106.59574658218222,0.5043942659519522,1,526.7247112764661,641.3532225761234,705.4885448337358,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_108,1.9969372783786545,0.9768230593767431,6,0.398786344076236,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,1.4227781724551514,0.8097610428143777,6,0.3305835614132047,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,439.0473932520628,312.81255278059876,87.67731802440326,72.6822281610636,0.29448808549416555,1,526.7247112764661,385.4947809416624,705.4885448337358,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_108,1.716315787730933,0.6445276329169589,6,0.26312730429506875,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,439.0473932520628,377.34984506495937,87.67731802440326,57.85126968934603,0.5719594724926556,1,526.7247112764661,435.2011147543054,705.4885448337358,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.6974097532628666,0.43018347571644056,6,0.1756216685470396,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,219.8603821991507,153.33277490178924,82.47912537467366,38.612247169204686,0.4885043646831261,1,302.33950757382433,191.94502207099393,496.5531573448342,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_108,1,0.918909398674607,6,0.3751431911000847,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.9411592324322173,0.656374771716028,6,0.2679638784566768,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,219.8603821991507,206.9236285528066,82.47912537467366,58.91464073305172,0.9012314452122865,1,302.33950757382433,265.8382692858583,496.5531573448342,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_108,1.743237868082264,0.7591891736243189,6,0.3099376822708011,leaf_1_log2-1,1,967514 MM WT,leaf,ns,219.8603821991507,383.26894394059923,82.47912537467366,68.14301728197727,0.15873733591045075,1,302.33950757382433,451.4119612225765,496.5531573448342,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,2.136265035708916,1.6163511010693803,6,0.6598725738009572,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,317.6105123370091,469.6800472296446,59.704226918553324,145.07983627861574,0.3663319250042816,1,377.3147392555624,614.7598835082604,676.2358718590865,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_108,1.4446009288263486,0.6651716419983581,6,0.27155518571087045,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,2.2241401564911687,1.1366782241687399,6,0.46404694182438777,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,317.6105123370091,489.00030487062725,59.704226918553324,102.02553798785695,0.18484380215615415,1,377.3147392555624,591.0258428584842,676.2358718590865,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_108,1.532002178708001,1.0841227502661805,6,0.44259125944914973,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,317.6105123370091,336.8265845406727,59.704226918553324,97.30828346049354,0.8703629284695404,1,377.3147392555624,434.13486800116624,676.2358718590865,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,1.1214809163197144,0.4620515214039858,6,0.18863174371940425,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,198.026734857116,179.10872808459482,31.580161574233752,30.125873032983538,0.6751425150347572,1,229.60689643134975,209.23460111757836,252.56758607448475,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_57,1.239935130120892,0.4421549463854237,5,0.19773770334111646,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,1.1145579154373304,0.3748948626920409,6,0.15305018679771037,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,198.026734857116,178.0030740654061,31.580161574233752,24.44323741183724,0.6296752687274014,1,229.60689643134975,202.44631147724334,252.56758607448475,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_57,0.6480634432283922,0.13045267542351058,5,0.05834021001873716,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,198.026734857116,103.50048524737424,31.580161574233752,9.317359449088704,0.03765113956617721,0.903627349588253,229.60689643134975,112.81784469646294,252.56758607448475,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,1.1940145657666101,0.28723845627946815,6,0.11726460873157193,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,145.67395772099292,190.69288391526234,13.22715898088158,18.728018117485206,0.08120838792418028,1,158.90111670187449,209.42090203274756,230.36299223602234,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_57,0.9121306668634089,0.20286976992425637,6,0.08282123675837488,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.9762519135520198,0.1309083041433221,6,0.05344309137403469,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,145.67395772099292,155.91459112854483,13.22715898088158,8.535253682536396,0.5324399737375178,1,158.90111670187449,164.44984481108122,230.36299223602234,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_57,0.8832359045907203,0.0730182789249422,6,0.029809587543721174,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,145.67395772099292,141.05925225105818,13.22715898088158,4.760809775705698,0.7533912160948718,1,158.90111670187449,145.82006202676388,230.36299223602234,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.9939626700167702,0.2775751296510314,6,0.11331957215531872,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,159.70733471984832,158.74312883940246,15.331411736425597,18.09796684051949,0.9684639186725235,1,175.0387464562739,176.84109567992195,194.61264945477484,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,1,967514 MM WT,MoneyMaker,m_57,1,0.21465563177684896,5,0.09599691688123964,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.9967298105805587,0.27201628699498415,6,0.11105018414402983,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,159.70733471984832,159.18506148364028,15.331411736425597,17.73552892979136,0.98271293879694,1,175.0387464562739,176.92059041343165,194.61264945477484,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_57,0.8005909017238372,0.27036980742574307,6,0.11037801167460347,fruit_1_log2-1,1,967514 MM WT,fruit,ns,159.70733471984832,127.86023911527406,15.331411736425597,17.628178056227224,0.20597824650403035,1,175.0387464562739,145.48841717150128,194.61264945477484,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,2.055993247165007,0.6525726886088334,6,0.2664116845279631,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,361.17496273220786,328.3572017067296,86.2874847020389,42.54790007418604,0.7448314105120571,1,447.46244743424677,370.90510178091563,492.2086921776715,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_57,2.261480121534589,1.208114090312053,5,0.5402850461026142,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,1.8480410996824288,0.33836610413063717,6,0.13813738356225008,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,361.17496273220786,295.14571848301824,86.2874847020389,22.06155335390035,0.49511437296605004,1,447.46244743424677,317.2072718369186,492.2086921776715,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_57,1.3613861849865159,0.37674585659457116,6,0.1538058518940774,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,361.17496273220786,217.42335912861884,86.2874847020389,24.56392267031883,0.17435167167675059,1,447.46244743424677,241.98728179893766,492.2086921776715,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.9752202732055603,0.4180351858239998,6,0.17066214996639123,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,90727.13660269429,80043.72269614585,14094.819361657854,14007.536740121153,0.6025937127201146,1,104821.95596435214,94051.259436267,115304.15156078736,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_57,1.1053826579344994,0.42064001261048184,6,0.171725566048927,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.8644794796708035,0.2607229999800159,6,0.1064397190264513,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,90727.13660269429,70954.38604842544,14094.819361657854,8736.314848751208,0.2659067107857002,1,104821.95596435214,79690.70089717665,115304.15156078736,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_57,0.7613292590845694,0.384312895974246,6,0.15689508278470238,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,90727.13660269429,62488.06528018351,14094.819361657854,12877.569143971687,0.1701478627800037,1,104821.95596435214,75365.6344241552,115304.15156078736,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,2.0109744306544437,1.2017765917710603,6,0.4906232391100232,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,124896.7203757557,165055.92028685723,19018.024848730933,40269.169518515344,0.39664304963265423,1,143914.74522448663,205325.08980537258,225857.59878590985,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_57,1.5216910166671667,0.5675661395106874,6,0.2317079061804125,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.9400077575802546,0.313133830644705,6,0.12783635104710164,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,124896.7203757557,77153.56453025673,19018.024848730933,10492.498684494138,0.06008128395301296,1,143914.74522448663,87646.06321475087,225857.59878590985,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_57,0.8985610618181248,0.382717797132539,6,0.1562438864094546,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,124896.7203757557,73751.7199281643,19018.024848730933,12824.120519580674,0.05347999629158193,1,143914.74522448663,86575.84044774497,225857.59878590985,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.9960620455409267,0.41019413178227765,6,0.1674610530584234,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,82077.5827732141,81754.36499014238,20000.494074659207,13744.798443692345,0.9896686024314256,1,102078.07684787331,95499.16343383472,112285.88453266065,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,1,967514 MM WT,MoneyMaker,m_57,1,0.5968865484481786,6,0.24367791300484468,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.8175345877711202,0.40083330849405224,6,0.16363951295367107,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,82077.5827732141,67101.26279774959,20000.494074659207,13431.13566942338,0.5500365702703173,1,102078.07684787331,80532.39846717297,112285.88453266065,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_57,0.5063487159804589,0.1634624525948458,6,0.06673326682687605,leaf_1_log2-1,1,967514 MM WT,leaf,ns,82077.5827732141,41559.8786479968,20000.494074659207,5477.305231709902,0.10065500223799813,1,102078.07684787331,47037.183879706696,112285.88453266065,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,1.2458898332964636,0.5619564711202416,6,0.22941776864994387,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,80410.2276443291,102259.62591869642,16767.31371776204,18830.05589601185,0.4067487426693047,1,97177.54136209114,121089.68181470827,151019.98621172403,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_57,0.9796856209387645,0.5003968389172563,6,0.20428615404149095,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,1.2002769346853062,1.1571872114756163,6,0.47241970083156515,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,80410.2276443291,98515.82945741291,16767.31371776204,38775.06709869984,0.6814609125957432,1,97177.54136209114,137290.89655611274,151019.98621172403,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_57,0.7789844458265373,0.21730942580627743,6,0.08871620158709645,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,80410.2276443291,63937.160331373925,16767.31371776204,7281.611379090057,0.3982110696846038,1,97177.54136209114,71218.77171046399,151019.98621172403,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,1.0739344714715813,0.23623318703347493,6,0.09644179475724617,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,84.45526851335163,84.45550453544897,8.46468462607908,7.584299276068983,0.9999839054673823,1,92.9199531394307,92.03980381151796,174.83049568333976,3,24,12.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_73,1.07393147021941,0.2406831052936521,5,0.10763675689446911,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,1.0245918680235429,0.4377392509699175,6,0.17870630087740072,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,84.45526851335163,80.57514257669146,8.46468462607908,14.05367944245564,0.8190017466343854,1,92.9199531394307,94.62882201914711,174.83049568333976,3,24,12.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_73,1.4673434586683785,1.2380970351266085,5,0.5536938266568083,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,84.45526851335163,115.3936626680932,8.46468462607908,43.5431515894884,0.5213777162289649,1,92.9199531394307,158.9368142575816,174.83049568333976,3,24,12.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,1.1678527088811341,0.43945431467628965,6,0.17940647270356377,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,101.67698352669939,91.84134821233084,4.250473734675465,14.108741800924381,0.5296809286022566,1,105.92745726137485,105.95009001325522,116.54509901458076,2,24,8.333333333333332,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_73,1.2929224467392508,0.13239231736447227,6,0.054048937234595015,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,1.181532302125388,0.40282259403975945,6,0.1644516353769505,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,101.67698352669939,92.91712795492548,4.250473734675465,12.932675322739723,0.5434519948898777,1,105.92745726137485,105.8498032776652,116.54509901458076,2,24,8.333333333333332,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_73,0.9498351463543168,0.12949849729220295,6,0.05286754013718105,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,101.67698352669939,74.69618365162852,4.250473734675465,4.157567239382424,0.0010796377082625196,0.025911304998300473,105.92745726137485,78.85375089101095,116.54509901458076,2,24,8.333333333333332,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,0.9335296697655201,0.13549852888877906,6,0.055317042779212414,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,78.64120835950264,73.41390126980797,7.3736346384763545,4.350199087031565,0.5618242014003356,1,86.014842997979,77.76410035683953,94.6163272977769,9,24,37.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,1,967514 MM WT,MoneyMaker,m_73,1,0.20966041388258866,5,0.09376298752644177,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.7729313783584124,0.10421521159579135,6,0.04254568197431158,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,78.64120835950264,60.784257573081476,7.3736346384763545,3.3458438409389717,0.07256685200895832,1,86.014842997979,64.13010141402044,94.6163272977769,9,24,37.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_73,0.8870525764134695,0.10843707497440093,6,0.04426925048120092,fruit_1_log2-1,1,967514 MM WT,fruit,ns,78.64120835950264,69.75888648756529,7.3736346384763545,3.4813873510111355,0.3195316899942023,1,86.014842997979,73.24027383857643,94.6163272977769,9,24,37.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,2.0854200938236254,0.42273134967053455,6,0.17257935082847725,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,194.76065323140625,163.99995611547726,28.59018171671545,13.571848687049986,0.37002283526644747,1,223.3508349481217,177.57180480252725,245.68591844293388,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_73,2.476572490354826,0.8129273588396283,5,0.36355216702695464,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,1.798077586776061,0.6288621305366011,6,0.2567318897290301,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,194.76065323140625,141.4029941482079,28.59018171671545,20.189706032709516,0.16841608128775812,1,223.3508349481217,161.59270018091743,245.68591844293388,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_73,2.3430433882151616,1.119251725490939,6,0.4569326035304048,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,194.76065323140625,184.25976328798353,28.59018171671545,35.933732080484575,0.824295742885021,1,223.3508349481217,220.19349536846812,245.68591844293388,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,1.038943435735331,0.07885995027487101,6,0.032194439885781335,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1727.1723925307936,1777.5146142215679,56.859941731981586,55.08104236026216,0.5391223338036837,1,1784.032334262775,1832.59565658183,2037.014117887638,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_73,1.0095187995902901,0.08140681413195376,6,0.03323419270147957,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.9908795010883018,0.028996926909259688,6,0.011837945839410856,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1727.1723925307936,1695.282662689368,56.859941731981586,20.253385322198266,0.6155011949586326,1,1784.032334262775,1715.5360480115662,2037.014117887638,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_73,1.047226483622823,0.08611012123411009,6,0.03515430978546144,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1727.1723925307936,1791.6859715485364,56.859941731981586,60.14504471295251,0.4538192652552636,1,1784.032334262775,1851.831016261489,2037.014117887638,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,1.1002126090391426,0.08449647307980825,6,0.034495540685057544,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1683.916481401971,1882.3392343143046,68.87722377564079,59.01796535223951,0.05416901403213244,1,1752.7937051776116,1941.3571996665441,2350.707704527008,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_73,0.9842360567287232,0.09861204888774629,6,0.04025820037756131,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,1.1786648587680695,0.17244181580206153,6,0.07039907650567598,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,1683.916481401971,2016.5621531135644,68.87722377564079,120.44485100189733,0.04351826038537585,1,1752.7937051776116,2137.0070041154618,2350.707704527008,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_73,1.1088366448795248,0.17603119991879343,6,0.07186443643514992,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1683.916481401971,1897.09398343017,68.87722377564079,122.95191596823125,0.1695025236716029,1,1752.7937051776116,2020.0458993984014,2350.707704527008,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,1.0622359295274764,0.08037189558580866,6,0.03281168897424649,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1710.8868039225827,1817.3654344809977,44.1684720031025,56.13708568045041,0.1685648787379967,1,1755.0552759256852,1873.502520161448,2418.2163337552847,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,1,967514 MM WT,MoneyMaker,m_73,1,0.06323633970286974,6,0.02581612757888868,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,1.193393505450256,0.2242301664568584,6,0.09154158212643988,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1710.8868039225827,2041.7612003617555,44.1684720031025,156.61728487032136,0.08996724269905237,1,1755.0552759256852,2198.378485232077,2418.2163337552847,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_73,1.0180247982868564,0.06884928260622844,6,0.028107601923656144,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1710.8868039225827,1741.7251934549317,44.1684720031025,48.08892522109229,0.6469256062351656,1,1755.0552759256852,1789.814118676024,2418.2163337552847,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,1.0778821544265484,0.12600863302324602,6,0.05144280901542847,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1929.533635665975,1844.134354192025,133.7284721718379,88.01282310120621,0.6071667076330963,1,2063.262107837813,1932.1471772932314,2665.7361768143046,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_73,1.1277973687342124,0.19146007798526743,6,0.07816324952956333,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,1.3040384055138643,0.2753666689694154,6,0.11241797185749233,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1929.533635665975,2231.0620998019162,133.7284721718379,192.3344245747239,0.2304333447057879,1,2063.262107837813,2423.39652437664,2665.7361768143046,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_73,1.1156565038576656,0.2341207199073413,6,0.09557938366434099,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1929.533635665975,1908.761990160484,133.7284721718379,163.52550623837465,0.9236884348564525,1,2063.262107837813,2072.287496398859,2665.7361768143046,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,12.04956086276757,23.98692817116619,6,9.792622419358075,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,33.4859581094603,467.2215633106875,3.967021586476678,379.7088049757272,0.305081030755699,1,37.452979695936975,846.9303682864147,931.6234051150562,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_33,0.8635968927224328,0.22876938638336694,5,0.10230877982482464,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,2.977182813323386,1.8511564329971155,6,0.7557314491522551,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,33.4859581094603,115.44022426583055,3.967021586476678,29.303476959646524,0.03780133561136144,0.7560267122272288,37.452979695936975,144.74370122547708,931.6234051150562,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_33,3.0780542906553157,1.4365221357569533,5,0.6424322293471457,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,33.4859581094603,119.35151446712823,3.967021586476678,24.910301208089212,0.02515531713651318,0.5282616598667768,37.452979695936975,144.26181567521743,931.6234051150562,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,3.3568063705485254,1.1436987472416205,6,0.4669130583670534,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,34.143275362773906,130.1601226834029,5.639550248801515,18.104547671484465,0.0023467706941213595,0.05632249665891263,39.78282561157542,148.26467035488736,163.0911373903761,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_33,0.8805489875568973,0.3562611268504343,6,0.14544299599541927,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,1.943222664120193,0.7536353966571429,6,0.3076703623183339,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,34.143275362773906,75.34843313638099,5.639550248801515,11.929914235374113,0.01639568605805647,0.3607050932772423,39.78282561157542,87.2783473717551,163.0911373903761,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_33,1.7349337161668346,0.9220232214659498,6,0.3764144039314578,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,34.143275362773906,67.27203193044073,5.639550248801515,14.595463540994334,0.07530160975452833,1,39.78282561157542,81.86749547143506,163.0911373903761,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,7.785584065569864,8.339379973456957,6,3.4045376176923785,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,38.77498679262034,301.88591931530686,14.563323814417851,132.01090116100104,0.10307671088364931,1,53.33831060703819,433.8968204763079,563.044381190393,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,1,967514 MM WT,MoneyMaker,m_33,0.9999999999999999,0.8398347677471689,5,0.3755855261100835,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,8.15084120309031,12.369675886436793,6,5.049899034229891,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,38.77498679262034,316.0487599985725,14.563323814417851,195.80976835633018,0.21640171454938642,1,53.33831060703819,511.85852835490266,563.044381190393,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_33,6.125438641570982,3.4273457042036797,6,1.399208024569817,fruit_1_log2-1,1,967514 MM WT,fruit,*,38.77498679262034,237.5138024259211,14.563323814417851,54.25427267282305,0.013304927908423162,0.30601334189373275,53.33831060703819,291.76807509874413,563.044381190393,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,1.6415860036393806,0.6921026261443262,6,0.28254971394897127,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,137.6213551512786,63.652475610067384,86.91100474433712,10.955861426630019,0.44461285415048857,1,224.53235989561574,74.6083370366974,454.9295284803637,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_33,3.5492302263651765,5.011965977977617,5,2.241419325534833,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,6.218152838527107,10.89484794322207,6,4.447803047684144,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,137.6213551512786,241.10879418838323,86.91100474433712,172.46350443012918,0.6080423525652483,1,224.53235989561574,413.5722986185124,454.9295284803637,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_33,2.39884579661053,1.6676879460268703,6,0.6808307529926609,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,137.6213551512786,93.01521408110612,86.91100474433712,26.399203455300185,0.6452530871160009,1,224.53235989561574,119.4144175364063,454.9295284803637,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.7594972664820778,0.18784644127822464,6,0.07668798852155564,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,2214.515456593377,1735.3556495316277,291.19471492845895,175.2224004024622,0.19534100966381587,1,2505.710171521836,1910.57804993409,2756.2811886740196,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_33,0.9692067653791487,0.3121740758755721,6,0.1274445328033386,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.9646656956275588,0.19649050938369012,6,0.08021691454826513,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,2214.515456593377,2204.1396838340625,291.19471492845895,183.2855521575634,0.9766452747760168,1,2505.710171521836,2387.425235991626,2756.2811886740196,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_33,0.6070660924899689,0.2274179690985149,6,0.09284299710523233,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,2214.515456593377,1387.0696047678487,291.19471492845895,212.13456144784607,0.0468259361977969,0.8896927877581411,2505.710171521836,1599.2041662156948,2756.2811886740196,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,1.2724054571981818,0.2680814191753594,6,0.10944378108346674,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,3112.414292548593,2907.2863012020375,471.66478308938196,250.06526315625442,0.7113205174818168,1,3584.079075637975,3157.351564358292,3942.486983201773,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_33,1.3621819527244545,0.5056462574197285,6,0.20642922017105458,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.9548169786495772,0.25397750661276736,6,0.10368588289093675,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,3112.414292548593,2181.636605281137,471.66478308938196,236.9091905819357,0.1190349546407098,1,3584.079075637975,2418.5457958630723,3942.486983201773,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_33,0.881563019435805,0.17875233480385436,6,0.07297533510009763,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,3112.414292548593,2014.2605295764868,471.66478308938196,166.73945467769036,0.06891676419531381,1,3584.079075637975,2180.999984254177,3942.486983201773,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.6682793116453022,0.24247027429553902,6,0.09898807496945776,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,2284.874121495706,1526.934105109315,407.14541323274597,226.17529083439086,0.143193136687944,1,2692.0195347284516,1753.1093959437057,2961.2214882012972,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,1,967514 MM WT,MoneyMaker,m_33,1,0.436478536892871,6,0.17819161651068277,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.6731009433392455,0.25447613646864403,6,0.10388944767717265,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,2284.874121495706,1537.9509265901895,407.14541323274597,237.37431049405401,0.15143988738575384,1,2692.0195347284516,1775.3252370842436,2961.2214882012972,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_33,0.6350134440102284,0.24211087631144204,6,0.09884135135685401,leaf_1_log2-1,1,967514 MM WT,leaf,ns,2284.874121495706,1450.9257850208332,407.14541323274597,225.84004584894024,0.11194688183474763,1,2692.0195347284516,1676.7658308697735,2961.2214882012972,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.5589673812037352,0.20991320135021346,6,0.08569670559702132,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1220.855697218344,1277.17010407264,190.90647605163105,195.80618491607024,0.8409831681129447,1,1411.762173269975,1472.9762889887102,1620.2739178875813,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_33,0.5343207688041726,0.2046604889608714,6,0.08355229474377407,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.5073765569030264,0.2680159515477053,6,0.10941705403639623,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1220.855697218344,1159.2915647213185,190.90647605163105,250.004195218059,0.8490196105158321,1,1411.762173269975,1409.2957599393776,1620.2739178875813,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_33,0.4093602531940725,0.047708475076774316,6,0.01947690339073093,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1220.855697218344,935.336648892066,190.90647605163105,44.502272524353074,0.19945751557649477,1,1411.762173269975,979.8389214164191,1620.2739178875813,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,1.4790517332710957,2.230746442556586,6,0.9106984216320703,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,86.29379057559308,661.0198143781186,9.17346213552125,407.0105785213517,0.21707484545546687,1,95.46725271111433,1068.0303928994704,2919.1073468000454,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_39,0.19308495410449963,0.045897302502421945,5,0.020525897675857333,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,3.1108965046159396,6.924494635342665,6,2.8269130972048337,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,86.29379057559308,1390.3261013614965,9.17346213552125,1263.407850274908,0.34932315409476816,1,95.46725271111433,2653.7339516364045,2919.1073468000454,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_39,0.2667087097028603,0.10437379453501232,5,0.04667737992997672,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,86.29379057559308,119.19781966713546,9.17346213552125,20.86111819005236,0.20331126755760712,1,95.46725271111433,140.05893785718783,2919.1073468000454,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,1.7681395816948575,2.785805415663642,6,1.1373002985096532,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,485.8868353275857,790.2193491918338,291.20120940189275,508.2837978563366,0.6175228612519919,1,777.0880447294785,1298.5031470481704,1428.3534617529876,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_39,1.0871864206385011,1.5960176374319226,6,0.651571472031756,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.4878875486661891,0.6438661228907748,6,0.2628572439577544,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,485.8868353275857,218.0473675139583,291.20120940189275,117.47651735252134,0.42360440388805476,1,777.0880447294785,335.52388486647965,1428.3534617529876,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_39,0.3421115310604335,0.4079759955889624,6,0.16655550274948644,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,485.8868353275857,152.89695125000202,291.20120940189275,74.43721205588157,0.31282893578559007,1,777.0880447294785,227.33416330588358,1428.3534617529876,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.3193207742541431,0.21029231055312947,6,0.08585147628101089,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,446.9213615105917,142.71127518827794,338.9970170832694,38.36885866720366,0.42177311196955247,1,785.918378593861,181.0801338554816,2573.778874550035,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,1,967514 MM WT,MoneyMaker,m_39,1,1.6960934062443183,5,0.7585160305102924,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,3.4503977901075,4.372272700234242,6,1.7849728553124475,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,446.9213615105917,1542.0564781079806,338.9970170832694,797.7424987556874,0.24863767805030293,1,785.918378593861,2339.798976863668,2573.778874550035,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_39,1.2384777008421601,2.5904112854167978,6,1.0575309788697058,fruit_1_log2-1,1,967514 MM WT,fruit,ns,446.9213615105917,553.5021402608854,338.9970170832694,472.63318491607765,0.8588461739931631,1,785.918378593861,1026.135325176963,2573.778874550035,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.29444705262162524,0.1155709314941065,6,0.04718163520978521,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,21012.266447056198,131.59467765043757,17459.76728346674,21.08648064625327,0.2977696224764307,1,38472.03373052293,152.68115829669085,116187.29057306626,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_39,47.01557870502062,87.35591958549341,5,39.0667548860337,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,126.30614229885508,269.5235997036375,6,110.03254881867656,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,21012.266447056198,56448.91308335485,17459.76728346674,49175.896528523575,0.521555867257061,1,38472.03373052293,105624.80961187842,116187.29057306626,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_39,0.9728185649795785,1.2662830373114884,6,0.5169578852258032,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,21012.266447056198,434.7733975634532,17459.76728346674,231.0395219087522,0.30390813725042026,1,38472.03373052293,665.8129194722054,116187.29057306626,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,1.0566176709111037,0.16802741001003133,6,0.06859690288766587,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,2379.522620020415,2779.961115788635,195.12572115591078,180.47845303098677,0.16302227728569138,1,2574.648341176326,2960.439568819622,3427.3595975423573,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_39,0.9044175597877034,0.18166417653490238,6,0.07416408950889933,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.8931927658948499,0.15158910838458006,6,0.06188599435094606,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,2379.522620020415,2349.9901870373783,195.12572115591078,162.8220525208493,0.9098614282019036,1,2574.648341176326,2512.8122395582277,3427.3595975423573,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_39,1.0201535564625523,0.4019708736906539,6,0.16410392200047486,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,2379.522620020415,2684.0240298593117,195.12572115591078,431.75742245192197,0.5410168702533069,1,2574.648341176326,3115.781452311234,3427.3595975423573,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.881831872241922,0.17193753193968542,6,0.07019320348095243,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1950.165652917846,2320.0996755825436,149.25815627510346,184.6783199276102,0.1516458219225583,1,2099.4238091929496,2504.7779955101537,4256.016019210796,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_39,0.7412260115344562,0.13896097290612408,6,0.05673057963012035,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,1.182674476258763,0.7052304338516464,6,0.28790911900302313,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1950.165652917846,3111.616573476426,149.25815627510346,757.4888985333889,0.188683074252303,1,2099.4238091929496,3869.1054720098145,4256.016019210796,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_39,0.9200929363203186,0.3681313877414585,6,0.15028900971153994,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1950.165652917846,2420.7645360281613,149.25815627510346,395.41038791089085,0.3055921411015919,1,2099.4238091929496,2816.174923939052,4256.016019210796,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,1.0710884732515387,0.12141795721820217,6,0.0495686734659455,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,2631.000022355788,2818.033797069825,212.1129838351329,130.41518099704936,0.47330400258915717,1,2843.113006190921,2948.4489780668746,4694.719097919006,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,1,967514 MM WT,MoneyMaker,m_39,1,0.19747950353496085,6,0.08062066971980017,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,1.354041803326358,0.6567746107598131,6,0.2681271120627628,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,2631.000022355788,3562.4840148223198,212.1129838351329,705.4424378313219,0.25372848879127324,1,2843.113006190921,4267.926452653642,4694.719097919006,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_39,1.156984579561596,0.1604644358358152,6,0.06550933161021981,leaf_1_log2-1,1,967514 MM WT,leaf,ns,2631.000022355788,3044.0264546918615,212.1129838351329,172.35505293100104,0.16293779643011083,1,2843.113006190921,3216.3815076228625,4694.719097919006,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.9261554383306695,0.1274554208545035,6,0.052033457674203254,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,2294.416365312902,2436.714978952926,361.7929881251648,136.90002830407772,0.7248335796822896,1,2656.209353438067,2573.6150072570035,3547.401727915165,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_39,0.8720700668251952,0.3368332215481927,6,0.1375115868684853,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,1.1105176232531764,0.282225504286329,6,0.11521807965019545,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,2294.416365312902,2921.7718916056037,361.7929881251648,303.1387701354552,0.21420984057189021,1,2656.209353438067,3224.910661741059,3547.401727915165,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_39,0.717535879081541,0.0976594514466573,6,0.03986930410073648,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,2294.416365312902,1887.8369139046147,361.7929881251648,104.8961399803474,0.3230201485875712,1,2656.209353438067,1992.7330538849621,3547.401727915165,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,1.2685140009959026,1.3545556448809852,6,0.5529950263608377,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,54.48911300487965,56.22161928878398,14.309540904858983,24.50920984414937,0.952848801137915,1,68.79865390973863,80.73082913293335,109.0601233016898,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_38,1.2294239053041114,0.7219425144085918,5,0.3228625076129465,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,1.719593947200733,1.2673711063732966,6,0.5174020875601931,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,54.48911300487965,76.21386611020085,14.309540904858983,22.931700527698954,0.44446187592578146,1,68.79865390973863,99.1455666378998,109.0601233016898,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_38,0.5381100771930639,0.6681602151307343,5,0.29881033217864106,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,54.48911300487965,23.8494962386342,14.309540904858983,13.24352803525493,0.15494295231717128,1,68.79865390973863,37.09302427388913,109.0601233016898,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.6323725358339765,0.5531188468728722,6,0.2258098236591933,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,48.329899897422315,28.027288567905657,16.178423539185108,10.00808341687008,0.3157941542606211,1,64.50832343660743,38.035371984775736,112.27397060863107,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_38,1.0904551569691487,0.8941363295524541,6,0.3650296279814227,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,1.4608204661071107,0.8531542759262639,6,0.34829877464883213,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,48.329899897422315,64.74480536301407,16.178423539185108,15.436897891298761,0.47980115175340976,1,64.50832343660743,80.18170325431282,112.27397060863107,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_38,1.777282879536343,1.2875357253374418,6,0.5256342587801606,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,48.329899897422315,78.77068865090811,16.178423539185108,23.296557356938308,0.3113565900837912,1,64.50832343660743,102.06724600784642,112.27397060863107,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,1.5433074764378885,1.666637842615098,6,0.6804020500699947,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,44.32085041603382,68.4006998091503,9.76582914472858,30.15599748391499,0.47613458173335876,1,54.0866795607624,98.55669729306528,132.91148300971315,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_38,1,0.4927039445155098,5,0.2203439025437929,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.9971840628522272,0.4651826805350333,6,0.1899100340818247,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,44.32085041603382,44.196045686926425,9.76582914472858,8.416974213044437,0.992501494637299,1,54.0866795607624,52.613019899970865,132.91148300971315,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_38,1.9578121300495712,1.8822200230556585,6,0.7684131066893255,fruit_1_log2-1,1,967514 MM WT,fruit,ns,44.32085041603382,86.7718985586236,9.76582914472858,34.05672235929743,0.27744665240492977,1,54.0866795607624,120.82862091792103,132.91148300971315,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.48356393994833896,0.507234827284005,6,0.2070777511024279,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,90.80875218539262,21.431965049038293,27.487557303734583,9.177862031099389,0.06318595241640994,1,118.2963094891272,30.609827080137684,130.12594043803992,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_38,2.048894624831951,1.3867975476466874,5,0.6201947175135992,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.843617612530042,0.9004480209135601,6,0.3676063651895297,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,90.80875218539262,37.38985001327557,27.487557303734583,16.29262672354705,0.14075669770716967,1,118.2963094891272,53.68247673682262,130.12594043803992,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_38,0.9668775430437436,0.44619371330420116,6,0.18215782067216316,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,90.80875218539262,42.85283495586406,27.487557303734583,8.073389522121657,0.158830212595951,1,118.2963094891272,50.92622447798572,130.12594043803992,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,1.1024513492212082,0.9003776924283716,6,0.36757765370568063,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,110.78516263154074,80.50649887769023,44.57437274113807,26.842354527866455,0.5762579717138938,1,155.3595353726788,107.3488534055567,170.8954889099467,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_38,1.5170856231418965,1.4951658144758886,6,0.6103988877197909,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.9282082318566964,0.5354625565630876,6,0.2186016733242901,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,110.78516263154074,67.78239695477023,44.57437274113807,15.963385033339856,0.3973514716439672,1,155.3595353726788,83.7457819881101,170.8954889099467,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_38,1.340086678084758,0.7888918274244695,6,0.32206373990695253,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,110.78516263154074,97.85981641861169,44.57437274113807,23.518701422679523,0.8044126347691694,1,155.3595353726788,121.37851784129121,170.8954889099467,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,1.189348305608866,0.7858768060075421,6,0.32083286256778,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,58.46217480274284,86.85214825880769,16.45692583302689,23.428816617155302,0.34740177655985116,1,74.91910063576972,110.280964875963,121.30906136355931,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_38,0.8005776476208267,0.5520174800844256,6,0.22536019255063633,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.9119854476322778,0.6232201801985092,6,0.25442857314862205,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,58.46217480274284,66.59772829716573,16.45692583302689,18.579644038815445,0.7499327888434084,1,74.91910063576972,85.17737233598118,121.30906136355931,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_38,0.9568233441115361,0.33702020667822297,6,0.13758792322816232,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,58.46217480274284,69.8720152442817,16.45692583302689,10.047356733498106,0.5698336681785676,1,74.91910063576972,79.9193719777798,121.30906136355931,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.831408303529694,0.45613663700215024,6,0.1862170022740635,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,73.02499011367847,60.713583145686094,29.359775066814258,13.598494750062327,0.7147799862496156,1,102.38476518049274,74.31207789574842,273.24476266530723,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_38,1,0.9848199604632604,6,0.40205106527381523,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,2.3097621294142097,2.674530305106018,6,1.091872424853326,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,73.02499011367847,168.6703566654216,29.359775066814258,79.73397303031227,0.30115839477769973,1,102.38476518049274,248.40432969573385,273.24476266530723,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_38,1.3785763709203058,1.9912006239344393,6,0.8129042506918123,leaf_1_log2-1,1,967514 MM WT,leaf,ns,73.02499011367847,100.67052585740609,29.359775066814258,59.362324870136796,0.6883465481137343,1,102.38476518049274,160.0328507275429,273.24476266530723,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.4148092392106239,0.5660387409111398,6,0.23108434831329033,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,60.3026106268076,30.291440592418297,23.073922897774125,16.87493225100386,0.3206990299009858,1,83.37653352458173,47.16637284342215,136.09351268001072,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_38,0.8257804695753349,0.7739725452325786,6,0.31597296845716516,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,1.2782958084583058,1.0188347929535309,6,0.4159375624883828,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,60.3026106268076,93.3475387750244,23.073922897774125,30.373836388621676,0.40804395466794086,1,83.37653352458173,123.72137516364609,136.09351268001072,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_38,0.3685890267115168,0.43882185513180555,6,0.17914827217574059,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,60.3026106268076,26.91621003161888,23.073922897774125,13.082300804516036,0.24400132395256421,1,83.37653352458173,39.99851083613492,136.09351268001072,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,1.9371608462744048,0.5441871423920609,6,0.22216347057397368,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,92.04846594796135,133.24920369655445,25.29039818716798,15.281697233029625,0.20748002206575292,1,117.33886413512933,148.53090092958408,181.26407152644728,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_27,1.3381894919243285,0.8221323348704273,5,0.3676687574541792,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,1.9309228450289821,1.1383003120273947,6,0.46470915641966576,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,92.04846594796135,132.82011764507385,25.29039818716798,31.965401924423666,0.3436703113843075,1,117.33886413512933,164.78551956949752,181.26407152644728,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_27,1.547591946609609,0.5856349894706848,5,0.261903929291765,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,92.04846594796135,106.45238619680421,25.29039818716798,18.01527740468429,0.6563793609523227,1,117.33886413512933,124.46766360148851,181.26407152644728,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,1.5002412970068622,0.24496051363103946,6,0.10000471092102169,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,75.94941968237427,103.19533277957504,11.724021301673599,6.878906375667401,0.07962642170463612,1,87.67344098404787,110.07423915524244,136.0536743201039,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_27,1.1041434997315671,0.4174969280055909,6,0.170442407132197,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,1.4002480125768313,0.7883249721894328,6,0.3218323222263083,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,75.94941968237427,96.31721238449799,11.724021301673599,22.137501252383803,0.44090003994629956,1,87.67344098404787,118.45471363688179,136.0536743201039,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_27,1.4784673497313436,0.7829856694776269,6,0.3196525610219445,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,75.94941968237427,101.69759388950116,11.724021301673599,21.98756458332056,0.33309037734987434,1,87.67344098404787,123.68515847282173,136.0536743201039,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,1.350433762797695,0.6403159119899785,6,0.2614078764267181,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,68.78582331086372,92.89069820082709,11.748116444696352,17.981155999956332,0.29319696981541327,1,80.53393975556007,110.87185420078342,121.95903962086177,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_27,1,0.3819040859510261,5,0.17079269941428335,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,1.169576684014906,0.5527290611309185,6,0.2256506942963935,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,68.78582331086372,80.4502951351552,11.748116444696352,15.521568787845448,0.5641845255080529,1,80.53393975556007,95.97186392300065,121.95903962086177,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_27,1.2259387324004813,0.4549158707845047,6,0.18571862655265367,fruit_1_log2-1,1,967514 MM WT,fruit,ns,68.78582331086372,84.32720503684375,11.748116444696352,12.774808631587119,0.3938712795565861,1,80.53393975556007,97.10201366843087,121.95903962086177,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,1.4803905646522293,0.5291098359795974,6,0.2160081860062856,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,134.14587241019797,101.829883811238,28.819243023496103,14.858300916328545,0.35700603280978077,1,162.96511543369408,116.68818472756655,207.01150916537514,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_27,1.950196507846575,0.9368469163971789,5,0.41897067791503084,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,2.209718303870812,1.2889175148738292,6,0.5261983719961716,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,134.14587241019797,151.99729281683915,28.819243023496103,36.1949882425928,0.7086937622221309,1,162.96511543369408,188.19228105943193,207.01150916537514,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_27,1.2364151236595011,0.47533707824235666,6,0.19405554958652962,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,134.14587241019797,85.04783223492215,28.819243023496103,13.34827074635158,0.17574380378774201,1,162.96511543369408,98.39610298127374,207.01150916537514,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,1.0498793793913639,0.24728460401616356,6,0.1009535168476321,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,758.070539804449,731.1298029385192,49.62257864254461,70.303433258732,0.7613642569219359,1,807.6931184469936,801.4332361972512,1118.6017623492173,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_27,1.0885654293751954,0.1745419695894934,6,0.07125646069910625,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.8161226650365552,0.20551174495695823,6,0.08389981854892363,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,758.070539804449,568.3430068011716,49.62257864254461,58.42733842226051,0.03339551993019185,0.8014924783246045,807.6931184469936,626.7703452234321,1118.6017623492173,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_27,1.2767090394611558,0.44958596368421583,6,0.18354270109062953,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,758.070539804449,889.0926393584326,49.62257864254461,127.8180536863103,0.37359415482276814,1,807.6931184469936,1016.9106930447429,1118.6017623492173,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,1.178899354569916,0.13109052055054296,6,0.05351748091077707,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,763.5316695393151,820.9785521177942,96.86111768361263,37.269257821546894,0.5985593009417549,1,860.3927872229277,858.2478099393411,1015.1916895246566,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_27,1.0964074397456836,0.34069834175531083,6,0.1390895155854786,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.9250883391029167,0.37165411699535233,6,0.15172715790720914,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,763.5316695393151,644.2260590556,96.86111768361263,105.6618972033045,0.4248002259917515,1,860.3927872229277,749.8879562589045,1015.1916895246566,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_27,1.2309984605572257,0.23088667412382338,6,0.09425909000193794,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,763.5316695393151,857.2600620145377,96.86111768361263,65.64147391696825,0.4442131530167154,1,860.3927872229277,922.9015359315059,1015.1916895246566,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,1.0694741611926741,0.18916979763599095,6,0.07722824649228822,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,696.3940975413478,744.7754933275622,118.594171635506,53.78129502069782,0.7212686432978055,1,814.9882691768538,798.55678834826,1339.6449679715756,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_27,1,0.41714197176662854,6,0.17029749685445114,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,1.0407070223778745,0.21169047693978357,6,0.08642227531814647,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,696.3940975413478,724.7422276537833,118.594171635506,60.18396242765049,0.8369466001921924,1,814.9882691768538,784.9261900814338,1339.6449679715756,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_27,1.5684824090329794,0.44170390162315787,6,0.18032486272887255,leaf_1_log2-1,1,967514 MM WT,leaf,*,696.3940975413478,1092.2818917480008,118.594171635506,125.57717004434062,0.04494133288546302,1,814.9882691768538,1217.8590617923414,1339.6449679715756,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,0.9381952455088326,0.3368481663390839,6,0.13751768805381798,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,448.31159247106757,653.3536313137067,75.01378210844575,95.76650626821116,0.12453257264300205,1,523.3253745795133,749.1201375819179,824.0321513401097,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_27,0.6437613329203289,0.26385273868737863,6,0.1077174295033307,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.7709599636629472,0.5263299478493861,6,0.21487330142944608,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,448.31159247106757,536.8919681355684,75.01378210844575,149.63649883468915,0.6122421081208791,1,523.3253745795133,686.5284669702576,824.0321513401097,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_27,0.827707526784977,0.17255750500844744,6,0.07044630642640816,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,448.31159247106757,576.4106361436051,75.01378210844575,49.05839198893977,0.18819236770182296,1,523.3253745795133,625.4690281325448,824.0321513401097,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.9813898826537586,0.21792196709544726,6,0.08896627052123855,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,175.8338395211693,151.32200834592092,20.8916119440102,13.717845443766418,0.35880318234628517,1,196.7254514651795,165.03985378968733,216.39799661169747,4,24,16.666666666666664,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_40,1.140359905478956,0.302967771416266,5,0.13549130637567772,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.7609240157225545,0.14311874154734655,6,0.05842798157004368,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,175.8338395211693,117.32803882838058,20.8916119440102,9.009099921500603,0.04590878332346276,0.5509053998815531,196.7254514651795,126.33713874988119,216.39799661169747,4,24,16.666666666666664,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_40,0.7448828947973672,0.22801682107511365,5,0.10197222238747215,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,175.8338395211693,114.85463383672192,20.8916119440102,15.723253071901912,0.05037782098920796,0.5509053998815531,196.7254514651795,130.57788690862384,216.39799661169747,4,24,16.666666666666664,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.9545070107117148,0.3190064880684792,6,0.13023385340083735,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,216.58890202511628,147.1768971681124,12.37806225309633,20.080957221561057,0.017857936277390046,0.26786904416085067,228.9669642782126,167.25785438967344,251.86366070603387,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_40,1.404674438741449,0.19663814453095593,6,0.08027718634474879,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.9880781450844254,0.1281123294805914,6,0.0523016394977946,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,216.58890202511628,152.35328176868774,12.37806225309633,8.064469859001871,0.0020678083307835637,0.03928835828488771,228.9669642782126,160.4177516276896,251.86366070603387,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_40,0.9594690964388126,0.15884020642321453,6,0.06484624272920445,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,216.58890202511628,147.94200876247555,12.37806225309633,9.998741434888286,0.0016878826715012731,0.033757653430025465,228.9669642782126,157.94075019736383,251.86366070603387,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.910788241201439,0.20768371980134573,6,0.08478652356607534,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,154.19153082843468,140.43583317138746,18.28645679610293,13.07336386227431,0.558541693545435,1,172.4779876245376,153.50919703366176,189.7257863869914,7,24,29.166666666666668,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_40,1,0.26518810886699246,5,0.11859572765024197,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.674090088962195,0.15109421707796838,6,0.061683955821056416,fruit_1_transp1-1,1,967514 MM WT,fruit,*,154.19153082843468,103.93898273335657,18.28645679610293,9.511143575602224,0.04994663998320289,0.5509053998815531,172.4779876245376,113.45012630895879,189.7257863869914,7,24,29.166666666666668,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_40,0.7640690431570432,0.214772136267392,6,0.08768035747043462,fruit_1_log2-1,1,967514 MM WT,fruit,ns,154.19153082843468,117.81297542300182,18.28645679610293,13.519568541950694,0.1496972973944421,0.9824509296959613,172.4779876245376,131.33254396495252,189.7257863869914,7,24,29.166666666666668,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,2.4706392537543613,0.5439112989838825,6,0.2220508579741491,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,355.0424155203622,380.95164866120643,83.10080445108618,34.23836171280138,0.7839761724519921,1,438.1432199714484,415.1900103740078,481.95754196859326,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_40,2.302606463615759,1.2051183793246227,5,0.5389453234208467,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,2.1510823745522702,0.8042343941816918,6,0.32832731655691627,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,355.0424155203622,331.67868427027884,83.10080445108618,50.62529155270299,0.8173540627419769,1,438.1432199714484,382.30397582298184,481.95754196859326,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_40,1.5903281624987642,0.7895961377876207,6,0.32235127340866504,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,355.0424155203622,245.21513389525606,83.10080445108618,49.70383631137734,0.2957093167399116,1,438.1432199714484,294.9189702066334,481.95754196859326,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,1.1514741471775911,0.04022413737316715,6,0.016421435317979072,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,6811.967443514581,7592.771319496247,125.84500622384995,108.28224273461205,8.8919722522132e-4,0.01867314172964772,6937.812449738431,7701.053562230859,8471.158918453946,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_40,1.0330621156048296,0.04674826352167126,6,0.019084898664876462,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,1.1409213084915684,0.04741911474318679,6,0.01935877252921577,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,6811.967443514581,7523.186352164674,125.84500622384995,127.65091878160213,0.0026543458932566295,0.04777822607861933,6937.812449738431,7650.837270946276,8471.158918453946,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_40,1.110217198199778,0.06336604029504293,6,0.025869077623915538,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,6811.967443514581,7320.724761007298,125.84500622384995,170.5795923652593,0.03933272512966532,0.5164380950584059,6937.812449738431,7491.304353372558,8471.158918453946,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,1.2266952709418568,0.06107405203733157,6,0.02493337733594163,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,7509.682335202002,8088.776195105068,175.47163746787254,164.4096246524912,0.036888435361314705,0.5164380950584059,7685.153972669875,8253.185819757558,9095.70796220034,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_40,1.138873370293346,0.06518331235437337,6,0.026610975835444934,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,1.1970919470299037,0.060605557514405495,6,0.024742115247865373,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,7509.682335202002,7893.573142295434,175.47163746787254,163.14845061709337,0.14035013281370876,0.9824509296959613,7685.153972669875,8056.721592912528,9095.70796220034,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_40,1.2219880886942744,0.0784139659745981,6,0.0320123675576212,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,7509.682335202002,8057.737236520813,175.47163746787254,211.088183661314,0.07475889831483962,0.5980711865187169,7685.153972669875,8268.825420182127,9095.70796220034,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,1.0961591309487766,0.023566871581131184,6,0.009621135034578203,leaf_1_panK4-1,1,967514 MM WT,leaf,*,6593.957266089812,7228.026466310379,100.60061123096631,63.4413532692882,5.887491660414274e-4,0.01354123081895283,6694.557877320778,7291.467819579667,8283.98814451778,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_40,1,0.037370603930846555,6,0.015256485168370226,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,1.0941494529820348,0.0924774770443614,6,0.03775377190977168,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,6593.957266089812,7214.774735679081,100.60061123096631,248.94675860673652,0.05627171811057918,0.5509053998815531,6694.557877320778,7463.721494285817,8283.98814451778,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_40,1.1223584220341112,0.04833440007589202,6,0.01973243620157933,leaf_1_log2-1,1,967514 MM WT,leaf,*,6593.957266089812,7400.783472128924,100.60061123096631,130.11484106905775,7.39731565587352e-4,0.016274094442921744,6694.557877320778,7530.898313197981,8283.98814451778,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,1.2707226299955405,0.06340912361736688,6,0.025886666316601793,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,7631.591331979115,8379.09071924385,135.75295555854487,170.69557145319877,0.006946129181838205,0.11113806690941128,7767.34428753766,8549.78629069705,10357.178902168886,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_40,1.1573613573787407,0.05042881820044648,6,0.020587478820445218,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,1.3812173883672556,0.11438780742732356,6,0.04669862683211442,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,7631.591331979115,9107.688434073858,135.75295555854487,307.9287497160375,0.0033539804234382713,0.05701766719845061,7767.34428753766,9415.617183789895,10357.178902168886,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_40,1.3160488776381707,0.036520289078352704,6,0.01490934558348358,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,7631.591331979115,8677.970059231557,135.75295555854487,98.31158764285553,1.4309031202611598e-4,0.0034341674886267833,7767.34428753766,8776.281646874411,10357.178902168886,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,1.5273709359474836,0.5666553856344041,6,0.23133609246738654,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,141.2439687942744,195.45085754874265,27.008566258885768,29.60304965255707,0.20916027538886148,1,168.25253505316016,225.05390720129972,247.5592979214297,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_41,1.1037655987794661,0.4719472660079072,5,0.21106123371777125,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,1.5768563440330339,0.4133394603525606,6,0.16874512807018857,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,141.2439687942744,201.78328487129767,27.008566258885768,21.593562645626232,0.11763623536785127,1,168.25253505316016,223.3768475169239,247.5592979214297,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_41,1.1445187907969092,0.32891737284299016,5,0.14709632093151384,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,141.2439687942744,146.45897330967503,27.008566258885768,18.823261194566797,0.8785183149753559,1,168.25253505316016,165.28223450424184,247.5592979214297,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,1.5313980337809214,0.3516864794211858,6,0.14357540400295365,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,153.34593364144732,195.9661873265021,29.58790062477528,18.372705133266553,0.25443471448940225,1,182.9338342662226,214.33889245976866,235.77278170574553,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_41,1.1983376544217412,0.566365406112685,6,0.2312177088233752,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,1.2949695072758742,0.09984077164117461,6,0.04075982434110247,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,153.34593364144732,165.7114815658931,29.58790062477528,5.215853224326711,0.6967358861016405,1,182.9338342662226,170.92733479021982,235.77278170574553,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_41,1.1227280455467026,0.354303926305533,6,0.14464397221886835,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,153.34593364144732,143.67050867050926,29.58790062477528,18.509445049703615,0.7883100414682211,1,182.9338342662226,162.1799537202129,235.77278170574553,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,1.239860188426786,0.3100888844924303,6,0.12659325698588095,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,127.96554716912783,158.6593874252516,25.768197053155166,16.199575398120274,0.3471930561112806,1,153.733744222283,174.85896282337188,202.45074839966108,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_41,1,0.45027307383221676,5,0.2013682403053237,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,1.3498529867951656,0.21652157987671627,6,0.0883945648332042,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,127.96554716912783,172.73467605312487,25.768197053155166,11.311458855657918,0.16695767015999352,1,153.733744222283,184.0461349087828,202.45074839966108,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_41,1.193429434595771,0.2049341558032317,6,0.0836640187643243,fruit_1_log2-1,1,967514 MM WT,fruit,ns,127.96554716912783,152.71785060579072,25.768197053155166,10.706111939544938,0.4129929462540295,1,153.733744222283,163.42396254533566,202.45074839966108,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,1.720260581958744,0.17268632882384963,6,0.07049889852881713,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,189.63060680137917,220.13408664383292,22.704904629509592,9.021430125060904,0.2645495974269472,1,212.33551143088877,229.15551676889382,308.63671884563564,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_41,1.4818879846678628,0.396745149748256,5,0.17742982491608678,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,1.9396986578544093,0.619509422300468,6,0.25291366258042147,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,189.63060680137917,248.21460009556236,22.704904629509592,32.36423521865181,0.1742861096821658,1,212.33551143088877,280.5788353142142,308.63671884563564,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_41,1.631444769335933,0.421070386851332,6,0.17190126559701377,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,189.63060680137917,208.7687225842842,22.704904629509592,21.99743951118744,0.5601805809146779,1,212.33551143088877,230.76616209547166,308.63671884563564,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,1.0248031565366853,0.16507135274292797,6,0.06739009756185765,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1608.416778757095,1723.6531889896294,97.71431149651424,113.34582239321985,0.45946070328548005,1,1706.1310902536093,1836.9990113828492,2646.478019388192,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_41,0.9562890043228736,0.14230637918983685,6,0.058096336026353154,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.8980637326644356,0.22886281721216467,6,0.0934328538776098,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1608.416778757095,1510.4856057960158,97.71431149651424,157.1480684025188,0.6104123358258152,1,1706.1310902536093,1667.6336741985347,2646.478019388192,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_41,1.270958886472694,0.390619334759766,6,0.15946967563780592,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1608.416778757095,2137.6713408522232,97.71431149651424,268.21776768249663,0.11079037272023029,1,1706.1310902536093,2405.88910853472,2646.478019388192,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,1.0939616302800508,0.23298801015065768,6,0.09511695684258317,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1742.7181828386567,1839.9733067147351,282.5495976574364,159.98062158860893,0.772260962631686,1,2025.267780496093,1999.9539283033441,2359.2219808067694,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_41,1.0361383056262121,0.41149151611848944,6,0.16799070799575647,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.7683182039195049,0.13095404329630092,6,0.05346176430504555,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1742.7181828386567,1292.2619469871158,282.5495976574364,89.91925907490602,0.1795024170316389,1,2025.267780496093,1382.1812060620218,2359.2219808067694,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_41,1.1936241503026743,0.1997356612414684,6,0.08154174224649875,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1742.7181828386567,2007.5992740666309,282.5495976574364,137.14798121225016,0.4260352606202418,1,2025.267780496093,2144.747255278881,2359.2219808067694,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,1.0383816921092335,0.22335990578817277,6,0.09118629969619105,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1681.9358703135756,1746.491415035427,200.89707921554785,153.36950834018762,0.8039332228768127,1,1882.8329495291234,1899.8609233756147,2828.3947341912913,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_41,1,0.2925767525261466,6,0.11944395904826809,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.984550202404807,0.18708415568899947,6,0.07637678673290924,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1681.9358703135756,1655.950301549136,200.89707921554785,128.46085726537007,0.9157513839888566,1,1882.8329495291234,1784.411158814506,2828.3947341912913,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_41,1.394072830207895,0.32990269356959506,6,0.13468221066921085,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1681.9358703135756,2344.7410989562254,200.89707921554785,226.52684121767544,0.05379200070872903,1,1882.8329495291234,2571.267940173901,2828.3947341912913,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,0.8098629103065217,0.2583287309464977,6,0.10546226278660693,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1096.1753684476357,1362.137478881085,111.44065709199002,177.38076274523073,0.23820617785444526,1,1207.6160255396258,1539.5182416263156,1693.4700657889473,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_41,0.651734342429636,0.16229676249484748,6,0.06625737583634109,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.6901278499610038,0.3724772183306788,6,0.1520631876202347,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1096.1753684476357,1160.7507859517978,111.44065709199002,255.76052981269595,0.8237316441942184,1,1207.6160255396258,1416.5113157644937,1693.4700657889473,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_41,0.7341923716423124,0.13179018131063996,6,0.05380311621999132,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1096.1753684476357,1234.864485575801,111.44065709199002,90.49339110505355,0.35770913064128085,1,1207.6160255396258,1325.3578766808546,1693.4700657889473,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,1.1446815957916743,0.14644606562875814,6,0.05978635593809921,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,47.074953579669376,40.90870829488114,5.6708393236808305,2.1366488323716823,0.35443386014219685,1,52.74579290335021,43.04535712725282,58.02037219368523,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_51,1.3172215704531938,0.35481443332403184,5,0.15867783846212036,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.9587532847612792,0.2767090634717838,6,0.11296600211821231,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,47.074953579669376,34.26398973937583,5.6708393236808305,4.037186624544912,0.10528602847064943,1,52.74579290335021,38.301176363920746,58.02037219368523,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_51,0.84104209985586,0.2963309814485526,5,0.13252324367163854,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,47.074953579669376,30.057219451424956,5.6708393236808305,4.736124646002581,0.051210383802002685,1,52.74579290335021,34.793344097427536,58.02037219368523,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,1.1968820387485415,0.2908016071985006,6,0.11871925900293169,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,41.10947661039426,42.774251256030226,3.4610423242009247,4.242796908232338,0.767572886864638,1,44.570518934595185,47.01704816426256,51.71875298068882,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_51,1.1502993677860718,0.2372200914228977,6,0.0968446967870793,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,1.0023877276966549,0.05588746608917007,6,0.0228159624892608,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,41.10947661039426,35.82340041236597,3.4610423242009247,0.8153984106773294,0.1915523667890338,1,44.570518934595185,36.6387988230433,51.71875298068882,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_51,1.0193142112901876,0.20695872324034564,6,0.08449054495945488,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,41.10947661039426,36.42832022791259,3.4610423242009247,3.0195288105697164,0.3325726718079699,1,44.570518934595185,39.44784903848231,51.71875298068882,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,1.029077689933656,0.2014371583599839,6,0.08223637553636189,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,35.73806763844074,36.777248088059345,4.256617285749501,2.938969151258715,0.8462022417684704,1,39.99468492419024,39.71621723931806,48.85500909567971,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_51,1,0.266329050060296,5,0.11910597206355326,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,1.1764580683576378,0.1623924466632248,6,0.0662964387345056,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,35.73806763844074,42.044338020754594,4.256617285749501,2.3693066116815036,0.24041650812692228,1,39.99468492419024,44.413644632436096,48.85500909567971,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_51,0.9518055609770361,0.2714412350367237,6,0.11081542016514209,fruit_1_log2-1,1,967514 MM WT,fruit,ns,35.73806763844074,34.01569151684135,4.256617285749501,3.960328981244079,0.7739893297331245,1,39.99468492419024,37.97602049808543,48.85500909567971,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,1.0641438034596893,0.16205102438161406,6,0.06615705367171174,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,43.21860087402264,38.030443225069966,7.794198879809221,2.3643252588795884,0.5536322412261317,1,51.012799753831864,40.394768483949555,56.11407972921506,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_51,1.2093155486542215,0.4876693027090184,5,0.2180923422794575,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,1.2661064917441633,0.22156808951964038,6,0.09045479376773735,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,43.21860087402264,45.248199439421825,7.794198879809221,3.232679537892605,0.8188384466762818,1,51.012799753831864,48.48087897731443,56.11407972921506,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_51,1.0193652163526317,0.4023323601327623,6,0.1642514982224915,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,43.21860087402264,36.43014305028413,7.794198879809221,5.87003115319063,0.5067630532842041,1,51.012799753831864,42.30017420347476,56.11407972921506,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.9673226046945703,0.09784233776695087,6,0.03994396712834555,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,279.3175813428644,262.7842324785183,17.526936830412293,10.851234834198605,0.44477556873958246,1,296.8445181732767,273.63546731271686,326.52896999060437,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_51,1.0281827329333935,0.15803514526997697,6,0.06451757788967635,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.9352365604070941,0.08437768614502196,6,0.0344470461220016,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,279.3175813428644,254.0676921222444,17.526936830412293,9.357933467481098,0.24112985652172406,1,296.8445181732767,263.4256255897255,326.52896999060437,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_51,0.9793298359219365,0.1283829892594034,6,0.052412135889791926,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,279.3175813428644,266.04613396511877,17.526936830412293,14.23835526588111,0.5702933395838881,1,296.8445181732767,280.2844892309999,326.52896999060437,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,1.0822758244216442,0.11977033415538278,6,0.048896034167220645,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,269.5734530668533,294.01258739373463,8.040972082471152,13.283166078739116,0.15309302657673518,1,277.61442514932446,307.29575347247373,338.02532881972115,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_51,0.9923140833742932,0.07250303937651977,6,0.02959924187889834,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.96270718548523,0.0792665301566461,6,0.032360425427453016,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,269.5734530668533,261.5304011417885,8.040972082471152,8.791079126406462,0.5150365058816824,1,277.61442514932446,270.321480268195,338.02532881972115,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_51,0.9698871324298658,0.1767033008020137,6,0.07213882047174386,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,269.5734530668533,263.4809157249542,8.040972082471152,19.59733441312315,0.7824121018430688,1,277.61442514932446,283.07825013807735,338.02532881972115,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.9817396771816865,0.14228603427059067,6,0.05808803024785127,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,271.6614200921023,266.700794863939,18.595369300628306,15.78027678748427,0.8430085298128052,1,290.2567893927306,282.4810716514233,319.28246833200365,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_51,1,0.16766888117463108,6,0.06845053410353173,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.9670603949916171,0.14445119855629923,6,0.058971954866065206,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,271.6614200921023,262.7130002182521,18.595369300628306,16.02040500452264,0.7231821873718962,1,290.2567893927306,278.7334052227747,319.28246833200365,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_51,0.9710523674138329,0.08947971318629658,6,0.03652993993950236,leaf_1_log2-1,1,967514 MM WT,leaf,ns,271.6614200921023,263.7974651154397,18.595369300628306,9.9237753598444165,0.7192240986613023,1,290.2567893927306,273.7212404752841,319.28246833200365,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.8890948672493915,0.1171608039921885,6,0.0478306979391827,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,250.35790358286093,241.53277423356883,7.395111496186662,12.993755326154764,0.5714334582373124,1,257.7530150790476,254.5265295597236,306.3214655144496,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_51,0.9215806333412424,0.06667950771407241,6,0.02722179503324203,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.9557679870173621,0.1697733938038751,6,0.06930969778668021,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,250.35790358286093,259.64528863170653,7.395111496186662,18.828770926883983,0.6610935542005536,1,257.7530150790476,278.4740595585905,306.3214655144496,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_51,0.9148369989673485,0.10421304677295097,6,0.04254479818908784,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,250.35790358286093,248.52591829226702,7.395111496186662,11.557780293579505,0.8968908227531014,1,257.7530150790476,260.08369858584655,306.3214655144496,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.9580356038910907,0.61050200133779,6,0.2492363983709198,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,58.34972890670202,34.181662998305285,10.82209075165354,8.892482222398302,0.12169599214383263,1,69.17181965835556,43.074145220703585,82.42920977058841,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_14,1.6354124658237152,0.6782419296648584,5,0.3033190119842509,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.9647260999683451,0.7874138726074609,6,0.32146036737952594,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,58.34972890670202,34.42037258412377,10.82209075165354,11.469354479572647,0.16355080130827773,1,69.17181965835556,45.88972706369641,82.42920977058841,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_14,1.4717336845261086,1.4054692127610129,5,0.6285449400033479,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,58.34972890670202,52.50984892774863,10.82209075165354,22.42579631824083,0.8226778968870756,1,69.17181965835556,74.93564524598946,82.42920977058841,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,1.2575674477578676,0.928423186334676,6,0.37902717864814406,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,37.03971255186034,44.868631731754434,13.191394508673213,13.52327537215634,0.6873262899585422,1,50.23110706053355,58.391907103910775,97.99519276238136,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_14,1.0381403439713652,0.9056383298351238,6,0.36972529993373743,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,1.6197449515322782,1.3779685410951856,6,0.562553301215093,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,37.03971255186034,57.79072912490277,13.191394508673213,20.071286789989053,0.41094446865435197,1,50.23110706053355,77.86201591489183,97.99519276238136,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_14,1.8264911486238598,1.6421511295147047,6,0.67040539130768,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,37.03971255186034,65.16720741700705,13.191394508673213,23.91933145788509,0.3340724672030754,1,50.23110706053355,89.08653887489214,97.99519276238136,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.7061806320999894,0.3440822079804282,6,0.1404709731870412,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,35.678906774941794,25.19575293896499,10.778376169699468,5.011850756925792,0.4134358010992711,1,46.457282944641264,30.207603695890782,55.903084644171074,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_14,1,0.6755022499579134,5,0.30209378997198977,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.8284263598529739,0.46768209710094644,6,0.1909304166220158,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,35.678906774941794,29.557346863098637,10.778376169699468,6.812188535157699,0.645905745340435,1,46.457282944641264,36.36953539825634,55.903084644171074,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_14,1.1817664422108727,0.5943250628125267,6,0.24263219087304205,fruit_1_log2-1,1,967514 MM WT,fruit,ns,35.678906774941794,42.164134721396366,10.778376169699468,8.65685131875915,0.6513239874362488,1,46.457282944641264,50.82098604015552,55.903084644171074,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,2.3451649786933997,1.3648349544954996,6,0.5571915369381121,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,271.461416509586,83.67292264666017,213.23594127513718,19.879984902201432,0.42927835858223945,1,484.6973577847232,103.5529075488616,533.1670935631955,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_14,7.608456677832973,13.363920115182337,5,5.9765267646849045,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,1.1018099210353465,0.9350365624281745,6,0.3817270781325094,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,271.461416509586,39.31137345632611,213.23594127513718,13.619604834160725,0.3378965874377397,1,484.6973577847232,52.930978290486834,533.1670935631955,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_14,1.535110620656163,1.689028665437668,6,0.6895430652093881,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,271.461416509586,54.77106872361428,213.23594127513718,24.60214274091337,0.36845943696779965,1,484.6973577847232,79.37321146452764,533.1670935631955,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,1.3400989425486443,0.6333633134066512,6,0.25856948994079326,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,139.79541672099538,90.7339854377651,33.578177531606634,17.506946382868797,0.23341178719043404,1,173.373594252602,108.2409318206339,190.71095367786222,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_14,2.0647135603830633,1.2147855665100962,6,0.49593413080792215,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,1.2336163681194348,0.7910563669660108,6,0.32294740947442824,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,139.79541672099538,83.52437721341943,33.578177531606634,21.865777681078267,0.19531680839715587,1,173.373594252602,105.3901548944977,190.71095367786222,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_14,1.0505470711150502,1.1150261449441405,6,0.45520751749595695,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,139.79541672099538,71.12931711665738,33.578177531606634,30.820703570654526,0.16306780904038626,1,173.373594252602,101.9500206873119,190.71095367786222,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,1.3538827369782072,0.7520932293836694,6,0.30704077516532907,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,102.66297958653877,91.66724384379783,31.20879525503371,20.788788303696325,0.7762154445920625,1,133.8717748415725,112.45603214749416,227.88905088063794,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_14,1.5162846613541459,1.1290664595568873,6,0.4609394519341856,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,2.3509407212645783,1.7364231127005199,6,0.708891767281927,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,102.66297958653877,159.17497909713205,31.20879525503371,47.99688533981151,0.3505938187035637,1,133.8717748415725,207.17186443694357,227.88905088063794,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_14,1.832667811072086,0.4568186271116146,6,0.18649542357036558,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,102.66297958653877,124.08431139108932,31.20879525503371,12.627032608697958,0.5460336861607862,1,133.8717748415725,136.71134399978726,227.88905088063794,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,1.358898878995591,0.5279377163459723,6,0.21552967016963903,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,67.70693010562654,92.00687142076873,16.136679730514263,14.592852313864492,0.29040587558763403,1,83.8436098361408,106.59972373463323,170.65326045921526,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_14,1,0.5837900407064416,6,0.2383312861082338,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.6013404184355785,0.6085626633461948,6,0.24844466695121944,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,67.70693010562654,40.714913680705926,16.136679730514263,16.82142570038188,0.27383254631584053,1,83.8436098361408,57.53633938108781,170.65326045921526,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_14,1.5096437521525512,1.9147471897736281,6,0.7816922668955697,leaf_1_log2-1,1,967514 MM WT,leaf,ns,67.70693010562654,102.21334401138857,16.136679730514263,52.92598367880709,0.5561122567264006,1,83.8436098361408,155.13932769019567,170.65326045921526,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,2.055864748835262,1.924365134597496,6,0.7856187764276894,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,114.5648925093318,139.19629085601053,53.271390231616664,53.19183558525741,0.7502679060139749,1,167.83628274094846,192.38812644126796,223.34925856386718,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_14,1.6920704029942615,1.927243248993522,6,0.7867937617096266,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,1.3904643582008154,1.1055949633474491,6,0.45135725373205343,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,114.5648925093318,94.14407311506747,53.271390231616664,30.56001403110369,0.7480835195937445,1,167.83628274094846,124.70408714617116,223.34925856386718,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_14,2.4997232683008086,1.2226728531452322,6,0.49915410209311495,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,114.5648925093318,169.2485886102512,53.271390231616664,33.796191902355304,0.4099554268048399,1,167.83628274094846,203.0447805126065,223.34925856386718,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.41949391333894887,0.3601104450665094,6,0.14701447357658334,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,45.24742404315837,21.56539904657082,14.688246684326169,7.557739665554751,0.20119541037318292,1,59.935670727484535,29.123138712125574,65.929237800233,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_20,0.8801608047864793,0.638885637364095,5,0.28571834299887916,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.8297135038377087,0.47736399501780724,6,0.19488303489501985,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,45.24742404315837,42.654022467618326,14.688246684326169,10.018573050241386,0.8879651281179501,1,59.935670727484535,52.67259551785971,65.929237800233,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_20,0.6611607045729013,0.42740905804917134,5,0.19114314159942014,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,45.24742404315837,33.98903768242757,14.688246684326169,9.826312116896126,0.5443894321726621,1,59.935670727484535,43.8153497993237,65.929237800233,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,1.2834601616031995,0.9048327778233471,6,0.3693964347020499,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,52.2545894269321,65.98029116809933,24.555341203532063,18.989981183096724,0.6683594841102248,1,76.80993063046417,84.97027235119606,93.46729958631568,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_20,1.0164654111563705,1.1700105111936088,6,0.4776547910195413,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.7402595200670881,0.466621076612507,6,0.19049725682146326,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,52.2545894269321,38.05536013908963,24.555341203532063,9.793108386086589,0.6089361040585101,1,76.80993063046417,47.848468525176216,93.46729958631568,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_20,0.6179817946696183,0.3535742634319379,6,0.1443460885981082,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,52.2545894269321,31.7692905231694,24.555341203532063,7.420562974687735,0.4554382998283356,1,76.80993063046417,39.189853497857136,93.46729958631568,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,1.1650350223815031,0.909058107249438,6,0.37112141821689815,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,51.40813337414527,59.892275816138635,16.538016199790277,19.078659365696247,0.7445629687963097,1,67.94614957393554,78.97093518183488,86.86802870001837,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_20,1,0.7193439249502541,5,0.32170038307805504,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.7383273310184529,0.5405528214394543,6,0.22067976525807503,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,51.40813337414527,37.95602990677334,16.538016199790277,11.344734805362192,0.5228928973123451,1,67.94614957393554,49.30076471213553,86.86802870001837,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_20,0.980740926760822,0.39185404118146444,6,0.15997374242368906,fruit_1_log2-1,1,967514 MM WT,fruit,ns,51.40813337414527,50.41806036840318,16.538016199790277,8.22395148687817,0.9590096828964756,1,67.94614957393554,58.64201185528135,86.86802870001837,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.8206299825354774,0.7767846833938103,6,0.31712101905403617,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,43.73069247291231,42.18705559300633,16.600614771246892,16.302599643274757,0.9485781554352959,1,60.331307244159206,58.48965523628108,66.75014788739554,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_20,0.8506570770551615,0.722066736534418,5,0.3229180614364779,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.9058672629801788,0.6724552121510264,6,0.2745286907741709,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,43.73069247291231,46.568945074556964,16.600614771246892,14.113007550348064,0.8994353002666209,1,60.331307244159206,60.68195262490503,66.75014788739554,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_20,0.7088055033286087,0.39240970359782995,6,0.16020059065524528,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,43.73069247291231,36.438367851445285,16.600614771246892,8.235613331021701,0.7077101637664811,1,60.331307244159206,44.67398118246699,66.75014788739554,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.8429310134484861,0.5235974561440279,6,0.2137577663620269,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,53.05748186434992,75.14320285351441,18.987195661636466,19.05546591949846,0.43077132660383244,1,72.04467752598639,94.19866877301287,103.61853565031416,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_20,0.595180871463871,0.5217215569402062,6,0.21299193371898414,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.23627549791177022,0.16570597628495562,6,0.06764918153797857,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,53.05748186434992,21.062812241614477,18.987195661636466,6.030595730943769,0.1594070836529113,1,72.04467752598639,27.093407972558246,103.61853565031416,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_20,0.704003705248081,0.3633808697266174,6,0.14834961885316328,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,53.05748186434992,62.75850857196542,18.987195661636466,13.22464747989255,0.6849393725814061,1,72.04467752598639,75.98315605185797,103.61853565031416,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.7131333745805778,0.4436309615317038,6,0.18111158164215785,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,41.9261339817193,63.57237421896626,4.383338106153433,16.145217225761982,0.24538066017744775,1,46.309472087872734,79.71759144472824,192.11314791924497,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_20,0.47031317890563923,0.12044337784743733,6,0.04917080310390941,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.8115281366386043,0.8349546176056367,6,0.3408687952524097,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,41.9261339817193,72.34378901695959,4.383338106153433,30.386796332592446,0.3655746713000113,1,46.309472087872734,102.73058534955203,192.11314791924497,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_20,1.3875107269948272,1.4002139864620113,6,0.5716349662567068,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,41.9261339817193,123.68983743219611,4.383338106153433,50.95847885802657,0.1699513137725235,1,46.309472087872734,174.64831629022268,192.11314791924497,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.5921312680334799,0.37355461015090746,6,0.1525030309890028,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,89.1451395839603,52.78562454087198,11.062431391745132,13.59490398449168,0.06593748868296335,1,100.20757097570544,66.38052852536366,121.94985956196699,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_20,1,0.3039684760244394,6,0.12409461069188311,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.6166808426970092,0.7853224025575495,6,0.32060652830709324,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,89.1451395839603,54.97409980097915,11.062431391745132,28.580513717464743,0.30457425107419706,1,100.20757097570544,83.55461351844389,121.94985956196699,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_20,1.0111443139112806,0.5694696204706042,6,0.23248499902822908,leaf_1_log2-1,1,967514 MM WT,leaf,ns,89.1451395839603,90.13860100314889,11.062431391745132,20.72490768954836,0.9673536520198416,1,100.20757097570544,110.86350869269725,121.94985956196699,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.352904706091124,0.30406506846823966,6,0.12413404439193632,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,30.4739112955606,31.459739284329736,8.96018604677285,11.065946714440686,0.94622485713229,1,39.43409734233345,42.52568599877042,79.76016324152964,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_20,0.34184602141835346,0.2462039312230556,6,0.10051233402729497,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.49838298076167453,0.2969137543318788,6,0.12121453262119693,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,30.4739112955606,44.42842038626968,8.96018604677285,10.80568643012111,0.34440237940294927,1,39.43409734233345,55.23410681639079,79.76016324152964,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_20,0.5415122860205973,0.665947224657056,6,0.2718718160053973,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,30.4739112955606,48.27318832373558,8.96018604677285,24.23605098674591,0.5153200701617382,1,39.43409734233345,72.50923931048149,79.76016324152964,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,2.483879340344616,0.5325495612372028,6,0.2174124479623684,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,286.8118571485732,243.46566645022338,129.47989798349096,21.310401708316725,0.75691623405795,1,416.29175513206417,264.7760681585401,457.92093064527063,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_83,2.9261047642742835,2.9537934311842466,5,1.3209765807240645,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,3.146061148742565,1.3842870342181053,6,0.5651328152308326,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,286.8118571485732,308.3716112254849,129.47989798349096,55.39336603764986,0.8838346293963262,1,416.29175513206417,363.76497726313477,457.92093064527063,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_83,2.890795944452194,1.5747787071142931,5,0.7042624477253582,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,286.8118571485732,283.35094614137296,129.47989798349096,69.0306181167121,0.9819345604406815,1,416.29175513206417,352.38156425808506,457.92093064527063,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,2.353369244426325,0.3591033985264424,6,0.14660334854818344,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,159.73421242690517,230.67328681844106,29.421679324543327,14.369813129958962,0.06559539057599743,1,189.1558917514485,245.04309994840003,531.5025702780978,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_83,1.6296363917683063,0.7352513870741509,6,0.3001651218342062,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,2.7884114248349756,1.4247373015018685,6,0.5816465676982352,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,159.73421242690517,273.3153880939625,29.421679324543327,57.012016221161765,0.11718887546417114,1,189.1558917514485,330.3274043151243,531.5025702780978,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_83,3.982082524618205,2.320761192085282,6,0.9474467892436933,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,159.73421242690517,390.3170174044967,29.421679324543327,92.86713739377397,0.05579376136947622,1,189.1558917514485,483.1841547982707,531.5025702780978,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,1.8652836342302779,0.41638491941378336,6,0.16998843152561044,fruit_1_panK4-1,1,967514 MM WT,fruit,*,98.01831453553807,182.8319579579749,22.959529607159162,16.661979548680062,0.018305589853226164,0.4393341564774279,120.97784414269722,199.49393750665496,225.1209132839267,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_83,1,0.5237701665887465,5,0.23423713941576527,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,1.8177985852647134,0.6616840357465522,6,0.2701313764207596,fruit_1_transp1-1,1,967514 MM WT,fruit,*,98.01831453553807,178.17755349273278,22.959529607159162,26.477822219927845,0.0480151064320628,1,120.97784414269722,204.65537571266063,225.1209132839267,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_83,1.4070132478358925,0.3409294718621772,6,0.13918387405648155,fruit_1_log2-1,1,967514 MM WT,fruit,ns,98.01831453553807,137.9130670820475,22.959529607159162,13.64256874554292,0.18102220213961193,1,120.97784414269722,151.5556358275904,225.1209132839267,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,3.486998819510362,0.5433916970854269,6,0.22183873138738283,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,319.7046506096342,341.7897470758166,49.02446546447622,21.744258549293235,0.6958938877117269,1,368.72911607411044,363.53400562510984,564.6051594576311,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_83,3.261682800041622,1.1183832109193683,5,0.5001561769020385,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,4.329518226956338,0.7608042388275643,6,0.3105970298790137,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,319.7046506096342,424.37207935715145,49.02446546447622,30.444197368485074,0.11344254594002051,1,368.72911607411044,454.8162767256365,564.6051594576311,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_83,4.8705557838020885,0.8964894000121052,6,0.36599026497391624,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,*,319.7046506096342,477.40366877959724,49.02446546447622,35.873748909158245,0.03295148868022925,0.7578842396452727,368.72911607411044,513.2774176887555,564.6051594576311,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.9186517451876787,0.16918528642456304,6,0.06906960395446687,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,2329.479413444333,1665.0373370747352,550.5707064947953,125.18723231474094,0.28755587237373603,1,2880.0501199391283,1790.224569389476,3168.0551319330416,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_83,1.285244649407735,0.7440731850441878,6,0.3037666057742913,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.9619155922363498,0.47048322837227896,6,0.19207397367490214,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,2329.479413444333,1743.45216735061,550.5707064947953,348.1301149476239,0.3932344490898777,1,2880.0501199391283,2091.5822822982336,3168.0551319330416,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_83,1.2091960792698557,0.41560984553280916,6,0.16967200893871953,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,2329.479413444333,2191.6429488928543,550.5707064947953,307.52701599857073,0.8325666933380926,1,2880.0501199391283,2499.169964891425,3168.0551319330416,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,1.2796146954185383,0.29339984076179315,6,0.11977998341337169,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,2521.5821357960617,2319.275237980529,373.55776924585786,217.09874896793625,0.6520599160526219,1,2895.1399050419195,2536.3739869484652,3606.571511227272,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_83,1.3912335646195495,0.5048476351572744,6,0.20610318399768132,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.8077287993597342,0.2600260250545487,6,0.10615518020463313,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,2521.5821357960617,1463.9917860165222,373.55776924585786,192.40407422129354,0.03792733338744621,0.8344013345238166,2895.1399050419195,1656.3958602378157,3606.571511227272,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_83,1.6370976783629165,0.420973225360374,6,0.17186159958443126,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,2521.5821357960617,2967.2057699686193,373.55776924585786,311.49560387435474,0.3818109917385907,1,2895.1399050419195,3278.701373842974,3606.571511227272,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.9383500538379574,0.3008822147870388,6,0.12283464981778945,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1812.4793707702274,1700.7401151424301,407.3504402646862,222.6352688105282,0.8160363155465743,1,2219.8298110349137,1923.3753839529584,3469.5237288399303,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_83,1,0.5505170106970857,6,0.22474762848836144,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.9554078192053063,0.4557944661401258,6,0.18607731160459548,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1812.4793707702274,1731.6569629821886,407.3504402646862,337.26128865171273,0.8816781686407014,1,2219.8298110349137,2068.9182516339015,3469.5237288399303,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_83,1.5085491585063069,0.5674748501199652,6,0.2316706374427127,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1812.4793707702274,2734.2142295854674,407.3504402646862,419.89825117810545,0.14623299510207552,1,2219.8298110349137,3154.112480763573,3469.5237288399303,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,1.0098035394366165,0.243580626930564,6,0.09944137453451876,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1928.654338711422,1830.2480837596272,294.008012730954,180.23543994485107,0.782370049137201,1,2222.662351442376,2010.4835237044783,2461.9756494156013,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_83,1.0640972635687571,0.39733948043474615,6,0.16221316362128468,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,1.1035074573168069,0.3217486054619277,6,0.13135331813896392,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1928.654338711422,2000.0845018778195,294.008012730954,238.07517940909085,0.8541772786900794,1,2222.662351442376,2238.15968128691,2461.9756494156013,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_83,1.144292782290583,0.14135767831237767,6,0.057709030514968875,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1928.654338711422,2074.007062022949,294.008012730954,104.59642731553065,0.657171121080417,1,2222.662351442376,2178.6034893384794,2461.9756494156013,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,1.7002071605446603,1.0184648969423196,6,0.4157865530741564,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,42.42090007874332,83.12539528843877,9.424534897449679,20.328359027046222,0.11226051012869849,1,51.845434976193005,103.45375431548499,113.79912974703349,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_4,0.8676568432590676,0.43103550634971566,5,0.19276493858280128,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,1.0818650341915756,0.6339798080726651,6,0.2588211728342735,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,42.42090007874332,52.8938241779348,9.424534897449679,12.654112275338331,0.5239847527280941,1,51.845434976193005,65.54793645327314,113.79912974703349,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_4,1.152076840495518,0.5350996845405301,5,0.23930385387426373,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,42.42090007874332,56.3265730148829,9.424534897449679,11.69988452523191,0.3829199835915383,1,51.845434976193005,68.0264575401148,113.79912974703349,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.946957305259899,0.5675696439727225,6,0.23170933687104733,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,36.08101832204369,46.298005412344686,11.2990523517643,11.328578461731453,0.5374616732197397,1,47.38007067380799,57.62658387407614,63.38924226148376,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_4,0.7379839277517851,0.5660903653696244,6,0.2311054239102128,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.9903490959769043,0.3200792849443666,6,0.13067182089143337,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,36.08101832204369,48.41948792302227,11.2990523517643,6.388719572961208,0.3699941890843592,1,47.38007067380799,54.808207495983474,63.38924226148376,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_4,0.8424007197475489,0.34299303654613883,6,0.14002632081097047,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,36.08101832204369,41.1860945214746,11.2990523517643,6.8460735481603745,0.7089797874126026,1,47.38007067380799,48.03216806963498,63.38924226148376,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.6711392633389918,0.2794945762982555,6,0.11410318296768455,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,48.89133349009634,32.81289354220424,9.010153260483843,5.578656770754547,0.17393011237327022,1,57.90148675058019,38.39155031295879,246.24947218094775,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_4,1,0.4120835685983975,5,0.1842893743593429,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,1.4382919949890907,1.225396973651108,6,0.5002662196326563,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,48.89133349009634,70.32001358314761,9.010153260483843,24.45868257788998,0.44099426739454717,1,57.90148675058019,94.7786961610376,246.24947218094775,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_4,3.0537151309595676,3.7356556323127568,6,1.5250750256533843,fruit_1_log2-1,1,967514 MM WT,fruit,ns,48.89133349009634,149.30020485149745,9.010153260483843,74.56295167663684,0.23731165128972037,1,57.90148675058019,223.8631565281343,246.24947218094775,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,1.4887050176669487,0.6281386778566729,6,0.2564365414092179,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,86.08956686842208,72.78477348713456,35.43468485656824,12.537524465084973,0.7377945670028052,1,121.52425172499032,85.32229795221953,133.67667689748936,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_4,1.7608349112805604,1.6206218657672542,5,0.7247641315356239,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.687507787365261,0.5043383608788657,6,0.20589527364414376,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,86.08956686842208,33.61317250911322,35.43468485656824,10.066494487770477,0.21782501736848578,1,121.52425172499032,43.6796669968837,133.67667689748936,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_4,1.5956083901302904,0.6446557716180114,6,0.26317961670071566,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,86.08956686842208,78.01142192145578,35.43468485656824,12.867202407910419,0.8387042192212946,1,121.52425172499032,90.8786243293662,133.67667689748936,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.6654574328679852,0.2971177027113819,6,0.12129779419847195,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,197.48449906618674,204.76557105567636,15.342615657686661,37.32411852370331,0.8621969802200861,1,212.8271147238734,242.08968957937967,313.6362199098955,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_4,0.6417950395775851,0.1221345043929315,6,0.04986120262506546,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.645601769808274,0.375581142930174,6,0.15333035953170732,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,197.48449906618674,198.65585466466956,15.342615657686661,47.18074677499437,0.9819236866876279,1,212.8271147238734,245.83660143966392,313.6362199098955,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_4,0.7574191825158254,0.41443057801437094,6,0.16919057499031756,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,197.48449906618674,233.06279827389696,15.342615657686661,52.061038007826184,0.5369922666289639,1,212.8271147238734,285.12383628172313,313.6362199098955,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.7907703898136826,0.268484134628706,6,0.10960818897883888,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,156.99879987379498,243.3251812159728,27.20827390953425,33.72715112956432,0.0756339280148887,1,184.20707378332924,277.05233234553714,317.06933305455993,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_4,0.5102225817980056,0.21659077718363068,6,0.0884228145154567,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.821418665808455,0.2825092369353284,6,0.11533391301909826,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,156.99879987379498,252.75585465348257,27.20827390953425,35.488993577935496,0.05971414026500818,1,184.20707378332924,288.2448482314181,317.06933305455993,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_4,0.6083962966201102,0.16922473811608313,6,0.06908571004008586,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,156.99879987379498,187.20748909312988,27.20827390953425,21.258121360485944,0.4033233335942522,1,184.20707378332924,208.46561045361582,317.06933305455993,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.7800065211568449,0.6842553465604428,6,0.27934607547405893,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,307.70649021557807,240.01306897043577,41.34700073485669,85.95660043961865,0.5002375298722239,1,349.05349095043476,325.9696694100544,419.6871212485218,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_4,1,0.3291417549364144,6,0.13437155877306695,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.6553058539636313,0.2930645268119206,6,0.11964309206656754,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,307.70649021557807,201.64186434087114,41.34700073485669,36.81495593834276,0.08477663045968131,1,349.05349095043476,238.4568202792139,419.6871212485218,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_4,1.0799083838631798,0.3919652428745056,6,0.1600191403247698,leaf_1_log2-1,1,967514 MM WT,leaf,ns,307.70649021557807,332.29481855291624,41.34700073485669,49.238928036649,0.7103865333631808,1,349.05349095043476,381.5337465895652,419.6871212485218,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.8015316038675468,0.2908866210114021,6,0.11875396574671454,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,191.3222338888669,246.6364766229459,50.389531173531964,36.54136599910251,0.3970194419078905,1,241.71176506239885,283.1778426220484,491.7826912542116,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_4,0.6217686008339545,0.4011245900817563,6,0.16375842816389485,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,1.2726672396758423,0.44154527901878216,6,0.18026010532180722,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,191.3222338888669,391.6079695330013,50.389531173531964,55.467204334463744,0.023557643125695447,0.5653834350166907,241.71176506239885,447.0751738674651,491.7826912542116,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_4,0.9182033435619107,0.8471140374001321,6,0.3458328575965449,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,191.3222338888669,282.5371281516442,50.389531173531964,106.41501481225666,0.4634130709094597,1,241.71176506239885,388.9521429639009,491.7826912542116,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,0.9914370980076934,0.13779863365057504,6,0.05625605661610341,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,58.146813886140436,50.28482143803452,1.3252028981986586,2.853257929760027,0.041126004651633845,0.9870241116392122,59.4720167843391,53.138079367794546,67.90181281047772,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_10,1.1464475117746753,0.05842458448497789,5,0.026128268493118022,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,1.1310094226666552,0.21081397163731908,6,0.08606444352683283,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,58.146813886140436,57.36380752527171,1.3252028981986586,4.365113211526216,0.8694525110141219,1,59.4720167843391,61.728920736797924,67.90181281047772,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_10,1.1011597875291979,0.09781664220706913,5,0.043744932261156326,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,58.146813886140436,55.849860169565765,1.3252028981986586,2.2187046581084178,0.40565218278320564,1,59.4720167843391,58.06856482767418,67.90181281047772,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,1.3996576358651176,0.32929580773353706,6,0.13443445056413345,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,53.473171744944786,70.98940965119385,3.2253051654469935,6.8183976122358825,0.05255677618823844,1,56.698476910391776,77.80780726342974,85.58858798977272,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_10,1.0542999795953387,0.15576672556277357,6,0.06359149942215603,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,1.0847475789163716,0.026881097613808323,6,0.010974162146629477,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,53.473171744944786,55.01744732042167,3.2253051654469935,0.5565998943192839,0.6558495997891255,1,56.698476910391776,55.57404721474095,85.58858798977272,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_10,1.042139569000207,0.130845976926544,6,0.05341764639433566,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,53.473171744944786,52.85640636808108,3.2253051654469935,2.7092962488260577,0.8865828069729865,1,56.698476910391776,55.56570261690714,85.58858798977272,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,1.1173805959783962,0.16603902605204737,6,0.06778514853603317,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,50.719124328797626,56.67256537001427,2.5916333136798877,3.4380033762450806,0.2009542422338692,1,53.31075764247751,60.11056874625935,66.12162562088528,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_10,1,0.1142580503672242,5,0.05109775351954162,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,1.1300220830529109,0.12845146038991104,6,0.0524400891117678,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,50.719124328797626,57.31373052464746,2.5916333136798877,2.659715399472978,0.10974401327679206,1,53.31075764247751,59.97344592412044,66.12162562088528,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_10,1.048096946481737,0.14832654032178713,6,0.06055405651678885,fruit_1_log2-1,1,967514 MM WT,fruit,ns,50.719124328797626,53.15855933724037,2.5916333136798877,3.071248721088052,0.558876327847063,1,53.31075764247751,56.22980805832842,66.12162562088528,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,1.0626748157917207,0.14483744224183415,6,0.059129638190387294,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,60.843437367344755,53.8979361032224,14.262782245087353,2.999003470895074,0.6566218384899705,1,75.10621961243211,56.896939574117475,82.61684157367533,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_10,1.1996152964494042,0.6288072018267127,5,0.2812111296051919,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,1.1071055679092796,0.6036396626941872,6,0.24643486035108486,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,60.843437367344755,56.15142494389485,14.262782245087353,12.49896032109655,0.8104659334011726,1,75.10621961243211,68.6503852649914,82.61684157367533,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_10,1.038874300253103,0.12510365329164028,6,0.05107335258709598,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,60.843437367344755,52.69079479652976,14.262782245087353,2.5903957197534377,0.6020986498712938,1,75.10621961243211,55.281190516283196,82.61684157367533,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,1.0629438095944446,0.04426570736702861,6,0.01807139935876306,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,332.598016334585,339.34238102598374,14.122869614025669,5.769252929008398,0.6725002799971582,1,346.72088594861066,345.11163395499216,381.3929745434718,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_10,1.0418180053942887,0.10836044479412542,6,0.04423796634110551,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,1.0351201400657943,0.05533816486408676,6,0.022591711203170835,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,332.598016334585,330.4597381416579,14.122869614025669,7.212352150637569,0.8963135608168571,1,346.72088594861066,337.6720902922955,381.3929745434718,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_10,1.0060035928936795,0.04469303880125552,6,0.018245856686247664,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,332.598016334585,321.16434702553613,14.122869614025669,5.8249480319495746,0.47981735106195733,1,346.72088594861066,326.9892950574857,381.3929745434718,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,1.070651801669156,0.07021016067924594,6,0.028663178070495295,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,348.8037372156643,341.8031398732081,9.481134701100967,9.150654066958374,0.6068343514130241,1,358.28487191676527,350.9537939401665,394.11335910844184,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_10,1.0925802197645582,0.07274583717348836,6,0.029698363664439162,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,1.038660129053388,0.11432514034628014,6,0.04667304310341008,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,348.8037372156643,331.58987153254157,9.481134701100967,14.900262303124405,0.35670243092918597,1,358.28487191676527,346.490133835666,394.11335910844184,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_10,1.0960809886856278,0.05608627332270527,6,0.022897125202483395,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,348.8037372156643,349.92134968997823,9.481134701100967,7.309854871656226,0.927584201250114,1,358.28487191676527,357.23120456163446,394.11335910844184,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,1.0597636162761657,0.027407823451076743,6,0.011189197069237456,leaf_1_panK4-1,1,967514 MM WT,leaf,*,319.2477137201226,338.3271115799352,6.910293690162065,3.572125582717958,0.041726425338517156,0.9870241116392122,326.15800741028465,341.89923716265315,387.7956114136813,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_10,1,0.05302056298674247,6,0.021645554198769186,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,1.0416167945772576,0.09552853078621902,6,0.03899935938399843,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,319.2477137201226,332.5337802412721,6.910293690162065,12.450456319890908,0.378731118982463,1,326.15800741028465,344.984236561163,387.7956114136813,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_10,1.0681122427878231,0.0886124963563537,6,0.03617590015121669,leaf_1_log2-1,1,967514 MM WT,leaf,ns,319.2477137201226,340.99239150648503,6.910293690162065,11.549073415043363,0.14402635189682844,1,326.15800741028465,352.5414649215284,387.7956114136813,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,1.0545406610282801,0.04926389673960108,6,0.02011190162553042,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,331.30021128283045,336.6596950581852,6.803321380803072,6.4206786125146085,0.579394423613705,1,338.10353266363353,343.0803736706998,395.9247288761318,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_10,1.0377528077562803,0.05219979728263349,6,0.021310478003195327,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,1.079852640545305,0.07943428377813523,6,0.032428910556645076,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,331.30021128283045,344.740486648726,6.803321380803072,10.352855553643288,0.30729741944088784,1,338.10353266363353,355.0933422023693,395.9247288761318,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_10,1.0904926559472434,0.09049392550341376,6,0.036943990384132847,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,331.30021128283045,348.1372872397417,6.803321380803072,11.794284465832606,0.25133038464178425,1,338.10353266363353,359.9315717055743,395.9247288761318,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,1.8450142681848,0.9384563969571899,6,0.38312321973264923,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,72.75482247834161,118.10528815561626,6.518631959837352,24.524947609293942,0.126780363074079,1,79.27345443817896,142.6302357649102,156.89325934140123,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_15,1.1365594855915795,0.2277046236560064,5,0.1018326034571674,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,1.220490462852143,0.6308130981834235,6,0.2575283689355956,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,72.75482247834161,78.1275138582808,6.518631959837352,16.48521789010789,0.7713179771409627,1,79.27345443817896,94.6127317483887,156.89325934140123,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_15,0.8262395718813573,0.4983442491857415,5,0.22286632347508242,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,72.75482247834161,52.89024827901581,6.518631959837352,14.266389050803244,0.2554688517394846,1,79.27345443817896,67.15663732981905,156.89325934140123,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.814585846003738,0.535427921248006,6,0.21858753351611834,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,77.7384945663005,52.144255862265055,22.40711675821752,13.992489965156611,0.35973446752658417,1,100.14561132451803,66.13674582742166,110.16017245696985,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_15,1.2144132909023388,0.8574167983603398,6,0.3500389421456075,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.9239770517356041,0.3473323690854737,6,0.14179784590190816,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,77.7384945663005,59.14673822646013,22.40711675821752,9.07693546812892,0.4685075156580907,1,100.14561132451803,68.22367369458905,110.16017245696985,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_15,1.16150496015912,0.27871932031484825,6,0.11378668603778666,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,77.7384945663005,74.35166241220108,22.40711675821752,7.283851173675245,0.8903735858878921,1,100.14561132451803,81.63551358587632,110.16017245696985,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,1.09840038761461,0.2757562808573201,6,0.11257703024467383,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,64.01321127549492,70.31213607745954,12.419205215150516,7.206417221820088,0.6749858096663548,1,76.43241649064544,77.51855329927963,90.86969631283543,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_15,1,0.4338196215165858,5,0.19401003273686326,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,1.1380795525949543,0.37334335612065644,6,0.1524167868922992,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,64.01321127549492,72.85212684858155,12.419205215150516,9.756687981268836,0.5909982120423553,1,76.43241649064544,82.60881482985039,90.86969631283543,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_15,1.05795555479617,0.40361811283566884,6,0.1647764045654124,fruit_1_log2-1,1,967514 MM WT,fruit,ns,64.01321127549492,67.72313244925068,12.419205215150516,10.547866798662167,0.8253547661785983,1,76.43241649064544,78.27099924791285,90.86969631283543,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,1.1874347011771502,0.31561902046430973,6,0.12885092554243346,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,*,40.8376556803037,76.0115084023071,6.561943233333071,8.248161519790859,0.008858378106081725,0.2126010745459614,47.399598913636765,84.25966992209796,97.75817436151237,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_15,0.6379566790447346,0.2292175449701975,5,0.10250920243779532,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,1.1219801854110971,0.6524060619345148,6,0.2663436594730268,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,40.8376556803037,71.82155465563953,6.561943233333071,17.04951294573534,0.1376007378064061,1,47.399598913636765,88.87106760137488,97.75817436151237,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_15,0.5322006669509222,0.5838286583619545,6,0.23834705170007867,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,40.8376556803037,34.06787373448869,6.561943233333071,15.257360177368449,0.6962101654247934,1,47.399598913636765,49.32523391185714,97.75817436151237,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.561504209966999,0.09141580540485096,6,0.037320346277907576,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,976.9586659136668,595.4346557678666,329.32211093251044,39.57553148253245,0.30069175943310883,1,1306.280776846177,635.0101872503991,1436.908854530795,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_15,0.9212873294498469,0.7607035175714251,6,0.3105559105983815,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.5552848808721471,0.09852780423984145,6,0.04022380764407343,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,976.9586659136668,588.839506501011,329.32211093251044,42.65444253682334,0.2935663634011207,1,1306.280776846177,631.4939490378343,1436.908854530795,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_15,0.6800794914925056,0.15699866193729775,6,0.06409443534101578,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,976.9586659136668,721.175176826235,329.32211093251044,67.96751897222019,0.47859814800069334,1,1306.280776846177,789.1426957984552,1436.908854530795,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.585979647309336,0.11362722877598001,6,0.04638812189794011,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,620.7309740782359,621.3890891452388,52.48287081241077,49.1912525386785,0.9928808582131384,1,673.2138448906467,670.5803416839174,789.1801181644629,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_15,0.5853590344894654,0.12123056155020628,6,0.04949216950484584,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.6175254156160286,0.14458950383002425,6,0.05902841775762558,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,620.7309740782359,654.8410978020079,52.48287081241077,62.59537325659469,0.6853454076831811,1,673.2138448906467,717.4364710586026,789.1801181644629,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_15,0.6124495274814409,0.11248212238531217,6,0.04592063417155072,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,620.7309740782359,649.4584850798128,52.48287081241077,48.69551557269078,0.6967185161844678,1,673.2138448906467,698.1540006525036,789.1801181644629,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.7605616588553137,0.153622016503891,6,0.06271592561532487,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1060.427767412219,806.520701879274,294.82770002155263,66.50570898144974,0.4357973894962347,1,1355.2554674337716,873.0264108607238,1490.781014177149,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_15,1,0.6810246291960945,6,0.2780271406330918,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.639513117085294,0.14191123117415158,6,0.05793501752446945,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1060.427767412219,678.1574669815874,294.82770002155263,61.43590128846092,0.25598032111040986,1,1355.2554674337716,739.5933682700484,1490.781014177149,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_15,0.8796323804693649,0.25550719721814363,6,0.10431037646552024,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1060.427767412219,932.7866013646243,294.82770002155263,110.61361963325967,0.6984678146865879,1,1355.2554674337716,1043.400220997884,1490.781014177149,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.654355835889896,0.1857744968368284,6,0.07584212074541953,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,646.9840564977002,693.8970981458789,80.84799216038712,80.42509077787318,0.6894706979635927,1,727.8320486580873,774.322188923752,895.3766339046647,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_15,0.6101161025578828,0.18675135978828117,6,0.0762409233753676,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.7329314289560614,0.08490738253457578,6,0.034663293767501824,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,646.9840564977002,777.2208388741237,80.84799216038712,36.75791922102584,0.1860665283888407,1,727.8320486580873,813.9787580951496,895.3766339046647,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_15,0.5754162093500856,0.1771266519857049,6,0.07231165286875164,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,646.9840564977002,610.1873262139134,80.84799216038712,76.68128460949768,0.7480620388955185,1,727.8320486580873,686.868610823411,895.3766339046647,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.43643342852999234,0.4208589637780897,6,0.17181495248879797,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,91.42806372571346,55.404687304683584,16.424794016779632,21.811697030115866,0.2205064902918699,1,107.85285774249309,77.21638433479944,153.26396207829893,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_92,0.7201965259047431,0.289305329192156,5,0.12938127646532302,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.7103820676923265,0.48439949131189786,6,0.19775526422964718,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,91.42806372571346,90.18213031920205,16.424794016779632,25.104787720782323,0.9678550836120877,1,107.85285774249309,115.28691803998437,153.26396207829893,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_92,0.8878202100363818,0.46893926370701605,5,0.20971601419351757,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,91.42806372571346,112.70768438963394,16.424794016779632,26.62319022700144,0.5192853626511473,1,107.85285774249309,139.33087461663538,153.26396207829893,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.33367652637383305,0.3018249317951141,6,0.1232195124247274,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,71.2626900976105,42.35982488079452,6.3547521177130895,15.642565645629594,0.13320699928689517,1,77.61744221532359,58.002390526424115,157.89240285458524,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_92,0.5613499809959465,0.12261560334506191,6,0.05005761044981665,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.2799312125666337,0.2261414367303815,6,0.0923218549482201,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,71.2626900976105,35.53692335464495,6.3547521177130895,11.720146007200212,0.028892662961329217,0.6356385851492428,77.61744221532359,47.25706936184516,157.89240285458524,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_92,0.8884285314206,0.5933946453858042,6,0.2422523495491648,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,71.2626900976105,112.78491004163517,6.3547521177130895,30.753638007987767,0.23908842566108138,1,77.61744221532359,143.53854804962293,157.89240285458524,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.6656721317802334,0.36444570937125564,6,0.148784337817705,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,126.94877083842833,84.50625891089692,29.30819700952086,18.88798880596714,0.262724963440755,1,156.2569678479492,103.39424771686406,238.60747902343329,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_92,1,0.5162328109080576,5,0.23086633148124233,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,1.1646560332610272,1.332601661461123,6,0.544032350160807,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,126.94877083842833,147.85165187204709,29.30819700952086,69.06423814925587,0.7889561845705201,1,156.2569678479492,216.91589002130297,238.60747902343329,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_92,1.1744783781303352,0.44168597185156705,6,0.1803175429302722,fruit_1_log2-1,1,967514 MM WT,fruit,ns,126.94877083842833,149.09858647995688,29.30819700952086,22.891090435603584,0.5679178369270683,1,156.2569678479492,171.98967691556047,238.60747902343329,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.4392118033820466,0.21769144390112535,6,0.08887215982124437,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,54.01874019060251,55.757398577080274,10.33686682393411,11.282211451063331,0.9120300782493808,1,64.35560701453662,67.0396100281436,94.32236820363237,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_92,0.4255160552862213,0.18207294753642675,5,0.08142549751104061,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.48470884905095596,0.4672196542457313,6,0.19074162511693699,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,54.01874019060251,61.53319260152816,10.33686682393411,24.214414856319436,0.7839371568103529,1,64.35560701453662,85.7476074578476,94.32236820363237,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_92,0.4843658771747252,0.3010140665406361,6,0.12288847807079022,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,54.01874019060251,61.48965274340851,10.33686682393411,15.60054124129197,0.6997642263745933,1,64.35560701453662,77.09019398470048,94.32236820363237,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,1.0932400842726746,0.4187410322825323,6,0.1709503105764171,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,75716.19121033206,103413.81792500167,9586.372299952469,16170.852630173691,0.17829043421454252,1,85302.56351028453,119584.67055517535,163927.49805841435,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_92,0.8004343802452069,0.24823721571962992,6,0.10134241894704811,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,1.060533015160452,0.5816290544564956,6,0.23744906716597744,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,75716.19121033206,100319.92945650291,9586.372299952469,22461.227823255766,0.34838782820765546,1,85302.56351028453,122781.15727975869,163927.49805841435,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_92,1.3228587656067423,0.6186438932490115,6,0.25256031182481753,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,75716.19121033206,125134.3391950008,9586.372299952469,23890.659039921324,0.09909855526398627,1,85302.56351028453,149024.99823492212,163927.49805841435,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.6784987682424365,0.1400722997309525,6,0.057184276906503184,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,42780.18934791191,64181.8289420318,16975.038016716608,5409.282448801086,0.27487853065033974,1,59755.22736462852,69591.11139083288,127514.13715880665,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_92,0.4522511473450316,0.43956525389958956,6,0.17945176345182134,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.3572031672225397,0.11538287900026618,6,0.04710486310065743,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,42780.18934791191,33789.23241911809,16975.038016716608,4455.831620292588,0.6277215065670441,1,59755.22736462852,38245.064039410674,127514.13715880665,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_92,1.090389996681933,0.3308766832672676,6,0.13507984029821507,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,42780.18934791191,103144.217090364,16975.038016716608,12777.725781278392,0.01878447346250157,0.4320428896375361,59755.22736462852,115921.9428716424,127514.13715880665,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,1.3687160666510294,0.8834120470842329,6,0.3606514579973198,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,94593.87687362579,129472.15908374086,17288.032575397687,34115.41961209209,0.39050100335053806,1,111881.90944902349,163587.57869583296,245470.46444099265,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_92,1,0.44767018612538784,6,0.18276058817732896,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,1.064707882423711,0.47731881465729814,6,0.19486459009007948,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,94593.87687362579,100714.84633636737,17288.032575397687,18432.99704201054,0.8135338175723593,1,111881.90944902349,119147.8433783779,245470.46444099265,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_92,1.9692189073857296,0.9549722607795651,6,0.38986579290366785,leaf_1_log2-1,1,967514 MM WT,leaf,ns,94593.87687362579,186276.05086246162,17288.032575397687,36878.91681116805,0.05860812491034667,1,111881.90944902349,223154.96767362967,245470.46444099265,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.2781259943417459,0.14368470476572168,6,0.05865903508641075,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,13173.493656070199,26309.016064117855,2907.938984858766,5548.785542489634,0.0713224286153709,1,16081.432640928964,31857.80160660749,41765.55397179201,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_92,0.1392637038618212,0.07530050518562545,6,0.030741302513096844,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.17404368355165478,0.09565239834697756,6,0.03904992810392203,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,13173.493656070199,16463.466772517524,2907.938984858766,3693.8840909863397,0.5008539152501944,1,16081.432640928964,20157.350863503863,41765.55397179201,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_92,0.3427789738947853,0.1435580231185803,6,0.05860731752053214,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,13173.493656070199,32424.79205147111,2907.938984858766,5543.893377430708,0.016317378306222718,0.3916170793493452,16081.432640928964,37968.68542890182,41765.55397179201,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.7945471778715785,0.23448359408132424,6,0.09572752642552301,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,82.89710700480718,80.83038747206528,14.853335011152263,9.738494161473223,0.9105780983453021,1,97.75044201595945,90.56888163353851,316.86012556864364,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_69,0.8148626337731063,0.32647806477055613,5,0.14600542919790854,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,1.1395247680317844,1.0064797072266565,6,0.4108936198618519,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,82.89710700480718,115.92543665029764,14.853335011152263,41.800778390784366,0.48373314654694277,1,97.75044201595945,157.726215041082,316.86012556864364,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_69,2.045197488633475,1.7582749620956042,5,0.7863244676763274,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,82.89710700480718,208.06077985951654,14.853335011152263,79.99387974834131,0.19424946237663326,1,97.75044201595945,288.05465960785784,316.86012556864364,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.8314917474798434,0.5618255063669534,6,0.22936430251330292,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,58.538229360375034,84.5888098283365,11.232882541712966,23.333548920372355,0.34704744553510636,1,69.771111902088,107.92235874870885,120.74435024063986,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_69,0.5754195469118509,0.2704654977043967,6,0.11041707706727784,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.897691741955741,0.4440988290979659,6,0.18130258777624786,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,58.538229360375034,91.32342717160049,11.232882541712966,18.444163956253924,0.16627662197260082,1,69.771111902088,109.76759112785442,120.74435024063986,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_69,0.792750747256397,0.3455558910046189,6,0.14107260176235267,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,58.538229360375034,80.64763409160426,11.232882541712966,14.351511627905335,0.25451151059106997,1,69.771111902088,94.9991457195096,120.74435024063986,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.6456169375963724,0.13913891262172845,6,0.05680322321482146,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,101.73138829665541,65.6795073695141,24.430764887187454,5.778670757368594,0.21739219746049201,1,126.16215318384286,71.45817812688269,138.77836850222715,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_69,1,0.5369911090839026,5,0.24014972464492218,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.6710067634967845,0.38573140165131736,6,0.15747418530238003,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,101.73138829665541,68.2624496069734,24.430764887187454,16.02006749169589,0.28896863247028426,1,126.16215318384286,84.2825170986693,138.77836850222715,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_69,0.5015635961727867,0.2355588921769397,6,0.09616651503479708,fruit_1_log2-1,1,967514 MM WT,fruit,ns,101.73138829665541,51.02476095772062,24.430764887187454,9.78315308214109,0.10891717046420955,1,126.16215318384286,60.807914039861714,138.77836850222715,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.552979269566621,0.3694031578002199,6,0.1508082076638924,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,78.96936044816908,56.2553487922828,33.46306601298369,15.341928332178082,0.5612085550032018,1,112.43242646115277,71.59727712446089,133.67498022070188,5,24,20.833333333333336,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_69,0.7762536398096646,0.735522158828677,5,0.32893550921966375,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.1562084478728983,0.23239446654846868,6,0.09487464368167375,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,78.96936044816908,15.891302265775675,33.46306601298369,9.651729215887178,0.13403067515804082,1,112.43242646115277,25.54303148166285,133.67498022070188,5,24,20.833333333333336,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_69,0.8882676212074001,0.7502230102766643,6,0.3062772614121014,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,78.96936044816908,90.36469828439644,33.46306601298369,31.15801100715072,0.80896612369617,1,112.43242646115277,121.52270929154716,133.67498022070188,5,24,20.833333333333336,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,1.4644804190173402,0.8609310820837923,6,0.35147364246791196,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,109.21365838361572,136.9762888109044,23.795593672271973,32.87415422898545,0.5109338005562656,1,133.00925205588769,169.85044303988985,212.0147895389814,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_69,1.1676565745831595,0.6231754607707088,6,0.254410316518672,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,1.394935434667129,0.5695475613684445,6,0.23251681826652962,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,109.21365838361572,130.47158329350577,23.795593672271973,21.747843425342257,0.5246292526318973,1,133.00925205588769,152.21942671884804,212.0147895389814,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_69,1.749121262979993,0.763172596551519,6,0.3115639078710251,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,109.21365838361572,163.59941462652262,23.795593672271973,29.14130313618774,0.18008976511467373,1,133.00925205588769,192.74071776271035,212.0147895389814,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,1.8060262737939254,1.1695842026673462,6,0.4774807512924844,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,147.21030102641845,168.92187376958648,18.831086251714016,44.65989469123285,0.6682590903902429,1,166.04138727813248,213.58176846081932,277.3895903202352,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_69,1.5738972431093903,0.4931615076869983,6,0.2013323424357983,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,1.8410441578866559,0.27735109336366726,6,0.11322810972400044,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,147.21030102641845,172.19717860995513,18.831086251714016,10.590490700773119,0.2813356552070525,1,166.04138727813248,182.78766931072826,277.3895903202352,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_69,2.256448289455921,1.0769170552024188,6,0.4396495467577651,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,147.21030102641845,211.05090144583613,18.831086251714016,41.12145339074131,0.20090775325963067,1,166.04138727813248,252.17235483657743,277.3895903202352,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,1.3691326565019124,0.7960637975554224,6,0.32499168445217197,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,93.53234569214308,128.05818892633906,21.348341367353658,30.397234577252433,0.37697768925233177,1,114.88068705949674,158.45542350359148,212.4742858753423,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_69,1,0.5590851252344811,6,0.22824554660075166,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,1.2720950095817913,0.528132377150341,6,0.21560914011024288,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,93.53234569214308,118.98203018945418,21.348341367353658,20.16642862717695,0.40653794127485887,1,114.88068705949674,139.14845881663112,212.4742858753423,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_69,1.7523915605870872,0.766101679543066,6,0.31275970099495093,leaf_1_log2-1,1,967514 MM WT,leaf,ns,93.53234569214308,163.90529323282556,21.348341367353658,29.253148472031057,0.08334955973157193,1,114.88068705949674,193.1584417048566,212.4742858753423,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,2.703061881258011,0.6120146407852466,6,0.24985393083943216,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,223.15432786449992,252.8237183050789,33.22313976431354,23.369424231814573,0.4837572031762243,1,256.37746762881346,276.19314253689345,428.43674478124,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_69,2.38585193403575,0.8700705565922102,6,0.3552048173117116,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,3.703944017133292,1.1274068665920254,6,0.46026192594341486,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,223.15432786449992,346.4385722348562,33.22313976431354,43.04937756627103,0.048410459218510074,1,256.37746762881346,389.48794980112723,428.43674478124,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_69,2.6216919735456603,0.8924165175189432,6,0.36432751765882265,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,223.15432786449992,245.21299996798953,33.22313976431354,34.07640732682536,0.6529381166037462,1,256.37746762881346,279.2894072948149,428.43674478124,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,1.6900173701749075,0.5758353890057455,6,0.23508381315018917,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,14732.995385867538,8064.18191623999,5395.066090223546,1121.7391420126621,0.28786573297202495,1,20128.061476091083,9185.921058252652,22140.867623700193,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_21,3.0876062042549175,2.5282069652157446,5,1.1306485270821702,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,1.184478939445355,0.4818576856533546,6,0.19671757641485552,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,14732.995385867538,5651.92631283653,5395.066090223546,938.668649403915,0.16850141216020975,1,20128.061476091083,6590.594962240445,22140.867623700193,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_21,1.8954214953425033,1.6964391427954113,5,0.7586706485964024,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,14732.995385867538,9044.299790132725,5395.066090223546,3620.115528256368,0.41031602712859727,1,20128.061476091083,12664.415318389094,22140.867623700193,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,1.4613732321849786,0.5409124710754339,6,0.22082659160712967,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,6144.915402466982,6973.170690336532,753.1748196830871,1053.7085819886145,0.5383597148623951,1,6898.090222150069,8026.879272325146,8829.567199557661,0,23,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_21,1.2877950765856054,0.3866359825006864,6,0.1578434788877213,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,1.0977898713348593,0.4882853325462855,6,0.1993416522705999,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,6144.915402466982,5238.275880758423,753.1748196830871,951.1898373136852,0.4729912544020348,1,6898.090222150069,6189.465718072109,8829.567199557661,0,23,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_21,1.232272294338998,0.7857796355537807,5,0.3514113360866528,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,6144.915402466982,5879.979772553261,753.1748196830871,1676.814091761928,0.8904497572377987,1,6898.090222150069,7556.793864315188,8829.567199557661,0,23,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,1.0510584818156188,0.37871895689699925,6,0.15461136671945738,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,4771.656231796832,5015.2897547384155,969.9007462135248,737.7522915135241,0.8466102593169721,1,5741.556978010357,5753.04204625194,9494.329532538033,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_21,0.9999999999999999,0.45450969110248246,5,0.2032629131475164,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,1.4140197938811765,0.8479485680656836,6,0.34617355331409594,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,4771.656231796832,6747.2163613571865,969.9007462135248,1651.8211929544589,0.33302089476685026,1,5741.556978010357,8399.037554311646,9494.329532538033,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_21,1.5706447284423066,0.5834804920863786,6,0.23820491341327765,fruit_1_log2-1,1,967514 MM WT,fruit,ns,4771.656231796832,7494.576706410576,969.9007462135248,1136.631959533091,0.10179928356702553,1,5741.556978010357,8631.208665943666,9494.329532538033,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,2.93135919777696,1.184764668381086,6,0.483678150468564,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,14870.988564881356,13987.438383707395,2181.788891877769,2307.945860867289,0.7871648532484096,1,17052.777456759126,16295.384244574683,22194.030489803277,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_21,3.1165255505595137,1.0224182208020292,5,0.4572393286295453,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,3.5909063899294567,1.561493065465433,6,0.6374768745474401,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,14870.988564881356,17134.570853305955,2181.788891877769,3041.8205010606594,0.560967300961271,1,17052.777456759126,20176.391354366613,22194.030489803277,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_21,2.851823214874774,1.4315581265471427,6,0.5844311578625215,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,14870.988564881356,13607.920015240092,2181.788891877769,2788.7045764709383,0.7296579287176875,1,17052.777456759126,16396.62459171103,22194.030489803277,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,1.42387339829493,0.43915399406245825,6,0.17928386732637605,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,249083.98538682997,298849.64627018786,53828.81273245457,37628.99173241023,0.46810303628868366,1,302912.79811928456,336478.6380025981,409528.0146438533,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_21,1.1867641978499817,0.6282160913372787,6,0.2564681453303341,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,1.5850660288863438,0.26182165808240127,6,0.10688824431855438,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,249083.98538682997,332681.5590591274,53828.81273245457,22434.237512473606,0.19677299597055214,1,302912.79811928456,355115.796571601,409528.0146438533,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_21,1.4672583473992193,0.7509197607260735,6,0.3065617085919526,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,249083.98538682997,307955.49564471305,53828.81273245457,64342.69948606262,0.49931703882697076,1,302912.79811928456,372298.1951307757,409528.0146438533,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,1.7935548461286657,0.46506939323757995,6,0.18986378473630808,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,282288.5411128951,376440.23125482217,31620.297150150167,39849.55753503861,0.09545841412997527,1,313908.8382630453,416289.7887898608,554965.6889693474,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_21,1.3449677767754227,0.36902875011051417,6,0.15065535636463354,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,2.116101180631622,0.7046305400497181,6,0.287664213383926,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,282288.5411128951,444137.86370401556,31620.297150150167,60376.398995391115,0.04671647179625088,0.9343294359250176,313908.8382630453,504514.26269940665,554965.6889693474,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_21,1.611742315396214,0.57782505865642,6,0.23589609238366485,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,282288.5411128951,338280.511042375,31620.297150150167,49511.04771660008,0.3668599182468595,1,313908.8382630453,387791.55875897506,554965.6889693474,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,1.9345041250827806,0.4739474043490254,6,0.19348821759527488,leaf_1_panK4-1,1,967514 MM WT,leaf,*,209884.98459768714,406023.36849716166,41289.4385277325,40610.271569818215,0.006926489752993244,0.15930926431884462,251174.42312541965,446633.64006697986,730719.8133637583,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_21,1,0.48187370979787475,6,0.196724118244462,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,2.7756240283847204,0.953828037745821,6,0.3893986658062325,leaf_1_transp1-1,1,967514 MM WT,leaf,*,209884.98459768714,582561.8064464973,41289.4385277325,81728.93297510102,0.004227913733489631,0.10146992960375115,251174.42312541965,664290.7394215984,730719.8133637583,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_21,1.8847076427474485,0.47524107724844405,6,0.19401635734488196,leaf_1_log2-1,1,967514 MM WT,leaf,*,209884.98459768714,395571.83456919144,41289.4385277325,40721.120173029914,0.009462423277403716,0.20817331210288176,251174.42312541965,436292.95474222134,730719.8133637583,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,3.51643010613206,0.7217227572158817,6,0.2946420818222494,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,555524.7560967305,738045.8786643707,39438.76417718343,61840.94880509329,0.035991910133866094,0.755830112811188,594963.5202739139,799886.827469464,902214.0377225857,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_21,2.646805616712288,0.46027517645071225,6,0.1879065539289562,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,3.5231308810555286,0.9423135160702217,6,0.38469788201665994,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,555524.7560967305,739452.2707059756,39438.76417718343,80742.30904182953,0.07847534396569648,1,594963.5202739139,820194.5797478051,902214.0377225857,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_21,3.1211577624080236,0.7867363534510398,6,0.32118377134216053,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,555524.7560967305,655084.1488899597,39438.76417718343,67411.65090117644,0.2378989931933003,1,594963.5202739139,722495.79979113606,902214.0377225857,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,2.5441563557554923,3.1859131932994225,6,1.300643614730756,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,74.33856569071685,58.270301618224174,30.87041293792315,29.789401723178624,0.7168509479908279,1,105.20897862864,88.0597033414028,140.65970755363546,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_22,3.2457174431483287,3.0138662354292998,5,1.3478419555022598,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,1.9468408844016545,1.219965381192683,6,0.49804878129700786,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,74.33856569071685,44.58963588465756,30.87041293792315,11.407102649611971,0.40676922781755076,1,105.20897862864,55.99673853426953,140.65970755363546,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_22,3.986153873876606,3.570826925766966,5,1.5969223483803061,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,74.33856569071685,91.29721449783624,30.87041293792315,36.575246914559614,0.732504598807669,1,105.20897862864,127.87246141239585,140.65970755363546,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.7888294302894762,0.5949921651499602,6,0.24290453426186373,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,33.61695054137823,18.067021991126882,12.763428023654686,5.56338467321517,0.3017878851834754,1,46.38037856503291,23.630406664342054,174.29943910216676,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_22,1.4677593217436986,1.3650214969120953,6,0.5572676925607862,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,4.077386441838369,6.958806021836683,6,2.8409206620844616,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,33.61695054137823,93.38676738263071,12.763428023654686,65.06726816479362,0.40588595046328657,1,46.38037856503291,158.45403554742433,174.29943910216676,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_22,3.0372833953346774,4.795149506030767,6,1.957611588355698,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,33.61695054137823,69.56467873752992,12.763428023654686,44.83632361932564,0.470846758855354,1,46.38037856503291,114.40100235685556,174.29943910216676,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,3.8798824558303515,3.50619461245939,6,1.431397956570153,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,22.903585106474594,88.86321803022811,8.553318528151502,32.78414491953831,0.10229849231981654,1,31.456903634626094,121.64736294976643,133.81209924474308,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_22,1,0.8350571132529183,5,0.3734488940656532,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,1.9600405263793246,1.578372567494277,6,0.6443679023945968,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,22.903585106474594,44.89195500806812,8.553318528151502,14.758335092375164,0.23420002346038454,1,31.456903634626094,59.650290100443286,133.81209924474308,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_22,1.2000947546756038,0.7796102467321667,6,0.31827455045651754,fruit_1_log2-1,1,967514 MM WT,fruit,ns,22.903585106474594,27.486472349546442,8.553318528151502,7.289628253605792,0.6936417079734725,1,31.456903634626094,34.77610060315224,133.81209924474308,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,2.940519887084056,3.110068352260194,6,1.2696800880359875,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,49.461843943893925,67.34844749111075,17.70167458931118,29.080225954328398,0.6135283162657388,1,67.1635185332051,96.42867344543914,106.07154078998308,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_22,2.1595677582332558,1.728207506085632,5,0.7728778925665708,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,1.5821630188448557,1.479319766410745,6,0.6039297656865878,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,49.461843943893925,36.23720535442992,17.70167458931118,13.832156786736025,0.5723354727177882,1,67.1635185332051,50.06936214116594,106.07154078998308,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_22,2.170880296303694,2.627636252564971,6,1.0727280080705208,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,49.461843943893925,49.72094162236044,17.70167458931118,24.569317228942143,0.993367745716498,1,67.1635185332051,74.29025885130258,106.07154078998308,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.6328062768554676,0.369823841702925,6,0.15097995114799742,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,61.12333088964788,52.88042935096677,24.445197692278956,12.616633134183662,0.7725977748395726,1,85.56852858192684,65.49706248515044,192.36535114442233,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_22,0.7314469251482303,0.7165474992890032,6,0.2925292916208917,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.6555814625642217,0.8792606150830353,6,0.3589566429798539,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,61.12333088964788,54.78363676668903,24.445197692278956,29.996196456015536,0.8732553433885077,1,85.56852858192684,84.77983322270457,192.36535114442233,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_22,1.4433145237135783,1.590698423292342,6,0.649399911952661,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,61.12333088964788,120.61051619418791,24.445197692278956,54.267075755286925,0.35109146554029813,1,85.56852858192684,174.87759194947483,192.36535114442233,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,1.054661513229469,0.8427469421562666,6,0.3440499984289439,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,38.19014008622118,88.13274406292382,15.099196186508573,28.750523344251498,0.16478834987540122,1,53.28933627272975,116.88326740717531,128.57159414789285,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_22,0.45701142477786155,0.44259373169782357,6,0.18068813433565814,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.6314726428875228,0.4645872250029311,6,0.18966694037879672,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,38.19014008622118,52.768984285705415,15.099196186508573,15.84950972792856,0.5205184642491905,1,53.28933627272975,68.61849401363398,128.57159414789285,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_22,0.7759720358204302,0.6966243811177226,6,0.28439571268675684,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,38.19014008622118,64.84406985093825,15.099196186508573,23.76551551792647,0.37004193627052695,1,53.28933627272975,88.60958536886473,128.57159414789285,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,1.5826141158151177,1.4338998906288742,6,0.5853871790455581,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,83.56495705722055,132.2510806262414,13.846212753280717,48.917854478789536,0.37646543136696947,1,97.41116981050126,181.16893510503093,199.28582861553403,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_22,1,0.405865775678325,6,0.1656940090784659,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.5063342555518248,0.25883095666215167,6,0.10566729557644965,leaf_1_transp1-1,1,967514 MM WT,leaf,*,83.56495705722055,42.31180032178798,13.846212753280717,8.830083017198644,0.03466063843945951,0.8318553225470282,97.41116981050126,51.141883338986624,199.28582861553403,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_22,0.5390703335176403,0.22942873018334908,6,0.09366388688064715,leaf_1_log2-1,1,967514 MM WT,leaf,*,83.56495705722055,45.047389271223174,13.846212753280717,7.827018684993645,0.042115321538532854,0.9686523953862557,97.41116981050126,52.87440795621682,199.28582861553403,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.7760870865686795,0.5037578844798845,6,0.20565829514660502,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,42.95666164521154,64.85368406177513,7.823720613025413,17.18582660238724,0.2842905323642503,1,50.780382258236955,82.03951066416236,90.2434617305786,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_22,0.5140511424639068,0.22933205576692342,6,0.09362441971540979,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.5160683133840871,0.39526265211990597,6,0.16136530201216423,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,42.95666164521154,43.125226446533475,7.823720613025413,13.484484533171928,0.9916370479119012,1,50.780382258236955,56.609710979705405,90.2434617305786,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_22,0.4259578513255821,0.3911986565557677,6,0.15970618277065204,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,42.95666164521154,35.595149554208206,7.823720613025413,13.345840305002156,0.646786764650453,1,50.780382258236955,48.94098985921036,90.2434617305786,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,1.0031423458167716,0.2123829599423103,6,0.08670498032010328,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,74.21279837099323,67.52218514991657,1.80267728392819,5.83617046873549,0.315832820615517,1,76.01547565492142,73.35835561865206,83.61702322041357,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_25,1.102541342259822,0.059885139221309384,5,0.02678144842817732,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.9984849647176304,0.20531641258181244,6,0.08382007444069811,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,74.21279837099323,67.2086936995742,1.80267728392819,5.641985516079866,0.281763930373318,1,76.01547565492142,72.85067921565407,83.61702322041357,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_25,0.8618357594496789,0.17877143948746047,5,0.07994901822589034,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,74.21279837099323,58.010743899958335,1.80267728392819,5.381422121909557,0.03657325252134912,0.7680383029483314,76.01547565492142,63.392166021867894,83.61702322041357,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.9774009271100987,0.11934422537585436,6,0.04872207598642653,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,65.60581592875346,65.78951296517464,3.0481698247678684,3.27951566331813,0.9680852754362901,1,68.65398575352133,69.06902862849277,75.97593149134205,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_25,0.9746718348032369,0.11092536334554658,6,0.04528508995490225,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.8471790043831842,0.08829332365322776,6,0.036045598440802795,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,65.60581592875346,57.02418787087251,3.0481698247678684,2.4262534443979984,0.05350748424398818,1,68.65398575352133,59.45044131527051,75.97593149134205,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_25,0.8922178690987537,0.17101461855586012,6,0.06981642566975953,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,65.60581592875346,60.055784109381015,3.0481698247678684,4.699390510466948,0.348902756307935,1,68.65398575352133,64.75517461984796,75.97593149134205,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,1.1816723078564741,0.17583075873601867,6,0.07178260666494357,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,67.31067174214355,79.53915682090833,4.89643447207069,4.831735474019423,0.10970439562308178,1,72.20710621421425,84.37089229492776,100.1685027669173,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_25,1,0.16266009599289566,5,0.07274380637335116,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,1.0940335810461363,0.18833809484505562,6,0.07688870524971486,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,67.31067174214355,73.64013524867829,4.89643447207069,5.175430399741986,0.3975213874760639,1,72.20710621421425,78.81556564842028,100.1685027669173,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_25,1.144572491139954,0.5102112124472382,6,0.20829285525707986,fruit_1_log2-1,1,967514 MM WT,fruit,ns,67.31067174214355,77.04194323620895,4.89643447207069,14.020332006443125,0.5359122775914062,1,72.20710621421425,91.06227524265208,100.1685027669173,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.9173252380673633,0.07721268606626831,6,0.03152194708867698,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,70.75960095774181,61.74577798033598,11.937954620103934,2.121763433159153,0.496210233895256,1,82.69755557784575,63.86754141349513,90.96731113563033,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_25,1.051238965922232,0.3965801759507145,5,0.17735604639092498,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.8940955375307829,0.1685389597459399,6,0.0688057421928378,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,70.75960095774181,60.18217123284992,11.937954620103934,4.631360726716661,0.44500805336514293,1,82.69755557784575,64.81353195956657,90.96731113563033,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_25,0.8817803006750219,0.22374868830301872,6,0.09134501949323914,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,70.75960095774181,59.35322436742505,11.937954620103934,6.1484946223891255,0.42790658357940914,1,82.69755557784575,65.50171898981418,90.96731113563033,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,1.573846725131724,0.22218633336246305,6,0.09070719075965952,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,3012.0998337470505,3738.719441938012,255.28697140887937,215.47761430728616,0.05544364458835497,1,3267.38680515593,3954.1970562452984,4349.616761869828,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_25,1.2679698310433438,0.26323512219537726,6,0.10746528862630886,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,1.4366571546884412,0.17263818108095283,6,0.07047924229508981,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,3012.0998337470505,3412.8215599797177,255.28697140887937,167.42552448978677,0.22315471424815309,1,3267.38680515593,3580.2470844695044,4349.616761869828,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_25,1.2671384671305848,0.34574563879792636,6,0.1411500659745897,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,3012.0998337470505,3010.1249041847714,255.28697140887937,335.3061562242433,0.9963594902462745,1,3267.38680515593,3345.4310604090147,4349.616761869828,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,1.5918979042070998,0.23808483403431469,6,0.09719772647988154,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,3573.7784712771745,3781.600551693705,287.09548501558515,230.89607386773415,0.585686141147731,1,3860.8739562927594,4012.496625561439,4953.714929204907,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_25,1.5044133775521464,0.29603396782351443,6,0.12085536128318401,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,1.7831431901495731,0.2757952155062561,6,0.11259292524854174,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,3573.7784712771745,4235.909384513671,287.09548501558515,267.46782385442543,0.12255744160880963,1,3860.8739562927594,4503.377208368097,4953.714929204907,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_25,1.4678672559160153,0.18789635920277403,6,0.07670836742891644,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,3573.7784712771745,3486.962078482,287.09548501558515,182.22299547105595,0.8045771954709665,1,3860.8739562927594,3669.185073953056,4953.714929204907,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,1.3647060651630845,0.12173615777044583,6,0.04969857829742363,leaf_1_panK4-1,1,967514 MM WT,leaf,*,2375.529574917848,3241.899618864671,143.8133845440661,118.0604425769002,9.933917709656357e-4,0.023841402503175256,2519.3429594619142,3359.9600614415713,4299.295664462531,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_25,1,0.1482908964952815,6,0.06053950498555233,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,1.5178957224246958,0.31206701007866877,6,0.12740082337478564,leaf_1_transp1-1,1,967514 MM WT,leaf,*,2375.529574917848,3605.806180261158,143.8133845440661,302.64442379568834,0.007659479655702964,0.17616803208116816,2519.3429594619142,3908.4506040568463,4299.295664462531,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_25,1.4529748225165073,0.32185115006622955,6,0.13139518179836646,leaf_1_log2-1,1,967514 MM WT,leaf,*,2375.529574917848,3451.5846624989745,143.8133845440661,312.13314036372685,0.0164896876765713,0.3627731288845686,2519.3429594619142,3763.7178028627013,4299.295664462531,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,2.274171334755054,0.2854070014466696,6,0.11651692042702015,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,5006.190523434829,5402.361264141028,366.6790319821758,276.78939045273603,0.4101874353204924,1,5372.869555417004,5679.150654593765,6718.5851088998525,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_25,2.107399788364224,0.37809528334963616,6,0.15435675305993887,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,2.4893923887826332,0.20022501796213477,6,0.08174152129113779,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,5006.190523434829,5913.625243128536,366.6790319821758,194.17940132587475,0.061952274168037474,1,5372.869555417004,6107.804644454411,6718.5851088998525,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_25,2.0326283616527907,0.23561091907825987,6,0.09618775492831917,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,5006.190523434829,4828.568787923016,366.6790319821758,228.4968565771722,0.691306856813872,1,5372.869555417004,5057.065644500189,6718.5851088998525,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,1.4427235020797555,1.1731947402464449,6,0.478954747086807,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,70.085128352437,164.90356816640565,8.93392359648465,54.74461785019612,0.14511304991171886,1,79.01905194892164,219.64818601660176,241.61300461826195,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_32,0.613167216116892,0.17477539397563893,5,0.07816193234476718,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,1.495926027649945,0.6309233467427162,6,0.257573377721453,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,70.085128352437,170.98462686500002,8.93392359648465,29.44068561280906,0.01724428918230081,0.3966186511929186,79.01905194892164,200.4253124778091,241.61300461826195,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_32,1.0454081707913554,0.6643385828534435,5,0.29710124626723516,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,70.085128352437,119.49035092677076,8.93392359648465,33.9587284365488,0.22391310568612147,1,79.01905194892164,153.44907936331956,241.61300461826195,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.9038278055001447,0.6195950958105075,6,0.2529486386444331,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,76.092625486902,103.30768849341624,12.775870950753085,28.9120770647818,0.4182318559147038,1,88.86849643765508,132.21976555819805,145.6433740012988,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_32,0.6657261595099382,0.27379101709150333,6,0.11177471467196855,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,0.9969570747931715,0.2769597602510686,6,0.11306834864978013,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,76.092625486902,113.9523815236551,12.775870950753085,12.92373355819998,0.06384307743382718,1,88.86849643765508,126.87611508185509,145.6433740012988,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_32,1.056021915243128,0.2507253997129823,6,0.10235821580869377,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,76.092625486902,120.70350391774974,12.775870950753085,11.699563356158238,0.027801455061443887,0.5282276461674339,88.86849643765508,132.403067273908,145.6433740012988,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,1.4142231918723525,0.45665551700709267,6,0.18642883414903713,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,114.30018844822946,161.64597733886646,27.698908247806788,21.308850875418663,0.21287481122281532,1,141.99909669603625,182.95482821428513,201.6111134410231,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_32,1,0.5418769871291931,5,0.24233475573273086,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,1.4227240878165788,0.3935276707530616,6,0.16065699883516335,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,114.30018844822946,162.6176313472703,27.698908247806788,18.363125242386154,0.18825044054627801,1,141.99909669603625,180.98075658965647,201.6111134410231,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_32,1.4369738878902505,0.4079571126586862,6,0.16654779382548224,fruit_1_log2-1,1,967514 MM WT,fruit,ns,114.30018844822946,164.24638618104058,27.698908247806788,19.03644421988949,0.17880162312172854,1,141.99909669603625,183.28283040093007,201.6111134410231,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.9802193956814669,0.10751614305948194,6,0.04389328160130164,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,*,65.4469105341879,112.03926164700127,10.875225680544693,5.017010358639979,0.0089937258617252,0.21584942068140478,76.32213621473258,117.05627200564125,144.77151601186662,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_32,0.5725879495275817,0.21275331408017495,5,0.09514617454432686,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,1.020818037152814,0.31997130464997714,6,0.13062773812084508,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,65.4469105341879,116.67969401791835,10.875225680544693,14.93077508377856,0.022402024486847485,0.45894767974096734,76.32213621473258,131.6104691016969,144.77151601186662,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_32,0.8090040894241244,0.39748061445258426,6,0.16227078134279338,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,65.4469105341879,92.46931987656569,10.875225680544693,18.547580887122724,0.24485430671752856,1,76.32213621473258,111.01690076368841,144.77151601186662,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,1.2519470754828224,0.1091656829318546,6,0.04456670343424975,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,2195.671783895496,2203.0461942501383,174.66191372994447,78.42384739245763,0.9703607100166345,1,2370.3336976254404,2281.470041642596,3321.824906787861,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_32,1.2477563456193266,0.24312868761840198,6,0.0992568710829352,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,1.330001305477276,0.1831003540356621,6,0.07475040651838714,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,2195.671783895496,2340.3979063966676,174.66191372994447,131.5379873669772,0.5241109715783189,1,2370.3336976254404,2471.935893763645,3321.824906787861,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_32,1.4695043795791056,0.6040704840809011,6,0.24661074244570608,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,2195.671783895496,2585.8809004503155,174.66191372994447,433.959923902285,0.43343501340589596,1,2370.3336976254404,3019.8408243526005,3321.824906787861,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,1.5353993593066746,0.1643915853493942,6,0.06711258368553441,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,2752.0651526476513,2701.8360291869076,310.1903504456946,118.09774148614895,0.8843576082822007,1,3062.255503093346,2819.9337706730566,3922.935750282335,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_32,1.5639435652270357,0.43178373123953917,6,0.17627497012864995,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,1.8208555741804855,0.504115607519566,6,0.20580433496601455,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,2752.0651526476513,3204.152173469819,310.1903504456946,362.1530540595763,0.3659422091540059,1,3062.255503093346,3566.3052275293953,3922.935750282335,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_32,1.4756779747316267,0.19676039302457013,6,0.08032709408327857,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,2752.0651526476513,2596.744550816971,310.1903504456946,141.3512618711075,0.6624589501160987,1,3062.255503093346,2738.0958126880782,3922.935750282335,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,1.248349321951202,0.17540412777538497,6,0.07160843530460591,leaf_1_panK4-1,1,967514 MM WT,leaf,*,1759.6959467320276,2196.715241943205,126.98143992021245,126.00907335733763,0.03467699886546161,0.624185979578309,1886.67738665224,2322.7243153005425,3357.8906915021576,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_32,1,0.17675765815454536,6,0.07216101176798904,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,1.518809954452166,0.5289364646629783,6,0.21593740746266038,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1759.6959467320276,2672.643720705732,126.98143992021245,379.9841806598658,0.06217745418923031,1,1886.67738665224,3052.6279013655976,3357.8906915021576,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_32,1.2620189197492546,0.1350184583475314,6,0.055121054801445996,leaf_1_log2-1,1,967514 MM WT,leaf,*,1759.6959467320276,2220.7695777818954,126.98143992021245,96.99629671369851,0.017334303923849933,0.3966186511929186,1886.67738665224,2317.765874495594,3357.8906915021576,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,2.3648804944914708,0.2712050659413513,6,0.11071900453569591,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,3828.061910443504,4161.470620662274,371.8909367588645,194.8317835076691,0.45134243673783225,1,4199.9528472023685,4356.302404169943,6394.677583736838,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_32,2.1754109950373457,0.5176707014166849,6,0.2113381788765905,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,3.057907246511597,0.6018382053188083,6,0.24569941845724289,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,3828.061910443504,5380.9869871689525,371.8909367588645,432.35627077362665,0.02185465141623654,0.45894767974096734,4199.9528472023685,5813.343257942579,6394.677583736838,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_32,2.289465148053861,0.32510638865878433,6,0.13272412738882894,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,3828.061910443504,4028.762541214621,371.8909367588645,233.55410899966762,0.6592245698717305,1,4199.9528472023685,4262.3166502142885,6394.677583736838,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.9927921046999648,0.06679953122050089,6,0.027270794424556936,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,32.71790847271539,30.676809740752475,0.72073914634422,0.8426547391753608,0.09885883609473614,1,33.438647619059616,31.519464479927837,36.78251238096558,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_49,1.0588480838950225,0.0521568356727235,5,0.023325246011099143,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.9662791538469825,0.10371929026165208,6,0.04234322293744466,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,32.71790847271539,29.857572011994893,0.72073914634422,1.3083857010071789,0.09367534104258492,1,33.438647619059616,31.165957713002072,36.78251238096558,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_49,0.8956550376438907,0.18936940443873407,5,0.08468857223673196,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,32.71790847271539,27.675319992045768,0.72073914634422,2.6168371055965864,0.12731766607785555,1,33.438647619059616,30.292157097642356,36.78251238096558,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.9836815930169344,0.059499724483979693,6,0.024290660803655568,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,32.8819090732966,30.395299208770865,0.765739900736001,0.7505700099983096,0.04285064798115153,0.9427142555853336,33.6476489740326,31.145869218769175,37.01241387143586,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_49,1.0641556273716437,0.06070228294930762,6,0.02478160324130854,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.9934132715995646,0.02681793544747352,6,0.010948376300201299,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,32.8819090732966,30.696003506200512,0.765739900736001,0.33829968544415506,0.03538997104103984,0.8139693339439162,33.6476489740326,31.034303191644668,37.01241387143586,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_49,1.0069965622668333,0.1055073439637066,6,0.043073192804566,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,32.8819090732966,31.115720808020786,0.765739900736001,1.330941427049069,0.2833339536899729,1,33.6476489740326,32.44666223506985,37.01241387143586,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,1.0645793841420201,0.07097749174815984,6,0.0289764396675992,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,30.899530320120164,32.8950029584712,1.3952724146778255,0.8953583760781144,0.2677350668224484,1,32.29480273479799,33.79036133454932,37.16939746800425,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_49,1,0.10096994789329733,5,0.0451551334348049,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,1.0126680506146326,0.05392426617501338,6,0.022014489480467525,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,30.899530320120164,31.290967134183816,1.3952724146778255,0.6802373851836723,0.8095152018163077,1,32.29480273479799,31.97120451936749,37.16939746800425,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_49,0.9440011401957723,0.11142831688239753,6,0.0454904198765044,fruit_1_log2-1,1,967514 MM WT,fruit,ns,30.899530320120164,29.16919185370727,1.3952724146778255,1.405632608249045,0.4052496519832557,1,32.29480273479799,30.574824461956318,37.16939746800425,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,1.08088536824839,0.2142851652863255,6,0.08748155239990871,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,30.311166099980152,33.398850208765374,1.8936498834961677,2.70313888083216,0.375206385645949,1,32.20481598347632,36.10198908959754,39.7121879985573,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_49,0.9809587973006535,0.1370354119047827,5,0.0612840992687556,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,1.0568605817493932,0.08966030322105317,6,0.03660366551246655,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,30.311166099980152,32.65649558990521,1.8936498834961677,1.131036072329997,0.32455220206216806,1,32.20481598347632,33.78753166223521,39.7121879985573,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_49,0.9343606608746499,0.14362372645506555,6,0.05863414079533001,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,30.311166099980152,28.871305570623758,1.8936498834961677,1.8117674112994946,0.5964138637783973,1,32.20481598347632,30.683072981923253,39.7121879985573,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,1.0088656008995687,0.07794594140234444,6,0.03182129732610356,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,31.204462508111313,31.962713661367907,0.5601016076226313,1.008157096307569,0.529758944349642,1,31.764564115733943,32.97087075767548,36.26795783344303,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_49,0.984932291811123,0.04330440885355176,6,0.017678950884010683,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.9902586728140141,0.03863181827280797,6,0.01577137376738448,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,31.204462508111313,31.373212033018255,0.5601016076226313,0.4996660638680075,0.8267015657296143,1,31.764564115733943,31.872878096886264,36.26795783344303,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_49,0.9758550909399322,0.03404502134229718,6,0.013898821761798555,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,31.204462508111313,30.91688012644037,0.5601016076226313,0.4403401799076509,0.6954372777204139,1,31.764564115733943,31.35722030634802,36.26795783344303,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,1.022447386560738,0.06391943800776409,6,0.02609500129408056,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,32.9685979979179,32.39300955579721,0.5664021384676312,0.8267375293716178,0.5800380275955455,1,33.53500013638553,33.21974708516883,36.888500150024086,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_49,1.0406151612272803,0.04379153611759293,6,0.01787781975679383,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,1.008443779353964,0.06841736859774562,6,0.02793127376806564,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,32.9685979979179,31.949349580695184,0.5664021384676312,0.8849140111922915,0.35876235729344474,1,33.53500013638553,32.83426359188748,36.888500150024086,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_49,1.0205249077235132,0.08103094113113292,6,0.03308074319146294,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,32.9685979979179,32.33210189818704,0.5664021384676312,1.0480586526006792,0.6082408151232688,1,33.53500013638553,33.38016055078772,36.888500150024086,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,1.0552454391141755,0.04226618272202724,6,0.01725509684070089,leaf_1_panK4-1,1,967514 MM WT,leaf,*,31.68183515511672,33.43211205020406,0.38640549073178876,0.5466731336926611,0.028067242793428527,0.6736138270422847,32.068240645848505,33.978785183896726,37.3766637022864,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_49,1,0.029875046109813282,6,0.012196436501860355,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,1.0211293395155552,0.0716087240169879,6,0.029234139162233882,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,31.68183515511672,32.351251406585035,0.38640549073178876,0.9261911778396356,0.5270767504005386,1,32.068240645848505,33.27744258442467,37.3766637022864,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_49,1.0089418829529377,0.06736204954497979,6,0.027500441568880044,leaf_1_log2-1,1,967514 MM WT,leaf,ns,31.68183515511672,31.965130416808037,0.38640549073178876,0.8712644564781765,0.7750445453571441,1,32.068240645848505,32.83639487328622,37.3766637022864,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.9801123553922211,0.019089618873185443,6,0.007793304270584653,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,31.118867348471323,31.05175807702952,0.46462642631430595,0.24690618121433036,0.9018113665374452,1,31.58349377478563,31.29866425824385,35.71808415014034,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_49,0.9822305809026194,0.035922719119984105,6,0.014665388669547037,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,1.0031104092124563,0.05339446614427066,6,0.02179819952362911,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,31.118867348471323,31.780378627050712,0.46462642631430595,0.6906069639859611,0.44776464732508003,1,31.58349377478563,32.47098559103667,35.71808415014034,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_49,0.9754773530033937,0.020846889010215145,6,0.008510706799910226,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,31.118867348471323,30.90491269540312,0.46462642631430595,0.26963480988828675,0.7008106493438636,1,31.58349377478563,31.174547505291407,35.71808415014034,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,1.2951047411478893,0.5591213908692428,6,0.22826035198414577,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,90.26881905592867,132.28256724091707,22.810299286592475,23.314612633581714,0.2300966632148,1,113.07911834252116,155.59717987449878,204.0476114049559,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_50,0.8837715957253723,0.4993651890069468,5,0.22332290164331275,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,1.4538286185580434,0.8873938626555641,6,0.36227702739725814,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,90.26881905592867,148.49469381196033,22.810299286592475,37.00313473799954,0.21692602026562502,1,113.07911834252116,185.49782854995988,204.0476114049559,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_50,1.164917932234671,0.4275903851734002,5,0.19122423355460821,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,90.26881905592867,118.98522938337874,22.810299286592475,19.531727226062063,0.36758323010148325,1,113.07911834252116,138.5169566094408,204.0476114049559,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,1.1735786438348002,0.2303055570812137,6,0.09402184996273312,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,82.53517589691451,119.86983827113777,11.209195677693895,9.603433061936737,0.030400329411933352,0.6688072470625337,93.74437157460841,129.4732713330745,165.1408885024083,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_50,0.808055814496664,0.2688142915490892,6,0.10974297497717013,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,1.1685756998262855,0.258665241780131,6,0.10559964275916028,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,82.53517589691451,119.35883537215811,11.209195677693895,10.785993904650768,0.039500657220435,0.829513801629135,93.74437157460841,130.14482927680888,165.1408885024083,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_50,1.3606234636807955,0.2674762733452405,6,0.10919673133283937,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,82.53517589691451,138.9746783448548,11.209195677693895,11.15340211188001,0.005102472317548313,0.12245933562115952,93.74437157460841,150.1280804567348,165.1408885024083,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,1.6897028612283895,0.4399482472979553,6,0.1796081198519631,fruit_1_panK4-1,1,967514 MM WT,fruit,*,102.14043933131707,172.58699258525118,10.918358597856331,18.345252269151363,0.011003029743198294,0.25306968409356073,113.0587979291734,190.93224485440254,210.0254693398428,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_50,1,0.239025719757605,5,0.10689555154976386,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,1.3831944938899219,0.35424949826696456,6,0.1446217520651695,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,102.14043933131707,141.28009328657538,10.918358597856331,14.771729292801227,0.0629571260622947,1,113.0587979291734,156.05182257937662,210.0254693398428,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_50,1.4297657666017243,0.4260658919913448,6,0.17394067203042743,fruit_1_log2-1,1,967514 MM WT,fruit,ns,102.14043933131707,146.03690354157746,10.918358597856331,17.766376658772394,0.06817039856618173,1,113.0587979291734,163.80328020034986,210.0254693398428,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,1.2562952213009793,0.5390444195542254,6,0.2200639627670979,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,77.31509290712795,128.31854583351623,24.153930981745084,22.477429838021983,0.15768811535208838,1,101.46902388887304,150.7959756715382,165.87557323869203,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_50,0.7569488971585276,0.5287800987797436,5,0.23647764920411207,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,1.2197514321991145,0.5996457572497419,6,0.24480435528111574,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,77.31509290712795,124.58594715982076,24.153930981745084,25.004424398632995,0.20719769956137682,1,101.46902388887304,149.59037155845377,165.87557323869203,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_50,0.7764453287250326,0.10814643538216269,6,0.04415059736452855,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,77.31509290712795,79.30646699272373,24.153930981745084,4.509561411553037,0.9390566439710915,1,101.46902388887304,83.81602840427676,165.87557323869203,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,1.2985492193748187,0.38021081794735323,6,0.15522041644287402,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,4412.1170071922425,3889.5205923678923,395.66824530336413,464.9288583771535,0.4125329085574745,1,4807.785252495607,4354.449450745045,5288.563777745168,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_50,1.4730224353927097,0.3235706807008962,6,0.13209717724036935,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,1.394195420601258,0.2636808169661578,6,0.1076472427545487,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,4412.1170071922425,4176.00789966542,395.66824530336413,322.43380624957916,0.6539573903529379,1,4807.785252495607,4498.441705914999,5288.563777745168,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_50,1.275819751989082,0.6327048515273057,6,0.25830067400421486,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,4412.1170071922425,3821.4394367741593,395.66824530336413,773.6832578788135,0.5172385536616838,1,4807.785252495607,4595.122694652973,5288.563777745168,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,1.8718813488196242,0.5743712164430379,6,0.2344860672045197,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,5615.659403862923,5606.811774303472,778.2231372417983,702.3518041575953,0.9934336493165938,1,6393.882541104721,6309.163578461067,9454.593926072994,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_50,1.8748352044902403,0.6364174867291899,6,0.25981635097850003,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,2.5715916349225934,0.7298255573448315,6,0.29795003612286347,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,5615.659403862923,7702.641124383403,778.2231372417983,892.4442629556812,0.1090224421870642,1,6393.882541104721,8595.085387339084,9454.593926072994,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_50,2.1827546714823223,0.8748819974888655,6,0.35716907983243906,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,5615.659403862923,6537.964919731821,778.2231372417983,1069.8219753535382,0.5030548326062514,1,6393.882541104721,7607.786895085359,9454.593926072994,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,1.4324575187004285,0.39639832192478297,6,0.1618289372685367,leaf_1_panK4-1,1,967514 MM WT,leaf,*,2995.2816068385046,4290.613658340917,227.28903159616723,484.72323925467015,0.04565492457955226,0.9130984915910452,3222.5706384346718,4775.336897595587,5828.881686279325,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_50,1,0.18587305790241546,6,0.07588235813195174,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,1.2972256757499252,0.5391937128008063,6,0.22012491147979232,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,2995.2816068385046,3885.5562064924006,227.28903159616723,659.3360985623759,0.24769261741313664,1,3222.5706384346718,4544.892305054776,5828.881686279325,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_50,1.5542716677532413,0.5262448699309266,6,0.21483856851467875,leaf_1_log2-1,1,967514 MM WT,leaf,*,2995.2816068385046,4655.481338451491,227.28903159616723,643.5020127115309,0.04949401891763281,0.9403863594350234,3222.5706384346718,5298.983351163022,5828.881686279325,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,2.720723451633359,0.55851913461465,6,0.22801448189778706,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,8526.25982845922,8149.33291197157,638.0986757136295,682.9675837212528,0.6952745929734845,1,9164.35850417285,8832.300495692823,12664.48798117199,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_50,2.8465636783509707,0.5218261139371853,6,0.2130346189342569,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,3.44549314041634,0.9755728825489018,6,0.39827596152349226,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,8526.25982845922,10320.222229977298,638.0986757136295,1192.948661997236,0.22307883734585415,1,9164.35850417285,11513.170891974534,12664.48798117199,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_50,2.6219719266584542,0.3927405764947057,6,0.16033566894975562,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,8526.25982845922,7853.544285566985,638.0986757136295,480.25048012535063,0.4207588291715999,1,9164.35850417285,8333.794765692335,12664.48798117199,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.6459315849136252,0.46232057309315977,6,0.1887415836115559,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,32.03252383585048,54.60804501025484,10.809363834453574,15.956502412782404,0.27352121109398764,1,42.84188767030406,70.56454742303724,170.83145351639126,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_55,0.378896898546521,0.28590057555795223,5,0.12785862435077922,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.7143937087231863,0.63841707948724,6,0.2606326813035979,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,32.03252383585048,60.39593776207016,10.809363834453574,22.034285865852944,0.284838061744538,1,42.84188767030406,82.43022362792311,170.83145351639126,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_55,1.4427612021335714,0.881505850094212,5,0.3942214006748795,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,32.03252383585048,121.97324067330578,10.809363834453574,33.32808070523171,0.05185241414915589,1,42.84188767030406,155.3013213785375,170.83145351639126,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,1.212405138517181,0.871230385553004,6,0.3556783155021862,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,47.470326220221125,102.49858641556253,13.629897893794793,30.06958928121197,0.1396699783887055,1,61.100224114015916,132.5681756967745,145.82499326645194,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_55,0.561503035789619,0.3949099898241208,6,0.16122132823279886,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.571788868025422,0.31298435506961725,6,0.12777532789910595,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,47.470326220221125,48.33990622345904,13.629897893794793,10.802321824915092,0.9611572782645659,1,61.100224114015916,59.14222804837413,145.82499326645194,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_55,0.8333574966309096,0.5216850097222908,6,0.212977013379749,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,47.470326220221125,70.45331850700474,13.629897893794793,18.005402746091438,0.3345112672783034,1,61.100224114015916,88.45872125309617,145.82499326645194,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.9678699021263713,0.2688696780087994,6,0.10976558640466168,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,84.54153084580483,81.82520318534272,20.007972188420048,9.27975070883756,0.9062107333225176,1,104.54950303422487,91.10495389418027,115.00445333764736,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_55,1,0.5291977263438983,5,0.23666441792865756,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.3461240773957696,0.19455672552413877,6,0.07942745059347668,fruit_1_transp1-1,1,967514 MM WT,fruit,*,84.54153084580483,29.261859365630194,20.007972188420048,6.714918264352049,0.04805546006060019,1,104.54950303422487,35.976777629982244,115.00445333764736,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_55,0.8966442987483811,0.71254038419993,6,0.29089339373608564,fruit_1_log2-1,1,967514 MM WT,fruit,ns,84.54153084580483,75.8036816403513,20.007972188420048,24.592572819380134,0.7891228820215721,1,104.54950303422487,100.39625445973144,115.00445333764736,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.8567768706071908,0.5937942627454449,6,0.2424154926530778,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,70.41497619545201,72.43322823440995,23.791165105713617,20.49417684963115,0.9502513464840827,1,94.20614130116563,92.9274050840411,126.56515217473554,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_55,0.8329039643708579,0.6292606948095792,5,0.28141393783259366,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,1.0895948683482042,0.6647521004114724,6,0.2713839085752458,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,70.41497619545201,92.11601817189036,23.791165105713617,22.943211077869222,0.5282331059830135,1,94.20614130116563,115.05922924975958,126.56515217473554,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_55,0.9099066111992106,0.589047532073959,6,0.2404776479711513,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,70.41497619545201,76.92489783749981,23.791165105713617,20.330348493679683,0.8401711341141905,1,94.20614130116563,97.25524633117949,126.56515217473554,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.8512766636832932,0.6144294260438911,6,0.2508397627931111,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,152.72530124962003,103.85745890591298,33.92969293141009,30.60295373719614,0.3102367629739198,1,186.65499418103013,134.46041264310912,219.55454843019749,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_55,1.2518261690340704,0.681221882460089,6,0.278107668940906,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,1.0715918540532685,0.696579615815664,6,0.28437743732871934,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,152.72530124962003,130.7363536370281,33.92969293141009,34.694617239177994,0.6601390416823376,1,186.65499418103013,165.4309708762061,219.55454843019749,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_55,1.3430788415447752,0.7175026654291624,6,0.29291923656472063,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,152.72530124962003,163.858310163936,33.92969293141009,35.73673386351624,0.8258249324071748,1,186.65499418103013,199.59504402745225,219.55454843019749,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.942148635021574,0.3180469940441895,6,0.1298421416057108,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,148.58380219496723,114.94402151427785,30.472616997912876,15.84100147621079,0.35779759439907477,1,179.0564191928801,130.78502299048864,207.08586092993784,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_55,1.2178800130715386,0.6118125960281363,6,0.2497714464127447,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.8305671897468249,0.6745646278813968,6,0.2753898561399722,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,148.58380219496723,101.33086158441043,30.472616997912876,33.59811432326918,0.322279592004322,1,179.0564191928801,134.92897590767961,207.08586092993784,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_55,1.3000931761054213,0.5952142374648005,6,0.24299519490475663,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,148.58380219496723,158.61397283816626,30.472616997912876,29.645900734504494,0.8182561475368209,1,179.0564191928801,188.25987357267076,207.08586092993784,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,1.391219998063206,0.6658960999042912,6,0.27185094441248064,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,122.00200397429413,169.73162773282473,40.361253019503536,33.16636000062707,0.3831845653184308,1,162.36325699379768,202.8979877334518,267.4750366978405,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_55,1,0.8103512406073368,6,0.3308245086532158,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.9101221170451447,0.9839003147549138,6,0.4016756214855503,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,122.00200397429413,111.03672214083473,40.361253019503536,49.005230768857174,0.8664431794258887,1,162.36325699379768,160.0419529096919,267.4750366978405,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_55,1.557057001603716,1.068021217200874,6,0.436017836101391,leaf_1_log2-1,1,967514 MM WT,leaf,ns,122.00200397429413,189.96407449785903,40.361253019503536,53.19504977290503,0.3344573858253099,1,162.36325699379768,243.15912427076407,267.4750366978405,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.7791947483036846,0.3755855736300689,6,0.153332168357365,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,92.23272827706609,95.06332077929525,25.835368148042647,18.70683181332238,0.931206767500709,1,118.06809642510873,113.77015259261763,256.2380083965797,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_55,0.755993551519855,0.5187084409940639,6,0.21176183428500217,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,1.423141981490957,1.190943840030408,6,0.48620078673088246,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,92.23272827706609,173.62617368184456,25.835368148042647,59.317470315046045,0.24967743941051343,1,118.06809642510873,232.94364399689061,256.2380083965797,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_55,1.0932625160783522,0.8476800452687173,6,0.3460639293412839,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,92.23272827706609,133.38021783153792,25.835368148042647,42.22049288285516,0.4291137621948219,1,118.06809642510873,175.60071071439307,256.2380083965797,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,1.6683687839089045,0.9910804052422395,6,0.4046068811523769,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,1742.927245695786,1250.6269765455565,613.7229533575128,303.29761941455354,0.499492303046872,1,2356.650199053299,1553.92459596011,2592.315218958629,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_63,2.325110095877778,1.8307187580291022,5,0.8187223181274123,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,1.306451226278276,0.42825874429250843,6,0.17483590023361723,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,1742.927245695786,979.3297278653995,613.7229533575128,131.05884946402122,0.2853478543283157,1,2356.650199053299,1110.3885773294207,2592.315218958629,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_63,2.2813888991020974,1.9264510040689764,5,0.861535080084191,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,1742.927245695786,1710.1533718005835,613.7229533575128,645.8158548550598,0.9715587802794619,1,2356.650199053299,2355.969226655643,2592.315218958629,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,2.242804306123253,1.6753224251336547,6,0.6839475160365878,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,1478.4460255699946,1681.229950717797,106.41086952457168,512.6943289436332,0.7132732968964204,1,1584.8568950945662,2193.9242796614303,2413.3167076275736,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_63,1.972285296906287,0.34771696492099485,6,0.1419548564942792,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,1.4838243924379397,1.0556091145113653,6,0.4309506163973371,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,1478.4460255699946,1112.2905388408014,106.41086952457168,323.0451634096707,0.32258156621236983,1,1584.8568950945662,1435.3357022504722,2413.3167076275736,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_63,1.1586075903069408,0.6453533241827482,6,0.26346439134277816,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,1478.4460255699946,868.5045666422749,106.41086952457168,197.49570859294192,0.02731739623270823,0.6009827171195811,1584.8568950945662,1066.0002752352168,2413.3167076275736,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,1.323856293070253,1.4986842944582528,6,0.6118353011576224,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,749.6106308195243,992.3767509627895,221.38111542346917,458.63824605841904,0.6478679790265749,1,970.9917462429935,1451.0149970212085,1596.1164967233294,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_63,1,0.6603738029707661,5,0.2953281428005371,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,1.3050347997258285,0.8311007849163066,6,0.3392954746452569,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,749.6106308195243,978.2679594639098,221.38111542346917,254.33949478304095,0.5147606664510728,1,970.9917462429935,1232.6074542469507,1596.1164967233294,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_63,1.0007782389906477,1.0988092394580342,6,0.44858699355464,fruit_1_log2-1,1,967514 MM WT,fruit,ns,749.6106308195243,750.1940070402321,221.38111542346917,336.2655792159276,0.9988779832787359,1,970.9917462429935,1086.4595862561596,1596.1164967233294,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,2.8298128626320587,1.5257910851937446,6,0.6229016021353486,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,4119.042272896068,2121.2578050588213,744.0012190818505,466.93366291517106,0.05756860573655283,1,4863.043491977919,2588.1914679739925,5349.347841175711,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_63,5.494909094862831,2.2193352559460537,5,0.992516899431454,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,5.338037064584261,0.9765140613507213,6,0.39866019616035586,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,4119.042272896068,4001.44933132101,744.0012190818505,298.8399211263997,0.8888279226046809,1,4863.043491977919,4300.28925244741,5349.347841175711,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_63,5.496176795930885,2.012472324378038,6,0.8215883860331709,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,4119.042272896068,4119.992555093383,744.0012190818505,615.8713883283201,0.9992383174984288,1,4863.043491977919,4735.863943421703,5349.347841175711,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,1.9422642526464984,0.24610183196868013,6,0.10047065218123855,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,2856.7048475947613,4154.103859475001,542.2156488389448,214.88606579735887,0.0641716393917069,1,3398.920496433706,4368.98992527236,5838.289777194746,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_63,1.3356612866550932,0.6209814675800677,6,0.2535146225493034,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,1.7403240602175016,0.25824553163246367,6,0.10542829680888476,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,2856.7048475947613,3722.1953117017647,542.2156488389448,225.4894482431557,0.18602653067098188,1,3398.920496433706,3947.68475994492,5838.289777194746,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_63,2.208877754202611,0.6679204423417167,6,0.27267737875187303,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,2856.7048475947613,4724.335317060279,542.2156488389448,583.200844025854,0.041091701248054426,0.8218340249610885,3398.920496433706,5307.536161086133,5838.289777194746,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,4.204804985081762,1.0393630077309826,6,0.4243181710775525,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,8294.309829846356,8993.213252556829,858.4094154979115,907.5293177624311,0.5881790725100936,1,9152.719245344268,9900.74257031926,13237.356598412318,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_63,3.8780305037729597,0.9831076247280639,6,0.4013520071372211,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,5.198607739090213,1.0481566314274757,6,0.4279081529186284,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,8294.309829846356,11118.752993278593,858.4094154979115,915.2075507326039,0.04820569798858094,0.9159082617830379,9152.719245344268,12033.960544011197,13237.356598412318,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_63,3.70110845724052,0.941453156731851,6,0.3843466417875855,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,8294.309829846356,7915.909951804431,858.4094154979115,822.0384357332125,0.7567620026031101,1,9152.719245344268,8737.948387537645,13237.356598412318,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,1.4772058209110115,0.17038368311977217,6,0.06955884735658355,leaf_1_panK4-1,1,967514 MM WT,leaf,*,2138.7943755926544,3159.439501357201,363.4549994285209,148.77207149896893,0.03721978040377487,0.7816153884792723,2502.249375021175,3308.2115728561703,4638.943917611466,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_63,1,0.4162528680751433,6,0.16993452179235716,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,1.7990917930193333,0.4229862749081132,6,0.17268342362091482,leaf_1_transp1-1,1,967514 MM WT,leaf,*,2138.7943755926544,3847.887408084654,363.4549994285209,369.3343351984964,0.008039537085550386,0.19294889005320925,2502.249375021175,4217.22174328315,4638.943917611466,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_63,1.6638113698126107,0.375234155552559,6,0.15318870252798347,leaf_1_log2-1,1,967514 MM WT,leaf,*,2138.7943755926544,3558.5503998023214,363.4549994285209,327.63913537118736,0.015961595957596206,0.3671167070247127,2502.249375021175,3886.189535173509,4638.943917611466,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,11.2859944211569,2.507246338892025,6,1.0235790316244486,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,27771.73432432993,24138.421390940457,4709.851621751921,2189.225075812946,0.5065831403618887,1,32481.58594608185,26327.646466753402,47134.312966768484,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_63,12.98476124738941,5.394035709634427,6,2.2021058571592853,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,15.219153092921069,11.794798711693689,6,4.815206410414323,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,27771.73432432993,32550.639036423134,4709.851621751921,10298.73638791185,0.6856814951015551,1,32481.58594608185,42849.37542433498,47134.312966768484,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_63,11.532741652198396,2.8197996202195457,6,1.1511783744052797,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,27771.73432432993,24666.162980885067,4709.851621751921,2462.1338324819076,0.5760396073481429,1,32481.58594608185,27128.296813366975,47134.312966768484,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.9642439823817321,0.22629005373321556,6,0.09238252758556097,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,61.50921678158582,67.70236043692731,10.873677147945884,6.486444608368781,0.6404012693876089,1,72.3828939295317,74.18880504529609,193.9688326120978,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_65,0.8760387637874415,0.3462936779085226,5,0.15486724079637473,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,1.2442380864750806,0.7858337995424578,6,0.32081530525193047,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,61.50921678158582,87.36155676265338,10.873677147945884,22.525370991893205,0.3351661269168472,1,72.3828939295317,109.88692775454658,193.9688326120978,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_65,1.9547800706056975,1.2447240952721501,5,0.5566575380520904,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,61.50921678158582,137.25076571198773,10.873677147945884,39.084536662646634,0.12571325761113294,1,72.3828939295317,176.33530237463435,193.9688326120978,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,1.5691981382117934,1.283096509298732,6,0.5238219564213575,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,74.3527828791224,110.17794239976044,9.143034616706322,36.77905545318241,0.3833834934669097,1,83.49581749582872,146.95699785294283,161.65269763823713,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_65,1.0589619475870542,0.3189694693499329,6,0.13021874057227567,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,1.1455424305621562,0.541291552354091,6,0.22098135089108828,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,74.3527828791224,80.43184914480436,9.143034616706322,15.515740145884267,0.7442830791516564,1,83.49581749582872,95.94758929068863,161.65269763823713,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_65,1.0295737837629475,0.3923607078774577,6,0.16018058823616327,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,74.3527828791224,72.2893548503733,9.143034616706322,11.246742648035026,0.889737847800064,1,83.49581749582872,83.53609749840832,161.65269763823713,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,1.2878236947083437,0.41962416991332235,6,0.17131085000443144,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,70.21289390855102,90.42182844947514,12.567753019350837,12.028230536744841,0.27594613835880083,1,82.78064692790186,102.45005898621999,112.695064884842,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_65,0.9999999999999999,0.40024486260741066,5,0.17899494408704678,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.8582106797349762,0.1711436319178414,6,0.06986909515423538,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,70.21289390855102,60.25745540741734,12.567753019350837,4.905711365550786,0.4924146237811411,1,82.78064692790186,65.16316677296813,112.695064884842,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_65,1.087788482018094,0.3743600526333301,6,0.1528318515055188,fruit_1_log2-1,1,967514 MM WT,fruit,ns,70.21289390855102,76.3767772828802,12.567753019350837,10.730766575604417,0.7184043005784917,1,82.78064692790186,87.10754385848462,112.695064884842,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,1.7937504320058417,0.8089261286823182,6,0.3302427091461073,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,87.82893569770141,125.94440878084373,8.731813067197042,23.187296301348102,0.17211691965949044,1,96.56074876489845,149.13170508219184,164.04487559041104,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_65,1.2508946834194647,0.2780817952113442,5,0.12436195947954821,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,1.4079222786057874,0.5975194057863484,6,0.24393627593126002,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,87.82893569770141,98.85429757923357,8.731813067197042,17.12747186240859,0.5834950242593664,1,96.56074876489845,115.98176944164217,164.04487559041104,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_65,1.6040014579107593,0.5832873545435322,6,0.2381260653415862,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,87.82893569770141,112.62158419344931,8.731813067197042,16.719520162689477,0.22793226749144968,1,96.56074876489845,129.34110435613877,164.04487559041104,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.9366554448896084,0.3193089217987415,6,0.13035732145419554,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1789.1368780662747,1876.8504289214854,125.35524588689218,261.2072518440311,0.7706607062780617,1,1914.4921239531668,2138.0576807655166,2351.8634488420685,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_65,0.8928813786491006,0.1532386567500819,6,0.06255941965119964,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.6389572958382881,0.2813384738891853,6,0.11485595100697207,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1789.1368780662747,1280.3291555070618,125.35524588689218,230.14593262416452,0.08942764787091481,1,1914.4921239531668,1510.4750881312264,2351.8634488420685,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_65,0.7694416181860517,0.2745854466593434,6,0.1120990391849332,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1789.1368780662747,1541.7908890635167,125.35524588689218,224.6216908510308,0.36498614348127,1,1914.4921239531668,1766.4125799145475,2351.8634488420685,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.846893624567066,0.2973655783834585,6,0.12139898901784481,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1919.4679006240701,1696.9875861949454,271.5592584909488,243.25673421524837,0.5554779755374363,1,2191.027159115019,1940.2443204101937,2450.3609664215555,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_65,0.9579239947444805,0.33196357842693675,6,0.13552356338906346,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.8169499351285888,0.6247295700629961,6,0.2550447789804423,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1919.4679006240701,1636.987052730133,271.5592584909488,511.0533499114443,0.6392136697043692,1,2191.027159115019,2148.040402641577,2450.3609664215555,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_65,1.0113104777773227,0.24590293545595823,6,0.10038945301994061,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1919.4679006240701,2026.4426095477006,271.5592584909488,201.15826901734934,0.7586430637275228,1,2191.027159115019,2227.60087856505,2450.3609664215555,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,1.0606048224136335,0.41384835676941456,6,0.16895288416239237,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,2003.7789126851078,2125.2175778445726,100.5764489418551,338.54422652193153,0.7429254473934538,1,2104.355361626963,2463.7618043665043,2710.1379848031547,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_65,1,0.12294818479674531,6,0.05019338625890639,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.8513064404517428,0.20213539363812133,6,0.08252142889500305,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,2003.7789126851078,1705.8298936102226,100.5764489418551,165.35469906445067,0.1610977470798736,1,2104.355361626963,1871.1845926746732,2710.1379848031547,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_65,0.9853249922122173,0.34876624801240447,6,0.1423832245225598,leaf_1_log2-1,1,967514 MM WT,leaf,ns,2003.7789126851078,1974.373441536459,100.5764489418551,285.30450281841445,0.9256195218534099,1,2104.355361626963,2259.6779443548735,2710.1379848031547,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.8455752671419697,0.1928721353428233,6,0.07873971953182243,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1831.7990599248974,1694.3458893871557,297.8103103476725,157.77698958860552,0.6946312934781527,1,2129.60937027257,1852.1228789757613,2342.570307299827,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_65,0.9141722414227058,0.3640537865098975,6,0.14862433597956182,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.907357915176899,0.2654478182320685,6,0.10836861800060421,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1831.7990599248974,1818.144656689393,297.8103103476725,217.14675154643848,0.9712436574188339,1,2129.60937027257,2035.2914082358316,2342.570307299827,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_65,0.7584786045596837,0.21794884949641527,6,0.08897724521547731,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1831.7990599248974,1519.823433539521,297.8103103476725,178.29072767158536,0.3944551351095702,1,2129.60937027257,1698.1141612111062,2342.570307299827,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,1.5836953947516386,1.0922784016438862,6,0.4459207901817173,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,1545.8952408635428,1205.4762591131237,285.25614419356754,339.425705088525,0.4623512909658035,1,1831.1513850571102,1544.9019642016488,2014.2665235628215,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_70,2.0309211029383882,0.8379787426359625,5,0.37475548644676265,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,1.0020919127324548,0.7241425718215905,6,0.2956299669982695,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,1545.8952408635428,762.7716884519183,285.25614419356754,225.02743133549257,0.06308355706350939,1,1831.1513850571102,987.7991197874109,2014.2665235628215,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_70,1.4323233627251872,0.7896964837963965,5,0.35316300387226074,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,1545.8952408635428,1090.254991496686,285.25614419356754,268.82039196170746,0.2786661332085311,1,1831.1513850571102,1359.0753834583934,2014.2665235628215,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.7783944413683027,0.44967436739946304,6,0.18357879175624986,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,1053.7713334035723,592.4977886560471,114.45991791816047,139.73638862133356,0.02948765174560849,0.5085711920046887,1168.2312513217328,732.2341772773807,1285.0543764539061,0,23,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_70,1.3843929278709446,0.3683342019230157,6,0.1503718082544425,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.5803231325362832,0.27190136311047525,6,0.11100326666464559,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,1053.7713334035723,441.72999505145174,114.45991791816047,84.49339632588779,0.0018855685373599712,0.04525364489663931,1168.2312513217328,526.2233913773396,1285.0543764539061,0,23,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_70,0.978760789461535,0.6230491402686518,5,0.2786360461927014,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,1053.7713334035723,745.0125187942036,114.45991791816047,212.09200944296785,0.24566266741994933,1,1168.2312513217328,957.1045282371715,1285.0543764539061,0,23,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,1.348116297263063,0.6185905936353454,6,0.25253855234865596,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,761.179367641068,1026.1583106573162,98.28519061006357,192.2271355817407,0.2576486347539612,1,859.4645582511315,1218.3854462390568,2509.0447135594236,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_70,1,0.288726122552049,5,0.12912224738126332,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.9202417540827534,0.5577800839962872,6,0.2277127657462742,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,761.179367641068,700.4690364496175,98.28519061006357,173.33025903454765,0.7686453842772984,1,859.4645582511315,873.7992954841652,2509.0447135594236,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_70,2.334085863143316,1.6228204451940238,6,0.6625136724802654,fruit_1_log2-1,1,967514 MM WT,fruit,ns,761.179367641068,1776.6580013273858,98.28519061006357,504.2917382720901,0.10102867545034726,1,859.4645582511315,2280.949739599476,2509.0447135594236,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.3575430315557291,0.23548396955980508,6,0.0961359280044348,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,*,1287.8187829790709,272.1543786640603,273.6567907185959,73.17668488600293,0.018370564478667185,0.3674112895733437,1561.4755736976667,345.3310635500632,1717.6231310674336,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_70,1.6918729510103305,0.8039040633058264,5,0.3595168265880244,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,1.1397610947972214,0.6583221863225946,6,0.268758907140632,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,1287.8187829790709,867.5626293996404,273.6567907185959,204.5737349852108,0.2546019200617781,1,1561.4755736976667,1072.1363643848513,1717.6231310674336,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_70,0.9450869525956307,0.3171235016488514,6,0.12946512741405763,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,1287.8187829790709,719.3806889425662,273.6567907185959,98.54618381660268,0.10764709672923081,1,1561.4755736976667,817.9268727591689,1717.6231310674336,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,1.660094101100761,0.2906784008106098,6,0.11866896020570104,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,369123.52293533116,428429.96472206566,58623.543138354245,30625.57622536052,0.39762174650161586,1,427747.0660736854,459055.54094742617,565260.1623645215,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_70,1.430291607637673,0.5564172129828395,6,0.22715637598491142,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,1.8692432657431435,0.29866077451956174,6,0.12192775062622435,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,369123.52293533116,482406.2839981659,58623.543138354245,31466.59087867182,0.12872219992569242,1,427747.0660736854,513872.8748768377,565260.1623645215,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_70,1.5315365574068676,0.6611638658413042,6,0.26991901794619133,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,369123.52293533116,395252.3852866531,58623.543138354245,69659.54234752285,0.7801475426722491,1,427747.0660736854,464911.927634176,565260.1623645215,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,2.2741356385361997,0.3690251197585327,6,0.1506538742796433,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,513919.16374162235,586899.1708031615,44939.59522412903,38880.105651885875,0.24808806157634378,1,558858.7589657514,625779.2764550473,826930.01864752,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_70,1.9913503779399933,0.4265379229667758,6,0.1741333778691931,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,2.703389524973018,0.5132490481351485,6,0.20953304648337934,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,513919.16374162235,697679.1725518533,44939.59522412903,54075.389854982954,0.026548847033746107,0.504428093641176,558858.7589657514,751754.5624068363,826930.01864752,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_70,2.030145425009888,0.37496538511041344,6,0.15307897745445034,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,513919.16374162235,523931.22308002063,44939.59522412903,39505.96587688217,0.8705024759226709,1,558858.7589657514,563437.1889569028,826930.01864752,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,1.6441257701627325,0.30962674582544575,6,0.12640458966512727,leaf_1_panK4-1,1,967514 MM WT,leaf,*,258075.7105503754,424308.9263689304,33198.413983301376,32621.954294656367,0.00508513519714111,0.11695810953424553,291274.1245336768,456930.8806635867,736861.4962613268,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_70,1,0.3150981328515731,6,0.12863827406500994,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,2.2524444374774935,0.8406772656851295,6,0.3432050565477889,leaf_1_transp1-1,1,967514 MM WT,leaf,*,258075.7105503754,581301.1986772447,33198.413983301376,88572.88883305238,0.012907223344357456,0.2710516902315066,291274.1245336768,669874.0875102971,736861.4962613268,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_70,1.6970801923382952,0.38343254385422626,6,0.15653568053669806,leaf_1_log2-1,1,967514 MM WT,leaf,*,258075.7105503754,437975.1764986733,33198.413983301376,40398.05698099493,0.006675195383461961,0.14685429843616316,291274.1245336768,478373.2334796682,736861.4962613268,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,3.581018948377811,0.3956698026437411,6,0.16153152051748138,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,782673.5029735971,924174.0095969618,60654.9259239231,41687.361933831555,0.08720307753803433,1,843328.4288975203,965861.3715307934,1179730.383585556,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_70,3.0327282691751893,0.5756978003976941,6,0.2350276428361649,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,3.908025370469884,0.6066473883833483,6,0.24766275922186912,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,782673.5029735971,1008566.4243329093,60654.9259239231,63915.74256305041,0.028253955111371597,0.5085711920046887,843328.4288975203,1072482.1668959598,1179730.383585556,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_70,3.591978193331979,0.34730649619001147,6,0.14178728333656634,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,782673.5029735971,927002.3245256043,60654.9259239231,36591.85389409177,0.07505573222101207,1,843328.4288975203,963594.178419696,1179730.383585556,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.9070142801083662,0.0912178025196908,6,0.03723951193853403,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,53.67071736142427,46.07381605483698,1.6993401147696903,1.891664178454754,0.01526204163041661,0.3662889991299986,55.37005747619396,47.965480233291736,60.90706322381337,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_105,1.0565677262880253,0.0748040741901072,5,0.033453398976603446,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.8834694497144641,0.2396532990855519,6,0.09783804965570145,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,53.67071736142427,44.877803810706304,1.6993401147696903,4.969902240637519,0.14406694273612955,1,55.37005747619396,49.84770605134382,60.90706322381337,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_105,0.8076008860343996,0.17623168907965944,5,0.07881320731434517,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,53.67071736142427,41.02389067614976,1.6993401147696903,4.003492884432899,0.030604683842797478,0.703907728384342,55.37005747619396,45.02738356058266,60.90706322381337,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,1.016875016976127,0.15011355355867742,6,0.0612836016157856,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,49.5511172956052,51.65443754349678,1.6023066525443381,3.1130374129129126,0.5657739674392143,1,51.15342394814954,54.76747495640969,63.67785716367643,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_105,0.9754688200549049,0.07726471403987216,6,0.03154318741995705,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,1.0522355422949938,0.21401926665400792,6,0.08737299973782839,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,49.5511172956052,53.45065440013684,1.6023066525443381,4.4383066577508155,0.43883106580404596,1,51.15342394814954,57.888961057887656,63.67785716367643,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_105,1.0268512889695633,0.2747936248068117,6,0.11218402755774906,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,49.5511172956052,52.16120456009073,1.6023066525443381,5.698638228021012,0.6752661553058793,1,51.15342394814954,57.85984278811174,63.67785716367643,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.9774366384465372,0.2312648707725555,6,0.09441348813724199,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,50.79723336807032,49.65107702567092,7.053814220762816,4.79594399000102,0.8967372358365564,1,57.85104758883314,54.44702101567194,63.63615234771646,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_105,1,0.3105052588985032,5,0.13886217325364492,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.9970639642249963,0.19808030951950178,6,0.08086594773588947,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,50.79723336807032,50.64809087363046,7.053814220762816,4.107766418670155,0.9859650194584662,1,57.85104758883314,54.75585729230061,63.63615234771646,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_105,0.9352902620853428,0.22399764667482436,6,0.09144665632292547,fruit_1_log2-1,1,967514 MM WT,fruit,ns,50.79723336807032,47.510157710032814,7.053814220762816,4.645237141965368,0.708474057417902,1,57.85104758883314,52.15539485199818,63.63615234771646,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,1.0322883543044685,0.14775807818982883,6,0.06032198282322343,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,44.48888068524934,52.43739243674535,6.305384280334683,3.0641898386960102,0.30118383169608964,1,50.79426496558403,55.50158227544136,61.051740502985496,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_105,0.8758130657016011,0.27755975946417066,5,0.12412849799607524,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.9944983544977333,0.14114641723769866,6,0.05762278354238961,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,44.48888068524934,50.517764997583285,6.305384280334683,2.9270779829205678,0.4208166084221664,1,50.79426496558403,53.44484298050385,61.051740502985496,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_105,0.8980019727767983,0.21243182962889032,6,0.08672493128610509,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,44.48888068524934,45.61601577613055,6.305384280334683,4.405386573370143,0.8873908885467889,1,50.79426496558403,50.0214023495007,61.051740502985496,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.921320762667355,0.3456886626936708,6,0.1411268055774301,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,103.81884196253857,115.02740610312057,19.358316199349048,17.619759626596327,0.6776637413888198,1,123.17715816188762,132.6471657297169,172.10871105885403,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_105,0.8315449152214929,0.37979805518192,6,0.15505190674951877,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.9016229251804552,0.4842775490406989,6,0.19770548150589493,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,103.81884196253857,112.56812021293928,19.358316199349048,24.683638567041026,0.7863117637526166,1,123.17715816188762,137.2517587799803,172.10871105885403,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_105,0.9890116650561658,0.6471217589299015,6,0.2641863518051004,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,103.81884196253857,123.47865265488824,19.358316199349048,32.98381194406998,0.6209785244385511,1,123.17715816188762,156.4624645989582,172.10871105885403,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.9369852819284804,0.5901021705802884,6,0.24090820233841762,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,113.32963109450672,116.9831299850431,20.220426777668322,30.077522125656298,0.9219749805845482,1,133.55005787217505,147.0606521106994,172.47275602664837,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_105,0.9077223045366778,0.3967121254773742,6,0.16195704703242356,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,1.0007417827535774,0.6248819873644286,6,0.25510700308318923,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,113.32963109450672,124.94316432844609,20.220426777668322,31.850250241234242,0.7656461653978719,1,133.55005787217505,156.79341456968032,172.47275602664837,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_105,0.7283914348484024,0.25538183181197793,6,0.10425919625276979,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,113.32963109450672,90.94007296196432,20.220426777668322,13.01681823888547,0.37741181160528825,1,133.55005787217505,103.95689120084978,172.47275602664837,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,1.1363657009501327,0.61396164229083094,6,0.25064879087561753,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,124.85055234194422,141.87588542606468,23.74591584015222,31.29363998466131,0.6745773902146845,1,148.59646818209643,173.169525410726,190.48647795179863,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_105,1,0.46588001568579746,6,0.1901947199650045,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.5797791886960194,0.12463935269087778,6,0.050883802660573345,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,124.85055234194422,72.38575194506232,23.74591584015222,6.352870867431074,0.07905651949901163,1,148.59646818209643,78.7386228124934,190.48647795179863,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_105,0.6616480334717627,0.31385834849734745,6,0.12813213422185346,leaf_1_log2-1,1,967514 MM WT,leaf,ns,124.85055234194422,82.60712243491076,23.74591584015222,15.997367730350541,0.1751054687812005,1,148.59646818209643,98.60449016526131,190.48647795179863,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,1.1277538323484433,0.5598615888234156,6,0.22856253653354164,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,89.95654413215318,140.80068887444753,26.773877862453027,28.536158930888476,0.2230896291804881,1,116.73042199460622,169.336847805336,193.01131168865004,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_105,0.7205137858403514,0.5252867365695709,6,0.2144474122078689,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,1.1820386685569617,0.54711859355233,6,0.22336023049873183,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,89.95654413215318,147.578180658873,26.773877862453027,27.88664814899064,0.16698993542390628,1,116.73042199460622,175.46482880786365,193.01131168865004,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_105,0.76455830658685775,0.22494709684342162,6,0.09183426773113593,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,89.95654413215318,95.45552687499072,26.773877862453027,11.465559050150304,0.8557789381001376,1,116.73042199460622,106.92108592514103,193.01131168865004,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,1.3940598434788412,0.230681270945094,6,0.09417523450536583,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,108.88006883358833,141.06967963429213,4.898694064452642,9.52991381489279,0.0187178661290166,0.427180382866655,113.77876289804097,150.5995934491849,177.1807482793918,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_75,1.0759599944481666,0.10824629911268967,5,0.04840921662574985,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,1.4713087120881045,0.2949902978929002,6,0.12042928481820221,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,108.88006883358833,148.88675663984301,4.898694064452642,12.186650886876768,0.02034598173232472,0.42726561637881916,113.77876289804097,161.0734075267198,177.1807482793918,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_75,1.1875280703751112,0.19451880548778752,5,0.0869914543945504,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,108.88006883358833,120.17002371038365,4.898694064452642,8.802962555564507,0.30356315846916276,1,113.77876289804097,128.97298626594815,177.1807482793918,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,1.485921860027192,0.44370390771541807,6,0.18114136179695509,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,110.02540318311323,150.36551101890268,11.586396713027918,18.33031343435559,0.09793670877396937,1,121.61179989614115,168.69582445325827,185.56540689858411,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_75,1.0872782637472023,0.2804605342032055,6,0.11449753363104044,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,1.3387206225243609,0.06578610974535425,6,0.02685706683980895,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,110.02540318311323,135.46971474915603,11.586396713027918,2.7177583751024432,0.08008619223785753,1,121.61179989614115,138.18747312425847,185.56540689858411,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_75,1.3782103332519566,0.18341381146740737,6,0.07487837497903034,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,110.02540318311323,139.46581353017464,11.586396713027918,7.577198654161309,0.06371421768254625,1,121.61179989614115,147.04301218433596,185.56540689858411,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,1.2986309294812182,0.25834403964966013,6,0.1054685125385022,fruit_1_panK4-1,1,967514 MM WT,fruit,*,101.193417409009,131.41290170724224,2.1878822306687256,10.672719212815954,0.03594553691941464,0.7189107383882929,103.38129963967772,142.0856209200582,159.95903250868992,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_75,1,0.048345569502464485,5,0.021620795963690254,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,1.3374307099268483,0.24395111636899214,6,0.09959262621439195,fruit_1_transp1-1,1,967514 MM WT,fruit,*,101.193417409009,135.3391840852548,2.1878822306687256,10.078118195372376,0.018573060124637174,0.427180382866655,103.38129963967772,145.41730228062718,159.95903250868992,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_75,1.2033306886309378,0.12335578650719957,6,0.050359788960389486,fruit_1_log2-1,1,967514 MM WT,fruit,*,101.193417409009,121.76914465570074,2.1878822306687256,5.096079144898296,0.00811186208697843,0.19468469008748235,103.38129963967772,126.86522380059904,159.95903250868992,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,1.6098553993829525,0.10656656647075784,6,0.04350561858229052,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,148.32865529425163,162.906769397906,7.520240472596825,4.4024822208348615,0.14090627288419988,1,155.84889576684844,167.30925161874086,195.08904419804534,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_75,1.465793517919539,0.1661745332298124,5,0.07431551048623164,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,1.6415752905817553,0.2720045547756282,6,0.1110453944855344,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,148.32865529425163,166.11661358815482,7.520240472596825,11.237062955522745,0.22317472334569832,1,155.84889576684844,177.35367654367758,195.08904419804534,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_75,1.532134811982329,0.13193374821938075,6,0.05386172716505193,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,148.32865529425163,155.04195755580136,7.520240472596825,5.450452239383259,0.4913696762648585,1,155.84889576684844,160.4924097951846,195.08904419804534,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,1.1833698889805149,0.1975069444103803,6,0.08063187241027898,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,7995.201063351163,9698.550406350789,317.33999731029365,660.835032403307,0.05216856723261589,0.939034210187086,8312.541060661457,10359.385438754096,11395.323982629507,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_75,0.9755354973996258,0.0948449312380019,6,0.03872028103707692,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,1.141872273207735,0.1415565007736912,6,0.05779019944490594,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,7995.201063351163,9358.448193117689,317.33999731029365,473.6314211884722,0.04127037265600239,0.7841370804640454,8312.541060661457,9832.079614306162,11395.323982629507,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_75,1.1183729067574109,0.15156660677260791,6,0.06187680810632575,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,7995.201063351163,9165.854320180695,317.33999731029365,507.12405984936873,0.08437244634763226,1,8312.541060661457,9672.978380030065,11395.323982629507,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,1.2759097335564016,0.33550430192004865,6,0.13696905770213164,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,8653.628407645267,10456.979664668586,262.3526151903484,1122.557978367123,0.17279712255221769,1,8915.981022835615,11579.53764303571,12737.491407339283,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_75,1.055873595432177,0.07841058788283863,6,0.032010988457435365,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,1.2128835985527524,0.19007996936570487,6,0.07759982254497247,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,8653.628407645267,9940.436060726654,262.3526151903484,635.9852464428257,0.10580078903943213,1,8915.981022835615,10576.42130716948,12737.491407339283,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_75,1.1019059302351772,0.13963754151979263,6,0.057006787610032035,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,8653.628407645267,9030.895839887888,262.3526151903484,467.2108089689047,0.5016862484586118,1,8915.981022835615,9498.106648856792,12737.491407339283,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,1.1279859042814406,0.1177233602983031,6,0.04806036058944365,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,8195.704907369402,9244.639611162916,322.91069469986985,393.8885331328462,0.06752022282762213,1,8518.61560206927,9638.528144295762,10879.454474050146,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_75,0.9999999999999999,0.0965098723590086,6,0.03939999040345089,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,1.1000296799170084,0.2614839306768062,6,0.10675036768257741,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,8195.704907369402,9015.518645947817,322.91069469986985,874.8945122795875,0.41144753833587255,1,8518.61560206927,9890.413158227404,10879.454474050146,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_75,0.9727744126030625,0.05874473796408504,6,0.023982438847585313,leaf_1_log2-1,1,967514 MM WT,leaf,ns,8195.704907369402,7972.572027134306,322.91069469986985,196.55299175384152,0.5708145224186614,1,8518.61560206927,8169.125018888148,10879.454474050146,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,1.220599434181764,0.07745552182095997,6,0.03162108437039335,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,9753.938051835177,10003.6727726558,463.93564115168675,259.1570763507745,0.6511823212149256,1,10217.873692986865,10262.829849006575,12849.247029547605,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_75,1.190128019746617,0.13865867636239104,6,0.0566071675829282,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,1.3411685746973194,0.20601793109796437,6,0.08410646817564589,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,9753.938051835177,10991.821869256446,463.93564115168675,689.3117939686496,0.17137369392369006,1,10217.873692986865,11681.133663225095,12849.247029547605,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_75,1.1811791764429325,0.15549878350285953,6,0.06348211253425276,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,9753.938051835177,9680.59597285589,463.93564115168675,520.2806612271518,0.9183143782067255,1,10217.873692986865,10200.876634083043,12849.247029547605,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,1.0519864751371877,0.1532676772582103,6,0.06257126722403146,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,612.0235250440827,629.6166230948753,26.59146177291989,37.449065081586895,0.7109985570642818,1,638.6149868170025,667.0656881764622,844.4367210907914,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_77,1.0225912836407787,0.09934847031961075,5,0.04442998661905398,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,1.1606375496632897,0.20488015942909701,6,0.08364197483689256,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,612.0235250440827,694.644571890351,26.59146177291989,50.05993802241919,0.18564845267198368,1,638.6149868170025,744.7045099127702,844.4367210907914,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_77,1.1869914278282694,0.21390059366313802,5,0.09565925357166746,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,612.0235250440827,710.4174360552867,26.59146177291989,57.25231039088725,0.17312449984356312,1,638.6149868170025,767.6697464461739,844.4367210907914,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,1.2206003771668108,0.06501856770698622,6,0.026543719114786056,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,597.3351903711382,730.5324790605114,31.562596877127433,15.886484463834067,0.0063383516184857555,0.15212043884365814,628.8977872482657,746.4189635243455,821.0608598767801,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_77,0.998049477005699,0.1291761463485265,6,0.05273594091549573,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,1.0933724481659604,0.14434371019662645,6,0.05892807292698403,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,597.3351903711382,654.3862348700395,31.562596877127433,35.26860388289481,0.25612547146183,1,628.8977872482657,689.6548387529343,821.0608598767801,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_77,1.1016245514555811,0.12857739751845318,6,0.052491502729201056,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,597.3351903711382,659.3251400075447,31.562596877127433,31.416299991143028,0.19410353504178665,1,628.8977872482657,690.7414399986877,821.0608598767801,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,1.1949970652663777,0.10743062550363655,6,0.04385836920532311,fruit_1_panK4-1,1,967514 MM WT,fruit,*,598.5025834222519,715.2088307439365,40.82491167966805,26.24934727407282,0.04700356731152215,1,639.3274951019199,741.4581780180093,878.3355675242246,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_77,1,0.1525261213897859,5,0.0682117551543892,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,1.1974317575779194,0.3348680688456767,6,0.13670931663718272,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,598.5025834222519,716.6660003822324,40.82491167966805,81.82087918524448,0.23599360092058497,1,639.3274951019199,798.4868795674769,878.3355675242246,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_77,1.1156267599400709,0.17344574548500125,6,0.07080892908248206,fruit_1_log2-1,1,967514 MM WT,fruit,ns,598.5025834222519,667.7054979591287,40.82491167966805,42.37932698522853,0.2699137803278626,1,639.3274951019199,710.0848249443573,878.3355675242246,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,1.1058138746283854,0.15970099164169438,6,0.06519765682310541,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,607.1892721654009,661.8324607492589,37.8713701711065,39.02096604170599,0.3413701012219522,1,645.0606423365074,700.8534267909648,911.439259438957,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_77,1.0145140371717,0.14149138274296635,5,0.06327687000874269,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,1.2609763510635914,0.3023829492791753,6,0.12344732210864433,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,607.1892721654009,754.6976037459239,37.8713701711065,73.88354119858249,0.11689459019644022,1,645.0606423365074,828.5811449445064,911.439259438957,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_77,1.0613109537116043,0.05222099785340892,6,0.021319133099971254,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,607.1892721654009,635.1973476107291,37.8713701711065,12.75955623665564,0.5152142507154556,1,645.0606423365074,647.9569038473848,911.439259438957,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,1.126808202972121,0.1801622857987619,6,0.07355094518340645,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,14180.619541235512,16977.454295702308,206.55614428125517,1108.1813275438892,0.052615593103632764,1,14387.175685516768,18085.6356232462,22811.745205779625,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_77,0.9411798815053108,0.03358081044549631,6,0.013709308456764904,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,1.2317618939158925,0.35427863405378435,6,0.14463364670033,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,14180.619541235512,18558.776198101732,206.55614428125517,2179.1739889706514,0.10091745323187917,1,14387.175685516768,20737.950187072383,22811.745205779625,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_77,1.201614896479793,0.254672901082987,6,0.10396977649460194,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,14180.619541235512,18104.555799480175,206.55614428125517,1566.4974073810154,0.05397426175532027,1,14387.175685516768,19671.05320686119,22811.745205779625,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,1.0854463691134764,0.1846217538900424,6,0.07537151540804987,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,15222.381974888109,16354.261597895029,1149.3035430879931,1135.6115926941377,0.4995625876583142,1,16371.685517976102,17489.873190589165,21469.513713172877,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_77,1.0103225477344344,0.18684771909870326,6,0.0762802618991177,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,1.1727861876440269,0.30036363128518634,6,0.12262293898969541,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,15222.381974888109,17670.197862279892,1149.3035430879931,1847.5418769681735,0.2918308183071617,1,16371.685517976102,19517.739739248067,21469.513713172877,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_77,1.093558838773448,0.11679210910119897,6,0.04768017888023346,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,15222.381974888109,16476.490991073173,1149.3035430879931,718.3902776132896,0.3806552918110646,1,16371.685517976102,17194.881268686462,21469.513713172877,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,1.2976857583374792,0.3024194053735398,6,0.12346220524684562,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,15066.853658787537,19552.04141596353,685.8598402334379,1860.1869788454142,0.062040729192790425,1,15752.713499020974,21412.228394808943,23553.451234289838,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_77,1,0.1115034818605857,6,0.045521105850352475,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,1.2182450863682646,0.28662535421665253,6,0.1170143108625476,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,15066.853658787537,18355.120436847625,685.8598402334379,1763.037497749877,0.12916597539621422,1,15752.713499020974,20118.1579345975,23553.451234289838,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_77,1.0226914441951889,0.07099768455158716,6,0.028984683345078074,leaf_1_log2-1,1,967514 MM WT,leaf,ns,15066.853658787537,15408.742327782991,685.8598402334379,436.7079823065878,0.6845864126787151,1,15752.713499020974,15845.450310089578,23553.451234289838,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,1.0272715251321753,0.14054166902032258,6,0.057375896116484755,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,17181.93758258304,15477.74973700597,922.3232463942702,864.474230328872,0.2074823848946426,1,18104.26082897731,16342.223967334841,19950.107099719782,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_77,1.140379934105347,0.14994645748454502,6,0.06121538492917783,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,1.1056041160169703,0.2403644014225783,6,0.09812835596913733,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,17181.93758258304,16657.97542058085,922.3232463942702,1478.4855791644027,0.7709832423378488,1,18104.26082897731,18136.460999745254,19950.107099719782,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_77,1.1126532958575606,0.14882947984855885,6,0.060759380718800104,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,17181.93758258304,16764.184381653497,922.3232463942702,915.4526976887184,0.7544737603723817,1,18104.26082897731,17679.637079342214,19950.107099719782,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,1.2325336759979002,0.6232119803546925,6,0.2544252255764018,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,72.34547947511997,93.80316647807537,19.86735837781151,19.36327765782341,0.45945008941086696,1,92.21283785293149,113.16644413589879,124.48308854948867,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_48,0.9505888032057166,0.5837224858082567,5,0.26104863165248365,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.5202511105977522,0.2449263200544623,6,0.09999075145183921,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,72.34547947511997,39.59421351979975,19.86735837781151,7.609892765900142,0.18241357412775286,1,92.21283785293149,47.20410628569989,124.48308854948867,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_48,0.7552593160559574,0.37255101799635987,5,0.1666098802653216,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,72.34547947511997,57.47974009777483,19.86735837781151,12.680005942041939,0.548831254909415,1,92.21283785293149,70.15974603981677,124.48308854948867,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.8777802992758041,0.3931034218207119,6,0.16048379993380046,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,62.19449585993739,66.80431792460278,17.84185066399914,12.213774678437325,0.8360043018800032,1,80.03634652393653,79.01809260304012,113.7883907982064,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_48,0.8172091997235704,0.5742444684209256,6,0.23443432254117266,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.6458544128902524,0.18640488987068277,6,0.0760994776238109,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,62.19449585993739,49.15337421826938,17.84185066399914,5.7916242837433565,0.5127547480744066,1,80.03634652393653,54.94499850201274,113.7883907982064,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_48,1.1628054474637075,0.48109097240795634,6,0.19640456704314568,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,62.19449585993739,88.4964322631919,17.84185066399914,14.947559371541178,0.28563191336085214,1,80.03634652393653,103.44399163473308,113.7883907982064,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.9649920688209235,0.36236676614919555,6,0.14793561280132753,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,76.10596635595309,73.44165392344676,10.10604464294624,11.258782770705135,0.8641110120430446,1,86.21201099889933,84.7004366941519,94.83321209878928,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_48,0.9999999999999999,0.2969255090932533,5,0.13278912451724928,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.3697439931338873,0.310847618933504,6,0.12690300902436535,fruit_1_transp1-1,1,967514 MM WT,fruit,*,76.10596635595309,28.13972390176337,10.10604464294624,9.65807613527756,0.007769369565923039,0.17092613045030686,86.21201099889933,37.79780003704093,94.83321209878928,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_48,0.8611234308443144,0.3558946197681651,6,0.14529337010563997,fruit_1_log2-1,1,967514 MM WT,fruit,ns,76.10596635595309,65.53663085616029,10.10604464294624,11.057692337002875,0.49832582120615154,1,86.21201099889933,76.59432319316316,94.83321209878928,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,1.902959041221507,0.968789494819203,6,0.3955066550792891,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,180.79939202426908,144.82653676796073,42.99786618830535,30.10041618501992,0.5138652273587119,1,223.79725821257443,174.92695295298066,246.1769840338319,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_48,2.375627045830511,1.2633195042134815,5,0.5649736577445353,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.9470764240070678,0.7139637429736652,6,0.2914744775221797,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,180.79939202426908,72.07816646199826,42.99786618830535,22.182946779922016,0.06520446266133666,1,223.79725821257443,94.26111324192028,246.1769840338319,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_48,2.073008056513791,0.5620766652291777,6,0.22946683768944084,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,180.79939202426908,157.7682814046583,42.99786618830535,17.46379542899953,0.6395600712630936,1,223.79725821257443,175.23207683365783,246.1769840338319,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,1.8139284318526743,0.4911307110794019,6,0.20050327319246727,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,2034.9557004707856,2508.0952610979225,394.24569194948816,277.23326923930864,0.3519764263409624,1,2429.201392420274,2785.3285303372313,3446.74606415608,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_48,1.471739953381506,0.6984232720640909,6,0.2851301068403426,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,2.038475912697699,0.5577373691333202,6,0.2276953274764905,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,2034.9557004707856,2818.5741436763637,394.24569194948816,314.8313691927996,0.15291760592678902,1,2429.201392420274,3133.4055128691634,3446.74606415608,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_48,1.8831696008306373,0.5603423434984571,6,0.22875880380775984,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,2034.9557004707856,2603.834125287364,394.24569194948816,316.30182409052793,0.2878651206657731,1,2429.201392420274,2920.135949377892,3446.74606415608,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,2.264174880515774,0.39662869288380903,6,0.1619229858187316,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,2414.127925275274,3130.6451723227597,213.82074150808396,223.88880744318766,0.043233231533958506,0.8646646306791701,2627.9486667833576,3354.533979765947,4453.149859972168,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_48,1.7459684844144991,0.37879267920670057,6,0.154641463726362,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,2.1620117680335023,0.489969494525309,6,0.2000292085194005,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,2414.127925275274,2989.3855648452513,213.82074150808396,276.5777861788451,0.13282195400722663,1,2627.9486667833576,3265.9633510240965,4453.149859972168,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_48,2.769285633443499,0.3884335398741121,6,0.15857732861243304,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,2414.127925275274,3829.055243801546,213.82074150808396,219.26281071860635,9.521464275929729e-4,0.02189936783463838,2627.9486667833576,4048.3180545201526,4453.149859972168,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,1.6209632963777647,0.2660716694598211,6,0.108623304197838,leaf_1_panK4-1,1,967514 MM WT,leaf,*,1382.686999693948,2241.2848768825834,227.40385368234428,150.19203057815167,0.012291158338804488,0.25811432511489424,1610.0908533762924,2391.476907460735,5017.98405350778,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_48,1,0.40285574912294947,6,0.16446517088298301,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,2.166737250338349,1.2520963463747299,6,0.5111661929035324,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1382.686999693948,2995.919427795447,227.40385368234428,706.7828496107632,0.07259797921414213,1,1610.0908533762924,3702.70227740621,5017.98405350778,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_48,3.0621379015283408,0.5807568866000369,6,0.23709300612958062,leaf_1_log2-1,1,967514 MM WT,leaf,*,1382.686999693948,4233.9782677133435,227.40385368234428,327.8254172937288,5.679756620251383e-5,0.0013631415888603318,1610.0908533762924,4561.803685007072,5017.98405350778,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,2.553579010022824,0.6403738979550753,6,0.2614315490978398,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,3485.26374561209,3530.8004998499005,588.6494932847331,361.47800424743315,0.9490007851914938,1,4073.9132388968233,3892.2785040973336,5518.41173600197,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_48,2.520645486927655,1.042818003072731,6,0.4257286670193819,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,3.2775049188239205,0.5395477998323599,6,0.2202694669050995,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,3485.26374561209,4531.7634426908035,588.6494932847331,304.5637283191974,0.1555117142542605,1,4073.9132388968233,4836.327171010001,5518.41173600197,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_48,3.433048939610993,0.4781497893910159,6,0.1952038341045384,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,3485.26374561209,4746.832138113214,588.6494932847331,269.90580370675923,0.09234228397407519,1,4073.9132388968233,5016.737941819973,5518.41173600197,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.7421940695537165,0.5893562727799951,6,0.24060369083658717,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,58.8916416506703,61.433938784628744,8.178222304005432,19.915589494131414,0.9095162264374459,1,67.06986395467574,81.34952827876016,124.67913153837664,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_90,0.7114801369425866,0.22092915573004546,5,0.09880252208480376,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,1.081159280263732,0.7058872829166095,6,0.2881772765108871,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,58.8916416506703,89.49124732308067,8.178222304005432,23.853417711807175,0.26956377527557757,1,67.06986395467574,113.34466503488784,124.67913153837664,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_90,0.7365614491146805,0.43312799787692424,5,0.19370072924223744,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,58.8916416506703,60.967707547484984,8.178222304005432,16.033271122687555,0.9119653236459788,1,67.06986395467574,77.00097867017254,124.67913153837664,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.87452878932544,0.35221887103310123,6,0.14379275196837543,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,46.0733268975513,72.38773565129674,8.612336021984094,11.902217337050732,0.10647530380362666,1,54.68566291953539,84.28995298834747,154.97673680219162,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_90,0.5566198532028399,0.2548623659541244,6,0.10404712520434675,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,1.0052815163873803,0.4063637707441713,6,0.1658973147127571,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,46.0733268975513,83.21058557662228,8.612336021984094,13.731887513903372,0.04965187496522284,1,54.68566291953539,96.94247309052565,154.97673680219162,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_90,1.2174973688236517,1.1870087689358566,6,0.4845943006836781,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,46.0733268975513,100.77641670154227,8.612336021984094,40.11152584590465,0.23533059149391145,1,54.68566291953539,140.88794254744693,154.97673680219162,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,1.0287249860305212,0.6318452573554154,6,0.25794974615304794,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,82.77341642135346,85.15108165175535,14.369231184613856,21.351381754108655,0.9285569540973766,1,97.14264760596731,106.502463405864,117.15270974645041,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_90,1,0.3881750820776504,5,0.17359717413943732,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,0.9344985599710084,0.4765042177669435,6,0.194532032302175,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,82.77341642135346,77.35163844963543,14.369231184613856,16.102080917040112,0.8072815095063783,1,97.14264760596731,93.45371936667554,117.15270974645041,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_90,1.0340520076593787,0.3288292968019032,6,0.1342439982738112,fruit_1_log2-1,1,967514 MM WT,fruit,ns,82.77341642135346,85.59201743132633,14.369231184613856,11.11183437118563,0.8805573806391258,1,97.14264760596731,96.70385180251196,117.15270974645041,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,1.0832058805250904,0.27852356283241214,6,0.1137067683802366,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,104.38541732179313,89.66065141876214,38.2284956984276,9.41189768906371,0.7254124530928371,1,142.61391302022074,99.07254910782585,197.4017972871882,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_90,1.2610983312616333,1.032717009336712,5,0.46184508687943454,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,1.646903328201319,1.276521939187918,6,0.5211378994130829,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,104.38541732179313,136.31981499092072,38.2284956984276,43.13636436106852,0.5930435582665203,1,142.61391302022074,179.45617935198925,197.4017972871882,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_90,0.9973007650732706,0.6678081318862524,6,0.2726315282004286,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,104.38541732179313,82.54999152474423,38.2284956984276,22.56664301332404,0.638673114748054,1,142.61391302022074,105.11663453806827,197.4017972871882,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,1.2383334171014955,0.3017042370423384,6,0.12317023899823876,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,2768.91347289136,2651.724653758106,235.1330437232913,263.75252000014314,0.747083697176756,1,3004.0465166146514,2915.477173758249,3588.8592248225164,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_90,1.2930596235489502,0.2689666645078496,6,0.109805180977097,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,1.3156543158918128,0.26275139693523647,6,0.1072678086158022,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,2768.91347289136,2817.29697114976,235.1330437232913,229.69960168474995,0.8859068972946593,1,3004.0465166146514,3046.9965728345096,3588.8592248225164,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_90,1.3877459129785543,0.3327898674757955,6,0.13586089448068905,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,2768.91347289136,2971.6714414528897,235.1330437232913,290.92785384030697,0.6001751301064573,1,3004.0465166146514,3262.5992952931965,3588.8592248225164,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,1.7439505229589043,0.2927218547333579,6,0.11950319677630461,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,2782.4689880787587,3734.4357608379387,180.15912710869307,255.90004171603525,0.014013376814676919,0.33632104355224607,2962.628115187452,3990.3358025539737,4389.369382809371,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_90,1.2993899366977129,0.2060824745504324,6,0.0841328179297766,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,1.552724622902669,0.6852940062784473,6,0.2797701065283079,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,2782.4689880787587,3324.9511853484914,180.15912710869307,599.0900985310653,0.4197409169331466,1,2962.628115187452,3924.041283879557,4389.369382809371,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_90,1.624917380673341,0.5698797451535476,6,0.23265243172891772,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,2782.4689880787587,3479.5422776662303,180.15912710869307,498.1939277842982,0.2341907770518552,1,2962.628115187452,3977.7362054505284,4389.369382809371,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,1.025078171385179,0.19884849991723055,6,0.08117956015251299,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,2141.365658987758,2195.0671939821896,266.1360898713706,173.83512232232223,0.8697483372262,1,2407.5017488591284,2368.9023163045117,2797.558405706179,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_90,0.9999999999999999,0.30443078209842117,6,0.12428334635625725,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,1.0065347003231073,0.37981434146152443,6,0.15505855559532528,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,2141.365658987758,2155.358841851436,266.1360898713706,332.0370660840736,0.9744443439504545,1,2407.5017488591284,2487.3959079355095,2797.558405706179,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_90,1.082142853953704,0.2584867033227887,6,0.10552675473916824,leaf_1_log2-1,1,967514 MM WT,leaf,ns,2141.365658987758,2317.263545575466,266.1360898713706,225.97136870287852,0.6255837356271259,1,2407.5017488591284,2543.2349142783446,2797.558405706179,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,1.7652275461784406,0.20892025822392077,6,0.08529133826318448,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,3984.0990373133245,3779.997647685739,331.30139665545624,182.63994276589182,0.6046236084719666,1,4315.400433968781,3962.637590451631,5608.298360650421,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_90,1.8605412021021401,0.3789728155353408,6,0.1547150040745798,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,2.181507943278525,0.48849522748026597,6,0.19942734151857447,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,3984.0990373133245,4671.406194545647,331.30139665545624,427.0468605910989,0.23400550992151462,1,4315.400433968781,5098.453055136746,5608.298360650421,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_90,2.0477606654841134,0.5267387934851594,6,0.21504021196131412,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,3984.0990373133245,4385.004366893598,331.30139665545624,460.47972519540656,0.4974695807901176,1,4315.400433968781,4845.484092089005,5608.298360650421,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,1.4345149853409032,0.3491835913452859,6,0.14255360422474514,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,338.6179168244462,408.9338972167626,18.253011980084345,40.63742904997787,0.15927707427862253,1,356.87092880453054,449.57132626674047,649.3926484396342,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_91,1.187850846544291,0.14317642654865015,5,0.06403044450765746,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,1.3564839592697717,0.3387690392663926,6,0.1383018811425901,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,338.6179168244462,386.6897715567526,18.253011980084345,39.42540010107222,0.3052259664081068,1,356.87092880453054,426.1151716578248,649.3926484396342,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_91,1.8099842975180045,0.5835055629302462,5,0.26095162079226236,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,338.6179168244462,515.9680730064224,18.253011980084345,74.38888012051773,0.07450971933623969,1,356.87092880453054,590.3569531269401,649.3926484396342,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,1.463871841086236,0.5900727309587012,6,0.24089618366323276,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,283.6783378969789,417.30258876243954,37.722385980413016,68.67172264961762,0.12763920350593227,1,321.40072387739195,485.97431141205715,597.0068354567394,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_91,0.9951261793152606,0.32413561878026476,6,0.1323278122454895,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,1.426410716867134,0.4260177298058542,6,0.17392100990053588,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,283.6783378969789,406.6236319877928,37.722385980413016,49.57926345370285,0.0787423035688758,1,321.40072387739195,456.2028954414957,597.0068354567394,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_91,1.7480482712369114,0.38169774837849113,6,0.15582745324942476,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,283.6783378969789,498.3121120272289,37.722385980413016,44.421374751625024,0.004413868678021397,0.10151897959449213,321.40072387739195,542.733486778854,597.0068354567394,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,1.6551628865647956,0.4730292666060446,6,0.1931133894312926,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,285.0677067828484,471.83348842510617,72.99177856334263,55.05039107424174,0.07614748588318847,1,358.059485346191,526.8838794993479,579.5722674492828,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_91,1,0.5725467135797865,5,0.25605067437170087,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,1.2489928982221161,0.13519870746938817,6,0.05519464119730163,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,285.0677067828484,356.0475412842422,72.99177856334263,15.734209792816909,0.3913347242292374,1,358.059485346191,371.7817510770591,579.5722674492828,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_91,1.6567592668992623,0.37963882207764954,6,0.1549869001069151,fruit_1_log2-1,1,967514 MM WT,fruit,ns,285.0677067828484,472.2885649062058,72.99177856334263,44.1817601948607,0.06572125567777048,1,358.059485346191,516.4703251010665,579.5722674492828,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.7278740578679389,0.4150008940365506,6,0.16942340553139656,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,270.5184438210109,207.49338850313964,31.055191281096747,48.29714169017577,0.30344218709716064,1,301.5736351021077,255.79053019331542,405.0093479531317,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_91,0.9489620794791729,0.24359658111568733,5,0.10893970289224368,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,0.9785166453864169,0.766867538432035,6,0.3130723615771091,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,270.5184438210109,278.94349614915154,31.055191281096747,89.24682017187723,0.9317796736431896,1,301.5736351021077,368.1903163210288,405.0093479531317,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_91,1.0251400878811263,0.6016374624055254,6,0.2456174655060724,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,270.5184438210109,292.23433398344037,31.055191281096747,70.01760763763143,0.785183696597957,1,301.5736351021077,362.2519416210718,405.0093479531317,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,1.0747362035707564,0.20949360351488855,6,0.08552540549806759,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,743472.3139868695,778427.8373030736,41145.13175156376,61945.76512369817,0.6498863461752351,1,784617.4457384333,840373.6024267718,955283.4309878096,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_91,1.0264748688363212,0.139148203279394,6,0.056807016109930705,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,1.0849062164859542,0.16161845061494412,6,0.06598045617096922,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,743472.3139868695,785793.9436393253,41145.13175156376,47789.42370303839,0.5176756434263838,1,784617.4457384333,833583.3673423637,955283.4309878096,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_91,1.0768444263713777,0.2992451807447691,6,0.12216633346860169,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,743472.3139868695,779954.8160256551,41145.13175156376,88484.66669053532,0.7194740326426434,1,784617.4457384333,868439.4827161904,955283.4309878096,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,1.1420939476123297,0.19040084009300962,6,0.07773081747085453,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,457821.38884922385,827214.8260038258,68060.69768475027,56300.1710881266,0.0020286658085758346,0.04868797940582003,525882.0865339742,883514.9970919524,1022060.5053883268,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_91,0.6320909887678333,0.23017361698969593,6,0.09396798564592734,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,1.003476440215412,0.30582216695053366,6,0.12485137684350948,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,457821.38884922385,726814.6290654321,68060.69768475027,90429.4346256343,0.04063449732099702,0.7720554490989434,525882.0865339742,817244.0636910665,1022060.5053883268,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_91,1.1684606768806378,0.2801344308123688,6,0.11436440247921688,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,457821.38884922385,846312.1598173633,68060.69768475027,82833.75417202462,0.004949820224187125,0.10889604493211676,525882.0865339742,929145.9139893879,1022060.5053883268,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,1.2167655832303674,0.2798870863030208,6,0.11426342450611994,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,724296.655045942,881299.24190878,80817.53908563973,82760.61616387719,0.2045532771275846,1,805114.1941315818,964059.8580726571,1130789.7326677844,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_91,1,0.27331581838479757,6,0.11158071561232528,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,1.2417912425083149,0.43479378559544973,6,0.17750381967365375,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,724296.655045942,899425.2432141167,80817.53908563973,128565.4228475055,0.2805022456773581,1,805114.1941315818,1027990.6660616222,1130789.7326677844,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_91,1.3435682270631724,0.16082479195985191,6,0.06565644638181597,leaf_1_log2-1,1,967514 MM WT,leaf,*,724296.655045942,973141.9726878626,80817.53908563973,47554.744496552565,0.028798793324778527,0.5759758664955705,805114.1941315818,1020696.7171844151,1130789.7326677844,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.6699231239642445,0.3321821623859424,6,0.13561279991665035,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,229247.0662341001,485223.0778252303,57352.67129134364,98223.89736104445,0.05430783265063162,0.9775409877113691,286599.7375254437,583446.9751862747,641791.6727049022,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_91,0.3165099060405836,0.1939602772850726,6,0.07918395161952774,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,0.5659919758240144,0.42061793305616507,6,0.171716552108623,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,229247.0662341001,409946.09487217735,57352.67129134364,124373.72430829782,0.22837128885161753,1,286599.7375254437,534319.8191804752,641791.6727049022,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_91,0.715842610316946,0.19835876282212841,6,0.0809796258206608,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,229247.0662341001,518482.4081919198,57352.67129134364,58653.27210877662,0.00548922865034847,0.11527380165731788,286599.7375254437,577135.6803006964,641791.6727049022,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.8783601858493926,0.5458725285527871,6,0.22285152659286162,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,16624.59590642571,11834.622112215406,3389.6703031692446,3002.5992148157925,0.31916780071184686,1,20014.266209594956,14837.221327031199,22015.692830554453,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_99,1.2338698279995706,0.5625494539614654,5,0.251579763952645,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.7393440416038637,0.3582374323224994,6,0.1462498193258242,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,16624.59590642571,9961.582371630948,3389.6703031692446,1970.502959474622,0.13590884437833586,1,20014.266209594956,11932.085331105569,22015.692830554453,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_99,1.0162439169330972,0.9942062481886578,5,0.4446225509209732,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,16624.59590642571,13692.404237460516,3389.6703031692446,5990.640237900314,0.6842323741392901,1,20014.266209594956,19683.04447536083,22015.692830554453,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,1.4450237422413013,1.3580913834237542,6,0.5544384855764505,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,12016.135471725433,19469.586859823154,2080.1876810497697,7470.24975286318,0.3749853888961295,1,14096.323152775203,26939.836612686333,29633.820273954967,0,23,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_99,0.8918320235372906,0.3781781143870245,6,0.15439056868935,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.9223910710426051,0.5466022421570716,6,0.223149430924339,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,12016.135471725433,12427.874055920149,2080.1876810497697,3006.613041085955,0.9128344468296181,1,14096.323152775203,15434.487097006104,29633.820273954967,0,23,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_99,0.6658203563628186,0.4079773638068013,5,0.182453023750634,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,12016.135471725433,8970.957972730388,2080.1876810497697,2458.288324204681,0.3708910409295779,1,14096.323152775203,11429.246296935069,29633.820273954967,0,23,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.6800415188348738,0.15297524728201958,6,0.06245188318617121,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,13473.54115415771,9162.567390557588,2372.2083673757033,841.4480182635278,0.14736207151656697,1,15845.749521533413,10004.015408821115,19266.522505611985,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_99,1,0.39369154000090106,5,0.17606420912171847,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,1.0782004525512228,0.5431897196216581,6,0.221756274433087,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,13473.54115415771,14527.178169880368,2372.2083673757033,2987.8422897668884,0.7887302783823164,1,15845.749521533413,17515.020459647258,19266.522505611985,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_99,1.0379302871115448,0.26266435761623236,6,0.10723227496261563,fruit_1_log2-1,1,967514 MM WT,fruit,ns,13473.54115415771,13984.596438544128,2372.2083673757033,1444.7984697627571,0.8594051141781525,1,15845.749521533413,15429.394908306884,19266.522505611985,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,2.806692042457862,1.143273603970267,6,0.46673949435332107,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,32909.743656614686,37816.08074110297,6307.369614418833,6288.63378544023,0.5953119100271685,1,39217.11327103352,44104.7145265432,81087.54158529852,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_99,2.442545970660378,1.0467706340663814,5,0.46813005892459714,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,4.990815403973279,1.1766077918771793,6,0.48034811958031925,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,32909.743656614686,67243.95673823822,6307.369614418833,6471.9901574877,0.004279247378126919,0.09842268969691913,39217.11327103352,73715.94689572592,81087.54158529852,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_99,2.4920751858074373,1.020657542722252,6,0.41668169696540663,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,32909.743656614686,33577.07757523173,6307.369614418833,5614.177992247679,0.9388264960148155,1,39217.11327103352,39191.255567479406,81087.54158529852,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,1.4591948655973992,0.127302668080991,6,0.05197109661555316,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,69063.35246662365,72394.27992969478,7229.104082093173,2578.4151283312153,0.6788756368160122,1,76292.45654871681,74972.69505802599,111005.77089775425,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_99,1.3920559665502512,0.35691856884242856,6,0.1457113955647301,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,1.4522180164857117,0.13405631989907282,6,0.054728263424673226,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,69063.35246662365,72048.14112429817,7229.104082093173,2715.2050187689006,0.7116694363194362,1,76292.45654871681,74763.34614306707,111005.77089775425,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_99,1.9001872267011388,0.3278987920282704,6,0.13386412129070716,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,69063.35246662365,94273.00578686866,7229.104082093173,6641.331392907926,0.028131109867951868,0.5907533072269893,76292.45654871681,100914.33717977659,111005.77089775425,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,2.1253293187858042,0.29605685131053466,6,0.12086470342763987,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,103461.50641620978,105442.86392069749,3897.1931608957584,5996.397999918852,0.7882952107008633,1,107358.69957710554,111439.26192061635,147196.32859567553,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_99,2.0853926456084606,0.1924139685490127,6,0.07855267372150194,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,2.2558923208335484,0.4644738132725825,6,0.18962064023376335,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,103461.50641620978,111920.41859248975,3897.1931608957584,9407.550720726356,0.4348763560015628,1,107358.69957710554,121327.9693132161,147196.32859567553,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_99,2.6231448058669944,0.18140020409112198,6,0.0740563232099964,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,103461.50641620978,130140.72612866144,3897.1931608957584,3674.1180492253957,5.582788833569093e-4,0.013398693200565822,107358.69957710554,133814.84417788684,147196.32859567553,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,1.2166817465259256,0.2402071921674719,6,0.09806417555949504,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,49612.48263442616,60362.602021140774,8392.03755569669,4865.207207004766,0.29989219517893234,1,58004.52019012285,65227.80922814554,101229.42163352465,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_99,1,0.4143354418524155,6,0.16915173581483797,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,1.211888963468769,0.20309679103465436,6,0.08291391773859406,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,49612.48263442616,60124.820154947025,8392.03755569669,4113.565303958237,0.2964291326003636,1,58004.52019012285,64238.385458905264,101229.42163352465,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_99,1.714370879215653,0.3442519379982898,6,0.1405402651766736,leaf_1_log2-1,1,967514 MM WT,leaf,*,49612.48263442616,85054.19547405248,8392.03755569669,6972.5514655153665,0.00912289963018978,0.20070379186417517,58004.52019012285,92026.74693956785,101229.42163352465,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,2.2288321419516253,0.2772165689998974,6,0.11317319038246564,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,116006.80211035845,110577.89593762589,5346.308682835039,5614.802942532683,0.4997857563868644,1,121353.11079319348,116192.69888015857,154904.51921993794,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_99,2.338258356574585,0.26396034999606993,6,0.10776136163613852,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,2.5477485649255343,0.7120572906149624,6,0.2906961716058885,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,116006.80211035845,126400.13143425225,5346.308682835039,14422.158765691309,0.5230603221340392,1,121353.11079319348,140822.29019994356,154904.51921993794,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_99,2.6315780672414033,0.44083348818923973,6,0.17996951793247867,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,116006.80211035845,130559.12116215088,5346.308682835039,8928.734583151148,0.19877786763689415,1,121353.11079319348,139487.85574530205,154904.51921993794,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,2.0813969993180073,2.602923988970775,6,1.0626392687046982,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,98.08079513171121,198.62070607290957,5.018924866241231,101.40408673601637,0.36730565184111486,1,103.09971999795245,300.02479280892595,330.02727208981855,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_102,1.0278136490106449,0.11760508473670526,5,0.05259459279417918,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,1.1316985502513497,0.16576182931020925,6,0.0676719834400556,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,98.08079513171121,107.99418140136767,5.018924866241231,6.457709479076887,0.2568929178068384,1,103.09971999795245,114.45189088044455,330.02727208981855,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_102,1.185435610998484,0.23361912953278136,5,0.10447765089592555,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,98.08079513171121,113.1221281368419,5.018924866241231,9.969950373036532,0.22720370491684524,1,103.09971999795245,123.09207850987843,330.02727208981855,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,1.2452107790358389,0.2971488052634885,6,0.12131049176219855,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,97.85010255448059,118.82627111633904,4.448428323822632,11.576251688531631,0.13827916391711745,1,102.29853087830321,130.40252280487067,143.44277508535774,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_102,1.025396162699643,0.11418593835806835,6,0.046616214129693453,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,1.022799149879714,0.1329582704865294,6,0.05427998662915752,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,97.85010255448059,97.60227836709888,4.448428323822632,5.179756323970831,0.9717762910855392,1,102.29853087830321,102.78203469106971,143.44277508535774,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_102,0.9772004516956753,0.057076071456424085,6,0.023301208598478423,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,97.85010255448059,93.25094816325654,4.448428323822632,2.223555864497924,0.3844267493687468,1,102.29853087830321,95.47450402775446,143.44277508535774,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,1.5124940516093037,0.5653118717965984,6,0.2307876052398878,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,95.42663227533711,144.33221368155577,10.339649470103877,22.023283938932437,0.08423056331413455,1,105.76628174544099,166.35549762048822,182.99104738253706,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_102,1,0.24228203937830176,5,0.10835182195543272,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,1.250635250167795,0.26379891674960254,6,0.10769545678924416,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,95.42663227533711,119.34391012833643,10.339649470103877,10.277014752751661,0.1357664422267408,1,105.76628174544099,129.6209248810881,182.99104738253706,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_102,1.410328634991488,0.6204913106400738,6,0.2533145168164919,fruit_1_log2-1,1,967514 MM WT,fruit,ns,95.42663227533711,134.58291203871087,10.339649470103877,24.17295124625208,0.1817916241491492,1,105.76628174544099,158.75586328496294,182.99104738253706,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,1.0688151674570638,0.15485616023615414,6,0.06321976268420798,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,117.56246753969309,101.99343195522809,12.196342998233341,6.032849046199993,0.2967291523596202,1,129.75881053792642,108.02628100142809,148.9187033250874,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_102,1.231967059263779,0.2857886878189845,5,0.12780858663274308,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,1.2682197246210076,0.36857104382437833,6,0.150468498555784,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,117.56246753969309,121.02193730573819,12.196342998233341,14.358702080704893,0.8583850178983693,1,129.75881053792642,135.38063938644308,148.9187033250874,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_102,1.1583143382036885,0.21501789922647263,6,0.08778068977833864,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,117.56246753969309,110.53403641101383,12.196342998233341,8.376615604352965,0.6485529133965671,1,129.75881053792642,118.9106520153668,148.9187033250874,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,1.0369632465230076,0.10441364150271629,6,0.042626690644590584,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,605.5695154459156,590.4332382446894,35.080552169078466,24.271077183623014,0.7309876048304119,1,640.6500676149941,614.7043154283124,733.4403672818077,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_102,1.0635467146108102,0.1509157657152126,6,0.061611103357280414,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,1.1092429019208152,0.15132485980208887,6,0.06177811531888653,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,605.5695154459156,631.5883236720986,35.080552169078466,35.17564658409012,0.6118674847674914,1,640.6500676149941,666.7639702561887,733.4403672818077,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_102,1.060086346198432,0.10023925468869015,6,0.04092250436402952,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,605.5695154459156,603.5992271699416,35.080552169078466,23.300735922659623,0.9637417876632808,1,640.6500676149941,626.8999630926013,733.4403672818077,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,1.1028269507946955,0.051522691387185,6,0.021034050678915478,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,615.3314289346068,627.9351654598702,14.049345912325316,11.97651189412664,0.5106758543673684,1,629.3807748469321,639.9116773539968,750.1357716261039,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_102,1.0806913210587876,0.060439977852611,6,0.024674517634002188,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.9915634336440236,0.03298896621166321,6,0.013467689060081646,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,615.3314289346068,564.5831817227038,14.049345912325316,7.668325073313151,0.013765935482339411,0.3303824515761459,629.3807748469321,572.2515067960169,750.1357716261039,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_102,1.1442127738363057,0.1309603928466018,6,0.05346435649810111,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,615.3314289346068,651.4997089456816,14.049345912325316,30.44190162350363,0.3162728110090693,1,629.3807748469321,681.9416105691853,750.1357716261039,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.9823858749351447,0.09926457302383332,6,0.04052459224060525,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,569.3868516791151,559.357600463355,26.819353282850926,23.074169991458124,0.7827193549283328,1,596.206204961966,582.4317704548131,674.446528045879,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_102,1,0.11537626936886872,6,0.04710216472993882,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.9646901678850985,0.08538229417113784,6,0.03485717563124968,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,569.3868516791151,549.2818975378932,26.819353282850926,19.847217491103233,0.5613219768587401,1,596.206204961966,569.1291150289965,674.446528045879,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_102,1.048663193766944,0.06899586810399044,6,0.028167445202524274,leaf_1_log2-1,1,967514 MM WT,leaf,ns,569.3868516791151,597.095034370726,26.819353282850926,16.0381729437093,0.400590811407723,1,596.206204961966,613.1332073144354,674.446528045879,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.9713080357405592,0.04899456764016614,6,0.020001948481113932,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,569.8354932592428,553.0500244809425,6.4521854679650295,11.38884647310932,0.23602029792122534,1,576.2876787272078,564.4388709540518,649.0755056939395,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_102,1.000787938075501,0.027757160313251966,6,0.0113318132460165,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.9964597324537746,0.09764445523520902,6,0.03986318192304929,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,569.8354932592428,567.3710698868681,6.4521854679650295,22.697571653076846,0.9203370163775308,1,576.2876787272078,590.0686415399449,649.0755056939395,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_102,0.9696669602712796,0.06576178399226677,6,0.026847135892696744,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,569.8354932592428,552.1156176861215,6.4521854679650295,15.28640618254398,0.322360006268647,1,576.2876787272078,567.4020238686654,649.0755056939395,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,1.156617972482898,0.13091008464071888,6,0.053443818259053096,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,187.72866104474357,173.28110878486214,19.52241650115663,8.006795939497053,0.5221295444601284,1,207.25107754590022,181.28790472435918,227.97618530049024,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_106,1.2530525966571437,0.2913783598591416,5,0.13030836396348733,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,1.2430090452494074,0.1621264819385568,6,0.06618785909033618,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,187.72866104474357,186.22396566089586,19.52241650115663,9.916070720091858,0.9474427169114134,1,207.25107754590022,196.1400363809877,227.97618530049024,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_106,1.0944259879215021,0.34402519313708557,5,0.1538527435654035,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,187.72866104474357,163.96368825473195,19.52241650115663,23.04976632636614,0.4546930260405503,1,207.25107754590022,187.01345458109807,227.97618530049024,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,1.3070390212693896,0.03672070198902547,6,0.014991163811652622,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,163.8251652207895,195.81674867497333,9.51776322233526,2.245932147917645,0.019009776445053278,0.4182150817911721,173.34292844312475,198.06268082289097,217.86894890518008,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_106,1.0935013733932122,0.15561420553756436,6,0.06352923338260286,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,1.2045844497357863,0.11347799543275529,6,0.046327197640688406,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,163.8251652207895,180.4673055763937,9.51776322233526,6.940604732988131,0.19083312664490246,1,173.34292844312475,187.40791030938183,217.86894890518008,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_106,1.142726093295101,0.1498344810611451,6,0.06116967074575255,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,163.8251652207895,171.19986823176984,9.51776322233526,9.164260475803454,0.5890305104629667,1,173.34292844312475,180.3641287075733,217.86894890518008,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,1.0333724860789535,0.17753325625737898,6,0.07247764836755789,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,149.81706398084205,154.8168318629324,5.360647094973979,10.858388482663392,0.6917151085890697,1,155.17771107581603,165.6752203455958,188.03972419505249,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_106,1,0.08000938604217611,5,0.035781285205665724,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,1.0951420190175722,0.11239297135439326,6,0.04588423841558498,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,149.81706398084205,164.07096193126415,5.360647094973979,6.874241882419906,0.13705400557024772,1,155.17771107581603,170.94520381368406,188.03972419505249,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_106,1.0353427244262927,0.11867227249605362,6,0.04844775237197561,fruit_1_log2-1,1,967514 MM WT,fruit,ns,149.81706398084205,155.1120071874732,5.360647094973979,7.25830001684026,0.5722333635844017,1,155.17771107581603,162.37030720431346,188.03972419505249,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,1.7463069449451725,0.15657732379928502,6,0.06392242476646484,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,242.37081784359805,261.6265793010397,34.96604699074921,9.57667000104803,0.6199394342305823,1,277.33686483434724,271.2032493020878,305.07055131778196,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_106,1.6177784519565233,0.521879523588617,5,0.2333916181618705,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,1.692141708318431,0.1402151587580269,6,0.057242598860083635,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,242.37081784359805,253.51170257979373,34.96604699074921,8.575918095850827,0.7708395519625375,1,277.33686483434724,262.0876206756446,305.07055131778196,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_106,1.6009092945214696,0.27496045337126074,6,0.11225213503398593,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,242.37081784359805,239.84353020484772,34.96604699074921,16.817285296372795,0.9502466497495933,1,277.33686483434724,256.6608155012205,305.07055131778196,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,1.1779079709128724,0.0839445737360882,6,0.034270228721475705,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,3048.2746230712073,3287.7095207315865,94.45766819026072,95.6531070571885,0.10524437911645056,1,3142.732291261468,3383.362627788775,4140.07821218277,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_106,1.0921241531240946,0.0828954639977938,6,0.03384193146430802,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,1.1935006870662606,0.050916604216375685,6,0.020786616627560494,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,3048.2746230712073,3331.23102038816,94.45766819026072,58.01841831265024,0.03305625497001147,0.6611250994002293,3142.732291261468,3389.24943870081,4140.07821218277,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_106,1.2905742812898235,0.14175787378091756,6,0.05787240963085167,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,3048.2746230712073,3602.177297874595,94.45766819026072,161.53016774610413,0.017989011428632008,0.4137472628585362,3142.732291261468,3763.707465620699,4140.07821218277,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,1.1714892246649407,0.06524259657618818,6,0.02663517851765231,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,3142.0307590794428,3269.793882437594,122.65714274649028,74.3425905599447,0.39831813295007445,1,3264.687901825933,3344.136472997539,3942.614268793971,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_106,1.1257147423260012,0.10764314804102171,6,0.04394513116789564,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,1.103549289772143,0.07589212704274004,6,0.03098283112486493,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,3142.0307590794428,3080.163812601301,122.65714274649028,86.47751045397412,0.6898283458303673,1,3264.687901825933,3166.641323055275,3942.614268793971,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_106,1.239052820825412,0.11041995135120788,6,0.04507875637223355,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,3142.0307590794428,3458.373537076909,122.65714274649028,125.82125273579159,0.1020189935585345,1,3264.687901825933,3584.1947898127005,3942.614268793971,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,1.1491998331782027,0.046448569271412235,6,0.018962548999546365,leaf_1_panK4-1,1,967514 MM WT,leaf,*,2791.14294318225,3207.581004681559,88.36063606348887,52.927184824831464,0.0035528097932636714,0.08526743503832812,2879.503579245739,3260.5081895063904,3948.9989116248203,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_106,1,0.07754474640290068,6,0.031657510153438,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,1.194584908189056,0.22443739538757745,6,0.0916261829831406,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,2791.14294318225,3334.2572365239,88.36063606348887,255.74177404411842,0.09013990875172093,1,2879.503579245739,3589.999010568018,3948.9989116248203,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_106,1.1818434980396644,0.13696995161964137,6,0.05591774859363662,leaf_1_log2-1,1,967514 MM WT,leaf,*,2791.14294318225,3298.6941394992346,88.36063606348887,156.07442938576804,0.022416305248363414,0.4707424102156317,2879.503579245739,3454.7685688850024,3948.9989116248203,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,1.2677914682922728,0.06730468742302381,6,0.027477023580654136,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,3386.8925656611377,3538.5872101506407,131.9761013273769,76.69230046679503,0.3493164318432227,1,3518.8686669885146,3615.279510617436,4387.345116995949,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_106,1.2134428922510359,0.11582140831717863,6,0.04728389194460523,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,1.3372275459595764,0.22475381931579344,6,0.09175536251089664,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,3386.8925656611377,3732.3932283339896,131.9761013273769,256.10233257141834,0.26705024545156075,1,3518.8686669885146,3988.4955609054077,4387.345116995949,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_106,1.2596139313627681,0.0647857026332562,6,0.026448652346527032,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,3386.8925656611377,3515.7625356572407,131.9761013273769,73.82196935368961,0.4193397445767716,1,3518.8686669885146,3589.58450501093,4387.345116995949,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,2.5382564939703736,0.6791857503908977,6,0.2772764215045,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,108.24606877291988,63.444511443884345,64.5757058588266,6.9306104954525045,0.5274352638218521,1,172.82177463174648,70.37512193933685,190.10395209492114,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.8,967514 MM WT,MoneyMaker,m_18,4.330654941722502,5.776910147926779,5,2.5835127581345287,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,4.452217726894259,3.0245727215188487,6,1.2347766429437037,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,108.24606877291988,111.28456844121622,64.5757058588266,30.863626682322707,0.9675620313218506,1,172.82177463174648,142.14819512353893,190.10395209492114,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_18,2.1432486981496597,0.8885935448524476,5,0.3973911141315162,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,108.24606877291988,53.571168587516844,64.5757058588266,9.932914639677547,0.4477712149776795,1,172.82177463174648,63.50408322719439,190.10395209492114,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,1.5514089112803322,1.2433819102256876,6,0.5076085392433294,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,67.97713571873399,38.77794882419713,15.908678749835968,12.687833500491271,0.1833003079189355,1,83.88581446856996,51.465782324688405,174.707600053773,1,24,4.166666666666666,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.6,967514 MM WT,MoneyMaker,m_18,2.719595474104862,1.5590182021518446,6,0.6364665158305358,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,4.629622034153753,3.202511396774268,6,1.307419802924133,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,67.97713571873399,115.71884434235403,15.908678749835968,32.67936508608391,0.22907513583472378,1,83.88581446856996,148.39820942843795,174.707600053773,1,24,4.166666666666666,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_18,5.479776774868701,2.141879289363151,6,0.8744185582624603,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,67.97713571873399,136.96872681266026,15.908678749835968,21.856364145315187,0.03073483065465025,0.6454314437476553,83.88581446856996,158.82509095797545,174.707600053773,1,24,4.166666666666666,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,1.5174601135170378,2.02209949816102,6,0.8255186632720718,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,24.995311385825953,37.929388052929156,4.772066212052826,20.634096043296243,0.5656274747058303,1,29.767377597878777,58.563484096225395,64.41983250584794,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,1,967514 MM WT,MoneyMaker,m_18,1,0.4269066417524625,5,0.1909184542009312,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,1.289039298571422,0.8202153381087164,6,0.3348515095951229,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,24.995311385825953,32.21993865635937,4.772066212052826,8.369717750343982,0.4754668662698921,1,29.767377597878777,40.58965640670335,64.41983250584794,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_18,1.4825487981076613,0.9809150033570144,6,0.4004568732108556,fruit_1_log2-1,1,967514 MM WT,fruit,ns,24.995311385825953,37.056768853383005,4.772066212052826,10.00954424249956,0.3123880185256883,1,29.767377597878777,47.06631309588256,64.41983250584794,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,2.9949086248930143,4.92701362441336,6,2.011444889258916,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,97.14629652433442,74.85867365129671,18.2872094185139,50.276691342454804,0.6908534460157998,1,115.43350594284831,125.13536499375152,245.34295576740263,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.4,967514 MM WT,MoneyMaker,m_18,3.886580768080489,1.6359645514062175,5,0.7316255891448503,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,4.63657750114234,7.033224285188424,6,2.8713017908770992,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,97.14629652433442,115.89269840556757,18.2872094185139,71.7690823456528,0.8091484380628899,1,115.43350594284831,187.66178075122036,245.34295576740263,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_18,7.161676908271853,4.314919780744111,6,1.76155862397749,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,97.14629652433442,179.00834436693427,18.2872094185139,44.03070633070446,0.1320875019609627,1,115.43350594284831,223.03905069763874,245.34295576740263,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,1.586854989234495,0.6404494498877509,6,0.2614623930451958,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,734.9367301749817,829.5268275766446,146.4678040846416,136.67919936276448,0.6469946476016077,1,881.4045342596232,966.2060269394091,3228.3801745196097,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.8,967514 MM WT,MoneyMaker,m_18,1.4059075346084575,0.6863167547777642,6,0.28018764185472855,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,4.583525930025933,2.5249711031564694,6,1.030815136334283,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,734.9367301749817,2396.033506302852,146.4678040846416,538.8575614422476,0.026197648179310848,0.5763482599448386,881.4045342596232,2934.8910677450995,3228.3801745196097,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_18,4.337324976081576,2.5257952408222577,6,1.031151589127448,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,734.9367301749817,2267.3322086686385,146.4678040846416,539.0334417968087,0.0351861923122851,0.703723846245702,881.4045342596232,2806.3656504654473,3228.3801745196097,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,2.85960409901077,2.0112771482792886,6,0.8211004574340531,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1157.7489646589358,1494.8551269463458,259.8523857543363,429.2294268839141,0.5200877054047444,1,1417.601350413272,1924.08455383026,6360.0197652730885,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.6,967514 MM WT,MoneyMaker,m_18,2.2147321337601418,1.2176126161426926,6,0.49708826898748615,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,3.7982223259168393,1.5057246441258612,6,0.6147095118736914,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1157.7489646589358,1985.5168479940962,259.8523857543363,321.33877053993285,0.0742631908253869,1,1417.601350413272,2306.855618534029,6360.0197652730885,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_18,9.67624072529283,3.390593256008435,6,1.3842039004237467,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,1157.7489646589358,5058.244972713104,259.8523857543363,723.5911775351577,0.002004581930526935,0.04810996633264644,1417.601350413272,5781.836150248262,6360.0197652730885,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,0.478962989169082,0.4703346493300496,6,0.19201331653491327,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,522.7489803443298,250.37741421080986,245.24219250195205,100.37476543115895,0.34004857350124384,1,767.9911728462819,350.75217964196884,2149.126954031489,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,1,967514 MM WT,MoneyMaker,m_18,0.9999999999999999,1.1491523802408983,6,0.46913949471582583,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,1.382023203885245,1.7102445601956378,6,0.6982044179749904,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,522.7489803443298,722.4512206432156,245.24219250195205,364.9856475683325,0.6607738182087062,1,767.9911728462819,1087.4368682115482,2149.126954031489,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_18,3.022835617196923,1.7504574686335177,6,0.7146212690993348,leaf_1_log2-1,1,967514 MM WT,leaf,*,522.7489803443298,1580.1842366382143,245.24219250195205,373.56753975404814,0.043290811705868924,0.8225254224115096,767.9911728462819,1953.7517763922624,2149.126954031489,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,2.2397090377483724,1.523807318273662,6,0.6220917326815462,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,803.7025457024738,1170.8056157509416,209.3827417027884,325.19781893991563,0.3686403975800502,1,1013.0852874052622,1496.0034346908571,2776.9863399178757,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.4,967514 MM WT,MoneyMaker,m_18,1.5374540667168448,0.9811226753210883,6,0.4005416549351661,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,1.8032948677412977,2.0677718888394625,6,0.8441643386879436,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,803.7025457024738,942.6705533719263,209.3827417027884,441.2860472921679,0.7840891235930754,1,1013.0852874052622,1383.9566006640941,2776.9863399178757,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_18,4.119425306560727,1.738930988169548,6,0.709915603154854,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,803.7025457024738,2153.4253786092477,209.3827417027884,371.1076576797298,0.013479148794634237,0.31002042227658744,1013.0852874052622,2524.5330362889777,2776.9863399178757,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,1.483850030822346,0.23945321424501118,6,0.09775636536160295,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,4.341760330997487,4.218687095939611,0.9709164685175341,0.2779280308188553,0.9080873721071021,1,5.312676799515021,4.496615126758466,5.843944479466524,4,24,16.666666666666664,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.8,967514 MM WT,MoneyMaker,m_19,1.5271389070724486,0.7636239927030829,5,0.34150303138677934,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,1.208166695892782,0.34678256811172525,6,0.14157339059427998,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,4.341760330997487,3.434900524874606,0.9709164685175341,0.4025028295464002,0.4251100738652475,1,5.312676799515021,3.837403354421006,5.843944479466524,4,24,16.666666666666664,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_19,1.1525519597111067,0.045981797813464134,5,0.0205636851277114,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,4.341760330997487,3.2767840272500495,0.9709164685175341,0.0584639628609663,0.334655845857804,1,5.312676799515021,3.3352479901110157,5.843944479466524,4,24,16.666666666666664,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,1.3543119057063617,0.7205936937995906,6,0.29418114361272324,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,3.6684167119083524,3.8504013490598172,0.3557387838841327,0.8363771059397168,0.8471992465448855,1,4.024155495792485,4.686778454999534,5.1554563004994884,6,24,25,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.6,967514 MM WT,MoneyMaker,m_19,1.290301965337402,0.30649227780909366,6,0.12512494845593788,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,1.252466104546866,0.3479762542062056,6,0.14206071090170208,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,3.6684167119083524,3.560846772652198,0.3557387838841327,0.4038883145009488,0.8456554896521654,1,4.024155495792485,3.9647350871531466,5.1554563004994884,6,24,25,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_19,1.4681292670354953,0.33450501495311946,6,0.13656110050619996,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,3.6684167119083524,4.173991889585674,0.3557387838841327,0.3882525461104316,0.3598091571892782,1,4.024155495792485,4.562244435696105,5.1554563004994884,6,24,25,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,1.2440009221510318,0.3465385229791733,6,0.14147375958611963,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,2.8430683750443606,3.5367796802936198,0.18322507822913692,0.40221957177792567,0.16101916438718078,1,3.0262934532734977,3.9389992520715453,4.3328991772787004,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,1,967514 MM WT,MoneyMaker,m_19,1,0.14410618249611196,5,0.06444624400785932,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,1.0671375689420555,0.26618388391857006,6,0.1086691155587876,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,2.8430683750443606,3.0339450740808793,0.18322507822913692,0.30895372578923014,0.609734509635809,1,3.0262934532734977,3.3428987998701096,4.3328991772787004,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_19,0.9585033435238548,0.08719782295583424,6,0.03559836215388992,fruit_1_log2-1,1,967514 MM WT,fruit,ns,2.8430683750443606,2.7250905433469526,0.18322507822913692,0.10120857764310047,0.5923693208995906,1,3.0262934532734977,2.826299120990053,4.3328991772787004,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,1.5117870398018163,0.499365205703116,6,0.20386499154543242,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,3.6030854327723314,4.298113922662474,0.40343767843115913,0.579602110241505,0.35214199153139536,1,4.0065231112034905,4.8777160329039795,6.789064830349588,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.4,967514 MM WT,MoneyMaker,m_19,1.2673228207943161,0.3173029820792463,5,0.14190220747851845,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,1.7840334984786723,0.9475048935803324,6,0.3868172530103152,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,3.6030854327723314,5.072129219544465,0.40343767843115913,1.0997478989551601,0.25438010217299173,1,4.0065231112034905,6.171877118499625,6.789064830349588,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_19,1.4290004672627323,0.4789124498194211,6,0.19551518892063927,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,3.6030854327723314,4.062746036398289,0.40343767843115913,0.5558630504610932,0.5207938425195873,1,4.0065231112034905,4.618609086859382,6.789064830349588,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,1.0480946545702121,0.1946234683696813,6,0.07945469824607011,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1627.0311167099667,1856.9663128233233,159.9667287159492,140.77421098860353,0.3062981852843694,1,1786.9978454259158,1997.7405238119268,3966.2482176039284,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.8,967514 MM WT,MoneyMaker,m_19,0.9183163983467288,0.22115754972315446,6,0.0902871915976546,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,1.5887840914306681,0.5522413413491413,6,0.22545158352925757,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,1627.0311167099667,2814.9352000523145,159.9667287159492,399.4448344536033,0.029938277940649093,0.5987655588129819,1786.9978454259158,3214.3800345059176,3966.2482176039284,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_19,1.757263980609201,0.6805327338336049,6,0.27782632519226835,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,1627.0311167099667,3113.440184529157,159.9667287159492,492.24001329259613,0.02812505301490916,0.5906261133130923,1786.9978454259158,3605.6801978217527,3966.2482176039284,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,1.433112562721875,0.47104896924903417,6,0.192304936420683,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1734.7229038168994,2539.123484557517,133.37182282426986,340.71711668949916,0.06682876370417058,1,1868.0947266411692,2879.840601247016,5959.67264963079,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.6,967514 MM WT,MoneyMaker,m_19,0.9790989691604558,0.18438950258401665,6,0.07527669920940686,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,1.3584566232192778,0.2883428095392081,6,0.11771545906192897,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,1734.7229038168994,2406.8514954733364,133.37182282426986,208.56288220091426,0.025029276074754286,0.5506440736445943,1868.0947266411692,2615.4143776742508,5959.67264963079,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_19,2.833182200290865,0.5504943466523804,6,0.22473837593085552,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,1734.7229038168994,5019.703021182,133.37182282426986,398.18120575508146,2.1087610722300595e-4,0.005061026573352143,1868.0947266411692,5417.884226937082,5959.67264963079,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,0.8755216271195762,0.3222490599306702,6,0.13155762782028307,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1771.7543971110147,1551.2092926148991,368.4154353380637,233.0878055640809,0.625868804941297,1,2140.1698324490785,1784.29709817898,4210.725661524045,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,1,967514 MM WT,MoneyMaker,m_19,1,0.5093425089928204,6,0.20793820855689374,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,1.0414009168256224,0.6799260479034965,6,0.2775786466984531,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1771.7543971110147,1845.1066535412383,368.4154353380637,491.8011878321092,0.907529171741791,1,2140.1698324490785,2336.9078413733473,4210.725661524045,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_19,1.815579063445658,0.8449591615978929,6,0.34495313323411875,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1771.7543971110147,3216.760188962542,368.4154353380637,611.1722306047716,0.07656515831343198,1,2140.1698324490785,3827.9324195673134,4210.725661524045,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,1.0225106543757385,0.36002903429209016,6,0.14698123776710134,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1334.356469548242,1811.6377479830755,144.5607574779614,260.41465430668137,0.1486237278884838,1,1478.9172270262036,2072.052402289757,3198.7561261777087,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.4,967514 MM WT,MoneyMaker,m_19,0.7531272233465405,0.19985845285815074,6,0.0815918717140926,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,0.9685970308693646,0.5826229080311925,6,0.23785480618881885,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1334.356469548242,1716.1160484714699,144.5607574779614,421.420298739028,0.4235872734572925,1,1478.9172270262036,2137.5363472104978,3198.7561261777087,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_19,1.493432403689515,0.36217198842309534,6,0.14785609512762668,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,1334.356469548242,2645.9954280249704,144.5607574779614,261.96468668203704,0.0024936836767384895,0.057354724564985256,1478.9172270262036,2907.9601147070075,3198.7561261777087,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,1.401863647566648,1.9001123064493477,6,0.775717600797294,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,94.07329888858635,449.0121212004132,4.328923628781142,248.45968863739222,0.21252791796891904,1,98.40222251736749,697.4718098378055,767.2189908215861,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.8,967514 MM WT,MoneyMaker,m_35,0.2937068548751236,0.03022126472572483,5,0.01351536045854745,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.6924398430849451,0.6089813057264295,6,0.24861557698726597,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,94.07329888858635,221.78610829015798,4.328923628781142,79.63071713877916,0.16983544048599933,1,98.40222251736749,301.41682542893716,767.2189908215861,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_35,0.4914056057772072,0.34565574577556535,5,0.15458194887350996,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,94.07329888858635,157.39553115796718,4.328923628781142,49.512068369465766,0.2706680112198502,1,98.40222251736749,206.90759952743295,767.2189908215861,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,2.326195425378448,3.1849956069015484,6,1.300269011652471,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,329.90779525640346,745.072421336339,111.41750980566233,416.4717075492064,0.374525478764085,1,441.3253050620658,1161.5441288855454,1277.6985417741,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.6,967514 MM WT,MoneyMaker,m_35,1.0300072612346818,0.8520729567710602,6,0.3478573279522744,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.8602414290221019,1.1312997443268344,6,0.4618511866236355,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,329.90779525640346,275.53238109865816,111.41750980566233,147.9293520056467,0.7755067721463984,1,441.3253050620658,423.46173310430487,1277.6985417741,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_35,0.6547399402009539,0.6122463675113459,6,0.24994853287921698,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,329.90779525640346,209.71095861895174,111.41750980566233,80.05765834204838,0.4035723388257356,1,441.3253050620658,289.76861696100013,1277.6985417741,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.41095490552456543,0.35018962289092304,6,0.14296431488340422,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,320.29657233769314,131.6274476248788,101.45045586672117,45.790980023761016,0.14443894795358317,1,421.7470282044143,177.41842764863983,646.1044071617212,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,1,967514 MM WT,MoneyMaker,m_35,1,0.7082502132653472,5,0.31673912438800794,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,1.0840107195966087,1.8366607148423373,6,0.7498135969965208,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,320.29657233769314,347.20491786411,101.45045586672117,240.16272501018204,0.9208260305165519,1,421.7470282044143,587.367642874292,646.1044071617212,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_35,1.1026634712014292,1.2310780878525434,6,0.5025855247933222,fruit_1_log2-1,1,967514 MM WT,fruit,ns,320.29657233769314,353.17933026780037,101.45045586672117,160.9764208978418,0.8670105390679266,1,421.7470282044143,514.1557511656422,646.1044071617212,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.6534727131205387,0.6354201509298321,6,0.25940919034339377,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,365.27598513085104,209.3050701287212,169.3903988005318,83.08787449988523,0.44064496205766474,1,534.6663839313828,292.3929446286064,588.1330223245211,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.4,967514 MM WT,MoneyMaker,m_35,1.1404305155839616,1.182555416342224,5,0.5288548596203557,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.46848302205043796,0.26632304596567324,6,0.10872592822661492,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,365.27598513085104,150.0535061611592,169.3903988005318,34.824542135218806,0.2762922288020499,1,534.6663839313828,184.87804829637798,588.1330223245211,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_35,0.445540073701354,0.3146986510172935,6,0.1284751862890939,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,365.27598513085104,142.70495844562686,169.3903988005318,41.15016179884337,0.2639195719639041,1,534.6663839313828,183.85512024447024,588.1330223245211,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,1.7574141470354938,0.7573083933315203,6,0.309169856931528,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,7012.146275150198,11070.867531772095,1318.7324874291292,1947.622042692449,0.11931301645355649,1,8330.878762579327,13018.489574464544,17160.97752675095,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.8,967514 MM WT,MoneyMaker,m_35,1.1131237032386965,0.5127725808177951,6,0.2093385295156079,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,2.055202046465348,1.0320134699354035,6,0.42131773483680784,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,7012.146275150198,12946.788692822132,1318.7324874291292,2654.0999678605504,0.08348727689192975,1,8330.878762579327,15600.888660682682,17160.97752675095,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_35,2.1659899229179165,0.6189135711951236,6,0.2526704073852936,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,7012.146275150198,13644.699260118792,1318.7324874291292,1591.7025671382507,0.00975684683049808,0.22440747710145584,8330.878762579327,15236.401827257043,17160.97752675095,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,4.239669471020426,1.5024066449191333,6,0.6133549443697843,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,12254.879383219153,26707.887364706323,4507.50010756636,3863.8424246952313,0.03570995150663932,0.785618933146065,16762.37949078551,30571.729789401554,42289.498368506815,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.6,967514 MM WT,MoneyMaker,m_35,1.9453668230131531,1.7526848585486952,6,0.7155305972244024,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,2.496098183637332,1.2796103484320807,6,0.522398737207265,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,12254.879383219153,15724.2232196437,4507.50010756636,3290.8618768902215,0.5493519438141943,1,16762.37949078551,19015.08509653392,42289.498368506815,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_35,5.570721030267156,1.3034312575125568,6,0.5321235826166646,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,12254.879383219153,35092.874770911396,4507.50010756636,3352.1237459129757,0.0026709124075320035,0.06410189778076808,16762.37949078551,38444.99851682437,42289.498368506815,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,1.0076002135780633,0.4568007119577347,6,0.1864881097394207,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,6299.521117687065,6347.398823621008,2050.112006089729,1174.7857855010236,0.9843322997278974,1,8349.633123776795,7522.184609122031,16792.13967152622,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,1,967514 MM WT,MoneyMaker,m_35,1,0.7971603295961671,6,0.32543934178324485,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,1.1277506532802688,0.6043136617805998,6,0.246710019325887,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,6299.521117687065,7104.289055824436,2050.112006089729,1554.154976688409,0.7613036749814948,1,8349.633123776795,8658.444032512845,16792.13967152622,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_35,1.8552577918284612,1.3913948962726044,6,0.5680345877634347,leaf_1_log2-1,1,967514 MM WT,leaf,ns,6299.521117687065,11687.235638376864,2050.112006089729,3578.345881192424,0.22787665500772408,1,8349.633123776795,15265.581519569289,16792.13967152622,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,1.1438183347577875,0.6437153562739869,6,0.2627956937441917,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,5373.772694005134,7205.507754604335,1399.773643027653,1655.4870223787582,0.418446373824115,1,6773.546337032787,8860.994776983092,13829.524832452391,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.4,967514 MM WT,MoneyMaker,m_35,0.8530446352369989,0.5442844173008141,6,0.2222031828891772,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,1.365172839399578,1.544602408987234,6,0.630581292915403,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,5373.772694005134,8599.935131090453,1399.773643027653,3972.360171138994,0.4717311072453384,1,6773.546337032787,12572.295302229446,13829.524832452391,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_35,1.4912717055938853,0.9315781755334457,6,0.38031519759497373,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,5373.772694005134,9394.29760159789,1399.773643027653,2395.8036186268664,0.18512171560772955,1,6773.546337032787,11790.101220224755,13829.524832452391,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,1.7249624995541046,1.2250858805625888,6,0.5001392164110932,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,96.30112079815973,248.12646915914786,19.67178721097577,71.94230476789276,0.09014914604211115,1,115.9729080091355,320.06877392704064,352.07565131974474,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.8,967514 MM WT,MoneyMaker,m_56,0.6694804573038478,0.30579852240911476,5,0.13675725670515468,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.8660660753796484,0.2872320835492309,6,0.117262007075347,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,96.30112079815973,124.57889223564088,19.67178721097577,16.867501635335266,0.3054437785324171,1,115.9729080091355,141.44639387097615,352.07565131974474,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_56,0.9830642832779911,0.3212247762288368,5,0.1436560871409675,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,96.30112079815973,141.4084477948301,19.67178721097577,20.66414642910856,0.15261936564407888,1,115.9729080091355,162.07259422393867,352.07565131974474,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,1.0628623810532107,0.3058749482827523,6,0.12487292473215615,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,130.90708250664247,152.88696993760126,22.294296272382745,17.96229072537822,0.46118074609771065,1,153.20137877902522,170.84926066297948,223.67915049913873,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.6,967514 MM WT,MoneyMaker,m_56,0.91005932988616145,0.37964348888311616,6,0.15498880532226877,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,1.0763403448709625,0.4972392938330314,6,0.20299709165879354,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,130.90708250664247,154.825701692302,22.294296272382745,29.200027024293284,0.5306798911465626,1,153.20137877902522,184.0257287165953,223.67915049913873,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_56,1.1358142152797155,0.6805358477921757,6,0.27782759646053146,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,130.90708250664247,163.3806943229054,22.294296272382745,39.96398794903889,0.4985042731100757,1,153.20137877902522,203.3446822719443,223.67915049913873,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.9811514001674811,0.5519620793848369,6,0.22533757530973872,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,143.84455848940917,141.13328996835693,24.991053148545724,32.41358403150336,0.9486620734136522,1,168.83561163795488,173.54687399986028,385.58141339393893,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,1,967514 MM WT,MoneyMaker,m_56,1,0.38848667100308,5,0.17373652094309663,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,1.204622358161621,0.5960374605777721,6,0.24333127433329763,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,143.84455848940917,173.2783712562293,24.991053148545724,35.001879723138494,0.5117481801559983,1,168.83561163795488,208.2802509793678,385.58141339393893,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_56,1.681533942819202,1.8501550314698347,6,0.7553226286906748,fruit_1_log2-1,1,967514 MM WT,fruit,ns,143.84455848940917,241.8795075897835,24.991053148545724,108.64905004107004,0.4158236413066784,1,168.83561163795488,350.5285576308535,385.58141339393893,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.8623022719761346,0.26263090656171045,6,0.10721861862679284,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,87.62373289528134,124.03748959682152,17.2383892758247,15.422814858215357,0.15155490081686138,1,104.86212217110604,139.46030445503686,289.780507578586,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.4,967514 MM WT,MoneyMaker,m_56,0.6091557012337926,0.2679712784977226,5,0.1198403989476871,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.8685155658442056,0.12090977906508711,6,0.04936121060368519,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,87.62373289528134,124.93123811003915,17.2383892758247,7.100341545789837,0.09807390070371265,1,104.86212217110604,132.03157965582898,289.780507578586,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_56,1.4517802309192058,0.9298730387841357,6,0.37961907843206083,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,87.62373289528134,208.83068634022564,17.2383892758247,54.60613873121618,0.07885762179896255,1,104.86212217110604,263.43682507144183,289.780507578586,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.5971653850769748,0.2967694685198642,6,0.12115562818510378,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,6883.255846302736,3185.736906932534,2250.5967362366555,646.3367868218435,0.16692354067550605,1,9133.852582539392,3832.0736937543775,10047.237840793332,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.8,967514 MM WT,MoneyMaker,m_56,1.2902641517872713,1.0333751859455833,6,0.42187365307006097,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.5275141419763848,0.3573061349319673,6,0.14586961875822602,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,6883.255846302736,2814.163903365561,2250.5967362366555,778.180115075422,0.13692488621023013,1,9133.852582539392,3592.344018440983,10047.237840793332,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_56,0.5231581852313715,0.315891189649388,6,0.1289620381469586,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,6883.255846302736,2790.925898426943,2250.5967362366555,687.9821483039411,0.13332698310832575,1,9133.852582539392,3478.908046730884,10047.237840793332,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.6832471423168547,0.49834718925376287,6,0.20344938807031993,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,3375.8517486721166,3644.9628398243804,944.1624675073523,1085.3546445678742,0.8554168085032284,1,4320.014216179469,4730.317484392254,5930.786381785867,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.6,967514 MM WT,MoneyMaker,m_56,0.6328023525959219,0.4335179420257794,6,0.17698295871743655,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.8390500058750393,0.4203525760490892,6,0.17160822056412164,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,3375.8517486721166,4476.134480121487,944.1624675073523,915.489503320209,0.42235825157900364,1,4320.014216179469,5391.6239834416965,5930.786381785867,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_56,0.49788873876709294,0.33625178149318513,6,0.13727421496002126,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,3375.8517486721166,2656.1193436085805,944.1624675073523,732.3256570069937,0.5611658339743215,1,4320.014216179469,3388.445000615574,5930.786381785867,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.8493149491615605,0.7731176992522929,6,0.3156239790471036,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,5334.764851653101,4530.895538770634,1826.103561159103,1683.779709759383,0.7529265225428408,1,7160.868412812204,6214.675248530017,7876.955254093425,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,1,967514 MM WT,MoneyMaker,m_56,0.9999999999999999,0.8384665616391669,6,0.3423025404003031,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.656822343041213,0.24712456032731359,6,0.10088817928525956,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,5334.764851653101,3503.992749436699,1826.103561159103,538.2147127982793,0.3741917945277138,1,7160.868412812204,4042.2074622349783,7876.955254093425,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_56,0.5382332925345699,0.3166228478794755,6,0.12926073636859564,leaf_1_log2-1,1,967514 MM WT,leaf,ns,5334.764851653101,2871.348051002945,1826.103561159103,689.5756330779817,0.2509998745483685,1,7160.868412812204,3560.9236840809267,7876.955254093425,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.48018243465440746,0.23939655881160649,6,0.09773323587777,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,2808.3753518095696,2561.660374775545,204.20887239730087,521.3838315990491,0.6737814603306469,1,3012.58422420687,3083.044206374594,4162.737100947869,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.4,967514 MM WT,MoneyMaker,m_56,0.5264290798008331,0.09376374633785524,6,0.0382788891499167,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.5909546725127532,0.290049927098562,6,0.11841238688715604,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,2808.3753518095696,3152.6042158412047,204.20887239730087,631.7022395659486,0.6225657933893878,1,3012.58422420687,3784.3064554071534,4162.737100947869,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_56,0.270372693667961,0.1666268700982954,6,0.06802513486297328,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,2808.3753518095696,1442.3747430266092,204.20887239730087,362.89809849595184,0.011421007156993998,0.27410417176785595,3012.58422420687,1805.272841522561,4162.737100947869,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.8813799518902811,0.44970688813129017,6,0.18359206828942293,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,74.00031513509738,49.25650831637655,4.122576308970496,10.260165572321148,0.06296680796501042,1,78.122891444067875,59.516673888697696,85.93518058847467,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.8,967514 MM WT,MoneyMaker,m_121,1.324137589589414,0.16495035351052623,5,0.07376804067243153,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.6977627635408581,0.3177439039369606,6,0.1297184055875781,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,74.00031513509738,38.99493889269521,4.122576308970496,7.249399886970702,0.003232201325729453,0.07757283181750688,78.122891444067875,46.24433877966591,85.93518058847467,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_121,0.9471313936849176,0.5740663951109438,5,0.25673029661326463,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,74.00031513509738,52.93107163339471,4.122576308970496,14.347544396802078,0.22132816146282008,1,78.122891444067875,67.27861603019679,85.93518058847467,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,1.129195046724353,1.0269088666676838,6,0.41923378927926497,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,64.93482240962831,63.105820696853336,24.254840750346407,23.429160810672474,0.9578162886168332,1,89.18966315997471,86.53498150752581,98.1086294759722,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.6,967514 MM WT,MoneyMaker,m_121,1.1619226089636132,1.0630987267285086,6,0.43400823778122316,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,1.0533742375838535,0.4215795634300287,6,0.17210913606481096,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,64.93482240962831,58.86852404859882,24.254840750346407,9.618434222061891,0.8232673131133053,1,89.18966315997471,68.48695827066071,98.1086294759722,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_121,1.1002005618350532,0.439964230879233,6,0.1796146451216952,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,64.93482240962831,61.4854445094714,24.254840750346407,10.037884617417696,0.8993332900464017,1,89.18966315997471,71.5233291268891,98.1086294759722,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,1.6035221771073158,0.7420478758340784,6,0.30293977675160344,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,55.88566907011774,89.61390973641419,7.730736252868524,16.929992111715457,0.11330013582334922,1,63.61640532298627,106.54390184812965,117.19829203294262,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,1,967514 MM WT,MoneyMaker,m_121,1,0.30931815016560565,5,0.1383312820889564,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,1.2913179222593067,0.6956462736284046,6,0.2839964019763529,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,55.88566907011774,72.16616606769566,7.730736252868524,15.871328937954589,0.38648166109407084,1,63.61640532298627,88.03749500565024,117.19829203294262,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_121,1.0101784533489673,0.3160604926337182,6,0.12903115580088184,fruit_1_log2-1,1,967514 MM WT,fruit,ns,55.88566907011774,56.45449874562376,7.730736252868524,7.210992472822886,0.9583029653096882,1,63.61640532298627,63.66549121844665,117.19829203294262,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,1.2442963651754553,0.559089447190694,6,0.22824731103198706,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,65.21821887517287,69.53833488934588,17.62274707207538,12.755753690477864,0.8477870124202405,1,82.84096594724825,82.29408857982374,102.39890602985774,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.4,967514 MM WT,MoneyMaker,m_121,1.1669936132167607,0.7051120807734281,5,0.31533570887314155,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,1.1348638216652693,0.44754473647970305,6,0.18270937357393885,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,65.21821887517287,63.42262397723436,17.62274707207538,10.210835587561663,0.9323844155788252,1,82.84096594724825,73.63345956479603,102.39890602985774,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_121,1.4363029328241843,0.5619564135608986,6,0.2294177451514405,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,65.21821887517287,80.26875038825192,17.62274707207538,12.821164184346014,0.5102386763587133,1,82.84096594724825,93.08991457259793,102.39890602985774,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.8165183264408705,0.6908428620300591,6,0.28203541740293403,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,241.3213959830799,184.87701279683523,46.06274126379117,63.85878158993035,0.49145889237168994,1,287.3841372468711,248.73579438676558,345.0798558757516,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.8,967514 MM WT,MoneyMaker,m_121,1.0658076923766264,0.49832012473982906,6,0.2034383390287742,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.683538758218104,0.2662912200762246,6,0.10871293536165501,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,241.3213959830799,154.76762695708166,46.06274126379117,24.61490708928219,0.13783317542951262,1,287.3841372468711,179.38253404636384,345.0798558757516,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_121,1.0112005601641967,0.9168693185295813,6,0.3743103318684687,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,241.3213959830799,228.95718668867045,46.06274126379117,84.75177319837643,0.9012846248251606,1,287.3841372468711,313.7089598870469,345.0798558757516,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,1.9217812566279715,0.8777376502998223,6,0.3583348952106705,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,356.8455840460558,435.13190882440864,154.9667482103202,81.1345965695397,0.6670384989577067,1,511.812332256376,516.2665053939484,567.8931559333432,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.6,967514 MM WT,MoneyMaker,m_121,1.5760258924309503,1.676475328649093,6,0.6844181869258352,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,1.5079543524385448,0.8714997906387032,6,0.3557882996678651,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,356.8455840460558,341.43274815156644,154.9667482103202,80.55799349584288,0.9319849788037394,1,511.812332256376,421.9907416474093,567.8931559333432,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_121,0.6350164376953071,0.2609100795658066,6,0.10651609394753103,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,356.8455840460558,143.78114768070392,154.9667482103202,24.117495745189075,0.2298296658986675,1,511.812332256376,167.898643425893,567.8931559333432,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.9699305986960969,0.5018370627663526,6,0.20487412296576982,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,226.42114305345407,219.6127948392913,33.459458506198885,46.387833103983496,0.9078350505980478,1,259.880601559653,266.0006279432748,292.60069073760235,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,1,967514 MM WT,MoneyMaker,m_121,1,0.3619741482828948,6,0.14777532722860467,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.6021212507095238,0.15818721390628612,6,0.06457965965048273,leaf_1_transp1-1,1,967514 MM WT,leaf,*,226.42114305345407,136.3329818424258,33.459458506198885,14.622200356065328,0.04378121998582511,1,259.880601559653,150.95518219849112,292.60069073760235,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_121,0.9305404173636952,0.3767004526561253,6,0.15378731581382651,leaf_1_log2-1,1,967514 MM WT,leaf,ns,226.42114305345407,210.6940249569261,33.459458506198885,34.82069983368914,0.7513935839309442,1,259.880601559653,245.51472479061525,292.60069073760235,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,5.976797418461256,2.288783118236963,6,0.9343917952627898,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1533.1103657664225,1353.2733032869312,682.8772244435252,211.5660583431699,0.8098457513359103,1,2215.9875902099475,1564.8393616301012,2437.5863492309422,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.4,967514 MM WT,MoneyMaker,m_121,6.77105655899141,7.387564316198889,6,3.015960502780034,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,7.777637080985778,2.4778841669846794,6,1.0115919751389688,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1533.1103657664225,1761.02147813173,682.8772244435252,229.04581131466665,0.7622094092429053,1,2215.9875902099475,1990.0672894463967,2437.5863492309422,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_121,5.49052575665189,2.544576946112301,6,1.0388191882041042,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1533.1103657664225,1243.1711177855518,682.8772244435252,235.21062801903452,0.7016327133007619,1,2215.9875902099475,1478.3817458045864,2437.5863492309422,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.9385840601986186,0.17324868054775824,6,0.07072847765874223,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,1802.943737311288,1717.2799964713888,158.8627269626688,129.40833433558274,0.6866430811393054,1,1961.8064642739569,1846.6883308069716,2323.3340028316775,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.8,967514 MM WT,MoneyMaker,m_23,0.9854038111154891,0.19415075270726814,5,0.08682685618724058,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,1.0149033066068542,0.3416612672258119,6,0.13948262826265478,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,1802.943737311288,1856.917478888147,158.8627269626688,255.20434186792338,0.8619159632565498,1,1961.8064642739569,2112.12182075607,2323.3340028316775,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_23,0.903613512021229,0.2201835624470124,5,0.09846908263191793,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,1802.943737311288,1653.2961452668821,158.8627269626688,180.16392249288467,0.5508855141377484,1,1961.8064642739569,1833.4600677597668,2323.3340028316775,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.951377491629854,0.2772422160633858,6,0.1131836607522902,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,1638.301953251459,1740.6874938013984,154.29985892562917,207.08644518870324,0.7007637296932856,1,1792.6018121770883,1947.7739389901017,2305.123703258642,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.6,967514 MM WT,MoneyMaker,m_23,0.8954183955287811,0.20657283864150677,6,0.08433300823166257,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.9738185308478172,0.3091918238763972,6,0.12622703352294298,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,1638.301953251459,1781.7467333338525,154.29985892562917,230.95124760269442,0.6183797136733876,1,1792.6018121770883,2012.6979809365469,2305.123703258642,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_23,1.039418723928139,0.25944782293661595,6,0.1059191301784445,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,1638.301953251459,1901.772103589616,154.29985892562917,193.79489937278552,0.31374537662097013,1,1792.6018121770883,2095.5670029624016,2305.123703258642,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,1.1379316430527375,0.3293640249026518,6,0.13446230010680482,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,1829.6496491832456,2082.0162315059556,383.2399950747661,246.01890021878773,0.5966721601492437,1,2212.8896442580117,2328.035131724743,2560.838644897218,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,1,967514 MM WT,MoneyMaker,m_23,1,0.46836872898940185,5,0.20946086331109579,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,1.0555259697705976,0.2954905670638903,6,0.1206335188520307,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,1829.6496491832456,1931.242720294579,383.2399950747661,220.7170754473584,0.8253512479763664,1,2212.8896442580117,2151.9597957419373,2560.838644897218,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_23,1.1263198372593637,0.3400501352216118,6,0.1388248863762285,fruit_1_log2-1,1,967514 MM WT,fruit,ns,1829.6496491832456,2060.7706951097252,383.2399950747661,254.00090465617035,0.630238036838463,1,2212.8896442580117,2314.7715997658956,2560.838644897218,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,1.6280283775698188,0.6405143979610092,6,0.26148890798507246,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,1837.7951123566618,2978.7215498809874,391.34909213920616,478.43308876019785,0.09825017684840574,1,2229.144204495868,3457.154638641185,3802.8701025053037,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.4,967514 MM WT,MoneyMaker,m_23,1.0044519250868889,0.47827909203640717,5,0.21389291240205693,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,1.3562555966952765,0.14531357580630985,6,0.05932401890411697,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,1837.7951123566618,2481.472576696326,391.34909213920616,108.54217037605787,0.17862913111934636,1,2229.144204495868,2590.014747072384,3802.8701025053037,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_23,0.8245003090860554,0.23254174794157412,6,0.09493477105862617,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,1837.7951123566618,1508.5467012707788,391.34909213920616,173.6973705627071,0.47330144010785113,1,2229.144204495868,1682.244071833486,3802.8701025053037,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,1.543076881327158,0.363582242881225,6,0.14843182909927713,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,116150.89887372612,148496.7620948546,16824.732969924407,14284.217643194846,0.1742786964965653,1,132975.63184365054,162780.97973804944,179059.0777118544,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.8,967514 MM WT,MoneyMaker,m_23,1.2069607732115375,0.4282470557284665,6,0.17483112839732914,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,1.2270403040137228,0.26465186611902325,6,0.1080436719111624,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,116150.89887372612,118083.23636422363,16824.732969924407,10397.495833031524,0.924479769296011,1,132975.63184365054,128480.73219725516,179059.0777118544,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_23,0.9817783192134633,0.25661415126972303,6,0.10476228856469959,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,116150.89887372612,94480.64659794339,16824.732969924407,10081.714546928255,0.3006658870036329,1,132975.63184365054,104562.36114487164,179059.0777118544,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,1.6808679980218566,0.4300792144026989,6,0.17557910404394306,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,177379.52939365336,161756.97934144997,19620.53949782072,16896.71380444539,0.5600057683676591,1,197000.06889147407,178653.69314589538,253882.68134285384,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.6,967514 MM WT,MoneyMaker,m_23,1.8432068630102583,0.49940990366776444,6,0.20388323941308736,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,1.5460465500768095,0.44880928230781125,6,0.18322562224647723,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,177379.52939365336,148782.5457775433,19620.53949782072,17632.570331178587,0.3040605462036061,1,197000.06889147407,166415.11610872188,253882.68134285384,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_23,2.239692225501982,0.3886090850859844,6,0.15864899464507903,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,177379.52939365336,215534.97923578136,19620.53949782072,15267.458348631231,0.1576808464565223,1,197000.06889147407,230802.43758441258,253882.68134285384,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.9335997429194836,0.36192964655444104,6,0.14775715947404075,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,96234.19538703516,89844.22007339937,11404.797842789905,14219.291354658151,0.7335277381520962,1,107638.99322982506,104063.51142805752,136044.5752333686,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,1,967514 MM WT,MoneyMaker,m_23,1,0.290291150895757,6,0.11851086608998011,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.8582410349528575,0.25686862772231345,6,0.10486617814143293,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,96234.19538703516,82592.13544682456,11404.797842789905,10091.712276754291,0.3917094914561128,1,107638.99322982506,92683.84772357885,136044.5752333686,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_23,1.1378065415808467,0.3609547342567751,6,0.14735915319516643,leaf_1_log2-1,1,967514 MM WT,leaf,ns,96234.19538703516,109495.89703513795,11404.797842789905,14180.98954065169,0.4836283986240024,1,107638.99322982506,123676.88657578964,136044.5752333686,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,2.2268803085839854,0.32648726564414915,6,0.13328786805744502,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,182892.4575613467,214302.03471981242,11238.670923466163,12826.850737361528,0.09583514880988692,1,194131.12848481286,227128.88545717395,297213.82411225967,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.4,967514 MM WT,MoneyMaker,m_23,1.9004934454513691,0.2860626520420274,6,0.11678458866171659,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,1.947116619534477,0.5159497143167288,6,0.21063558883512304,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,182892.4575613467,187379.20120562424,11238.670923466163,20270.346411422433,0.85144352769794,1,194131.12848481286,207649.5476170467,297213.82411225967,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_23,2.6630944413782833,0.35414963953333484,6,0.14458098490787727,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,182892.4575613467,256280.750805725,11238.670923466163,13913.634750874646,0.0023366646639368196,0.056079951934483674,194131.12848481286,270194.38555659965,297213.82411225967,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,1.4049214636462317,0.2971847578687409,6,0.12132516935183053,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,11263.780275552652,7175.715990872219,3245.36950959722,619.6751778236279,0.2793508505328331,1,14509.149785149872,7795.391168695846,15960.064763664861,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.8,967514 MM WT,MoneyMaker,m_82,2.205316750418862,1.4208098521563524,5,0.6354054825046059,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,1.0826705742646099,0.34678623035429507,6,0.14157488569854837,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,11263.780275552652,5529.801311764739,3245.36950959722,723.1017515928497,0.15318096507847492,1,14509.149785149872,6252.9030633575885,15960.064763664861,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_82,1.3139670810207371,0.46053911481719195,5,0.20595935340576435,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,11263.780275552652,6711.161327331242,3245.36950959722,1051.9490690019038,0.24148785866428382,1,14509.149785149872,7763.110396333146,15960.064763664861,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,1.2818786265910551,0.3533196552816375,6,0.14424214525600992,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,5901.959480872984,6547.26772791548,379.1511391577789,736.7249309331455,0.46002308806590786,1,6281.110620030763,7283.992658848625,8012.391924733488,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.6,967514 MM WT,MoneyMaker,m_82,1.1555348013767959,0.1818338760671356,6,0.07423336905282606,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.9016665832086237,0.12196972568016178,6,0.04979393199727238,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,5901.959480872984,4605.313170156286,379.1511391577789,254.325329441478,0.019960048320171512,0.45908111136394475,6281.110620030763,4859.638499597764,8012.391924733488,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_82,1.063286884050331,0.1672292026281647,6,0.06827103608858319,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,5901.959480872984,5430.7980155436635,379.1511391577789,348.6981856642908,0.38203808099992265,1,6281.110620030763,5779.496201207954,8012.391924733488,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,1.365084304265087,0.15281912754675192,6,0.062388147571140515,fruit_1_panK4-1,1,967514 MM WT,fruit,*,5107.556668860965,6972.245441806576,487.73998169621524,318.6509991848608,0.014747150504198229,0.3539316121007575,5595.29665055718,7290.896440991437,8019.986085090582,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,1,967514 MM WT,MoneyMaker,m_82,1,0.21353062239453513,5,0.0954937973904039,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,1.276909542499063,0.23253668658497584,6,0.0949327047684475,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,5107.556668860965,6521.887849323294,487.73998169621524,484.8741693330931,0.07030775443156462,1,5595.29665055718,7006.762018656387,8019.986085090582,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_82,1.150360841943966,0.2289818781738227,6,0.09348146031166768,fruit_1_log2-1,1,967514 MM WT,fruit,ns,5107.556668860965,5875.5331898674185,487.73998169621524,477.4618560297199,0.29012549564748724,1,5595.29665055718,6352.995045897138,8019.986085090582,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,1.042748960780543,0.45308550450334056,6,0.1849713826474457,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,7767.503126167148,5325.899408582503,1553.0036496291218,944.7518189893949,0.22251470630320427,1,9320.50677579627,6270.651227571898,10252.557453375897,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.4,967514 MM WT,MoneyMaker,m_82,1.5207864796729464,0.6798988156210533,5,0.30405999391005417,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.8297953592979093,0.2960215680822686,6,0.1208502991100182,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,7767.503126167148,4238.226821171917,1553.0036496291218,617.2497511532157,0.08568403411808588,1,9320.50677579627,4855.476572325133,10252.557453375897,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_82,1.182896123900331,0.2880222653028514,6,0.11758459742541831,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,7767.503126167148,6041.708986196922,1553.0036496291218,600.5699947355271,0.34581928583185145,1,9320.50677579627,6642.278980932449,10252.557453375897,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.6334443589344552,0.1989784114262131,6,0.08123259630396669,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,112267.5825168915,114229.4351355467,39829.72227532762,14648.727168404952,0.9645526188072201,1,152097.30479221913,128878.16230395164,444130.16820647917,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.8,967514 MM WT,MoneyMaker,m_82,0.6225651624044777,0.5410200336712869,6,0.22087050385300452,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.6218712023597358,0.25122853849939625,6,0.10256362135811332,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,112267.5825168915,112142.4402485937,39829.72227532762,18495.364853988154,0.9978051346287026,1,152097.30479221913,130637.80510258186,444130.16820647917,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_82,1.5565116773625447,1.6716716095399717,6,0.6824570768116679,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,112267.5825168915,280686.7677945544,39829.72227532762,123067.93057497208,0.240386977722501,1,152097.30479221913,403754.6983695265,444130.16820647917,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,1.0793313881127082,0.5347848261146995,6,0.21832499102734032,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,87315.25067000066,194636.53444727827,13465.145853155334,39370.68828425219,0.04087260070350426,0.8991972154770936,100780.396523156,234007.22273153046,257407.94500468354,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.6,967514 MM WT,MoneyMaker,m_82,0.4841952769899348,0.18290144260874,6,0.07466920126839247,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.46523155024885865,0.10960280338103803,6,0.044745157110355684,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,87315.25067000066,83895.50943599254,13465.145853155334,8068.923417938428,0.832881974740344,1,100780.396523156,91964.43285393096,257407.94500468354,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_82,0.7749709204459488,0.2788381834090389,6,0.11383521169278922,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,87315.25067000066,139751.01244555466,13465.145853155334,20527.978103832476,0.062718735155603,1,100780.396523156,160278.99054938715,257407.94500468354,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,1.1352530723226146,0.31269034503179083,6,0.1276552988037841,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,180330.65339424144,204720.9282997571,42015.94977651779,23020.163442523513,0.6248518071808822,1,222346.60317075922,227741.0917422806,373383.580383476,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,1,967514 MM WT,MoneyMaker,m_82,1,0.5707162707710788,6,0.2329939418822041,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,1.5088158620186596,0.9148894344125795,6,0.37350204756238614,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,180330.65339424144,272085.7502494205,42015.94977651779,67353.86828101214,0.27963973697980016,1,222346.60317075922,339439.6185304327,373383.580383476,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_82,1.6287622728954694,0.5859392279315514,6,0.23920868811877166,leaf_1_log2-1,1,967514 MM WT,leaf,ns,180330.65339424144,293715.7648951298,42015.94977651779,43136.659026037414,0.08911274077236653,1,222346.60317075922,336852.4239211672,373383.580383476,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.4615696001458682,0.15733629010891256,6,0.06423227146488995,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,83725.26771891712,83235.14758122317,14228.559815781657,11583.047482259897,0.9792349801472932,1,97953.82753469878,94818.19506348306,176410.76350147603,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.4,967514 MM WT,MoneyMaker,m_82,0.46428749712272016,0.19327114202341728,6,0.078902613327058585,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.6798130056389838,0.5132092040635883,6,0.20951678020927975,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,83725.26771891712,122591.1234927811,14228.559815781657,37782.297872197094,0.3707107418558924,1,97953.82753469878,160373.4213649782,176410.76350147603,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_82,0.5418438887364097,0.13187993705830245,6,0.05383975885053383,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,83725.26771891712,97711.06249351343,14228.559815781657,9708.958892105162,0.4381810358166601,1,97953.82753469878,107420.02138561859,176410.76350147603,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,1.0207773294353542,0.25827950372699127,6,0.10544216585839913,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,851.6485383916953,1023.4767775331366,138.99691959235219,105.72100791909611,0.3544556348880374,1,990.6454579840474,1129.1977854522327,1485.0264178488299,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.8,967514 MM WT,MoneyMaker,m_86,0.8494022919917703,0.309986800034843,5,0.13863031140110862,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.8945836548979331,0.15774769438277628,6,0.06440022655638435,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,851.6485383916953,896.9493835205088,138.99691959235219,64.57053311008747,0.7780230272974432,1,990.6454579840474,961.5199166305963,1485.0264178488299,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_86,1.248137925689775,0.21986220034774412,5,0.09832536513204675,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,851.6485383916953,1251.438629430068,138.99691959235219,98.58538679614101,0.050341628597116383,1,990.6454579840474,1350.024016226209,1485.0264178488299,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.8120277984960302,0.19244036726181815,6,0.07856345095087522,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,899.5523644790958,814.1752079581987,78.6487751004289,78.7712121854844,0.46080474347661327,1,978.2011395795247,892.9464201436831,1379.4563177712798,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.6,967514 MM WT,MoneyMaker,m_86,0.8971797704227834,0.19214124989443437,6,0.07844133679699274,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.8514650268628627,0.2633225094714712,6,0.1075009643323825,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,899.5523644790958,853.7167281701054,78.6487751004289,107.78525089058547,0.7389696602576168,1,978.2011395795247,961.5019790606909,1379.4563177712798,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_86,1.1151455550154554,0.3321460289345386,6,0.13559804849688617,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,899.5523644790958,1118.0945601122892,78.6487751004289,135.9566378616014,0.20153120879045,1,978.2011395795247,1254.0511979738906,1379.4563177712798,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.881476823715799,0.17542409558969138,6,0.07161658713066081,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,1002.6445024002205,883.8078912918543,147.76764900651452,71.80597736722343,0.49735964611672423,1,1150.4121514067351,955.6138686590778,1265.4533665474087,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,1,967514 MM WT,MoneyMaker,m_86,1,0.32954702016807574,5,0.1473779077756623,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.7268035856121821,0.1798982315784804,6,0.07344314549938677,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,1002.6445024002205,728.7256194388224,147.76764900651452,73.63736607393963,0.1486605489248891,1,1150.4121514067351,802.362985512762,1265.4533665474087,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_86,1.041188388151529,0.23173626634352795,6,0.094605934573223735,fruit_1_log2-1,1,967514 MM WT,fruit,ns,1002.6445024002205,1043.9418133430775,147.76764900651452,94.85612019427774,0.8207747687608737,1,1150.4121514067351,1138.7979335373552,1265.4533665474087,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,1.3553328552772586,0.20050430188205284,6,0.08185553847399839,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,1537.280639553939,1358.917036266137,161.57359820951646,82.07200564196422,0.3629529941631315,1,1698.8542377634553,1440.9890419081014,1868.739661539801,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.4,967514 MM WT,MoneyMaker,m_86,1.5332260196648546,0.36033663786200365,5,0.16114744340863293,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,1.0288097827271283,0.3752302665857295,6,0.15318711486392367,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,1537.280639553939,1031.5304726669206,161.57359820951646,153.59221855686417,0.050214526420020875,1,1698.8542377634553,1185.1226912237848,1868.739661539801,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_86,1.1035295869818373,0.4185808782367996,6,0.17088492796103585,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,1537.280639553939,1106.4478736233252,161.57359820951646,171.33683356319034,0.10068335710944692,1,1698.8542377634553,1277.7847071865156,1868.739661539801,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,2.241706728739463,0.43050364549415165,6,0.17575237731144835,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,12061.268311501992,13999.65076073196,1519.0355720136577,1097.588668127083,0.3276862511516498,1,13580.30388351565,15097.239428859044,22235.671071212128,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.8,967514 MM WT,MoneyMaker,m_86,1.9313214874520503,0.5958063984963231,6,0.24323694363355505,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,2.1128422622583964,0.3694502321716761,6,0.15082742569556407,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,12061.268311501992,13194.881116659282,1519.0355720136577,941.9302078222715,0.5429100892413463,1,13580.30388351565,14136.811324481554,22235.671071212128,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_86,2.7744388738975947,1.132608789052343,6,0.46238560189496514,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,12061.268311501992,17326.608692210873,1519.0355720136577,2887.637736163788,0.1473852806074535,1,13580.30388351565,20214.24642837466,22235.671071212128,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,3.036206699429073,0.9771104029649348,6,0.398903651604891,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,20082.392095537383,18961.37121081097,1981.9208477668153,2491.1875126455116,0.7323998230242609,1,22064.312943304198,21452.55872345648,31962.296830553583,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.6,967514 MM WT,MoneyMaker,m_86,3.215711181597832,0.7773623897743116,6,0.3173568666962659,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,4.11584287709505,1.315074254092053,6,0.5368768160661205,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,20082.392095537383,25703.791725591826,1981.9208477668153,3352.8417567296137,0.18640736517027676,1,22064.312943304198,29056.63348232144,31962.296830553583,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_86,3.6756015414001584,0.8353137886564496,6,0.3410154262198881,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,20082.392095537383,22954.446830850713,1981.9208477668153,2129.670580854757,0.34693182799725775,1,22064.312943304198,25084.11741170547,31962.296830553583,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,1.2315820299300022,0.2948820462199645,6,0.12038509125778636,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,6245.085755978491,7691.335392434932,761.5987833058188,751.8152186461723,0.20634325641326223,1,7006.68453928431,8443.150611081104,11443.505886127952,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,1,967514 MM WT,MoneyMaker,m_86,1,0.29871942207324537,6,0.12195169338975557,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,1.3113174062789663,0.19907226890970028,6,0.08127091346114758,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,6245.085755978491,8189.289655519432,761.5987833058188,507.5438240315734,0.0636059954088688,1,7006.68453928431,8696.833479551005,11443.505886127952,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_86,1.5983679758406553,0.16522241970069834,6,0.06745177038911299,leaf_1_log2-1,1,967514 MM WT,leaf,*,6245.085755978491,9981.945078734649,761.5987833058188,421.2420904725812,0.002799998466504023,0.06719996319609656,7006.68453928431,10403.187169207229,11443.505886127952,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,3.0253417388826236,0.6432208814139914,6,0.2625938252279212,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,23734.370934539536,18893.518600463074,1907.6557881676029,1639.9209575387958,0.08387339927300246,1,25642.026722707138,20533.439558001868,37606.21932790922,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.4,967514 MM WT,MoneyMaker,m_86,3.8004875932757782,0.7482336461759864,6,0.30546510691888945,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,4.647534386425913,2.025153561578214,6,0.8267654794411096,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,23734.370934539536,29024.2507970887,1907.6557881676029,5163.221319192401,0.37174049327805647,1,25642.026722707138,34187.472116281104,37606.21932790922,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_86,3.232407432462284,0.7053068056581764,6,0.2879402976624786,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,23734.370934539536,20186.661613989214,1907.6557881676029,1798.2118515041518,0.20586944232816476,1,25642.026722707138,21984.873465493365,37606.21932790922,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,0.6478657736786924,0.3965866083379152,6,0.1619058048748155,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,88.39690434263368,28.88293742130715,50.54491688709364,7.218030987796665,0.3061707596148275,1,138.9418212297273,36.100968409103814,152.83600335270006,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.8,967514 MM WT,MoneyMaker,m_100,1.9828083268460686,2.535164627881094,5,1.133760088419017,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,1.836082582939421,1.8246760236970194,6,0.7449208673247074,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,88.39690434263368,81.85562580697791,50.54491688709364,33.20981547241904,0.9168489224333113,1,138.9418212297273,115.06544127939695,152.83600335270006,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_100,2.0603211490008015,1.851838372339314,5,0.8281672967786544,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,88.39690434263368,91.85255531634046,50.54491688709364,36.921080228408556,0.9574492181228793,1,138.9418212297273,128.77363554474903,152.83600335270006,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,1.0114433970709498,1.002109001653717,6,0.4091092867835785,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,83.48486613860484,45.0918346510506,28.082056048471387,18.23877477205017,0.2825240092259468,1,111.56692218707623,63.33060942310077,122.72361440578386,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.6,967514 MM WT,MoneyMaker,m_100,1.872627655643118,1.5429370395122275,6,0.6299014086742408,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,1.5423105174242018,1.048255714314942,6,0.4279486033380507,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,83.48486613860484,68.75877684669878,28.082056048471387,19.078662945202648,0.6748964985216227,1,111.56692218707623,87.83743979190143,122.72361440578386,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_100,1.5122611321737887,0.8641736403928371,6,0.35279741135430887,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,83.48486613860484,67.41912510246748,28.082056048471387,15.728297385870675,0.6313539728855557,1,111.56692218707623,83.14742248833815,122.72361440578386,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,1.6555328723717246,1.073745450259494,6,0.43835474446178935,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,44.58166891160943,73.80641838836198,14.476930226293128,19.54258608342865,0.26114249457280764,1,59.058599137902554,93.34900447179062,102.68390491896969,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,1,967514 MM WT,MoneyMaker,m_100,1,0.7261145865959961,5,0.32472831501656096,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,1.0901369351474244,0.7683096810617881,6,0.31366111384031087,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,44.58166891160943,48.60012391105911,14.476930226293128,13.983535927675373,0.8462869001335619,1,59.058599137902554,62.58365983873448,102.68390491896969,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_100,0.8533910946510305,0.7321501907929505,6,0.2988990637540132,fruit_1_log2-1,1,967514 MM WT,fruit,ns,44.58166891160943,38.04559923384818,14.476930226293128,13.325419098271455,0.7476400689089457,1,59.058599137902554,51.37101833211963,102.68390491896969,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,3.236307822819653,1.3998794406575057,6,0.5714983885039355,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,77.92037301857388,144.2800038529973,38.92569447048645,25.47835193980079,0.19611513726195814,1,116.84606748906033,169.7583557927981,186.73419137207793,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.4,967514 MM WT,MoneyMaker,m_100,1.7478119352836248,1.9523831438425434,5,0.8731322855513354,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,1.9001026508895118,1.1555325386566138,6,0.4717441834819303,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,77.92037301857388,84.70974728002761,38.92569447048645,21.031142998968946,0.8828759855107007,1,116.84606748906033,105.74089027899656,186.73419137207793,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_100,1.717097391195327,1.5517335795753353,6,0.6334925811170015,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,77.92037301857388,76.55106738325836,38.92569447048645,28.24215650931904,0.9780158459997712,1,116.84606748906033,104.7932238925774,186.73419137207793,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,1.5446518239650429,0.15895665476220697,6,0.06489378256452547,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1994.1315982841727,2383.8363521686238,223.05953150683064,100.14953241044645,0.1553935147501643,1,2217.1911297910033,2483.9858845790704,3180.7840332783994,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.8,967514 MM WT,MoneyMaker,m_100,1.2921352624368774,0.35403856700835157,6,0.14453563973943537,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,1.401514122632333,0.37539530857339165,6,0.1532544929732415,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1994.1315982841727,2162.9342365534153,223.05953150683064,236.51519767412125,0.614941106472408,1,2217.1911297910033,2399.4494342275366,3180.7840332783994,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_100,1.6257202403102335,0.607377421972123,6,0.24796079418646758,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1994.1315982841727,2508.947937121364,223.05953150683064,382.67391131354464,0.27843722314213337,1,2217.1911297910033,2891.6218484349083,3180.7840332783994,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,1.4021346817153642,0.4221646701480687,6,0.17234800488218968,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,2858.9107605398826,2163.891935419818,453.3030072162122,265.9819079533856,0.22224953020141794,1,3312.213767756095,2429.8738433732033,4034.3222633356813,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.6,967514 MM WT,MoneyMaker,m_100,1.8524852667859828,0.7194794412561997,6,0.2937262519167389,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,2.1233581666495622,0.6199912049714763,6,0.2531103495322357,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,2858.9107605398826,3276.94455656688,453.3030072162122,390.6211373746483,0.5010657053322414,1,3312.213767756095,3667.565693941528,4034.3222633356813,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_100,2.040959202055048,0.7218375264058707,6,0.29468893614786035,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,2858.9107605398826,3149.7795578701225,453.3030072162122,454.7887023289891,0.6602307116438246,1,3312.213767756095,3604.5682601991116,4034.3222633356813,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,1.2192861528139007,0.2913471280573027,6,0.11894196696095001,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1543.2839395802719,1881.7047373903101,96.04388884080014,183.56122735292143,0.14326096811028735,1,1639.327828421072,2065.2659647432315,2572.0940901690756,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,1,967514 MM WT,MoneyMaker,m_100,1,0.15244020529140673,6,0.06223345320817713,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,1.2246109580591351,0.25773712007219796,6,0.10522073865855422,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1543.2839395802719,1889.9224238066731,96.04388884080014,162.38547608251977,0.10293009615040699,1,1639.327828421072,2052.307899889193,2572.0940901690756,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_100,1.4199646628891833,0.23309312013632946,6,0.09515986781454436,leaf_1_log2-1,1,967514 MM WT,leaf,*,1543.2839395802719,2191.4086590083916,96.04388884080014,146.85869569076795,0.005359656080961223,0.12863174594306936,1639.327828421072,2338.2673546991596,2572.0940901690756,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,2.1944988841770448,0.3387347648909777,6,0.13828788868742023,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,3954.7303490425847,3386.73488337726,233.98965842981897,213.41747764976003,0.10339368531170845,1,4188.720007472404,3600.1523610270197,4863.706922456715,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.4,967514 MM WT,MoneyMaker,m_100,2.562542282477297,0.37138678991052193,6,0.15161802208183245,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,2.7509885125752107,0.2793386322380015,6,0.11403951907167785,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,3954.7303490425847,4245.556389427144,233.98965842981897,175.99535826077852,0.3457437051284534,1,4188.720007472404,4421.551747687922,4863.706922456715,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_100,2.1777561800368463,0.3365942673780656,6,0.1374140342370317,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,3954.7303490425847,3360.8961369725475,233.98965842981897,212.06887211094465,0.08973974745555882,1,4188.720007472404,3572.965009083492,4863.706922456715,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,2.6991453716441085,0.7382856127057698,6,0.3014038392611962,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,61.95997476126221,210.5093881364922,3.7998057780121006,23.506824957047897,0.0012878423216059233,0.028332531075330313,65.75978053927432,234.0162130935401,257.41783440289413,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.8,967514 MM WT,MoneyMaker,m_24,0.7944490294922647,0.10894347090034562,5,0.0487210013275886,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,1.666601333080852,0.4063996365700658,6,0.1659119568748646,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,61.95997476126221,129.98011540245827,3.7998057780121006,12.939660417394125,0.0025333321373849573,0.0531999748850841,65.75978053927432,142.9197758198524,257.41783440289413,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_24,1.4029543478228814,0.4199723213317411,5,0.18781733183323163,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,61.95997476126221,109.41799002242371,3.7998057780121006,14.648085286921415,0.029442937876721646,0.500529943904268,65.75978053927432,124.06607530934512,257.41783440289413,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,3.3134020052311532,0.7773571393195375,6,0.3173547232070802,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,54.32395707904711,258.4159549533905,4.4543594173889485,24.750852364745075,3.412653715056791e-4,0.007849103544630618,58.77831649643606,283.16680731813557,311.48348804994913,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.6,967514 MM WT,MoneyMaker,m_24,0.696540228525252,0.13989934743155177,6,0.057113669425941045,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,1.198044214400051,0.2997263411778235,6,0.122362766392835,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,54.32395707904711,93.43681788439535,4.4543594173889485,9.543209993300268,0.00736500754704313,0.13993514339381946,58.77831649643606,102.98002787769562,311.48348804994913,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_24,1.0457567199499864,0.29320591391333434,6,0.11970081310901334,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,54.32395707904711,81.55974463954254,4.4543594173889485,9.335601257990138,0.03306987070601995,0.5291179312963192,58.77831649643606,90.89534589753268,311.48348804994913,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,3.3337604679839608,0.36883846007202653,6,0.15057767078172865,fruit_1_panK4-1,1,967514 MM WT,fruit,*,77.99112650544876,260.00373439740116,8.811111109537146,11.743722170833612,7.559641213866526e-7,1.814313891327966e-5,86.80223761498591,271.7474565682348,298.9222022250583,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,1,967514 MM WT,MoneyMaker,m_24,1,0.2526216030082881,5,0.11297581538229952,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,1.5654321742366486,0.6518885081369362,6,0.2661323690199423,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,77.99112650544876,122.08981873659016,8.811111109537146,20.75596325942909,0.09329302330257214,1,86.80223761498591,142.84578199601924,298.9222022250583,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_24,1.0549646894007274,0.30384673812889784,6,0.12404491140414362,fruit_1_log2-1,1,967514 MM WT,fruit,ns,77.99112650544876,82.27788454983359,8.811111109537146,9.67440237767775,0.7507109465063565,1,86.80223761498591,91.95228692751134,298.9222022250583,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,4.006347934330986,1.1912655581414247,6,0.4863321275997163,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,*,126.85249659832706,312.45958857125123,35.66017122925648,37.929590487293524,0.006093656313115968,0.12187312626231936,162.51266782758353,350.38917905854476,385.4280969643993,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.4,967514 MM WT,MoneyMaker,m_24,1.6264990939637813,1.022405631650017,5,0.45723369858960966,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,2.612849045569604,1.780263109524494,6,0.7267893710392557,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,126.85249659832706,203.77904045266,35.66017122925648,56.683121779538126,0.2832828190143607,1,162.51266782758353,260.4621622321981,385.4280969643993,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_24,2.092272460705417,1.7677094639460265,6,0.721664366692757,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,126.85249659832706,163.17868616674272,35.66017122925648,56.28341691720938,0.600174535575278,1,162.51266782758353,219.46210308395212,385.4280969643993,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,1.4372387695928466,0.9355940912947894,6,0.3819546883391892,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,164.1705511120883,158.58177480258354,23.914809484826364,42.14404290537986,0.9110503845565872,1,188.08536059691465,200.72581770796342,220.79839947875976,1,24,4.166666666666666,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.8,967514 MM WT,MoneyMaker,m_24,1.4878902772872316,0.5309066929975986,6,0.21674174981209263,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.7233743707541177,0.3557280730748727,6,0.14522537770282093,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,164.1705511120883,79.81554212692664,23.914809484826364,16.023849780376473,0.01727922999707809,0.31102613994740563,188.08536059691465,95.83939190730311,220.79839947875976,1,24,4.166666666666666,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_24,0.9868725771548261,0.6604263121283002,6,0.26961791290373216,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,164.1705511120883,108.88935652184401,23.914809484826364,29.74904939348016,0.17952780176865696,1,188.08536059691465,138.63840591532417,220.79839947875976,1,24,4.166666666666666,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,2.2835150503682153,1.6341458377276736,6,0.6671372446209601,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,124.48673168765345,251.95804422837,13.249514319334935,73.61046092492198,0.14547384190146787,1,137.73624600698838,325.568505153292,358.12535566862124,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.6,967514 MM WT,MoneyMaker,m_24,1.1282327827654193,0.29413806685625427,6,0.12008136295441126,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,1.441753648685388,0.7061410909980707,6,0.2882808932262495,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,124.48673168765345,159.07993666313308,13.249514319334935,31.80828172513296,0.35035691841805744,1,137.73624600698838,190.88821838826604,358.12535566862124,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_24,0.9547861335802794,0.3831054276838621,6,0.1564021359193638,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,124.48673168765345,105.3490086848621,13.249514319334935,17.25706877781615,0.4010494538219165,1,137.73624600698838,122.60607746267826,358.12535566862124,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,1.1954520398036137,0.6494726491204569,6,0.2651460987064629,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,110.33780757772625,131.90355713625146,19.958833609030098,29.255639219058512,0.5579121157467934,1,130.29664118675635,161.15919635530997,177.275115990841,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,1,967514 MM WT,MoneyMaker,m_24,1,0.4430843722247797,6,0.18088843749202027,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.795429297357113,0.2705116229728,6,0.11043590762925067,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,110.33780757772625,87.76592475347513,19.958833609030098,12.18525592566781,0.36178595717825907,1,130.29664118675635,99.95118067914294,177.275115990841,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_24,0.8646916784624528,0.20556164934760435,6,0.08392019193109154,leaf_1_log2-1,1,967514 MM WT,leaf,ns,110.33780757772625,95.40818403225126,19.958833609030098,9.259569989178633,0.5190457926955925,1,130.29664118675635,104.66775402142989,177.275115990841,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,2.751856926088646,0.562271452159989,6,0.22954635912094926,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,175.71017590561945,303.63385999220225,47.05090752422348,25.327642002854947,0.04485667706864734,0.6728501560297101,222.76108342984293,328.9615019950572,361.85765219456295,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.4,967514 MM WT,MoneyMaker,m_24,1.5924747805220107,1.0445260595561334,6,0.42642597815874667,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,1.8704731609846446,0.8006851315187341,6,0.32687833614235656,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,175.71017590561945,206.3839077160251,47.05090752422348,36.067038954602666,0.6168712237229106,1,222.76108342984293,242.4509466706278,361.85765219456295,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_24,1.6287935495772217,1.6608357539308303,6,0.6780333572835225,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,175.71017590561945,179.7175092570932,47.05090752422348,74.81271410722904,0.9648909765249694,1,222.76108342984293,254.53022336432224,361.85765219456295,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.7907072703185468,0.2970236151471281,6,0.12125938311121143,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,2368.2909674273915,1193.3547125708685,289.930037567337,183.00762078601358,0.011176879227949188,0.2570682222428313,2658.2210049947284,1376.3623333568821,2924.0431054942014,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.8,967514 MM WT,MoneyMaker,m_62,1.5692106181408114,0.429560553715314,5,0.19210531971197836,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.6257379099020135,0.3089381117458034,6,0.12612345597935812,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,2368.2909674273915,944.3789271280945,289.930037567337,190.34859828474393,0.004363938372509473,0.10473452094022737,2658.2210049947284,1134.7275254128383,2924.0431054942014,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_62,0.7795809604642783,0.9894072777856376,5,0.44247638611234064,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,2368.2909674273915,1176.5626141590683,289.930037567337,667.7961622330406,0.15766529007512048,1,2658.2210049947284,1844.358776392109,2924.0431054942014,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,2.0428238078910503,0.8007075517973921,6,0.32688748918279037,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,3517.4773189678635,3083.079553722386,614.7289900191674,493.34657760208495,0.5942087587739868,1,4132.206308987031,3576.426131324471,4545.426939885734,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.6,967514 MM WT,MoneyMaker,m_62,2.3306522863572385,0.9977126972473617,6,0.4073145030253252,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,1.5846473348265864,1.0248900423626643,6,0.4184096077079939,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,3517.4773189678635,2391.5884370411077,614.7289900191674,631.4739928243089,0.23028539494746197,1,4132.206308987031,3023.0624298654166,4545.426939885734,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_62,0.8511332551494414,0.3357012508232621,6,0.13704946175517724,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,3517.4773189678635,1284.5510838027071,614.7289900191674,206.83839289216863,0.013338674619707424,0.29345084163356333,4132.206308987031,1491.3894766948758,4545.426939885734,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.7482602957966045,0.22600809655435347,6,0.0922674190493065,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,1509.2244087879828,1129.2927025431516,343.02165949490484,139.25224096508268,0.349214164095333,1,1852.2460682828878,1268.5449435082342,2037.4706751111767,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,1,967514 MM WT,MoneyMaker,m_62,1,0.5082211392283048,5,0.2272834029833749,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.6864827117880293,0.31952086479458414,6,0.1304438468199241,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,1509.2244087879828,1036.05646484146,343.02165949490484,196.86903759683017,0.2733314283021585,1,1852.2460682828878,1232.92550243829,2037.4706751111767,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_62,0.34785863877809164,0.11215330133597408,6,0.045786393540289905,fruit_1_log2-1,1,967514 MM WT,fruit,*,1509.2244087879828,524.9967484516578,343.02165949490484,69.10194272137795,0.04406323381219912,0.898933499711859,1852.2460682828878,594.0986911730358,2037.4706751111767,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,5.646822619152079,2.3175522924267455,6,0.9461367614438257,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,6585.51598012815,8522.322528920406,380.60415033309636,1427.9326944226345,0.24031679987982885,1,6966.120130461246,9950.25522334304,10945.280745677344,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.4,967514 MM WT,MoneyMaker,m_62,4.363510119357795,0.5639033848828441,5,0.2521852602680533,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,5.442307269734814,1.2004136870385427,6,0.49006683558290776,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,6585.51598012815,8213.662971608066,380.60415033309636,739.6208301992116,0.0891832913153428,1,6966.120130461246,8953.283801807278,10945.280745677344,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_62,3.711265365559214,1.3729518712989477,6,0.5605052543469571,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,6585.51598012815,5601.132277191422,380.60415033309636,845.9282111143443,0.3244360988048615,1,6966.120130461246,6447.060488305766,10945.280745677344,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,1.0992476373698383,0.23316153674106138,6,0.09518779877646551,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1021813.1477660871,1001741.7783475374,29671.126593280867,86744.41643693311,0.8337838307767943,1,1051484.274359368,1088486.1947844706,1266457.5525616622,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.8,967514 MM WT,MoneyMaker,m_62,1.1212726800395307,0.07975343840554558,6,0.03255920488767898,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,1.0170137059450859,0.18815874026991333,6,0.07681548405102614,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1021813.1477660871,926802.190664598,29671.126593280867,70001.76937565934,0.2530714345862309,1,1051484.274359368,996803.9600402573,1266457.5525616622,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_62,1.1735599529892038,0.22003971848471984,6,0.08983083890553656,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1021813.1477660871,1069462.4162374518,29671.126593280867,81862.63154587742,0.6030792215871191,1,1051484.274359368,1151325.0477833292,1266457.5525616622,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,1.0378385976205933,0.23163351014695463,6,0.0945639845316381,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1103756.2451948097,945779.865313808,82055.48055710495,86175.93598746213,0.21388496984438024,1,1185811.7257519148,1031955.8013012701,1411086.440018246,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.6,967514 MM WT,MoneyMaker,m_62,1.2111918170808924,0.22055808005384167,6,0.09004245912997272,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,1.2308506942676458,0.4331157447907083,6,0.17681876238378946,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1103756.2451948097,1121671.3335915369,82055.48055710495,161134.52097050467,0.9236995774755223,1,1185811.7257519148,1282805.8545620416,1411086.440018246,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_62,1.1827816464391636,0.2532583091447033,6,0.10339227175409367,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1103756.2451948097,1077866.123720546,82055.48055710495,94221.13330364252,0.840077391647182,1,1185811.7257519148,1172087.2570241885,1411086.440018246,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,1.1940252262558675,0.2104833450381267,6,0.08592946578293066,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,911297.6405793307,1088112.3714791737,34476.153138075875,78307.31942422703,0.07838034814824484,1,945773.7937174066,1166419.6909034008,1391341.2200731735,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,1,967514 MM WT,MoneyMaker,m_62,1,0.0926689368235969,6,0.037831935037337165,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,1.2731475482107935,0.2812614400434263,6,0.1148245020711331,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,911297.6405793307,1160216.3567938558,34476.153138075875,104639.29781812006,0.06408027962299037,1,945773.7937174066,1264855.654611976,1391341.2200731735,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_62,1.1760036358680455,0.15430619111641267,6,0.0629952387312656,leaf_1_log2-1,1,967514 MM WT,leaf,*,911297.6405793307,1071689.3386792643,34476.153138075875,57407.412423534,0.04280635712913614,0.898933499711859,945773.7937174066,1129096.7511027984,1391341.2200731735,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.8429171722501455,0.11381389416305343,6,0.046464327723101606,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1060751.3020204825,768148.430275359,129371.5168803633,42342.83222516729,0.07471142013241981,1,1190122.8189008457,810491.2625005263,1309135.1007909304,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.4,967514 MM WT,MoneyMaker,m_62,1.164000930964927,0.34773951944536413,6,0.14196406434029518,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.9568351824841562,0.22809727959029602,6,0.09312032445219615,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1060751.3020204825,871961.6442211049,129371.5168803633,84860.33196326811,0.2546788076245136,1,1190122.8189008457,956821.976184373,1309135.1007909304,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_62,0.8025146290030566,0.13025138818343554,6,0.053174906556432575,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,1060751.3020204825,731329.6879408824,129371.5168803633,48458.16688290338,0.05199325476804214,0.9878718405928006,1190122.8189008457,779787.8548237858,1309135.1007909304,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,1.7877506272581773,0.44720879675820824,6,0.18257222675693968,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,84.46456827673971,145.46984483054692,11.69825330144025,14.855960944302314,0.01059295118629311,0.21185902372586218,96.16282157817996,160.32580577484924,231.0147650319912,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.8,967514 MM WT,MoneyMaker,m_61,1.0380267133283148,0.32146965678561334,5,0.1437656010552316,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,1.9326938565016443,0.9156733586294341,6,0.37382208328377026,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,84.46456827673971,157.26392211727836,11.69825330144025,30.418023420258944,0.06407376155800154,0.8495324971104359,96.16282157817996,187.6819455375373,231.0147650319912,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_61,2.0364611123171046,1.2175331071975406,5,0.5444973585100478,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,84.46456827673971,165.70749717288746,11.69825330144025,44.30592558346816,0.14213178770334622,1,96.16282157817996,210.01342275635562,231.0147650319912,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,1.369017003289157,0.30258445868556594,6,0.1235295879793157,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,52.486604591784115,111.3973548672646,9.05980193312649,10.051642394270766,0.0014722771558555803,0.03386237458467835,61.54640652491061,121.44899726153537,133.5938969876889,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.6,967514 MM WT,MoneyMaker,m_61,0.6450337552151577,0.27272709833927644,6,0.11134037166017947,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,1.2938395073861468,0.29976437332411243,6,0.12237829295154014,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,52.486604591784115,105.28013779178673,9.05980193312649,9.957961146734833,0.0029081610584462624,0.06397954328581777,61.54640652491061,115.23809893852156,133.5938969876889,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_61,1.3616187681308942,0.25039050727477324,6,0.10222149654330565,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,52.486604591784115,110.79535808757782,9.05980193312649,8.317796125350485,8.069378333683459e-4,0.0193665080008403,61.54640652491061,119.11315421292831,133.5938969876889,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,2.130711723458346,1.1234511351174805,6,0.45864700533139785,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,81.37032235510941,173.37669978361635,7.186666315193924,37.32025467102142,0.05663549980736239,0.8495324971104359,88.55698867030333,210.69695445463776,231.76664990010156,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,1,967514 MM WT,MoneyMaker,m_61,1,0.19749060772121277,5,0.08832048475647532,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,1.8532111832378784,0.5960750393500747,6,0.2433466158028479,fruit_1_transp1-1,1,967514 MM WT,fruit,*,81.37032235510941,150.7963913721599,7.186666315193924,19.801192571902693,0.015476097023459237,0.2940458434457255,88.55698867030333,170.5975839440626,231.76664990010156,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_61,1.2761307129308987,0.5380140529551811,6,0.21964331736448697,fruit_1_log2-1,1,967514 MM WT,fruit,ns,81.37032235510941,103.83916747844282,7.186666315193924,17.872447537093908,0.2842499169032393,1,88.55698867030333,121.71161501553672,231.76664990010156,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,1.6584541792657554,0.29833081957062824,6,0.12179304708239215,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,93.43666829582637,134.94895117803293,16.424223774507837,9.91033950170527,0.06875803515595826,0.8495324971104359,109.8608920703342,144.8592906797382,248.99492015261382,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.4,967514 MM WT,MoneyMaker,m_61,1.14828927293735,0.4513399944170385,5,0.20184538169617472,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,2.4983090140371216,0.6945002447668693,6,0.28352853765280883,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,93.43666829582637,203.28820981487615,16.424223774507837,23.070808505681832,0.004081528563380921,0.08571209983099934,109.8608920703342,226.359018320558,248.99492015261382,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_61,2.277787222606727,0.8587560712162218,6,0.35058569799948597,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,*,93.43666829582637,185.3442805598587,16.424223774507837,28.527271259309206,0.024092705092578052,0.4095759865738269,109.8608920703342,213.8715518191679,248.99492015261382,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,1.0964288374920999,0.22793356176978197,6,0.09305348693185282,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,559.3745928352228,649.4545998621514,94.52577960862114,55.11895807058235,0.4340902321731368,1,653.9003724438439,704.5735579327338,1182.631038088398,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.8,967514 MM WT,MoneyMaker,m_61,0.944353053585451,0.3908926870074051,6,0.159581271225599,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,1.1365175930997613,0.47696149716772024,6,0.19471871583580644,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,559.3745928352228,673.2006249956185,94.52577960862114,115.33896351000239,0.46357948474268806,1,653.9003724438439,788.5395885056208,1182.631038088398,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_61,1.5815638257550138,0.5719183737909567,6,0.2334846983850307,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,559.3745928352228,936.8176633894647,94.52577960862114,138.30146214544257,0.05127249468569301,0.8203599149710882,653.9003724438439,1075.1191255349072,1182.631038088398,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,1.4828182338069897,0.29031751197343664,6,0.1185216279548776,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,697.9991773194146,878.3270648993303,104.07948550777823,70.20466246994388,0.1855937653916421,1,802.0786628271928,948.5317273692741,1100.6980006819444,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.6,967514 MM WT,MoneyMaker,m_61,1.1783832568453685,0.43040015031807455,6,0.17571012558274363,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,0.9111410700740966,0.11764706011809725,6,0.04802921117131253,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,697.9991773194146,539.7019294352596,104.07948550777823,28.4494451954656,0.194867944366772,1,802.0786628271928,568.1513746307252,1100.6980006819444,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_61,1.580857535717317,0.2656321608489175,6,0.10844387555879247,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,697.9991773194146,936.3993021624211,104.07948550777823,64.23524391207377,0.0856771555485171,0.9424487110336881,802.0786628271928,1000.6345460744949,1100.6980006819444,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,1.1910748869386996,0.26573029400749415,6,0.1084839382530192,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,592.3362991324378,705.5168905188561,92.63893235589153,64.25897450010531,0.3419304742766296,1,684.9752314883293,769.7758650189614,1098.0661514797137,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,1,967514 MM WT,MoneyMaker,m_61,1,0.38309000296030365,6,0.1563958388023402,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,1.2797428694712392,0.3801027918423672,6,0.15517631497018802,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,592.3362991324378,758.0381551437204,92.63893235589153,91.91656412245067,0.23293293163867393,1,684.9752314883293,849.954719266171,1098.0661514797137,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_61,1.508615402028814,0.43269444229178833,6,0.17664676635883722,leaf_1_log2-1,1,967514 MM WT,leaf,ns,592.3362991324378,893.6076640519426,92.63893235589153,104.63429183870606,0.05690169791745828,0.8495324971104359,684.9752314883293,998.2419558906487,1098.0661514797137,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,1.0114707181275358,0.39173224425692393,6,0.15992401903746162,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,522.2710670834367,599.1308218564938,47.00989876655952,94.72880157903555,0.4899322811551122,1,569.2809658499963,693.8596234355293,894.6132972535783,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.4,967514 MM WT,MoneyMaker,m_61,0.8817137626857888,0.19440014904812913,6,0.0793635285148189,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,1.0648434767173143,0.4891160191852638,6,0.199680778670874,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,522.2710670834367,630.7454441540522,47.00989876655952,118.27817344578892,0.4241685215507045,1,569.2809658499963,749.0236175998411,894.6132972535783,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_61,1.2608520936008396,0.2747344118364355,6,0.1121598539638197,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,522.2710670834367,746.8484628769074,47.00989876655952,66.43635280816363,0.022126392543501232,0.3982750657830222,569.2809658499963,813.2848156850711,894.6132972535783,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,2.2924750243301233,1.300619072927123,6,0.5309755130671924,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,145.09384909344632,423.7490932800137,25.07621204469378,98.14736903485324,0.03543273539562833,0.7795201787038233,170.1700611381401,521.896462314867,574.0861085463538,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.8,967514 MM WT,MoneyMaker,m_111,0.7849551314811932,0.3033491390649742,5,0.13566185917306384,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,1.497884028739365,0.5267440495321004,6,0.2150423577334924,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,145.09384909344632,276.87411739737115,25.07621204469378,39.74918074974047,0.022621463748027038,0.5429151299526489,170.1700611381401,316.6232981471116,574.0861085463538,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_111,1.1337476748545208,0.46001004535609014,5,0.2057227463497958,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,145.09384909344632,209.5658814727154,25.07621204469378,38.02651121936357,0.2003084185124178,1,170.1700611381401,247.592392692079,574.0861085463538,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,1.2341799263478257,0.7299024852483484,6,0.29798144180796327,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,121.79601265661636,228.13012974355274,22.53724621393847,55.07993083470662,0.11951741119215165,1,144.33325887055483,283.21006057825934,741.5047374148265,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.6,967514 MM WT,MoneyMaker,m_111,0.6589142525758364,0.29865672982730496,6,0.12192609938752506,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,1.675402908823918,1.4955143985410653,6,0.6105411965684823,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,121.79601265661636,309.68732743349517,22.53724621393847,112.85456797139486,0.15914741765320395,1,144.33325887055483,422.54189540489006,741.5047374148265,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_111,2.6672285189411555,2.3995558066510347,6,0.9796145559379208,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,121.79601265661636,493.0198385922093,22.53724621393847,181.0753772394512,0.09586151884731212,1,144.33325887055483,674.0952158316604,741.5047374148265,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,1.32603017646004,0.40669628582069545,6,0.16603306342430155,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,184.84349394551683,245.10805089406398,20.461153725696917,30.690131553825495,0.13928013409986945,1,205.30464767121373,275.7981824478895,337.9428057078297,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,1,967514 MM WT,MoneyMaker,m_111,1,0.24752037332846075,5,0.11069447611571281,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,1.4727525168251328,0.46370349047148607,6,0.1893061572671104,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,184.84349394551683,272.2287209270111,20.461153725696917,34.99201153465218,0.06382144758956186,1,205.30464767121373,307.2207324616633,337.9428057078297,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_111,1.394182671997355,0.239343937289143,6,0.09771175323118267,fruit_1_log2-1,1,967514 MM WT,fruit,*,184.84349394551683,257.70559629028753,20.461153725696917,18.061381866793955,0.02685340625538939,0.6176283438739559,205.30464767121373,275.7669781570815,337.9428057078297,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.7918944873291935,0.2680917377720399,6,0.10944799363292154,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,246.34953519871243,146.37654387412192,159.1810605006087,20.230749548435895,0.5660248677988312,1,405.5305956993211,166.6072934225578,476.79175733742113,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.4,967514 MM WT,MoneyMaker,m_111,1.3327465843689619,1.9256272666798977,5,0.8611666935246733,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,1.5769263361770691,1.8812435720833431,6,0.768014472249156,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,246.34953519871243,291.4845736736721,159.1810605006087,141.96247845125615,0.8373589976107012,1,405.5305956993211,433.4470521249283,476.79175733742113,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_111,1.2666093744680238,1.112487692692519,6,0.4541711987038083,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,246.34953519871243,234.12450224081502,159.1810605006087,83.95059121783552,0.94799404451382,1,405.5305956993211,318.07509345865054,476.79175733742113,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.6791852680867818,0.17042047709803965,6,0.0695738684353106,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,56106.61072558939,45294.22683563709,3323.720332945065,4639.815859991648,0.09046817690152013,1,59430.33105853445,49934.04269562874,65373.3641643879,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.8,967514 MM WT,MoneyMaker,m_111,0.84131656745972,0.12208027688451684,6,0.049839064337459056,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.7039616897154677,0.22488607515939577,6,0.09180935573295114,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,56106.61072558939,46946.543094772576,3323.720332945065,6122.679598036644,0.22631486844670498,1,59430.33105853445,53069.22269280922,65373.3641643879,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_111,0.7775467263102623,0.21842109109972838,6,0.0891700370427158,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,56106.61072558939,51853.859987293006,3323.720332945065,5946.665916550576,0.5501732919278262,1,59430.33105853445,57800.52590384358,65373.3641643879,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.6908779822065372,0.1203430146886596,6,0.04912983001591284,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,43720.1326879251,46074.002944674816,5854.994382049509,3276.422162991783,0.7349407948208322,1,49575.12706997461,49350.4251076666,54532.63977697207,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.6,967514 MM WT,MoneyMaker,m_111,0.655581784146386,0.2150539948361259,6,0.08779542574927282,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.5629672310311736,0.155623174384731,6,0.06353289489912607,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,43720.1326879251,37543.75523365795,5854.994382049509,4236.94901568156,0.41468183310157614,1,49575.12706997461,41780.704249339506,54532.63977697207,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_111,0.6449301076696669,0.11406255842346631,6,0.04656584448231462,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,43720.1326879251,43009.782400329204,5854.994382049509,3105.43237887996,0.9174178989110342,1,49575.12706997461,46115.214779209164,54532.63977697207,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.8117531739266182,0.1826652026490164,6,0.07457275670869605,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,66689.05961878091,54135.055811726874,10251.091117349044,4973.187018083076,0.3058568618189829,1,76940.15073612996,59108.24282980995,84634.16580974296,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,1,967514 MM WT,MoneyMaker,m_111,0.9999999999999999,0.3765226663536696,6,0.1537147348597811,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.8121862723808756,0.2500319638887284,6,0.1020751218188957,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,66689.05961878091,54163.93874036365,10251.091117349044,6807.29388457466,0.33624207431048864,1,76940.15073612996,60971.23262493831,84634.16580974296,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_111,0.9508584156770992,0.3337031815830563,6,0.1362337534036348,leaf_1_log2-1,1,967514 MM WT,leaf,ns,66689.05961878091,63411.85357210963,10251.091117349044,9085.300902825298,0.8158110948881917,1,76940.15073612996,72497.15447493493,84634.16580974296,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.3249846723085208,0.07756825859689961,6,0.03166710896644312,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,22702.281093711128,21672.92218677292,1396.7990954645627,2111.8497178175567,0.6941939872364786,1,24099.08018917569,23784.771904590478,26528.806952171897,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.4,967514 MM WT,MoneyMaker,m_111,0.34041987131750967,0.05130444298701316,6,0.02094495114264885,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.3106170713972525,0.09571396541640324,6,0.03907506275476393,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,22702.281093711128,20714.760393022498,1396.7990954645627,2605.879189660058,0.5212106817060415,1,24099.08018917569,23320.639582682554,26528.806952171897,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_111,0.34256211051202434,0.04671881609278917,6,0.019072876802376793,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,22702.281093711128,22845.145011071807,1396.7990954645627,1271.9522181753696,0.9412232268530686,1,24099.08018917569,24117.097229247178,26528.806952171897,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.0648858485432386,0.03467122220097998,6,0.014154467191842811,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,69.95599667579123,4.741114843908732,12.187557441373785,1.0342463883499302,0.005722235236113695,0.1258891751945013,82.14355411716501,5.775361232258662,265.6624534877313,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.8,967514 MM WT,MoneyMaker,m_1,0.9574022892165303,0.3729676729642634,5,0.1667962140316007,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,2.7280223913261143,1.4139633150745725,6,0.5772481061578107,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,69.95599667579123,199.33263946471737,12.187557441373785,42.178681887765606,0.026669011991963094,0.5067112278472988,82.14355411716501,241.51132135248298,265.6624534877313,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_1,1.6089577411318348,0.4489568379658073,5,0.2007796017309807,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,69.95599667579123,117.56420854415879,12.187557441373785,14.670674291737074,0.03811067809364219,0.6097708494982751,82.14355411716501,132.23488283589586,265.6624534877313,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.3800724389703561,0.30243202191213475,6,0.12346735592715859,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,28.494451034551066,27.77134186604891,3.9056513934149115,9.021580622997227,0.9434771686846446,1,32.400102427965976,36.792922489046134,188.12613213281418,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.6,967514 MM WT,MoneyMaker,m_1,0.3899687510261459,0.130929833380128,6,0.05345188064815569,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,2.070761194598295,0.6609509343412653,6,0.2698320890253145,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,28.494451034551066,151.30751709839825,3.9056513934149115,19.716239385978266,0.0012989720527645035,0.02987635721358358,32.400102427965976,171.02375648437652,188.12613213281418,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_1,1.0599629476133567,0.19663626904110543,6,0.08027642067922353,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,28.494451034551066,77.44995523290586,3.9056513934149115,5.865681627705073,7.898062469523088e-5,0.0018955349926855411,32.400102427965976,83.31563686061094,188.12613213281418,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.33159863253807503,0.4974852941042279,6,0.20309752084896318,fruit_1_panK4-1,1,967514 MM WT,fruit,*,73.06854961986588,24.22943113548801,7.867648272604712,14.840041279824213,0.021173391557386137,0.42346783114772274,80.93619789247059,39.06947241531222,276.2257073251035,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,1,967514 MM WT,MoneyMaker,m_1,1,0.2407683805430272,5,0.10767489314534931,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,2.9519225513518403,1.187443808021905,6,0.4847719046468423,fruit_1_transp1-1,1,967514 MM WT,fruit,*,73.06854961986588,215.692699417453,7.867648272604712,35.42157996900468,0.009198538796345886,0.1931693147232636,80.93619789247059,251.1142793864577,276.2257073251035,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_1,1.306108756636145,0.7589042633988408,6,0.30982136815831396,fruit_1_log2-1,1,967514 MM WT,fruit,ns,73.06854961986588,95.43547249320949,7.867648272604712,22.638198012570495,0.3857605208180578,1,80.93619789247059,118.07367050577999,276.2257073251035,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,1.4928425653341029,1.1511374334436566,6,0.4699498892923317,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,107.3144045406429,109.07984105976276,48.123355327400176,34.338556804607215,0.976951232513027,1,155.4377598680431,143.41839786436998,219.769671864217,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.4,967514 MM WT,MoneyMaker,m_1,1.4686811918251934,1.4726868724952387,5,0.6586055912941837,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,2.263616637782214,1.152909782324359,6,0.470673447692984,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,107.3144045406429,165.39918461814366,48.123355327400176,34.39142616750815,0.3565012941460791,1,155.4377598680431,199.7906107856518,219.769671864217,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_1,1.3333441111723183,1.002861336164958,6,0.40941642606164963,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,107.3144045406429,97.42552034755052,48.123355327400176,29.915464442873798,0.866490697370267,1,155.4377598680431,127.34098479042432,219.769671864217,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.43160500465257506,0.40488235794799604,6,0.16529253047124726,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1565.6515982902422,427.6874064613816,578.1355305840946,163.7922009768912,0.10878642064172095,1,2143.7871288743368,591.4796074382728,2358.1658417617705,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.8,967514 MM WT,MoneyMaker,m_1,1.579992899382667,1.4291088064042134,6,0.583431227101372,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.14305032113045132,0.18990701449127903,6,0.07752921401316074,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1565.6515982902422,141.7518800251138,578.1355305840946,76.82549578629009,0.05686082455545779,0.8529123683318668,2143.7871288743368,218.5773758114039,2358.1658417617705,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_1,0.3018628246846574,0.4786567757378291,6,0.19541081041391342,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1565.6515982902422,299.12287208164,578.1355305840946,193.637102905509,0.08222158090186121,1,2143.7871288743368,492.759974987149,2358.1658417617705,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.3365461782505851,0.31671878855088054,6,0.1292999039836827,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,2121.817723717922,333.49141131101067,979.8172894222147,128.12627285219082,0.12817868152734016,1,3101.635013140137,461.6176841632015,3411.798514454151,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.6,967514 MM WT,MoneyMaker,m_1,2.1412534825242315,2.4220367766805375,6,0.9887923735204347,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.20171912377454798,0.19888520046265518,6,0.08119454308744169,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,2121.817723717922,199.88815688141747,979.8172894222147,80.4575553516526,0.10722071630154162,1,3101.635013140137,280.34571223307006,3411.798514454151,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_1,0.2962097502633342,0.45263094105806595,6,0.18478580789800497,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,2121.817723717922,293.52110956330426,979.8172894222147,183.1085415573096,0.1222712593382726,1,3101.635013140137,476.62965112061386,3411.798514454151,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.3878100014696782,0.31278773374904467,6,0.12769505758111344,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,990.9231863649335,384.28992236052306,272.5205374787977,126.5359933413306,0.08290873420082313,1,1263.4437238437313,510.82591570185366,1389.7880962281045,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,1,967514 MM WT,MoneyMaker,m_1,1,0.6736508646051963,6,0.27501681384457466,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.20253237794503123,0.23706863754376384,6,0.09678286599983876,leaf_1_transp1-1,1,967514 MM WT,leaf,*,990.9231863649335,200.69402929535732,272.5205374787977,95.9043859620906,0.032734133179319336,0.5564802640484288,1263.4437238437313,296.5984152574479,1389.7880962281045,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_1,0.1791075424188362,0.3165948240324439,6,0.12924929568095275,leaf_1_log2-1,1,967514 MM WT,leaf,*,990.9231863649335,177.48181663566564,272.5205374787977,128.07612391159316,0.030144632447489904,0.5426033840548182,1263.4437238437313,305.5579405472588,1389.7880962281045,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.47564611566359327,0.47557833637235564,6,0.1941540428056622,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,3598.7667073883795,471.32876451547156,2291.872035664174,192.39174274262047,0.23123617416662945,1,5890.638743052554,663.7205072580921,6479.70261735781,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.4,967514 MM WT,MoneyMaker,m_1,3.6317312551641505,5.665340281041241,6,2.312865484631148,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.45261256262224925,0.43049025791699697,6,0.1757469118559615,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,3598.7667073883795,448.50428274243717,2291.872035664174,174.15168989010644,0.22820292572860476,1,5890.638743052554,622.6559726325436,6479.70261735781,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_1,0.20338817656648284,0.37472224962588785,6,0.15297971780854167,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,3598.7667073883795,201.54205999221287,2291.872035664174,151.59114942004848,0.1986926003077129,1,5890.638743052554,353.13320941226135,6479.70261735781,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,1.8521517736489586,2.054858359133223,6,0.838892412261517,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,237.21552821537,136.3706299217489,54.09325691501473,61.766151308052066,0.2505161048203768,1,291.3087851303847,198.13678122980096,320.4396636434232,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.8,967514 MM WT,MoneyMaker,m_2,3.2218019493880883,1.6427968377517628,5,0.7346810804869268,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,1.54570669337145,2.545919072872067,6,1.0393671091593646,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,237.21552821537,113.8076255133503,54.09325691501473,76.52674549276638,0.22201103563799826,1,291.3087851303847,190.33437100611667,320.4396636434232,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_2,0.8351972853617662,0.6489472904577114,5,0.29021805105554865,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,237.21552821537,61.49408570839168,54.09325691501473,21.368237203982282,0.0278198634214285,0.667676722114284,291.3087851303847,82.86232291237397,320.4396636434232,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,1.478577088473633,2.497046540434996,6,1.0194149813412905,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,46.85884269760951,108.86499249776432,33.468237365180194,75.05770592617107,0.4754596899520589,1,80.3270800627897,183.9226984239354,3183770.1957672285,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.6,967514 MM WT,MoneyMaker,m_2,0.6364250767435479,1.1134332617277705,6,0.4545572256459653,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,1.1383657251495978,1.6885574858556132,6,0.6893507069505127,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,46.85884269760951,83.81583692471304,33.468237365180194,50.755662403755956,0.5588766363414186,1,80.3270800627897,134.571499328469,3183770.1957672285,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_2,19655.74035625049,48143.28634105077,6,19654.414346046226,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,46.85884269760951,1447217.0866858205,33.468237365180194,1447119.4549207506,0.3632020528357218,1,80.3270800627897,2894336.541606571,3183770.1957672285,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,231.0592046541984,562.6920013823446,6,229.71804762203186,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,73.62821549612136,17012.476912641727,20.004474150430376,16913.72991366323,0.3625656396603306,1,93.63268964655174,33926.20682630496,37318.82750893546,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,1,967514 MM WT,MoneyMaker,m_2,1,0.6075301941394474,5,0.2716957624958897,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,1.474855128273807,1.9346848140829223,6,0.7898317679357497,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,73.62821549612136,108.59095121010357,20.004474150430376,58.1539036152559,0.5898406380049926,1,93.63268964655174,166.74485482535948,37318.82750893546,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_2,0.5401623181332366,0.711151398044478,6,0.29032634251264433,fruit_1_log2-1,1,967514 MM WT,fruit,ns,73.62821549612136,39.7711875623984,20.004474150430376,21.37621051072172,0.27732864696266446,1,93.63268964655174,61.14739807312012,37318.82750893546,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,2.227211336195834,1.7746488572109222,6,0.7244973621300073,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,95.39739495383115,163.98559621683123,85.70136047662916,53.34344790527963,0.5190682334778495,1,181.0987554304603,217.32904412211087,388.46996685865895,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.4,967514 MM WT,MoneyMaker,m_2,1.2956635484239947,2.602725959045573,5,1.163974434245847,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,2.6098292092621707,2.671537701038979,6,1.090650699358922,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,95.39739495383115,192.1570674276271,85.70136047662916,80.30266472339419,0.4319515114279301,1,181.0987554304603,272.4597321510213,388.46996685865895,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_2,3.2828688747972543,3.707516781415776,6,1.5135873878790744,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,95.39739495383115,241.71177695908167,85.70136047662916,111.44273836697191,0.32570589109036024,1,181.0987554304603,353.15451532605357,388.46996685865895,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.5491675247180031,0.10580816649931568,6,0.04319600309046141,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,2368.794325253014,1056.2325849442288,820.9851822776571,83.08034242724995,0.17139580154065176,1,3189.7795075306713,1139.3129273714787,3508.7574582837387,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.8,967514 MM WT,MoneyMaker,m_2,1.2316083926097945,1.0455775015127216,6,0.42685522754004573,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.4800410819177225,0.10924507362812726,6,0.0445991145502818,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,2368.794325253014,923.2793455762742,820.9851822776571,85.77899443682023,0.13905668360038623,1,3189.7795075306713,1009.0583400130944,3508.7574582837387,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_2,0.93040949228054,1.0135458936009047,6,0.4137783783692378,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,2368.794325253014,1789.4882323800055,820.9851822776571,795.8340333460065,0.6233933530750388,1,3189.7795075306713,2585.322265726012,3508.7574582837387,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.4905350223100411,0.08819149236526357,6,0.03600402599157568,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1596.411502396993,943.4626981744109,827.8259967339623,69.24776817603853,0.4669929411854389,1,2424.2374991309553,1012.7104663504495,2666.661249044051,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.6,967514 MM WT,MoneyMaker,m_2,0.8300230135855887,1.0542897192749134,6,0.4304119755476095,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.37260844687929817,0.07438379069247195,6,0.03036705538842348,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1596.411502396993,716.6505033622822,827.8259967339623,58.40599082498444,0.3371478404547071,1,2424.2374991309553,775.0564941872666,2666.661249044051,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_2,0.5706778698522194,0.13161840271405517,6,0.0537329879015973,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1596.411502396993,1097.6041636001632,827.8259967339623,103.3464838206237,0.5751950094318683,1,2424.2374991309553,1200.950647420787,2666.661249044051,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.5281796988085011,0.21450310831450603,6,0.08757052726858193,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1923.334023596175,1015.8659852911703,622.5408108369254,168.42737455992025,0.21127473122315857,1,2545.8748344331007,1184.2933598510906,2800.462317876411,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,1,967514 MM WT,MoneyMaker,m_2,1,0.7928458145599478,6,0.3236779483955277,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.40522728196935764,0.14551874080949848,6,0.059407777165931736,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1923.334023596175,779.3874187010663,622.5408108369254,114.26099908945645,0.12682153563639204,1,2545.8748344331007,893.6484177905227,2800.462317876411,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_2,0.6182510992026078,0.2716390519535953,6,0.11089617858327976,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1923.334023596175,1189.1033742221096,622.5408108369254,213.2903933560194,0.3061708105964386,1,2545.8748344331007,1402.393767578129,2800.462317876411,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.3446502658874367,0.11320320709654934,6,0.04621501577219292,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,411.1774328528891,662.8775826227752,123.96489907035236,88.88691223569249,0.13307897680934935,1,535.1423319232415,751.7644948584677,826.9409443443146,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.4,967514 MM WT,MoneyMaker,m_2,0.21378368385751612,0.15787728237148618,6,0.06445313063123982,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.2484699299286114,0.12141451128051078,6,0.049567266667773946,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,411.1774328528891,477.89067007225583,123.96489907035236,95.33441043879424,0.6792939977058499,1,535.1423319232415,573.22508051105,826.9409443443146,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_2,0.2967598377366726,0.05627905289122359,6,0.02297582713176736,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,411.1774328528891,570.7682927558225,123.96489907035236,44.19019004279228,0.2690985872468697,1,535.1423319232415,614.9584827986148,826.9409443443146,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.949993641078292,0.22033572870161364,6,0.0899516845705433,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,247.53209525400527,275.3093048839986,28.99022601881599,26.06810686032798,0.49506481666110325,1,276.5223212728213,301.3774117443266,385.1180513314314,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.8,967514 MM WT,MoneyMaker,m_87,0.854144456008027,0.22368476820123018,5,0.1000348694458468,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,1.013109835014308,0.13684318617946148,6,0.05586599681939328,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,247.53209525400527,293.60045413814,28.99022601881599,16.190033370687892,0.21179223102890204,1,276.5223212728213,309.7904875088279,385.1180513314314,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_87,1.1308259735257513,0.17277824697699853,5,0.07726878105476324,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,247.53209525400527,327.7147332931339,28.99022601881599,22.392586099076414,0.06214543081006326,1,276.5223212728213,350.10731939221034,385.1180513314314,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,1.052495471005946,0.3184610786059772,6,0.1300111909201681,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,233.54789951871354,305.01445903080895,16.255934747639095,37.67740019685298,0.12637677930390187,1,249.80383426635262,342.69185922766195,376.96104515042816,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.6,967514 MM WT,MoneyMaker,m_87,0.805890013501193,0.13740020506812814,6,0.05609339882844752,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.9290827314148367,0.16332726724991878,6,0.06667807764091382,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,233.54789951871354,269.249298000791,16.255934747639095,19.32338745497815,0.18864781253380025,1,249.80383426635262,288.57268545576915,376.96104515042816,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_87,1.0514244259658265,0.14276945344752395,6,0.05828538530041173,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,233.54789951871354,304.70406888423906,16.255934747639095,16.891175075381312,0.012583027742913037,0.3019926658299129,249.80383426635262,321.59524395962035,376.96104515042816,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.9657328937754175,0.4555584735432012,6,0.1859809680303389,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,289.8012081128336,279.8705593304188,32.42772636782549,53.89750922118649,0.878479636870077,1,322.22893448065906,333.7680685516053,426.54171640726884,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,1,967514 MM WT,MoneyMaker,m_87,1,0.2502080684425176,5,0.11189644991127784,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,1.077976585783111,0.26256129885596424,6,0.10719020139991885,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,289.8012081128336,312.3989168772932,32.42772636782549,31.063849863554427,0.6271743789280463,1,322.22893448065906,343.4627667408476,426.54171640726884,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_87,1.263654408388861,0.18220326325946512,6,0.07438417074261382,fruit_1_log2-1,1,967514 MM WT,fruit,ns,289.8012081128336,366.2085741881999,32.42772636782549,21.556622545680778,0.08941599245573531,1,322.22893448065906,387.7651967338807,426.54171640726884,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,1.2881986362706777,0.3812830811651113,6,0.155658166068451,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,284.49809794690213,373.3215210805471,36.506135395254375,45.10992457926518,0.16054340517446733,1,321.0042333421565,418.43144565981225,478.3425023425437,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.4,967514 MM WT,MoneyMaker,m_87,0.9817008693632958,0.28167653568862056,5,0.1259695762932802,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,1.3949640611005412,0.25859463187780424,6,0.10557081638724557,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,284.49809794690213,404.26227018092146,36.506135395254375,30.594550130481892,0.0350841939696896,0.7718522673331711,321.0042333421565,434.85682031140334,478.3425023425437,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_87,0.9909898932969008,0.27801439706179415,6,0.11349890232481909,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,284.49809794690213,287.1900683050499,36.506135395254375,32.892119013213076,0.9575628670981142,1,321.0042333421565,320.082187318263,478.3425023425437,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,1.4864414825747356,0.18846633582693534,6,0.07694105941133465,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,24759.938144453186,28424.13819905551,4004.280021848227,1471.287858638969,0.42173101484819847,1,28764.218166301413,29895.42605769448,32884.96866346393,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.8,967514 MM WT,MoneyMaker,m_87,1.2948219891895505,0.5129329239764499,6,0.20940398933601628,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,1.2950724331552372,0.11635833205823364,6,0.04750309014400039,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,24759.938144453186,24764.727202061746,4004.280021848227,908.3670060098527,0.9991104303847529,1,28764.218166301413,25673.094208071598,32884.96866346393,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_87,1.218489433826182,0.2754508057464096,6,0.11245232055286536,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,24759.938144453186,23300.28626567406,4004.280021848227,2150.343849838319,0.7566834982761923,1,28764.218166301413,25450.63011551238,32884.96866346393,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,1.7462480268667406,0.23368124733918255,6,0.09539996973968443,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,37315.74340119801,33392.229581424275,1985.9127787698185,1824.2641609876941,0.17655190173098428,1,39301.656179967824,35216.49374241197,43231.82179796461,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.6,967514 MM WT,MoneyMaker,m_87,1.9514283443252562,0.25438781574182545,6,0.10385339089143643,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,1.4442332289360778,0.5895512219924124,6,0.24068327851928378,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,37315.74340119801,27617.020496387606,1985.9127787698185,4602.411094571917,0.09546847023067845,1,39301.656179967824,32219.431590959524,43231.82179796461,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_87,1.7187160397037355,0.6802743350655722,6,0.27772083433696104,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,37315.74340119801,32865.75543683814,1985.9127787698185,5310.653307574041,0.46071727896349157,1,39301.656179967824,38176.40874441218,43231.82179796461,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.9654786933079132,0.28031734434724487,6,0.11443907661713275,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,19122.271903916942,18462.146090872353,2936.916169306036,2188.335139505996,0.8608563854212548,1,22059.188073222977,20650.481230378347,24265.106880545278,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,1,967514 MM WT,MoneyMaker,m_87,1,0.37620770524948,6,0.15358615252743307,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.9832854515526037,0.38236487292531607,6,0.15609980570519252,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,19122.271903916942,18802.65176375464,2936.916169306036,2984.982928843297,0.9406654044622063,1,22059.188073222977,21787.634692597934,24265.106880545278,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_87,0.9564022131323312,0.21559772965951562,6,0.08801740456138736,leaf_1_log2-1,1,967514 MM WT,leaf,ns,19122.271903916942,18288.58316902436,2936.916169306036,1683.0927422999084,0.8116875846461797,1,22059.188073222977,19971.67591132427,24265.106880545278,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,2.255650010982316,0.27992495374589293,6,0.11427888382493673,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,36598.77059076293,43133.15283007709,2465.823511825212,2185.271889376576,0.07587828590721073,1,39064.59410258814,45318.424719453666,58138.9855646462,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.4,967514 MM WT,MoneyMaker,m_87,1.9139342215537765,0.3158625413381051,6,0.12895034252285267,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,2.040208594744055,0.40964302042916895,6,0.16723606279066155,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,36598.77059076293,39013.423489404115,2465.823511825212,3197.9334648235576,0.5640094448553704,1,39064.59410258814,42211.356954227675,58138.9855646462,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_87,2.5790585707580953,0.4529690549670465,6,0.18492384232332834,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,36598.77059076293,49317.45924616371,2465.823511825212,3536.1639944237477,0.016343345318993965,0.3758969423368612,39064.59410258814,52853.623240587454,58138.9855646462,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.9060740288397329,0.43834624332202904,6,0.1789541044674749,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,74.63233355855702,100.58945344080874,9.137166433872762,19.866914828608007,0.2741999576948374,1,83.76949999242979,120.45636826941674,132.50200509635843,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.8,967514 MM WT,MoneyMaker,m_88,0.6722615228136672,0.18403811301039028,5,0.08230434622840421,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.8994784534330511,0.35651718190889203,6,0.14554753003529924,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,74.63233355855702,99.85723366166405,9.137166433872762,16.158223312788582,0.2125362632384607,1,83.76949999242979,116.01545697445263,132.50200509635843,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_88,0.9617702135831125,0.22028948079066565,5,0.0985164507552125,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,74.63233355855702,106.77266651584749,9.137166433872762,10.936982653707663,0.05514305039892251,1,83.76949999242979,117.70964916955515,132.50200509635843,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.9849397474467536,0.29454644471310226,6,0.12024808251633275,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,65.96605268382268,109.3448743858892,5.758563756317681,13.349559211085916,0.021119982698233505,0.48575960205937063,71.72461644014037,122.69443359697512,154.8581376644582,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.6,967514 MM WT,MoneyMaker,m_88,0.5941987462637588,0.12705771436022767,6,0.05187109467780877,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.7364602835134504,0.24542034966542348,6,0.10019243819595264,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,65.96605268382268,81.75947554124673,5.758563756317681,11.123045442477352,0.24514154858288884,1,71.72461644014037,92.88252098372408,154.8581376644582,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_88,1.0634153367707562,0.5013663903564827,6,0.20468197175907188,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,65.96605268382268,118.05698442027034,5.758563756317681,22.7231407292371,0.07083727992736853,1,71.72461644014037,140.78012514950746,154.8581376644582,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.8293273806039694,0.35707480593414737,6,0.14577517909033133,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,111.01681566749893,92.0692849405206,5.957187130969893,16.183496185967957,0.3120830306371671,1,116.97400279846883,108.25278112648856,135.05512438296265,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,1,967514 MM WT,MoneyMaker,m_88,0.9999999999999999,0.1199879072322857,5,0.05366022340986589,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.9636931527081798,0.3484200290615351,6,0.14224188122774117,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,111.01681566749893,106.9861450942349,5.957187130969893,15.791240708458421,0.8187530801461378,1,116.97400279846883,122.77738580269332,135.05512438296265,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_88,0.8953401093704477,0.2565057863500029,6,0.10471804877147757,fruit_1_log2-1,1,967514 MM WT,fruit,ns,111.01681566749893,99.39780788169733,5.957187130969893,11.62546431752329,0.40196957122078125,1,116.97400279846883,111.02327219922063,135.05512438296265,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,1.0331970530866763,0.3014579448971117,6,0.12306969065099528,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,95.36830463653448,114.70224679072665,19.21850892016549,13.662805161257658,0.437450298243545,1,114.58681355669997,128.3650519519843,186.82928506086486,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.4,967514 MM WT,MoneyMaker,m_88,0.8590437769550827,0.3870935417602423,5,0.17311349460541106,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,1.3313499205860133,0.4863503172326522,6,0.19855168557678773,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,95.36830463653448,147.80222872263678,19.21850892016549,22.042575878149453,0.10659155682936869,1,114.58681355669997,169.84480460078623,186.82928506086486,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_88,0.8658618062905533,0.6392989207402612,6,0.2609926914876043,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,95.36830463653448,96.12522054248602,19.21850892016549,28.974577521443784,0.9831429238755662,1,114.58681355669997,125.0997980639298,186.82928506086486,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,1.3857465098345734,0.28560691096097224,6,0.11659853314448167,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1179.37056356463,1452.7316474405125,127.89451933237842,122.2347506863654,0.15340165579353085,1,1307.2650828970084,1574.966398126878,1732.463037939566,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.8,967514 MM WT,MoneyMaker,m_88,1.124990045574293,0.2988312111756399,6,0.12199733109970062,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,1.312475187545673,0.19318237625939663,6,0.07886637485564543,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1179.37056356463,1375.918487181061,127.89451933237842,82.67867020309512,0.23061728761341688,1,1307.2650828970084,1458.5971573841562,1732.463037939566,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_88,1.074290518953649,0.3450264292254035,6,0.140856449896122,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1179.37056356463,1126.2202894637378,127.89451933237842,147.66526277208024,0.7912096384662106,1,1307.2650828970084,1273.885552235818,1732.463037939566,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,1.6267675059554203,0.18101136693758713,6,0.07389758110679696,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1805.022981153884,1705.4032769755493,112.72362945280531,77.46969159313385,0.48520999268785225,1,1917.7466106066895,1782.872968568683,2109.5212716673586,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.6,967514 MM WT,MoneyMaker,m_88,1.7217937674257329,0.2633837547796146,6,0.10752596762473099,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,1.4069040124133683,0.2747589837576919,6,0.11216988540866604,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1805.022981153884,1474.9118754684287,112.72362945280531,117.59202802711573,0.07025986840982677,1,1917.7466106066895,1592.5039034955444,2109.5212716673586,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_88,1.6937312001935805,0.27397650953606617,6,0.11185044164535529,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1805.022981153884,1775.6039068590899,112.72362945280531,117.25714277844611,0.860087794561663,1,1917.7466106066895,1892.8610496375359,2109.5212716673586,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.9674939610558332,0.26349873054828793,6,0.10757290628573664,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1048.3386659324408,1014.261328430965,166.86569872703495,112.77283706606464,0.8694717337788889,1,1215.2043646594757,1127.0341654970296,1336.7248011254233,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,1,967514 MM WT,MoneyMaker,m_88,1,0.3898890985678483,6,0.15917155796082066,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.9700839754118015,0.3094697447515128,6,0.12634049424509314,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,1048.3386659324408,1016.9765406256465,166.86569872703495,132.44762519014614,0.8860389455242639,1,1215.2043646594757,1149.4241658157925,1336.7248011254233,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_88,0.9993655466868846,0.2611542457528888,6,0.10661577437599642,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1048.3386659324408,1047.673543992573,166.86569872703495,111.76943867668619,0.9974320434776971,1,1215.2043646594757,1159.4429826692592,1336.7248011254233,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,1.8848150490877364,0.1130691118664567,6,0.046160271623748236,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,1802.6391351292646,1975.9244940900257,108.41591941964292,48.39159757311933,0.18829165428284714,1,1911.0550545489075,2024.316091663145,2594.0147551917935,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.4,967514 MM WT,MoneyMaker,m_88,1.7195198400184106,0.25331859942094026,6,0.10341688515629899,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,1.7220541853533076,0.37953980683162203,6,0.1549464773019945,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,1802.6391351292646,1805.2959873366626,108.41591941964292,162.43638330570414,0.9894518538352477,1,1911.0550545489075,1967.7323706423667,2594.0147551917935,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_88,2.1442719910798718,0.2576553986729206,6,0.10518737603700493,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,1802.6391351292646,2247.9232385249716,108.41591941964292,110.27199346756771,0.016405119787338975,0.3937228748961354,1911.0550545489075,2358.1952319925394,2594.0147551917935,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.8661288211550061,0.650488993065305,6,0.26556101938447046,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,88.40944193178245,47.19066014481918,20.019161947314608,14.468979102638016,0.1356595470605711,1,108.42860387909707,61.65963924745719,119.27146426700678,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.8,967514 MM WT,MoneyMaker,m_76,1.6226508695652007,0.8215941394141725,5,0.36742806912910575,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.7473527484541861,0.4741598913830957,6,0.19357496506367983,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,88.40944193178245,40.719196381858204,20.019161947314608,10.546849574505194,0.07850975853686745,1,108.42860387909707,51.2660459563634,119.27146426700678,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_76,0.460178244621643,0.42299313057572796,5,0.18916827879655448,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,88.40944193178245,25.072615779048192,20.019161947314608,10.306753148987982,0.03074213650855345,0.7378112762052828,108.42860387909707,35.37936892803617,119.27146426700678,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,2.185260002493561,3.3600177194959833,6,1.371721489912523,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,42.54152345579989,119.06296105955913,9.642609287096713,74.73766149183723,0.3550615117846415,1,52.1841327428966,193.80062255139637,213.18068480653602,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.6,967514 MM WT,MoneyMaker,m_76,0.7807994092016359,0.43350751709511415,6,0.17697870275731423,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,1.128505671001156,0.6662598676788587,6,0.27199945198457365,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,42.54152345579989,61.48615112553326,9.642609287096713,14.81977436227575,0.3131285820620887,1,52.1841327428966,76.305925487809,213.18068480653602,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_76,1.5710130891928866,0.9000553174748032,6,0.36744604468199793,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,42.54152345579989,85.59597944829977,9.642609287096713,20.020141337662473,0.0927147140003741,1,52.1841327428966,105.61612078596224,213.18068480653602,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,1.1907500093090844,0.6777548512624549,6,0.276692259381487,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,54.484574340672744,64.87750740335757,17.746730912494964,15.075459975759337,0.6666847514042336,1,72.2313052531677,79.9529673791169,87.9482641170286,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,1,967514 MM WT,MoneyMaker,m_76,1,0.7283326919397868,5,0.32572028188255525,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.8286329817784703,0.46345276614509673,6,0.18920379948948424,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,54.484574340672744,45.14771529684239,17.746730912494964,10.308688478822544,0.6638328802518774,1,72.2313052531677,55.45640377566494,87.9482641170286,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_76,0.7669878977777942,0.5120977373458753,6,0.20906302582186595,fruit_1_log2-1,1,967514 MM WT,fruit,ns,54.484574340672744,41.78900913487054,17.746730912494964,11.390709972277442,0.5660769067133911,1,72.2313052531677,53.17971910714798,87.9482641170286,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,1.3553632056968914,0.8139106468833283,6,0.33227763018045564,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,39.07783753694922,73.8463873394048,7.655816771954628,18.104005243309604,0.12227684263937866,1,46.733654308903844,91.9503925827144,101.14543184098585,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.4,967514 MM WT,MoneyMaker,m_76,0.717227545774871,0.3141976776460613,5,0.14051347311783183,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.6980556496541529,0.3328256473310204,6,0.13587550154541767,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,39.07783753694922,38.0332649375083,7.655816771954628,7.403118865027502,0.9240600331482526,1,46.733654308903844,45.4363838025358,101.14543184098585,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_76,1.077016257967296,0.5570508798084911,6,0.22741506938320735,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,39.07783753694922,58.68077237333231,7.655816771954628,12.39061325399861,0.21489880698915967,1,46.733654308903844,71.07138562733093,101.14543184098585,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,1.2407993157250183,0.39503151605887854,6,0.16127094111038523,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,138.37643855007204,225.60952307248522,25.568656450029287,29.32324320964424,0.04929299916778431,1,163.94509500010133,254.93276628212945,280.4260429103424,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.8,967514 MM WT,MoneyMaker,m_76,0.7610378672279292,0.34445115940387266,6,0.1406215969749266,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.8070221428149847,0.29347082293872445,6,0.11980896176575731,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,138.37643855007204,146.73757346733896,25.568656450029287,21.78437913466131,0.8085896814060914,1,163.94509500010133,168.52195260200028,280.4260429103424,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_76,1.0369549656936063,0.4404909933507144,6,0.17982969500015802,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,138.37643855007204,188.54532904145017,25.568656450029287,32.69770639706526,0.25616383639021223,1,163.94509500010133,221.24303543851545,280.4260429103424,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,1.0356347643112591,0.37293590641114815,6,0.15225044624494247,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,135.95692000315353,188.3052821616234,20.25825122428021,27.683083097788273,0.1607556734381366,1,156.21517122743373,215.9883652594117,332.1642345162882,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.6,967514 MM WT,MoneyMaker,m_76,0.7477310842671943,0.2729114114906983,6,0.11141561718915746,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,1.3060090109677,0.8689347881508007,6,0.3547411417871434,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,135.95692000315353,237.4663383180732,20.25825122428021,64.50114760582518,0.18410476281686952,1,156.21517122743373,301.9674859238984,332.1642345162882,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_76,1.0645900311272358,0.5402199220696795,6,0.220543859659468,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,135.95692000315353,193.57010126169843,20.25825122428021,40.10059835120398,0.23844217208690022,1,156.21517122743373,233.6706996129024,332.1642345162882,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.8496247463129111,0.5517120953946333,6,0.22523551977309478,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,181.8259570369428,154.4838326206148,35.82514098609522,40.95366394145622,0.6263827041177769,1,217.65109802303803,195.43749656207103,290.91560813381483,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,1,967514 MM WT,MoneyMaker,m_76,1,0.4826225958561683,6,0.19702984969751258,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,1.3128309191240273,0.34705576084689044,6,0.1416849210613783,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,181.8259570369428,238.70673829741554,35.82514098609522,25.761996369688806,0.2292508128304003,1,217.65109802303803,264.46873466710434,290.91560813381483,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_76,0.8389427554792767,0.3802015800753912,6,0.155216645097438,leaf_1_log2-1,1,967514 MM WT,leaf,ns,181.8259570369428,152.54156941422937,35.82514098609522,28.222415042905162,0.5360176343897867,1,217.65109802303803,180.76398445713454,290.91560813381483,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.9074335442088848,0.22585361435627255,6,0.09220435195603287,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,170.59477506636338,164.9949726232054,47.932560967315894,16.765144537376784,0.9156710112136082,1,218.52733603367926,181.76011716058218,305.58556011749033,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.4,967514 MM WT,MoneyMaker,m_76,0.9382311406269814,0.6457291266225237,6,0.26361781204636864,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,1.0498834377450763,0.7228129351803648,6,0.295087145112551,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,170.59477506636338,190.89606084523405,47.932560967315894,53.654502569388804,0.7836374954199741,1,218.52733603367926,244.55056341462284,305.58556011749033,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_76,1.1278327702168656,0.9798686305805773,6,0.4000296933136872,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,170.59477506636338,205.069272822308,47.932560967315894,72.73578182995591,0.7018602781481791,1,218.52733603367926,277.8050546522639,305.58556011749033,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,1.219134149165341,0.5594400732589195,6,0.2283904535249322,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,70.6955407612669,69.21941294245177,2.410017254157901,12.967443431454623,0.9149731120972008,1,73.1055580154248,82.1868563739064,90.40554201129704,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.8,967514 MM WT,MoneyMaker,m_120,1.2451326047423426,0.09491366395583402,5,0.042446680919763294,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.8451033079085372,0.568544828461193,6,0.23210745427135232,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,70.6955407612669,47.98286955475928,2.410017254157901,13.17848551386205,0.1471139933505683,1,73.1055580154248,61.16135506862133,90.40554201129704,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_120,0.959023222197098,0.5336949797140607,5,0.23867565077820216,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,70.6955407612669,54.45095971112744,2.410017254157901,13.551411419190902,0.2996875201184008,1,73.1055580154248,68.00237113031834,90.40554201129704,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,1.3340931644340996,0.5596256791702308,6,0.228466226820925,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,63.80686168157371,75.74650067499844,10.108075375557293,12.971745651246374,0.4854360058588447,1,73.914937057131,88.71824632624482,97.59007095886932,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.6,967514 MM WT,MoneyMaker,m_120,1.1238050240580477,0.43608151895937114,6,0.17802953461804796,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,1.1828588819083101,0.4076365065397541,6,0.16641690692551594,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,63.80686168157371,67.15979324794867,10.108075375557293,9.448739180154476,0.8134490615563221,1,73.914937057131,76.60853242810315,97.59007095886932,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_120,1.1336864297129556,0.5045001366558655,6,0.20596131832854236,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,63.80686168157371,64.36790338395505,10.108075375557293,11.693972770195646,0.9717748562917135,1,73.914937057131,76.0618761541507,97.59007095886932,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,1.387720863552493,0.5183436450512491,6,0.21161290696497986,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,56.77751951238643,78.7913484080974,9.754973016946249,12.014855954276957,0.18891883082666977,1,66.53249252933267,90.80620436237436,99.8868247986118,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,1,967514 MM WT,MoneyMaker,m_120,1,0.38417991789531075,5,0.17181048240084054,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,1.063863099018165,0.4386869161671842,6,0.17909318357411697,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,56.77751951238643,60.40350786301176,9.754973016946249,10.16846672491483,0.8027417688377957,1,66.53249252933267,70.57197458792659,99.8868247986118,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_120,1.0570318663161142,0.26876336654538563,6,0.10972218493146628,fruit_1_log2-1,1,967514 MM WT,fruit,ns,56.77751951238643,60.01564741497742,9.754973016946249,6.229753495887999,0.7877485534637335,1,66.53249252933267,66.24540091086543,99.8868247986118,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,1.4192837941069845,0.6770787742213806,6,0.27641625208524656,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,85.88848601308547,80.58341331352315,35.96985941958828,15.694229146310809,0.8972727726693039,1,121.85834543267376,96.27764245983396,134.04417997594115,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.4,967514 MM WT,MoneyMaker,m_120,1.5127199418133839,1.4166002934623434,5,0.6335229106255901,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,1.2607790106025463,0.5438266825377012,6,0.22201631345465048,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,85.88848601308547,71.58390487529333,35.96985941958828,12.605535569239523,0.7228801326243544,1,121.85834543267376,84.18944044453285,134.04417997594115,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_120,0.9190234950218582,0.516194128855495,6,0.21073537065273887,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,85.88848601308547,52.179874420945126,35.96985941958828,11.965031619185869,0.4155064219833676,1,121.85834543267376,64.14490604013099,134.04417997594115,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.7879042339450262,0.3532474192061058,6,0.14421265500166427,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,184.61476947057716,183.533092119829,22.388478865268038,33.592654227458155,0.9792276307423791,1,207.0032483358452,217.12574634728716,293.16084426194305,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.8,967514 MM WT,MoneyMaker,m_120,0.7925478551828816,0.23542862453071484,6,0.09611333349092302,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.5700890144294609,0.17081894459817862,6,0.06973654211104775,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,184.61476947057716,132.79557983576598,22.388478865268038,16.244313275613482,0.09335227834624547,1,207.0032483358452,149.03989311137946,293.16084426194305,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_120,0.9751151973834384,0.41398039496754874,6,0.16900678853105658,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,184.61476947057716,227.1417002707802,22.388478865268038,39.36815814916802,0.3754479679794932,1,207.0032483358452,266.5098584199482,293.16084426194305,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.9315618589212868,0.28760031055687424,6,0.11741233512172002,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,191.84406991084705,216.99645858312368,43.83602397033555,27.3498326186205,0.6388733938105209,1,235.68009388118261,244.34629120174418,268.78092032191864,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.6,967514 MM WT,MoneyMaker,m_120,0.8235831107847998,0.4609627518840365,6,0.18818725542417578,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.6909744120424026,0.1958737395799994,6,0.07996511933029866,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,191.84406991084705,160.9544218119676,43.83602397033555,18.626940915061535,0.5380676384855392,1,235.68009388118261,179.58136272702913,268.78092032191864,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_120,0.5936416864110515,0.2939618713951456,6,0.12000943145862616,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,191.84406991084705,138.28189978460256,43.83602397033555,27.954795887898634,0.3313619248115871,1,235.68009388118261,166.23669567250118,268.78092032191864,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.9464960466742914,0.41051694664803967,6,0.16759284167550706,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,232.93832449773902,220.47520325604322,15.405458393162315,39.03879573770747,0.7757295037791009,1,248.34378289090134,259.5139989937507,354.56947142304676,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,1,967514 MM WT,MoneyMaker,m_120,1,0.16199786960041593,6,0.0661353533231576,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.9141363488907287,0.3880330683415094,6,0.15841383679386856,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,232.93832449773902,212.93738947308694,15.405458393162315,36.90065372002202,0.6329722061035372,1,248.34378289090134,249.83804319310894,354.56947142304676,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_120,1.0869805585792998,0.7270123236537381,6,0.2968015382777993,leaf_1_log2-1,1,967514 MM WT,leaf,ns,232.93832449773902,253.19943007707855,15.405458393162315,69.13645303478211,0.7853176569971685,1,248.34378289090134,322.33588311186065,354.56947142304676,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.7045286833123318,0.27729579442116686,6,0.11320553402526018,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,239.6956828866481,164.11173105137274,43.00866145265956,26.369907419715894,0.17113475117776047,1,282.7043443393076,190.48163847108864,310.9747787732384,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.4,967514 MM WT,MoneyMaker,m_120,1.029009216939631,0.45226252616986773,6,0.18463540314971663,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,1.07247339667091,0.3255649348382008,6,0.13291132808267445,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,239.6956828866481,249.82015608892078,43.00866145265956,30.96014207034747,0.8526859480483935,1,282.7043443393076,280.7802981592682,310.9747787732384,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_120,0.9277948183328009,0.18042429625729053,6,0.07365791050518443,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,239.6956828866481,216.11897046012677,43.00866145265956,17.157750259082068,0.6273291462716525,1,282.7043443393076,233.27672071920884,310.9747787732384,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,1.2139189265912287,0.2504400827779449,6,0.10224173565772435,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,2417.263897147184,2386.3008761825604,355.1340354316534,200.98503947670164,0.9418175551056069,1,2772.3979325788373,2587.285915659262,3114.1794683556063,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.8,967514 MM WT,MoneyMaker,m_36,1.2296699148880297,0.4039631783047434,5,0.18065782541925487,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,1.1879524796380108,0.6178178264836292,6,0.2522230714800412,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,2417.263897147184,2335.256482888677,355.1340354316534,495.81576107096487,0.8961245858225204,1,2772.3979325788373,2831.072243959642,3114.1794683556063,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_36,0.7998832084242338,0.2566760219689015,5,0.11478900666333862,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,2417.263897147184,1572.3966068033944,355.1340354316534,225.65024827979315,0.08596010237976758,1,2772.3979325788373,1798.0468550831877,3114.1794683556063,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,1.346825627105486,0.4431351009205267,6,0.18090914739533645,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,2871.8036363753326,2647.5665743608565,360.9570729159549,355.62807983494105,0.6675260299570864,1,3232.7607092912876,3003.1946541957977,3556.036780220417,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.6,967514 MM WT,MoneyMaker,m_36,1.4608957413729036,0.44977536365752974,6,0.18362002330594884,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,1.3694867899843455,0.3520837151468295,6,0.14373757480885888,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,2871.8036363753326,2692.1134972636805,360.9570729159549,282.5568439483087,0.703750739779667,1,3232.7607092912876,2974.670341211989,3556.036780220417,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_36,1.0867695989000246,0.24495837385211938,6,0.1000038373599356,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,2871.8036363753326,2136.3529221395675,360.9570729159549,196.5858176243686,0.11267819084907463,1,3232.7607092912876,2332.938739763936,3556.036780220417,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,1.126058339816705,0.24435459803947465,6,0.09975734691659995,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,1965.7827420843205,2213.5860509917998,160.07853883057606,196.10127096477066,0.35340257081526716,1,2125.8612809148967,2409.6873219565705,2650.6560541522276,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,1,967514 MM WT,MoneyMaker,m_36,1,0.1820885324206666,5,0.08143246728315696,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,0.9300407211551164,0.23960816868226953,6,0.09781962524571347,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,1965.7827420843205,1828.2579990823835,160.07853883057606,192.29213114517927,0.5959963008313152,1,2125.8612809148967,2020.550130227563,2650.6560541522276,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_36,0.6860764579583691,0.12372422684802534,6,0.05051020409966953,fruit_1_log2-1,1,967514 MM WT,fruit,*,1965.7827420843205,1348.677260804901,160.07853883057606,99.29208751828705,0.013961484851141213,0.30715266672510666,2125.8612809148967,1447.969348323188,2650.6560541522276,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,1.4043033863991645,0.600107864697408,6,0.24499300985663602,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,2331.9860486025223,2760.5553616340467,491.80903292694035,481.60303070746886,0.5492561773115786,1,2823.7950815294625,3242.1583923415155,3706.292996789883,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.4,967514 MM WT,MoneyMaker,m_36,1.1862887992036781,0.5594303002207858,5,0.2501848359933585,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,1.4995504201547105,0.5252990862789388,6,0.21445245395560608,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,2331.9860486025223,2947.7903368254215,491.80903292694035,421.5669329835628,0.3683023219803202,1,2823.7950815294625,3369.3572698089843,3706.292996789883,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_36,0.8119757178844667,0.28402466590454034,6,0.11595258430509844,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,2331.9860486025223,1596.1678532088113,491.80903292694035,227.93758912703973,0.2259807047385789,1,2823.7950815294625,1824.105442335851,3706.292996789883,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,1.459621257032589,0.4947433028704869,6,0.2019781076153215,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,5029.583915146937,9113.57915404853,1404.9324176325474,1261.110347816801,0.0561113675067574,1,6434.516332779484,10374.68950186533,13043.347270041773,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.8,967514 MM WT,MoneyMaker,m_36,0.8055328727041822,0.5511658086167079,6,0.22501249912990373,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,1.4742949797418965,0.8321033637205978,6,0.3397047757281641,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,5029.583915146937,9205.19890317969,1404.9324176325474,2121.047735972925,0.13640795587224908,1,6434.516332779484,11326.246639152614,13043.347270041773,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_36,1.7529424002973568,0.358008841253367,6,0.14615649741263562,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,5029.583915146937,10945.016894366247,1404.9324176325474,912.571532944456,0.0069035926888418525,0.1587826318433626,6434.516332779484,11857.588427310702,13043.347270041773,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,3.2027004890490005,0.9557377996969413,6,0.39017832285797027,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,9671.754311800127,19997.0124256736,3250.078961606029,2436.1943294722932,0.030915118884196662,0.6492174965681299,12921.833273406155,22433.206755145897,30348.757635832484,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.6,967514 MM WT,MoneyMaker,m_36,1.5490180035391274,1.2750310096483592,6,0.520529229977356,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,2.078438716430432,0.9332075866539931,6,0.3809804018994,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,9671.754311800127,12977.349889749414,3250.078961606029,2378.764376116428,0.43263048467442855,1,12921.833273406155,15356.114265865843,30348.757635832484,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_36,4.06171078380519,0.8745641651833211,6,0.3570393253370464,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,9671.754311800127,25360.49852022306,3250.078961606029,2229.281148715558,0.0033100584151058254,0.0794414019625398,12921.833273406155,27589.77966893862,30348.757635832484,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,0.9434006411127035,0.3479293620154702,6,0.14204156724499825,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,6243.797224888628,5890.402304937651,1674.1510404222845,886.8787433831515,0.8569091083034166,1,7917.948265310913,6777.281048320802,13057.010599443007,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,1,967514 MM WT,MoneyMaker,m_36,0.9999999999999999,0.6567823479336836,6,0.26813027075076845,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,1.1971313621066928,0.5270784880446074,6,0.21517889168448867,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,6243.797224888628,7474.645476548912,1674.1510404222845,1343.5333667542209,0.5796241534704328,1,7917.948265310913,8818.178843303132,13057.010599443007,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_36,1.5451188529443673,0.871943424587746,6,0.3559694124691536,leaf_1_log2-1,1,967514 MM WT,leaf,ns,6243.797224888628,9647.40880613714,1674.1510404222845,2222.6008297201365,0.25137289501181803,1,7917.948265310913,11870.009635857277,13057.010599443007,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,1.141971803196638,0.515650161704169,6,0.21051329699314153,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,5331.149304314183,7130.240375700231,1145.280621242515,1314.4023395679326,0.3268440760599527,1,6476.4299255566975,8444.642715268164,11689.571214805357,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.4,967514 MM WT,MoneyMaker,m_36,0.8538312684248447,0.4493024089826886,6,0.18342694036847804,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,1.2013149225784354,1.226399441010309,6,0.5006754752182959,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,5331.149304314183,7500.766779812532,1145.280621242515,3126.116142737791,0.5375822457448298,1,6476.4299255566975,10626.882922550323,11689.571214805357,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_36,1.4006512281029555,0.6943131166908367,6,0.2834521429356708,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,5331.149304314183,8745.382251066081,1145.280621242515,1769.817703450476,0.1414902270510059,1,6476.4299255566975,10515.199954516556,11689.571214805357,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,1.1896780102761753,1.1619853869163823,6,0.4743785477526035,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,386088.8723685524,203389.3601291343,38210.62614426083,81100.55700196732,0.08077495832115608,1,424299.4985128132,284489.9171311016,466729.44836409454,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.8,967514 MM WT,MoneyMaker,m_58,2.2583356434061397,0.49977020470695493,5,0.2235040301707473,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,1.2779020968687382,1.4209296493214902,6,0.5800921002049149,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,386088.8723685524,218472.298844521,38210.62614426083,99173.52431289709,0.1626301611555791,1,424299.4985128132,317645.82315741805,466729.44836409454,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_58,1.0452986129263158,0.5645519020124194,5,0.25247528594531404,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,386088.8723685524,178706.01472880953,38210.62614426083,43163.60091829967,0.007180538714397608,0.15797185171674738,424299.4985128132,221869.6156471092,466729.44836409454,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,1.0053722968362535,1.0238952057652928,6,0.41800346736782606,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,141960.05841440422,171880.14435739184,33659.46939388842,71462.57813067036,0.715909456694513,1,175619.52780829265,243342.7224880622,352305.41918732336,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.6,967514 MM WT,MoneyMaker,m_58,0.830361822889407,0.4822631682555374,6,0.19688311399400948,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,1.4375151742828811,1.0676671637608162,6,0.43587329438975453,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,141960.05841440422,245760.01989432695,33659.46939388842,74517.63391233064,0.24508103711449872,1,175619.52780829265,320277.6538066576,352305.41918732336,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_58,1.194073143907964,0.9249195143307408,6,0.3775968105421914,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,141960.05841440422,204140.7595912829,33659.46939388842,64554.58789656025,0.4193857665865103,1,175619.52780829265,268695.34748784313,352305.41918732336,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,1.9619438949440173,1.4381286361111096,6,0.5871135571594875,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,170961.68742491837,335417.238912646,55731.317679269305,100373.92444203225,0.19158947828799186,1,226693.00510418767,435791.16335467825,523892.15081554,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,1,967514 MM WT,MoneyMaker,m_58,0.9999999999999999,0.7289294852170385,5,0.3259871759498452,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,2.1612648986884877,1.5297998155156043,6,0.6245381594361785,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,170961.68742491837,369493.4940520291,55731.317679269305,106772.0975984618,0.14090273381622004,1,226693.00510418767,476265.5916504909,523892.15081554,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_58,0.9700732017806303,0.36113593375493946,6,0.14743312758052493,fruit_1_log2-1,1,967514 MM WT,fruit,ns,170961.68742491837,165845.35150210987,55731.317679269305,25205.416273499814,0.9362387189566104,1,226693.00510418767,191050.76777560968,523892.15081554,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,1.1806974519171856,0.7055242370691533,6,0.2880290636643031,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,82501.31696518448,201854.02871806346,17139.578005296567,49241.9347514685,0.06081895307790342,1,99640.89497048105,251095.96346953197,276205.5598164852,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.4,967514 MM WT,MoneyMaker,m_58,0.48257196222058096,0.2241745627501177,5,0.10025391222711108,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,1.2735527186119238,0.1080800325284228,6,0.04412348851300732,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,82501.31696518448,217728.72179848675,17139.578005296567,7543.426051257734,5.130747737295432e-4,0.012313794569509037,99640.89497048105,225272.14784974448,276205.5598164852,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_58,0.902675112719056,0.630759436968348,6,0.25750646183627685,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,82501.31696518448,154322.8604669282,17139.578005296567,44023.73923835023,0.17587470506258193,1,99640.89497048105,198346.5997052784,276205.5598164852,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,2.414898056870681,0.8292987742905568,6,0.33855980688789683,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,85003.77572834789,133291.274643902,25590.324402462436,18686.94542814718,0.16131593716234072,1,110594.10013081032,151978.22007204918,210627.36992586814,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.8,967514 MM WT,MoneyMaker,m_58,1.5400516904161041,1.1356604396507834,6,0.4636314330348715,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,2.4881308379568563,0.8773215106980382,6,0.35816500692964787,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,85003.77572834789,137333.38760553286,25590.324402462436,19769.062371253247,0.13862057832922547,1,110594.10013081032,157102.4499767861,210627.36992586814,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_58,3.03222090939617,1.070177451989834,6,0.4368981152678226,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,85003.77572834789,167364.6590858765,25590.324402462436,24114.76811945813,0.0412615370628001,0.825230741256002,110594.10013081032,191479.42720533465,210627.36992586814,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,4.52815715337329,1.274921719260291,6,0.5204846123632629,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,327156.15189146384,249933.46491120633,30303.909341252107,28728.35862244916,0.09423226591705845,1,357460.06123271596,278661.8235336555,437720.22391277587,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.6,967514 MM WT,MoneyMaker,m_58,5.927235354352054,1.3448423108818526,6,0.5490295743609873,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,6.453534092215932,1.8515624905091632,6,0.7558972214373786,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,327156.15189146384,356205.4235216947,30303.909341252107,41722.0527626469,0.5867740660452513,1,357460.06123271596,397927.47628434165,437720.22391277587,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_58,5.385080852824535,0.8616575891410868,6,0.3517702377320624,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,327156.15189146384,297231.714974994,30303.909341252107,19416.10049985058,0.4284204122114166,1,357460.06123271596,316647.8154748446,437720.22391277587,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,1.6384768107058227,0.5871271375275753,6,0.23969365018057404,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,55195.40432138408,90436.39003811977,19511.67768089828,13229.987934985178,0.16992587683369442,1,74707.08200228236,103666.37797310496,172571.11508056335,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,1,967514 MM WT,MoneyMaker,m_58,0.9999999999999999,0.8658991619223513,6,0.35350185256889166,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,2.001532872624632,0.48490968572392107,6,0.19796355022615988,leaf_1_transp1-1,1,967514 MM WT,leaf,*,55195.40432138408,110475.41616705792,19511.67768089828,10926.67819562952,0.03911855807075675,0.8214897194858918,74707.08200228236,121402.09436268744,172571.11508056335,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_58,2.5577482799293927,0.6970479775080897,6,0.28456864518897085,leaf_1_log2-1,1,967514 MM WT,leaf,*,55195.40432138408,141175.9504630275,19511.67768089828,15706.881428393737,0.006838822381591944,0.15729291477661472,74707.08200228236,156882.83189142123,172571.11508056335,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,5.5746667018933564,1.7644876401706797,6,0.7203490626442959,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,405358.3256213049,307695.9825679605,35628.83446542029,39759.95776518195,0.09764453560160537,1,440987.1600867252,347455.94033314247,485085.87609539775,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.4,967514 MM WT,MoneyMaker,m_58,7.344059357932069,1.5811545479802789,6,0.645503641172111,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,6.080561444907243,1.448416821363285,6,0.5913136912006637,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,405358.3256213049,335619.04745267465,35628.83446542029,32637.79826659068,0.17973911665960216,1,440987.1600867252,368256.84571926534,485085.87609539775,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_58,6.765093191883967,1.1836384626597103,6,0.4832183789081017,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,405358.3256213049,373402.0539978783,35628.83446542029,26671.433799356444,0.49045245073523625,1,440987.1600867252,400073.48779723473,485085.87609539775,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,1.1428633129931995,0.7022571295842882,6,0.2866952726188452,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,98243.61846385222,71933.61353143683,22162.274998528534,18045.051151254036,0.3835983252617209,1,120405.89346238076,89978.66468269087,132446.48280861884,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_45,1.5608701101741427,0.7873389849832518,5,0.35210869835164743,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,0.8422769753092696,0.4286968709637906,6,0.1750147646981748,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,98243.61846385222,53014.23690786117,22162.274998528534,11015.704417986486,0.11796186153296492,1,120405.89346238076,64029.941325847656,132446.48280861884,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_45,1.1723625690584425,1.306280908367061,5,0.5841865817637845,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,98243.61846385222,73790.34308180146,22162.274998528534,36769.62181311812,0.5879047152036907,1,120405.89346238076,110559.96489491958,132446.48280861884,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,2.0657777845601104,1.758603223566109,6,0.7179467596251028,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,80051.72893601836,130023.30121805125,14630.376643195581,45188.69768228077,0.33304316388823907,1,94682.10557921394,175211.99890033202,192733.19879036525,0,23,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_45,1.271841906046731,0.5693686440713435,6,0.2324437755858537,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,1.1292568006826862,0.6459972370342061,6,0.26372726766359356,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,80051.72893601836,71077.19825681245,14630.376643195581,16599.40881305341,0.6937121364882299,1,94682.10557921394,87676.60706986586,192733.19879036525,0,23,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_45,0.8476615147538223,0.4302732037231388,5,0.19242402648431078,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,80051.72893601836,53353.1482851411,14630.376643195581,12111.470722630276,0.19357061013622603,1,94682.10557921394,65464.619007771376,192733.19879036525,0,23,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,0.7698197971012428,0.1876834046255492,6,0.07662142908681795,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,62941.57202670208,48453.668206829054,12177.601277264888,4822.673197656799,0.3167629895079398,1,75119.17330396696,53276.34140448585,98584.28998146858,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_45,1,0.43262256378503916,5,0.19347469224471725,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,1.1440624426453556,0.6854427798199584,6,0.2798308430722961,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,62941.57202670208,72009.08863680737,12177.601277264888,17612.993164527696,0.6824764687976672,1,75119.17330396696,89622.08180133507,98584.28998146858,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_45,1.0520657093732755,0.2717392317410517,6,0.11093707681024786,fruit_1_log2-1,1,967514 MM WT,fruit,ns,62941.57202670208,66218.66962334144,12177.601277264888,6982.5540104839965,0.822588623418642,1,75119.17330396696,73201.22363382543,98584.28998146858,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,4.516297460019141,1.8152289570874307,6,0.7410641185314446,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,226597.130556835,284262.8618738064,45092.41466679766,46643.74059295141,0.39735235957382187,1,271689.54522363265,330906.6024667578,523098.1299212722,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_45,3.600118701526939,1.6019571996357589,5,0.7164170390861516,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,6.93218681282656,1.526359771189515,6,0.6231337672209326,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,226597.130556835,436322.73558207724,45092.41466679766,39221.01889180653,0.007289869589822434,0.1749568701557384,271689.54522363265,475543.7544738838,523098.1299212722,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_45,3.586773008655908,1.4667414143139208,6,0.5987946749462069,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,226597.130556835,225757.13166774675,45092.41466679766,37689.07816233234,0.988933649408818,1,271689.54522363265,263446.2098300791,523098.1299212722,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,2.3062882943756278,1.2649669682962594,6,0.5164206023002036,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,25140.243395396956,33967.93582596893,10033.280157173811,7606.049044657943,0.5003436942734889,1,35173.52355257077,41573.984870626875,49394.331184290444,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_45,1.7069229451449688,1.668641354791309,6,0.6812199804908563,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,2.1868056175254864,1.0519161597980777,6,0.42944297394887704,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,25140.243395396956,32208.14720394007,10033.280157173811,6325.007769229416,0.566879428217278,1,35173.52355257077,38533.15497316948,49394.331184290444,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_45,2.580751843201522,1.1464779003966883,6,0.46804764289154704,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,25140.243395396956,38010.34467651103,10033.280157173811,6893.592763753008,0.3183722387925154,1,35173.52355257077,44903.93744026404,49394.331184290444,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,6.574266728950859,3.7858705178996566,6,1.5455751668500746,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,108360.60770386591,96828.4281268758,23223.277513371053,22763.84882575475,0.7302385254882358,1,131583.88521723697,119592.27695263055,159247.17928251578,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_45,7.357256042853076,3.8622784020337324,6,1.576768554925772,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,8.526887323430353,3.1902970173409364,6,1.3024333034013986,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,108360.60770386591,125587.40470733888,23223.277513371053,19182.758276766355,0.5804506988829973,1,131583.88521723697,144770.16298410523,159247.17928251578,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_45,5.582373709970651,1.8059842538925457,6,0.737289984256287,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,108360.60770386591,82219.4312824168,23223.277513371053,10859.101583883868,0.3414231046438974,1,131583.88521723697,93078.53286630067,159247.17928251578,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,1.632379213889785,0.5924620847758075,6,0.24187163327437972,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,14728.399701289269,24042.333526245122,3628.16762013599,3562.382091268722,0.09690693698717102,1,18356.56732142526,27604.715617513844,52857.95894495413,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_45,1,0.603402918909324,6,0.2463382101056365,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,1.9671595181922752,0.5278093464391577,6,0.21547726337463496,leaf_1_transp1-1,1,967514 MM WT,leaf,*,14728.399701289269,28973.111660131446,3628.16762013599,3173.635261521603,0.014670211740969321,0.33741487004229437,18356.56732142526,32146.746921653048,52857.95894495413,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_45,2.7643864793414785,1.2203378225357624,6,0.4982008298386181,leaf_1_log2-1,1,967514 MM WT,leaf,*,14728.399701289269,40714.98899658112,3628.16762013599,7337.700953377169,0.014745618246835608,0.33741487004229437,18356.56732142526,48052.689949958294,52857.95894495413,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,6.258190544995449,2.4922528079467323,6,1.017457948248016,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,138559.57143269133,92173.13175352229,19678.166563112063,14985.52734105047,0.09229883905580465,1,158237.73799580339,107158.65909457277,174061.51179538373,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_45,9.40764606086582,3.272688691963087,6,1.3360695637143463,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,6.267700991501926,3.748714013776924,6,1.5304060875623557,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,138559.57143269133,92313.20541100742,19678.166563112063,22540.432562904676,0.15379282125453625,1,158237.73799580339,114853.6379739121,174061.51179538373,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_45,7.888381708993446,3.0038829090121957,6,1.2263300623578448,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,138559.57143269133,116183.2388063948,19678.166563112063,18061.87932411333,0.4218931527251325,1,158237.73799580339,134245.11813050814,174061.51179538373,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,1.5373682070008234,0.4848445588854042,6,0.19793696230567204,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,69.91267905552463,117.89106329355809,11.033105345943062,15.178536179589475,0.03177631193393485,0.635526238678697,80.94578440146769,133.06959947314758,1158.8499691383117,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_6,0.911702100595856,0.3217212725730646,5,0.14387812705622222,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,2.4890152557038907,0.7023573884436638,6,0.28673620312678916,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,69.91267905552463,190.86686827045975,11.033105345943062,21.987989420778185,0.0015490191264468864,0.03717645903472527,80.94578440146769,212.85485769123792,1158.8499691383117,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_6,7.872479670108871,13.116269973233297,5,5.8657742542778,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,69.91267905552463,603.6907715664482,11.033105345943062,449.8092003774716,0.3010709829910461,1,80.94578440146769,1053.4999719439197,1158.8499691383117,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,3.5809261923320532,4.794519968940975,6,1.9573545809150068,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,37.92571906158621,274.59862540890435,4.922896737418345,150.09716718206033,0.17573424454621328,1,42.84861579900455,424.6957925909647,467.1653718500612,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_6,0.49457349084842583,0.15725098051955547,6,0.06419744397087475,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,2.000652803439788,0.6554587014766008,6,0.2675898943474858,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,37.92571906158621,153.41743455127153,4.922896737418345,20.519779859880426,0.001970329564894133,0.04531757999256506,42.84861579900455,173.93721441115196,467.1653718500612,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_6,1.634630759202377,0.7065979300747671,6,0.2884673969983279,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,37.92571906158621,125.34951446060516,4.922896737418345,22.12074375077773,0.009935681791688484,0.21858499941714665,42.84861579900455,147.47025821138288,467.1653718500612,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,2.34904366462323,1.6787016639361052,6,0.6853270845007573,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,76.68368758811918,180.1333305088184,28.834855901305307,52.553408043532635,0.12463767156081809,1,105.51854348942449,232.68673855235104,286.00410746588943,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_6,1,0.8408137368542405,5,0.3760233344043404,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,2.8727490977682946,1.2684712055516834,6,0.5178512011691102,fruit_1_transp1-1,1,967514 MM WT,fruit,*,76.68368758811918,220.29299433231515,28.834855901305307,39.710739727584304,0.017563831665138564,0.36884046496790984,105.51854348942449,260.00373405989944,286.00410746588943,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_6,1.2884985369358468,0.8851779996586719,6,0.3613724051168748,fruit_1_log2-1,1,967514 MM WT,fruit,ns,76.68368758811918,98.80681926413712,28.834855901305307,27.711368616949667,0.5939116534585633,1,105.51854348942449,126.51818788108679,286.00410746588943,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,0.9514286226417483,0.6174256532332134,6,0.2520629674209933,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,144.99452130321535,72.95905526105436,81.81878332978482,19.329117846245712,0.4352539472972661,1,226.81330463300017,92.28817310730007,249.49463509630021,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_6,1.8908131033291593,2.3858054707070555,5,1.0669646427183719,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,1.654364370012012,0.8735943962048754,6,0.35664341880945105,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,144.99452130321535,126.86276050691674,81.81878332978482,27.348732508342692,0.8419964008653783,1,226.81330463300017,154.21149301525944,249.49463509630021,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_6,1.2723698741679947,1.3409613619317147,6,0.547445183586716,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,144.99452130321535,97.57001392723303,81.81878332978482,41.98011542978429,0.6243616443366367,1,226.81330463300017,139.55012935701734,249.49463509630021,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,1.5327629715043385,0.7975631533296247,6,0.3256037938837872,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,120.95047046700823,124.25816597048801,14.908059913440853,26.396077549631535,0.915836886904311,1,135.85853038044908,150.65424352011954,214.26553600624402,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_6,1.4919615227693768,0.4504502326997001,6,0.18389553743870185,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,1.8337197999934487,0.7405029851977237,6,0.302309077790358,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,120.95047046700823,148.6561611201547,14.908059913440853,24.50761941723561,0.36156784392432595,1,135.85853038044908,173.16378053739032,214.26553600624402,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_6,2.0176136482967104,0.9434026063435232,6,0.38514250125889615,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,120.95047046700823,163.56408409861228,14.908059913440853,31.222766816155012,0.25696256930548766,1,135.85853038044908,194.78685091476729,214.26553600624402,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,1.8207310255553852,0.7216228702670254,6,0.29460130314613914,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,134.48026664533523,147.60318598969857,22.563442524206476,23.88276485145466,0.6980140801249404,1,157.0437091695417,171.48595084115323,197.2339496743343,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_6,1.6588557500595649,0.6817592627442884,6,0.27832705352325937,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,1.9120601384855804,0.7341248099492442,6,0.29970519864888734,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,134.48026664533523,155.00706270344753,22.563442524206476,24.29652790958364,0.5497888032365341,1,157.0437091695417,179.30359061303116,197.2339496743343,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_6,1.8090360041788032,0.4491906175085518,6,0.18338130169027328,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,134.48026664533523,146.65509294840237,22.563442524206476,14.866371803691248,0.6633738977387512,1,157.0437091695417,161.5214647520936,197.2339496743343,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,1.062898399520428,0.3156413995652042,6,0.12886006177211573,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,81.06808963980528,86.16714273032761,20.231590528822874,10.446439038732724,0.8287889141130882,1,101.29968016862816,96.61358176906033,251.98416075245711,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_6,1,0.611301853796341,6,0.24956293676974659,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,2.1759511090225603,1.5916260286534833,6,0.6497786052555721,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,81.06808963980528,176.40019955807463,20.231590528822874,52.676310216886364,0.13867475586346137,1,101.29968016862816,229.07650977496098,251.98416075245711,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_6,0.8174401586510917,0.42096358969285996,6,0.17185766583964115,leaf_1_log2-1,1,967514 MM WT,leaf,ns,81.06808963980528,66.26831205670335,20.231590528822874,13.932172659575732,0.5619343990653947,1,101.29968016862816,80.20048471627908,251.98416075245711,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,2.8635171726706763,1.1016062664900501,6,0.4497288750588417,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,246.58718140799678,232.13986683918816,20.88246251395289,36.45866075687896,0.7398591433631133,1,267.4696439219497,268.59852759606713,297.5419802970374,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_6,3.0417292735478485,0.6309680906414988,6,0.25759164434163967,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,3.0105939886301973,0.7985762233127772,6,0.32601737797252944,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,246.58718140799678,244.06310333933178,20.88246251395289,26.4296060216113,0.94182253286829,1,267.4696439219497,270.4927093609431,297.5419802970374,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_6,2.8344771691571866,1.1881400135566351,6,0.48505612936620734,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,246.58718140799678,229.7856492312163,20.88246251395289,39.322573775796684,0.7162060216634152,1,267.4696439219497,269.10822300701295,297.5419802970374,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,1.8603918562227897,0.5561203788928045,6,0.22703519397510324,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,1537.890144855133,964.7993328196176,842.7096237967187,117.74046577395931,0.5362217081155077,1,2380.5997686518517,1082.539798593577,2618.659745517037,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_11,2.9654646349021614,3.633543727701435,5,1.6249701548716788,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,2.2883540247853578,1.1570921419789229,6,0.47238088887206475,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,1537.890144855133,1186.7405401626343,842.7096237967187,244.97675846949505,0.7066753645087476,1,2380.5997686518517,1431.7172986321293,2618.659745517037,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_11,2.2468749843739815,2.501555273540637,5,1.1187295282219891,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,1537.890144855133,1165.229507214906,842.7096237967187,580.1732032011884,0.7262891037127717,1,2380.5997686518517,1745.4027104160946,2618.659745517037,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,2.3221282050629055,1.15622144326957,6,0.4720254276124624,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,795.170846690925,1204.2558321637866,147.5082272508144,244.79241623806655,0.18927853411838508,1,942.6790739417395,1449.0482484018532,1593.9530732420387,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_11,1.5333026435313242,0.6967216469655916,6,0.28443542130286986,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,2.077904202245762,1.0647342776743887,6,0.43467594865884523,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,795.170846690925,1077.601249050895,147.5082272508144,225.42297412022555,0.3229703696127867,1,942.6790739417395,1303.0242231711204,1593.9530732420387,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_11,1.7316184103433865,1.1051806573745406,6,0.4511881140268846,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,795.170846690925,898.0174157445875,147.5082272508144,233.98618411128433,0.7191958880887497,1,942.6790739417395,1132.003599855872,1593.9530732420387,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,0.8908317318731716,0.37134280816814164,6,0.15160006661069406,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,518.6000624505415,461.9853917823508,147.6501309391878,78.61980401181219,0.7462083849951165,1,666.2501933897292,540.605195794163,779.8372000258006,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_11,1,0.6366287888718785,5,0.28470904967017635,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,1.1037318367667548,0.6449511839268784,6,0.26330021827079264,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,518.6000624505415,572.3953994758899,147.6501309391878,136.54750963847428,0.7953348241361826,1,666.2501933897292,708.9429091143642,779.8372000258006,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_11,0.47462264792870934,0.11020508357937069,6,0.04499103697170523,fruit_1_log2-1,1,967514 MM WT,fruit,ns,518.6000624505415,246.13933485627,147.6501309391878,23.332354583240946,0.13900862263617592,1,666.2501933897292,269.47168943951095,779.8372000258006,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,4.5047084772578625,1.483773981688561,6,0.6057481914591142,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,3424.839294922844,2336.142097627411,525.3357570379915,314.1410499199992,0.12051888311929569,1,3950.175051960836,2650.2831475474104,4345.19255715692,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_11,6.604008643461103,2.265110532762983,5,1.0129882255617588,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,5.804875830916239,2.310774285044581,6,0.9433696515173057,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,3424.839294922844,3010.4089684308,525.3357570379915,489.2315601908202,0.5783474832882209,1,3950.175051960836,3499.6405286216204,4345.19255715692,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_11,6.297011015800198,1.7638870724226505,6,0.7201038818878552,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,3424.839294922844,3265.6303060457303,525.3357570379915,373.44591811791906,0.8115041527687111,1,3950.175051960836,3639.0762241636494,4345.19255715692,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,1.4724545477163202,0.6030788420787826,6,0.24620590629358904,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,968.5904234769334,1239.6492746461554,204.0267996016681,207.2790454712547,0.3733131496762502,1,1172.6172230786015,1446.92832011741,2222.9665773542342,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_11,1.1504910324980284,0.5936164255150312,6,0.2423428909077806,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,1.190660332798788,0.6110984794148272,6,0.2494799095261694,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,968.5904234769334,1002.4086788914115,204.0267996016681,210.03540609287938,0.9103426855300067,1,1172.6172230786015,1212.4440849842908,2222.9665773542342,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_11,1.8093259069610335,1.4478258244268354,6,0.5910724177116887,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,968.5904234769334,1523.258936339582,204.0267996016681,497.6197703460853,0.33850984316057303,1,1172.6172230786015,2020.8787066856673,2222.9665773542342,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,3.0945363229208653,2.448077196081704,6,0.9994233302239228,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1839.5605127726085,2605.2686746933073,860.868808608275,841.4075723410522,0.5390088617874912,1,2700.4293213808833,3446.676247034359,3791.3438717377953,3,24,12.5,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_11,2.185028699834923,2.5046997061225755,6,1.0225393731498817,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,2.2523100302135077,0.35880420560895354,6,0.1464812035510997,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,1839.5605127726085,1896.2041983317977,860.868808608275,123.32150966088794,0.9504958166432353,1,2700.4293213808833,2019.5257079926855,3791.3438717377953,3,24,12.5,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_11,1.4971212577061066,0.8340944979157228,6,0.340517652859408,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,1839.5605127726085,1260.416006763062,860.868808608275,286.6794510065254,0.5465072555784332,1,2700.4293213808833,1547.0954577695873,3791.3438717377953,3,24,12.5,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,1.00781074952276,0.3350459133549902,6,0.13678192135407832,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,841.89306662726494,848.4688824956387,89.48158235090453,115.15575122795438,0.9649758944012248,1,931.3746489781695,963.6246337235931,1246.4715573475146,4,24,16.666666666666664,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_11,1,0.26034686211947305,6,0.10628616138790593,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,0.43842565711636855,0.4764058742294328,6,0.1944918837211081,leaf_1_transp1-1,1,967514 MM WT,leaf,*,841.89306662726494,369.10752095777326,89.48158235090453,163.74136842007712,0.03596807390785047,0.8632337737884113,931.3746489781695,532.8488893778504,1246.4715573475146,4,24,16.666666666666664,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_11,1.072576908017351,0.669653645448767,6,0.273384955957353,leaf_1_log2-1,1,967514 MM WT,leaf,ns,841.89306662726494,902.9950622843176,89.48158235090453,230.1608989406957,0.8122306806291835,1,931.3746489781695,1133.1559612250132,1246.4715573475146,4,24,16.666666666666664,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,4.07148882589544,3.012505557586205,6,1.2298502438974548,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,11533.138351348207,3427.758213371754,5318.433009515515,1035.402393327118,0.19088207578241723,1,16851.571360863723,4463.1606066988725,18536.728496950098,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_11,13.699053726088382,15.473992625544948,6,6.317231036029149,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,8.627438005409982,12.769807081264835,6,5.213251910479702,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,11533.138351348207,7263.380239511223,5318.433009515515,4389.000638014204,0.5501173578407743,1,16851.571360863723,11652.380877525427,18536.728496950098,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_11,4.4581592304708,2.4815662183106717,6,1.0130951662982053,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,11533.138351348207,3753.2933460537092,5318.433009515515,852.917796340055,0.2054842080197463,1,16851.571360863723,4606.211142393764,18536.728496950098,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,2.1251995059712283,1.81785813539899,6,0.7421374760824634,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,11902.281577834136,7599.575824944533,5847.987979500483,2653.8355604614917,0.5293799179359104,1,17750.269557334617,10253.411385406025,19525.296513068082,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_46,3.3284387855065813,3.656805211100984,5,1.6353730064994538,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,1.5031237862604963,0.5898748321904641,6,0.24081539182941505,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,11902.281577834136,5375.073331171296,5847.987979500483,861.1402481881362,0.3290456389447058,1,17750.269557334617,6236.213579359432,19525.296513068082,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_46,2.3814092885958855,3.2783494955507715,5,1.4661224652107339,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,11902.281577834136,8515.765417817043,5847.987979500483,5242.7590029631865,0.6778502527341317,1,17750.269557334617,13758.52442078023,19525.296513068082,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,2.3011272836618835,1.3907441421243283,6,0.5677689184948889,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,5327.213035256437,8228.682166498624,940.977688794969,2030.3048890352393,0.23557614627229287,1,6268.1907240514065,10258.987055533864,11284.885761087251,0,23,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_46,1.4897397922617739,0.6445629006898275,6,0.2631417023030508,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,1.538192492907017,0.7022689038260899,6,0.28670007943293224,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,5327.213035256437,5500.476755411776,940.977688794969,1025.2209199872111,0.9033981621123168,1,6268.1907240514065,6525.6976753989875,11284.885761087251,0,23,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_46,2.1436295571549593,1.2528692527924297,5,0.5603001632326482,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,5327.213035256437,7665.480494616647,940.977688794969,2003.5971038254877,0.33326000277402273,1,6268.1907240514065,9669.077598442134,11284.885761087251,0,23,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,0.7329470119479748,0.32572288111034403,6,0.13297580937826206,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,3575.9352491809864,2620.971055806641,829.2802442309471,475.5128840440988,0.3535271070603958,1,4405.2154934119335,3096.4839398507397,4987.679695538445,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_46,1,0.5185572079144138,5,0.23190583342382426,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.9990853166956046,0.6586820939732294,6,0.2689058388237285,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,3575.9352491809864,3572.664400910962,829.2802442309471,961.5898677603517,0.9980009947161538,1,4405.2154934119335,4534.254268671313,4987.679695538445,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_46,0.6523304943932017,0.4189517424664166,6,0.1710363326487712,fruit_1_log2-1,1,967514 MM WT,fruit,ns,3575.9352491809864,2332.6916090163095,829.2802442309471,611.6148508093858,0.2633251268798988,1,4405.2154934119335,2944.306459825695,4987.679695538445,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,5.561092656913077,2.6398187142296945,6,1.0777014772187858,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,24097.880792980974,19886.10725581702,4370.611311768067,3853.790700481076,0.4891688147549068,1,28468.492104749042,23739.897956298097,39846.73820241175,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_46,6.738903004046348,2.7329868454920367,5,1.2222288736265816,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,8.869704483363698,3.087138057308426,6,1.2603188343220961,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,24097.880792980974,31717.488911878874,4370.611311768067,4506.818544859076,0.255948891398609,1,28468.492104749042,36224.30745673795,39846.73820241175,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_46,6.8312710687961165,2.4168649997471094,6,0.9866810044287022,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,24097.880792980974,24428.183011618305,4370.611311768067,3528.3073834338975,0.9545257467150969,1,28468.492104749042,27956.490395052202,39846.73820241175,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,1.6815602961772995,0.35720315084591464,6,0.14582757568115004,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,15102.432091624176,21803.676345404496,2972.2133726253487,1890.8493912558029,0.09156763252885568,1,18074.645464249523,23694.5257366603,32808.55236635254,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_46,1.1647416600155909,0.5614852174889626,6,0.22922538016059935,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,1.015602740501905,0.19184993852391347,6,0.0783224094279849,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,15102.432091624176,13168.646702559021,2972.2133726253487,1015.5547021669108,0.5601839428915596,1,18074.645464249523,14184.201404725933,32808.55236635254,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_46,1.963707823591772,0.8243833538448794,6,0.3365530948940379,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,15102.432091624176,25462.096078188588,2972.2133726253487,4363.860618495537,0.08203410360557432,1,18074.645464249523,29825.956696684123,32808.55236635254,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,3.5721676540819973,1.4048452103447877,6,0.5735256554896057,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,45540.564148331985,46317.92720022367,8327.62141907961,7436.526538185361,0.9458806223226321,1,53868.185567411594,53754.45373840903,59595.87790203614,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_46,3.5122152486679545,1.5731832602339393,6,0.6422493765768723,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,3.758875110655442,1.027533339040239,6,0.4194887290578026,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,45540.564148331985,48738.83887591883,8327.62141907961,5439.231944114023,0.7554662202545811,1,53868.185567411594,54178.07082003285,59595.87790203614,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_46,3.2375925008066266,1.1318773537089575,6,0.46208699466644315,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,45540.564148331985,41979.7132379804,8327.62141907961,5991.57538271555,0.7364281024701248,1,53868.185567411594,47971.28862069595,59595.87790203614,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,1.0249589073423933,0.29466469316874805,6,0.12029635724620014,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,12966.336321671553,13289.96190849446,2837.5669593664848,1559.803026326182,0.9229184182159555,1,15803.903281038038,14849.764934820643,18480.69458111891,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_46,1,0.5360489647188652,6,0.21884107345140036,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.8268019538640682,0.20251882862749165,6,0.08267796557391752,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,12966.336321671553,10720.592205216675,2837.5669593664848,1072.0303080229967,0.48535282165134075,1,15803.903281038038,11792.622513239672,18480.69458111891,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_46,1.148985680766806,0.35940345580886374,6,0.14672584642077316,leaf_1_log2-1,1,967514 MM WT,leaf,ns,12966.336321671553,14898.134765607152,2837.5669593664848,1902.4966717736734,0.5859815875320709,1,15803.903281038038,16800.631437380827,18480.69458111891,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,10.23134153647431,4.360467365462566,6,1.7801533475735574,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,180207.2007030618,132663.0153838137,33695.08193474855,23082.06700878822,0.27482828531013476,1,213902.28263781033,155745.08239260194,296201.22474798147,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_46,13.898081634815284,6.36538768807481,6,2.5986586417962627,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,14.591590506390542,15.126967621252678,6,6.175558671278615,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,180207.2007030618,189199.4699739695,33695.08193474855,80074.37070601364,0.9205820409677681,1,213902.28263781033,269273.84067998314,296201.22474798147,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_46,9.469878549214174,4.654202049261252,6,1.900070030084314,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,180207.2007030618,122789.63019449406,33695.08193474855,24636.947044801804,0.20166648416129732,1,213902.28263781033,147426.57723929588,296201.22474798147,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,1.460093942901806,0.6221932586621219,6,0.25400933418695143,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,473.984189025494,564.7854356736706,162.07613472203354,98.25448093349452,0.6470096508171277,1,636.0603237475275,663.0399166071651,882.139202272513,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_54,1.225352850329549,0.9369175702702008,5,0.419002275287621,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,1.8413658757583986,0.5678817134577016,6,0.23183673870479599,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,473.984189025494,712.2669287347202,162.07613472203354,89.67780060392798,0.2432246598961257,1,636.0603237475275,801.9447293386481,882.139202272513,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_54,1.4457253406064956,0.701380026248876,5,0.3136666833506147,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,473.984189025494,559.2274526775557,162.07613472203354,121.33080564693921,0.6856687698473434,1,636.0603237475275,680.5582583244949,882.139202272513,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,1.7346620815102343,1.1340967491523875,6,0.4629930590620867,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,342.74953982550335,670.9923592349573,20.517941008645305,179.09240555890173,0.1267652422160036,1,363.26748083414867,850.0847647938591,935.0932412732451,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_54,0.8860825641416744,0.1299291844597623,6,0.053043367437061874,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,1.473410423128541,0.48473639442929684,6,0.19789280435137727,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,342.74953982550335,569.9364426503513,20.517941008645305,76.54779630148333,0.03015519662971793,0.6031039325943586,363.26748083414867,646.4842389518346,935.0932412732451,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_54,1.2246791569927202,0.266481999670363,6,0.10879082080481742,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,342.74953982550335,473.7235947078468,20.517941008645305,42.08186152969832,0.025684286887342755,0.5646359290377574,363.26748083414867,515.8054562375452,935.0932412732451,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,1.3817151591651344,0.49709335050379394,6,0.20293751054412776,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,386.8144501381946,534.4673895400695,90.83569199979122,78.49916155354083,0.2519230291537279,1,477.6501421379858,612.9665510936103,1343.6822699437125,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_54,1,0.5250961592107057,5,0.23483014134383806,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,2.503270239560423,1.603559443333787,6,0.6546504013982024,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,386.8144501381946,968.3011012628718,90.83569199979122,253.228235049594,0.07218231267929662,1,477.6501421379858,1221.5293363124658,1343.6822699437125,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_54,1.0473889469684952,0.37093877725128066,6,0.15143512167959103,fruit_1_log2-1,1,967514 MM WT,fruit,ns,386.8144501381946,405.14517960244115,90.83569199979122,58.57729332410159,0.8700964238937671,1,477.6501421379858,463.72247292654276,1343.6822699437125,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,1.4894334908104552,0.5093867323536727,6,0.20795626266836023,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,611.689715076907,576.134396765258,81.39744518979091,80.44048739685573,0.7632151512798725,1,693.0871602666979,656.5748841621137,1020.7705707256738,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_54,1.5813517691967625,0.47053624954848566,5,0.21043020797364373,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,2.1794040037029956,0.53793221063194685,6,0.219609905375939,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,611.689715076907,843.024961321354,81.39744518979091,84.94828479289478,0.08097565966209483,1,693.0871602666979,927.9732461142488,1020.7705707256738,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_54,2.038481330860775,0.7381501684852468,6,0.3013485443897145,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,611.689715076907,788.514035113886,81.39744518979091,116.56597149805276,0.24669370000099772,1,693.0871602666979,905.0800066119389,1020.7705707256738,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,1.0418963584133945,0.14787787241076245,6,0.060370888609127024,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,7729.957270105573,5788.122863734981,387.4014765281681,335.38280256071357,0.0036763587136518206,0.08455625041399187,8117.358746633741,6123.505666295695,8929.094621297116,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_54,1.3914380395887358,0.17081408372870488,6,0.06973455766939493,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.9814600776882944,0.10259977542418242,6,0.04188618291889874,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,7729.957270105573,5452.376783580949,387.4014765281681,232.69336827000342,9.321780154929154e-4,0.022372272371829968,8117.358746633741,5685.070151850953,8929.094621297116,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_54,1.236047514580117,0.26026948712493314,6,0.10625457317866037,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,7729.957270105573,6866.704948176155,387.4014765281681,590.2837834353825,0.2537921035385813,1,8117.358746633741,7456.988731611537,8929.094621297116,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,1.5746250199919043,0.310402437076852,6,0.12672126429244165,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,10947.630823279702,8747.62926890668,1491.449661984344,703.9838859686865,0.22329493516490626,1,12439.080485264047,9451.613154875366,13682.988533790452,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_54,1.9706383151426496,0.6576139299273388,6,0.2684697626780587,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,1.649488704626713,0.6533282934479412,6,0.26672015891179507,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,10947.630823279702,9163.52495872178,1491.449661984344,1481.7299605186345,0.4159463242744369,1,12439.080485264047,10645.254919240415,13682.988533790452,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_54,1.4785191289983193,0.3008375374946153,6,0.12281641038953499,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,10947.630823279702,8213.725200130888,1491.449661984344,682.2909661571836,0.13944014384766443,1,12439.080485264047,8896.016166288071,13682.988533790452,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,1.224976804706846,0.14663953861151127,6,0.05986534095255912,leaf_1_panK4-1,1,967514 MM WT,leaf,*,5555.372966797932,6805.2030258229215,370.19425146075554,332.57429677598816,0.031077070177157818,0.6031039325943586,5925.567218258688,7137.777322598909,9511.102912639031,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_54,1,0.16322702853793827,6,0.06663715535810949,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.9998316538082502,0.2602553268252487,6,0.10624879226052175,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,5555.372966797932,5554.437740915222,370.19425146075554,590.2516682790317,0.9989603126129905,1,5925.567218258688,6144.689409194254,9511.102912639031,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_54,1.421191320880628,0.33122521299185065,6,0.13522212696245195,leaf_1_log2-1,1,967514 MM WT,leaf,*,5555.372966797932,7895.247844668086,370.19425146075554,751.2093486401233,0.025665269501716242,0.5646359290377574,5925.567218258688,8646.45719330821,9511.102912639031,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,2.365000791455282,0.3720265251681032,6,0.15187919290708946,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,18003.99538067502,13138.461463306387,2660.339385067128,843.7455624951331,0.1319352496368836,1,20664.334765742147,13982.20702580152,23867.747104663562,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_54,3.2408256814217755,1.1730038784056789,6,0.4788768280665995,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,3.0393419960592603,2.122281305727357,6,0.8664177149466086,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,18003.99538067502,16884.678361761282,2660.339385067128,4813.273551569227,0.8439346808156253,1,20664.334765742147,21697.951913330508,23867.747104663562,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_54,2.4779301876673525,0.5193477757452158,6,0.2120228416041941,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,18003.99538067502,13765.826378179738,2660.339385067128,1177.8659625916198,0.18922392583445097,1,20664.334765742147,14943.692340771358,23867.747104663562,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.7475554095659435,0.3292248221727628,6,0.13440547083029972,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,99.79753214803992,86.1690686276392,7.8368315946095235,15.49262314432442,0.4572248059298024,1,107.63436374264944,101.66169177196363,183.74204384290312,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_109,0.8657884575842877,0.15202587307115076,5,0.06798803730516956,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,1.3373468096610235,0.2738158658134167,6,0.1117848591202099,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,99.79753214803992,154.153026713493,7.8368315946095235,12.885194961873463,0.0069216263890896695,0.15227578055997273,107.63436374264944,167.03822167536646,183.74204384290312,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_109,1.1670779981811847,0.41801266139554594,5,0.18694094526720856,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,99.79753214803992,134.52651513481044,7.8368315946095235,21.548271788172876,0.1898395466344814,1,107.63436374264944,156.07478692298332,183.74204384290312,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.8234891674932708,0.15813923237688937,6,0.06456007127313267,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,82.10830402830325,94.92178597041597,9.074015443593144,7.4416974861702405,0.3014473274188934,1,91.18231947189639,102.36348345658621,187.26006295141897,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_109,0.7123264510596683,0.19282668228486918,6,0.0787211633986163,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.9929194331902199,0.2951218614225465,6,0.1204829954042677,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,82.10830402830325,114.451640220172,9.074015443593144,13.887810009270053,0.08447018272501171,1,91.18231947189639,128.33945022944204,187.26006295141897,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_109,1.2638822197770183,0.521729716377277,6,0.2129952647952195,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,82.10830402830325,145.68492494282714,9.074015443593144,24.55149592209919,0.049059895088730245,0.8830781115971444,91.18231947189639,170.23642086492632,187.26006295141897,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.8791224050645738,0.14846125120962905,6,0.06060905200645718,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,115.26780159034894,101.33450696061367,16.876269432187403,6.986272181259448,0.4777616946236213,1,132.14407102253634,108.32077914187312,174.30023204209235,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_109,1,0.32738097835061325,5,0.14640922442647164,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,1.0641042933899252,0.3572653324558145,6,0.14585296121708996,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,115.26780159034894,122.65696256190834,16.876269432187403,16.81215019493638,0.7635713265468416,1,132.14407102253634,139.4691127568447,174.30023204209235,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_109,1.2525558118007443,0.299108262539774,6,0.12211043684547906,fruit_1_log2-1,1,967514 MM WT,fruit,ns,115.26780159034894,144.37935479548662,16.876269432187403,14.075401606415516,0.22061064586266685,1,132.14407102253634,158.45475640190213,174.30023204209235,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.6790814479786326,0.19577911001071407,6,0.0799264869704106,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,*,28.693733564626175,78.27622560928788,9.376686347505984,9.212950441918899,0.004537626057878747,0.10436539933121118,38.07041991213216,87.48917605120678,127.83599832921661,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_109,0.24893103857919527,0.1818973537053482,5,0.08134696956249636,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.5721418251092253,0.34129477398236413,6,0.1393330080225507,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,28.693733564626175,65.9495303782303,9.376686347505984,16.06060952372987,0.08079263152420549,1,38.07041991213216,82.01013990196017,127.83599832921661,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_109,0.8227032108953343,0.45440534329846133,6,0.18551020457924164,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,*,28.693733564626175,94.83119048122639,9.376686347505984,21.383353454425066,0.026123179136063504,0.52246358272127,38.07041991213216,116.21454393565145,127.83599832921661,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.9923701267813128,0.24987948893472048,6,0.10201287417958342,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,1695.861336972824,1747.2400455219538,63.779538727328905,179.61139106784037,0.7961875345628069,1,1759.6408757001527,1926.851436589794,2382.5033273547724,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_109,0.9631888499170174,0.08873155787573392,6,0.03622450681296369,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,1.0573703613474663,0.4232487838815727,6,0.1727905924605611,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,1695.861336972824,1861.684253118835,63.779538727328905,304.22786265823066,0.6147909119822912,1,1759.6408757001527,2165.9121157770655,2382.5033273547724,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_109,0.8031296404694297,0.22504759503957183,6,0.09187529594790894,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,1695.861336972824,1414.0492863536904,63.779538727328905,161.76242305381567,0.1522700446705359,1,1759.6408757001527,1575.811709407506,2382.5033273547724,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.7426645729971644,0.14207267557768888,6,0.05800092692621851,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,1075.5597803910264,1307.5900284703562,82.83755233377164,102.12071027528425,0.10938694224232279,1,1158.397332724798,1409.7107387456404,1952.4209066517105,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_109,0.610879654666267,0.11524550374395645,6,0.04704877988711695,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.869483214666203,0.17418093212171576,6,0.07110906777009263,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,1075.5597803910264,1530.8762835307864,82.83755233377164,125.1998699422962,0.014786693575974738,0.3105205650954695,1158.397332724798,1656.0761534730825,1952.4209066517105,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_109,0.9404310091833721,0.16574458833962394,6,0.06766494484328821,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,1075.5597803910264,1655.7922038879678,82.83755233377164,119.13589306813232,0.0031740251213632905,0.07617660291271897,1158.397332724798,1774.9280969561003,1952.4209066517105,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,1.1746230819794259,0.26590623132623864,6,0.10855576436262543,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,1760.6737631139824,2068.1280419892596,231.5502632211366,191.13128614805848,0.3308049691203486,1,1992.224026335119,2259.259328137318,3210.4689915389054,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_109,1,0.3221380397557505,6,0.1315123040236651,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,1.4981649270129458,0.3906950456819102,6,0.15950058449234072,leaf_1_transp1-1,1,967514 MM WT,leaf,*,1760.6737631139824,2637.779679809268,231.5502632211366,280.8284943170093,0.03753198905518197,0.7131077920484574,1992.224026335119,2918.6081741262774,3210.4689915389054,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_109,1.0980098049564615,0.3218348442713521,6,0.1313885249854831,leaf_1_log2-1,1,967514 MM WT,leaf,ns,1760.6737631139824,1933.237055228743,231.5502632211366,231.33232871618603,0.609536789463216,1,1992.224026335119,2164.569383944929,3210.4689915389054,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.557773837104098,0.08376526464728327,6,0.03419702609250646,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,956.9044131587275,982.0577607405977,105.70331597276385,60.209806617600385,0.8413960384388539,1,1062.6077291314914,1042.267567358198,1317.2120338957104,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_109,0.5434876313862465,0.14705687883683902,6,0.06003571938609097,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.6112178922026507,0.16876950484072228,6,0.06889986183365754,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,956.9044131587275,1076.1553063470374,105.70331597276385,121.31017901269927,0.4759638038688606,1,1062.6077291314914,1197.4654853597367,1317.2120338957104,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_109,0.5410716599381296,0.1313497973059088,6,0.05362333020291219,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,956.9044131587275,952.6506756175954,105.70331597276385,94.41319057906506,0.9766544123156378,1,1062.6077291314914,1047.0638661966605,1317.2120338957104,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.8972093046134688,0.2616582149567469,6,0.10682151894191792,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,127.56726455889998,72.88867280025754,71.7794899564418,8.678107440647116,0.49046840626450355,1,199.3467545153418,81.56678024090465,219.28142996687598,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_28,1.57026506765985,1.9756913418796007,5,0.8835560286001128,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,1.346107675275416,0.7460314325438564,6,0.30456605696833616,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,127.56726455889998,109.35687067950656,71.7794899564418,24.742739022299247,0.820060202268974,1,199.3467545153418,134.0996097018058,219.28142996687598,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_28,1.1008836520561969,0.9705155489858028,5,0.43402774815055645,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,127.56726455889998,89.43503805998326,71.7794899564418,35.26011863509108,0.6508535292923301,1,199.3467545153418,124.69515669507433,219.28142996687598,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,1.0141245433380246,0.47775613970122993,6,0.19504312729164164,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,86.85286698928837,82.38678716101917,29.681113735474565,15.845170813541776,0.8978313863098676,1,116.53398072476294,98.23195797456094,128.18737879723923,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_28,1.0690989066118677,0.8949309847877767,6,0.36535404462275123,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,1.1112812031237596,0.7825130663870669,6,0.31945962161815544,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,86.85286698928837,90.27972802673972,29.681113735474565,25.952682070156786,0.9324841172885745,1,116.53398072476294,116.2324100968965,128.18737879723923,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_28,1.0215646986665177,0.6922890936418001,6,0.2826258389860421,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,86.85286698928837,82.99122031227283,29.681113735474565,22.960330657322796,0.9201967622207808,1,116.53398072476294,105.95155096959563,128.18737879723923,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.8850031878435289,0.3831712328883063,6,0.15642900078158178,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,81.2393188807366,71.89705618768888,23.571389191032086,12.708185476689918,0.7386581961048688,1,104.81070807176869,84.6052416643788,162.17316814422705,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_28,1,0.6487896412896861,5,0.29014754820428845,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,1.157986553537003,1.2363006787819137,6,0.5047176386120298,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,81.2393188807366,94.07403888239776,23.571389191032086,41.00291718793506,0.7931579178460858,1,104.81070807176869,135.0769560703328,162.17316814422705,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_28,1.3510713164040185,1.1358093135217517,6,0.463692210538189,fruit_1_log2-1,1,967514 MM WT,fruit,ns,81.2393188807366,109.76011350396264,23.571389191032086,37.67003935442559,0.5386681758481013,1,104.81070807176869,147.43015285838823,162.17316814422705,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,1.3855510780944256,1.412002811983096,6,0.5764477341222665,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,80.58597426466274,112.56122585886142,37.58414414069468,46.830221290436874,0.6074132139679391,1,118.17011840535741,159.3914471492983,175.33059186422815,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_28,0.9919577782645741,1.0344830844547048,5,0.4626348996828752,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,1.1541693700559064,0.6488459598540924,6,0.2648902538848176,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,80.58597426466274,93.76393349635067,37.58414414069468,21.519503803747973,0.7704322437089403,1,118.17011840535741,115.28343730009865,175.33059186422815,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_28,0.6791536538809118,0.3051316193761595,6,0.12456946197678727,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,80.58597426466274,55.17398025664881,37.58414414069468,10.119938244334016,0.5451581462180481,1,118.17011840535741,65.29391850098283,175.33059186422815,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.8107353162279457,0.5949680379875913,6,0.2428946843890729,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,524.2097360890472,440.8945416782723,118.3031619291325,132.0911256808989,0.6486613040443207,1,642.5128980181796,572.9856673591712,706.7641878199977,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_28,0.9639387789655319,0.532863958709397,6,0.21754080019291783,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.3642793243648022,0.18331976996429714,6,0.07483998269615294,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,524.2097360890472,198.10258976498505,118.3031619291325,40.69952203827876,0.039300761582636276,0.9432182779832706,642.5128980181796,238.8021118032638,706.7641878199977,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_28,0.6442547832277002,0.27290347356056793,6,0.1114123765427519,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,524.2097360890472,350.3590033511612,118.3031619291325,60.5883421011511,0.22977249364323885,1,642.5128980181796,410.94734545231233,706.7641878199977,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.8430983915537948,0.4940443080080133,6,0.20169274415767363,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,358.9988639482563,458.49424774446004,70.16671337524036,109.68466306484224,0.46546016681499836,1,429.1655773234967,568.1789108093022,624.9968018902325,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_28,0.6601421201103207,0.3160466047488706,6,0.12902548609563463,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.6951921242483599,0.5416261908957396,6,0.22111796650363963,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,358.9988639482563,378.0597771722677,70.16671337524036,120.24849855072016,0.8944643883133836,1,429.1655773234967,498.30827572298784,624.9968018902325,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_28,0.6716108098609912,0.28534307166997874,6,0.11649082120497638,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,358.9988639482563,365.2357733440356,70.16671337524036,63.350104771374276,0.9487109116438501,1,429.1655773234967,428.58587811540986,624.9968018902325,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.5584568466048493,0.18507264729122738,6,0.07555559186826508,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,543.8205698619286,303.7003205639448,148.85262032021146,41.0886850260552,0.17300858249249582,1,692.67319018214,344.78900559,959.0357026108062,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_28,1,0.6704655668933762,6,0.27371642149910563,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.5483489687557106,0.17223245434168086,6,0.07031360504738655,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,543.8205698619286,298.20344867193137,148.85262032021146,38.23798476591633,0.16409937939136046,1,692.67319018214,336.4414334378477,959.0357026108062,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_28,1.339408622547841,0.6461430178531686,6,0.26378678243371745,leaf_1_log2-1,1,967514 MM WT,leaf,ns,543.8205698619286,728.3979603919477,148.85262032021146,143.45267834514877,0.39294009921713147,1,692.67319018214,871.8506387370965,959.0357026108062,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.5436650088972352,0.27556937227620115,6,0.11250072513595898,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,221.26482630199942,295.65621495248496,33.26408051355073,61.1802084533174,0.31767444852324084,1,254.52890681555016,356.83642340580235,530.6654122829154,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_28,0.40687101327957614,0.14982887469987274,6,0.06116738195834739,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.6285013531647463,0.6334341678695212,6,0.2585984161541317,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,221.26482630199942,341.79196403704555,33.26408051355073,140.63113803833204,0.43863143645337443,1,254.52890681555016,482.4231020753776,530.6654122829154,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_28,0.5313172445388171,0.31494340345420047,6,0.12857510605304803,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,221.26482630199942,288.9412467025692,33.26408051355073,69.92178744382649,0.41048831101137306,1,254.52890681555016,358.86303414639565,530.6654122829154,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.9144986760139251,0.4299104899875046,6,0.17551022258988047,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,102.77547900711112,92.06813933258167,40.467836009155384,17.669680724011773,0.817176910407412,1,143.2433150162665,109.73782005659343,157.56764651789317,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_31,1.0208530351545724,0.8988116612110193,5,0.40196079468747,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,1.0726721931017018,0.44460569976793574,6,0.18150951686074931,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,102.77547900711112,107.9924285545599,40.467836009155384,18.27366613734779,0.9105616759676973,1,143.2433150162665,126.26609469190768,157.56764651789317,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_31,0.657493871541589,0.33578151583615906,5,0.15016605899951474,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,102.77547900711112,66.19390378919238,40.467836009155384,15.118129753073019,0.43506358121661354,1,143.2433150162665,81.3120335422654,157.56764651789317,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.8457212699615184,0.2928204889146738,6,0.11954346401220815,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,90.63433132622828,85.14389988921029,7.123078756795345,12.035167015165644,0.7047262583835722,1,97.75741008302363,97.17906690437593,115.32090106182154,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_31,0.900256881480294,0.17330739170584186,6,0.07075244638866102,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.834072851967208,0.2541464741956111,6,0.10375486361777651,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,90.63433132622828,83.97118285961452,7.123078756795345,10.445632662511368,0.6111738879285882,1,97.75741008302363,94.41681552212589,115.32090106182154,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_31,0.8876595968405239,0.37641804902960496,6,0.15367202501607882,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,90.63433132622828,89.36608612495377,7.123078756795345,15.471096658520349,0.9427177501556809,1,97.75741008302363,104.83718278347412,115.32090106182154,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.657360348173561,0.5476423810096844,6,0.2235740658327632,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,100.67607722942154,66.18046118028086,15.809230476584567,22.508559918275047,0.24300131546054515,1,116.4853077060061,88.68902109855591,128.32282020074547,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_31,1,0.3511312219391249,5,0.15703065625568974,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.9543603399095021,0.5006188627880878,6,0.20437679490720007,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,100.67607722942154,96.08125528542602,15.809230476584567,20.575853987978924,0.8634515658976629,1,116.4853077060061,116.65710927340496,128.32282020074547,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_31,0.6414990572310424,0.4308105963092259,6,0.17587768945695892,fruit_1_log2-1,1,967514 MM WT,fruit,ns,100.67607722942154,64.58360862839353,15.809230476584567,17.70667584670101,0.1627089260041724,1,116.4853077060061,82.29028447509455,128.32282020074547,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,1.360501658496585,0.3669776374110501,6,0.1498179931115286,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,163.61302797402348,136.9699700415583,37.71100429068172,15.083087844853198,0.5393738760808966,1,201.3240322647052,152.0530578864115,281.96341907651004,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_31,1.6251430575823953,0.8375809965419236,5,0.3745776089859515,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,1.4980217568748355,0.3548183504139962,6,0.14485398498172186,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,163.61302797402348,150.81495408648468,37.71100429068172,14.583330979009297,0.7639316160438525,1,201.3240322647052,165.39828506549398,281.96341907651004,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_31,2.188218806599233,0.8766024866948409,6,0.35787146660954006,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,163.61302797402348,220.30128556805704,37.71100429068172,36.029095410588404,0.3060101058062042,1,201.3240322647052,256.33038097864545,281.96341907651004,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.9469789413278159,0.08822399965359533,6,0.03601729703646474,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,622.6376018892105,567.3445396883089,5.814990720050899,21.57832230072416,0.05011937363603629,1,628.4525926092614,588.9228619890331,835.7807842435226,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_31,1.0392709470542647,0.02377486683727094,6,0.009706048742321852,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,1.0813891284673567,0.4576298666096062,6,0.18682661070857742,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,622.6376018892105,647.8710249395838,5.814990720050899,111.92968800907308,0.8307393079511264,1,628.4525926092614,759.8007129486568,835.7807842435226,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_31,0.9828164493889678,0.07333335595612493,6,0.029938217203065953,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,622.6376018892105,588.8151486186631,5.814990720050899,17.9362848706498,0.12268315415620552,1,628.4525926092614,606.751433489313,835.7807842435226,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.9458180363825512,0.058741477770110836,6,0.023981107878968764,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,615.1727567931816,566.6490299435309,29.32300588658978,14.367321190619148,0.17929968328333268,1,644.4957626797714,581.01635113415,859.6799708493384,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_31,1.0268110560855472,0.11988850778700483,6,0.048944278350308255,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,1.094924586509401,0.37154205725042233,6,0.15168140970791166,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,615.1727567931816,655.9802530091821,29.32300588658978,90.87384715160105,0.6839576705378994,1,644.4957626797714,746.8541001607831,859.6799708493384,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_31,1.1452864605663633,0.3899439743433242,6,0.15919396090234658,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,615.1727567931816,686.1525546388515,29.32300588658978,95.3746915878197,0.5038390207620134,1,644.4957626797714,781.5272462266712,859.6799708493384,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.9268487316700159,0.07599726190469583,6,0.031025752252526538,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,599.1099853739104,555.2843300746506,22.522604997628076,18.587837978225735,0.16539872063872618,1,621.6325903715384,573.8721680528763,683.7958494086923,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_31,1,0.09208474448646631,6,0.03759343951440151,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.9697664434751339,0.14919110760188753,6,0.06090701463088083,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,599.1099853739104,580.9967597664966,22.522604997628076,36.49000064467557,0.6834254253498748,1,621.6325903715384,617.4867604111721,683.7958494086923,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_31,0.9054640598447207,0.058141263128913184,6,0.023736071277788443,leaf_1_log2-1,1,967514 MM WT,leaf,ns,599.1099853739104,542.4725596501721,22.522604997628076,14.220517316069923,0.0643958526405248,1,621.6325903715384,556.6930769662421,683.7958494086923,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,1.1951980983706232,0.25530284279995313,6,0.10422694912364523,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,861.904905932057,716.0551152337496,128.31767896240558,62.44340596503441,0.33968294524926734,1,990.2225848944626,778.498521198784,1089.2448433839088,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_31,1.4386421975493093,0.5246329490569107,6,0.21418050457349874,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,1.3222045245790064,0.745167822235801,6,0.30421348953644556,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,861.904905932057,792.1459333818466,128.31767896240558,182.25733926672612,0.761454465380579,1,990.2225848944626,974.4032726485727,1089.2448433839088,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_31,1.106000412269229,0.234630842932419,6,0.09578764051725523,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,861.904905932057,662.6158908181567,128.31767896240558,57.38733190929417,0.19966008737229263,1,990.2225848944626,720.0032227274509,1089.2448433839088,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,1.113106257423604,0.07190619661465725,6,0.02935558184169224,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,481.26413198214993,341.1612173750279,71.50002567923256,8.99733154051679,0.1216011735112425,1,552.7641576613825,350.15854891554466,608.0405734275207,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_34,1.57021985354799,0.5216367358976172,5,0.23328304020563534,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,1.0629702052659975,0.14603812671872757,6,0.05961981557546553,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,481.26413198214993,325.79478090556006,71.50002567923256,18.27316011005038,0.09484041750474505,1,552.7641576613825,344.0679410156104,608.0405734275207,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_34,1.2464304116185256,0.33617030894413624,5,0.15033993256323883,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,481.26413198214993,382.0243698793675,71.50002567923256,46.07839913870429,0.2824332385599109,1,552.7641576613825,428.1027690180718,608.0405734275207,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,1.3013080164219715,0.061039589514786635,6,0.024919308070027586,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,471.4475545368258,398.844067313019,14.273447112262815,7.637636946711215,0.0022866846957814812,0.054880432698755546,485.72100164908863,406.48170425973024,534.2931018139975,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_34,1.5381913191648977,0.11407263251347645,6,0.04656995721233924,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,1.3903780232099503,0.20033147808683544,6,0.0817849834550494,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,471.4475545368258,426.1435562384727,14.273447112262815,25.0666675642475,0.1552373865407705,1,485.72100164908863,451.2102238027202,534.2931018139975,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_34,1.4115594209020064,0.10012412754746787,6,0.040875503905439536,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,471.4475545368258,432.6355433009229,14.273447112262815,12.528127103943232,0.06870260594092294,1,485.72100164908863,445.16367040486614,534.2931018139975,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,1.0390914257214503,0.12375372611583205,6,0.05052224712532156,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,306.4947439651267,318.4760604828544,18.34070265998307,15.48480319721829,0.6305665603458355,1,324.8354466251098,333.9608636800727,378.9340751339744,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_34,1,0.1338067249450112,5,0.05984018656473237,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,1.0530115342856445,0.17376908100879007,6,0.07094093025731507,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,306.4947439651267,322.7425005932039,18.34070265998307,21.7430222558637,0.5818963283956637,1,324.8354466251098,344.4855228490676,378.9340751339744,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_34,1.0911566518616678,0.0784665930125099,6,0.03203385245588087,fruit_1_log2-1,1,967514 MM WT,fruit,ns,306.4947439651267,334.43377863818677,18.34070265998307,9.818207406681854,0.22625177688265327,1,324.8354466251098,344.2519860448686,378.9340751339744,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,1.54601725317415,0.12013261739623982,6,0.04904393568096424,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,536.5557691849363,473.8461621772796,26.317768286195214,15.031708509579275,0.0805095510209153,1,562.8735374711315,488.8778706868589,671.6592147463177,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_34,1.7506198058847826,0.19200433306848633,5,0.08586694814312924,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,1.7873005982586236,0.5019026368315485,6,0.20490089346578477,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,536.5557691849363,547.7982392519947,26.317768286195214,62.801046881021406,0.8737642287336843,1,562.8735374711315,610.5992861330161,671.6592147463177,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_34,1.488252729689743,0.3425034196802304,6,0.1398264355624811,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,536.5557691849363,456.1416393416587,26.317768286195214,42.856067567278934,0.1482600640575192,1,562.8735374711315,498.99770690893763,671.6592147463177,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.9580124853190192,0.10295571173123304,6,0.04203149330776618,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,51121.150229780935,51610.26366825283,3572.295960740689,2264.3300429032,0.910633112249938,1,54693.44619052162,53874.593711156034,72513.7763081729,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_34,0.9489333458709944,0.16242697229822045,6,0.06631053376596974,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.9301061463202943,0.12614278361539483,6,0.051497575765337936,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,51121.150229780935,50106.88710916736,3572.295960740689,2774.2889620482,0.8273553406754867,1,54693.44619052162,52881.17607121556,72513.7763081729,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_34,1.1443830471390972,0.1942030243997871,6,0.07928305271412496,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,51121.150229780935,61650.460411963984,3572.295960740689,4271.154413647749,0.08883858799873903,1,54693.44619052162,65921.61482561173,72513.7763081729,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.8620626774858402,0.06351221818857418,6,0.025928754499053276,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,43767.717192848075,46441.23408139987,6086.63064062151,1396.8396829817068,0.6847480953646586,1,49854.34783346958,47838.073764381574,70134.29750185249,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_34,0.8124356774106712,0.27675002220385575,6,0.11298272345056025,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.6900159946955371,0.1572189410874596,6,0.06418436392749417,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,43767.717192848075,37172.69656427245,6086.63064062151,3457.7544619097325,0.37396859643430636,1,49854.34783346958,40630.451026182185,70134.29750185249,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_34,1.1267038334574073,0.13915230028490955,6,0.05680868870542845,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,43767.717192848075,60698.04184379099,6086.63064062151,3060.4104306203576,0.04021710016534002,0.9249933038028204,49854.34783346958,63758.45227441135,70134.29750185249,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.9114896933751574,0.18146219452705242,6,0.07408163069949011,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,53872.22448470133,49103.97737699806,8044.532920805756,3990.9422392356732,0.6111565812553367,1,61916.75740550709,53094.91961623373,85768.58119889823,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_34,1,0.36577292034026065,6,0.14932616942688617,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.9225029922171568,0.24678018080998967,6,0.10074758693604131,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,53872.22448470133,49697.28828453136,8044.532920805756,5427.49661971038,0.6774144593722733,1,61916.75740550709,55124.78490424174,85768.58119889823,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_34,1.2690611450218288,0.4366927753315941,6,0.17827907898704312,leaf_1_log2-1,1,967514 MM WT,leaf,ns,53872.22448470133,68367.14688942806,8044.532920805756,9604.290564115789,0.274973660985181,1,61916.75740550709,77971.43745354384,85768.58119889823,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.4732039851547961,0.10626441989041763,6,0.04338226775739712,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,23826.379007651816,25492.551315314453,1704.5102418364836,2337.099267281918,0.5785090763459908,1,25530.8892494883,27829.650582596372,30612.615640856013,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_34,0.44227575964341415,0.07750153987112618,6,0.031639871160704186,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.43798756634030955,0.16767153171490487,6,0.06845161618206731,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,23826.379007651816,23595.36449539317,1704.5102418364836,3687.640833300944,0.956232457341729,1,25530.8892494883,27283.00532869411,30612.615640856013,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_34,0.4820621009542402,0.06370500422542567,6,0.026007459069023204,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,23826.379007651816,25969.757718173583,1704.5102418364836,1401.0796732430997,0.35508462782434547,1,25530.8892494883,27370.837391416684,30612.615640856013,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,1.085698753451508,0.08471066703569133,6,0.0345829850013745,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,46.92967360200102,49.29436518423791,0.9168451017441558,1.570183521349063,0.23030016268357364,1,47.846518703745176,50.86454870558698,68.40446138167307,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_42,1.0336168837786475,0.045153667679135964,5,0.020193334072796634,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.92060060121601,0.08989124278867965,6,0.03669794619615052,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,46.92967360200102,41.798355281245016,0.9168451017441558,1.6662098538417052,0.028405595532126897,0.6533286972389186,47.846518703745176,43.46456513508672,68.40446138167307,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_42,1.238525905890456,0.2931614986415465,5,0.13110580786964204,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,46.92967360200102,56.233230535646996,0.9168451017441558,5.952643447692162,0.19411579473417037,1,47.846518703745176,62.18587398333916,68.40446138167307,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.9806563879161854,0.07395180115121887,6,0.03019069639670864,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,47.20488920389556,44.52508944356565,1.7894707268880534,1.3707588855698933,0.2637773567716173,1,48.99435993078362,45.89584832913554,53.89379592386198,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_42,1.0396784535907457,0.09654110927446898,6,0.03941274282078695,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.9946534511743883,0.058798840687734076,6,0.02400452619202447,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,47.20488920389556,45.16060306607211,1.7894707268880534,1.089886007902752,0.35692671645685503,1,48.99435993078362,46.25048907397486,53.89379592386198,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_42,0.9733320993789163,0.0893085058282491,6,0.03646004482826465,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,47.20488920389556,44.192542175989736,1.7894707268880534,1.6554083337431382,0.24497250154841216,1,48.99435993078362,45.847950509732875,53.89379592386198,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,1.063091438831125,0.1558897309226794,6,0.06364171615005548,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,45.403354316773296,48.267917268377886,3.2002017394952453,2.889547387688482,0.5238547288177025,1,48.603556056268545,51.15746465606637,56.27321112167301,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_42,0.9999999999999999,0.15760660724092937,5,0.07048381749876573,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.9887954732671336,0.09690160445953806,6,0.039559914363811864,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,45.403354316773296,44.8946312195692,3.2002017394952453,1.7961528086013592,0.8940017164611551,1,48.603556056268545,46.690784028170555,56.27321112167301,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_42,1.033405101312415,0.05951599423531617,6,0.024297302901824955,fruit_1_log2-1,1,967514 MM WT,fruit,ns,45.403354316773296,46.92005796764858,3.2002017394952453,1.1031790525935232,0.6730314284173273,1,48.603556056268545,48.02323702024211,56.27321112167301,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.9986253380506601,0.16605614110062056,6,0.06779213572535436,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,44.611568620898424,45.34094005322163,2.081185577191857,3.0779903582290498,0.8490305517440981,1,46.692754198090284,48.41893041145068,53.26082345259575,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_42,0.9825610748855539,0.10249622510101483,5,0.04583770535259788,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.9395888181499786,0.20610663511519337,6,0.0841426814390369,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,44.611568620898424,42.66048402254175,2.081185577191857,3.8203599785399756,0.6663591373624005,1,46.692754198090284,46.48084400108173,53.26082345259575,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_42,0.927501750790261,0.10090097302533321,6,0.04119264974373264,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,44.611568620898424,42.11169062055779,2.081185577191857,1.8702844715614337,0.39597484144703543,1,46.692754198090284,43.98197509211922,53.26082345259575,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,1.0294598072799257,0.0478202485302183,6,0.01952253471201868,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,158.94702995466218,176.78800844042186,2.9462468374615667,3.3525835657110923,0.0026128861443707884,0.06270926746489892,161.89327679212374,180.14059200613295,198.15465120674625,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_42,0.925569444830229,0.04202438305781604,6,0.01715638254115193,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.9501177978677271,0.07702839604833697,6,0.03144671100390695,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,158.94702995466218,163.16269181275706,2.9462468374615667,5.400309338031809,0.5131768947876383,1,161.89327679212374,168.56300115078886,198.15465120674625,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_42,0.9457693532169146,0.032901425391056095,6,0.013431950669722989,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,158.94702995466218,162.41593816177016,2.9462468374615667,2.3066542195994897,0.3769464693246206,1,161.89327679212374,164.72259238136965,198.15465120674625,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.9829335915376727,0.09269528378910442,6,0.037842691140964516,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,170.56888222906514,168.79811222186484,8.127226613048585,6.49868402197655,0.8684327372962044,1,178.69610884211372,175.29679624384138,196.5657197263251,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_42,0.9932450180107177,0.11592432787427172,6,0.047325908677843774,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.9129441213689053,0.03280747524176694,6,0.013393595681886866,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,170.56888222906514,156.7788969446508,8.127226613048585,2.3000675594255267,0.15540329856221793,1,178.69610884211372,159.0789645040763,196.5657197263251,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_42,0.986062840075259,0.08620199770048576,6,0.035191818195793166,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,170.56888222906514,169.33549465580046,8.127226613048585,6.043452506096681,0.9056816266475792,1,178.69610884211372,175.37894716189714,196.5657197263251,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.9902943792630547,0.0907879442085004,6,0.03706402301784887,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,171.72890790902974,170.0621722592949,6.410072165529577,6.364964195570327,0.857302671115534,1,178.13898007455933,176.42713645486523,197.06737139629516,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_42,1,0.09143135079087669,6,0.037326692655177185,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.9955465848510613,0.11679158102715005,6,0.04767996329490575,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,171.72890790902974,170.96412778903698,6.410072165529577,8.188028025776788,0.9429042952325952,1,178.13898007455933,179.15215581481377,197.06737139629516,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_42,1.0112457661520928,0.06909501580029082,6,0.02820792208004233,leaf_1_log2-1,1,967514 MM WT,leaf,ns,171.72890790902974,173.66013104892897,6.410072165529577,4.844115653188675,0.8152596020805765,1,178.13898007455933,178.50424670211765,197.06737139629516,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.9118565589648672,0.1058229347798753,6,0.043202032215752965,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,155.57157896848796,156.59213104072242,5.675416064320361,7.419037811861978,0.9153060856238632,1,161.24699503280831,164.0111688525844,183.62577381634952,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_42,0.9059137501235328,0.08095243605080084,6,0.03304869362662464,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.9294955152197757,0.1042857942991309,6,0.04257449724228626,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,155.57157896848796,159.62124973503302,5.675416064320361,7.311271916193819,0.6715795978739605,1,161.24699503280831,166.93252165122684,183.62577381634952,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_42,0.8592585776884795,0.03340857423144952,6,0.013638993316824334,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,155.57157896848796,147.55953715790878,5.675416064320361,2.342209427276796,0.23521496349221377,1,161.24699503280831,149.90174658518558,183.62577381634952,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.9887435742319312,0.019416409043211274,6,0.007926715798838094,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,65.27125361129964,62.16279960331607,1.3810591915143624,0.4983565593317606,0.08736959428058107,1,66.65231280281401,62.66115616264783,430.2985468389849,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_78,1.0381857477794898,0.049119100311645805,5,0.021966729458094223,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,1.0014971644194859,0.02425061219545105,6,0.009900270971495,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,65.27125361129964,62.96462415288913,1.3810591915143624,0.6224349532664674,0.18209208995746648,1,66.65231280281401,63.5870591061556,430.2985468389849,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_78,3.6214390684856004,5.815040510490341,5,2.6005651746742964,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,65.27125361129964,227.6816729400898,1.3810591915143624,163.4988241862601,0.3767763406571942,1,66.65231280281401,391.1804971263499,430.2985468389849,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,5.163242341556607,10.176873316602203,6,4.154691133770154,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,63.346969528619866,324.6156105043382,1.0781994931607,261.20749514134985,0.3631168950680715,1,64.42516902178056,585.823105645688,644.4054162102568,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_78,1.0075786397681428,0.042007598771173736,6,0.01714953038482355,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,1.0228041454192065,0.03695917973902365,6,0.01508852194540305,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,63.346969528619866,64.30420463114022,1.0781994931607,0.9486228689080823,0.5203808154968027,1,64.42516902178056,65.25282750004831,644.4054162102568,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_78,1.0283373673220644,0.03987921424123365,6,0.016280621039025778,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,63.346969528619866,64.65208104042583,1.0781994931607,1.0235707310185693,0.40066785432316665,1,64.42516902178056,65.6756517714444,644.4054162102568,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,1.0540053466831647,0.09625241106140733,6,0.03929488226884457,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,62.8704966822211,66.2658396516872,1.4286530474566532,2.470488765311661,0.26904771116933085,1,64.29914972967775,68.73632841699886,75.60996125869875,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_78,1,0.05081183542293674,5,0.022723743613443665,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.98164902823691,0.049192672341427456,6,0.020082824386736718,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,62.8704966822211,61.716761972874224,1.4286530474566532,1.2626171439759604,0.5608575043233566,1,64.29914972967775,62.97937911685018,75.60996125869875,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_78,0.9887334398157204,0.047652900454812644,6,0.019454215146321903,fruit_1_log2-1,1,967514 MM WT,fruit,ns,62.8704966822211,62.1621624475353,1.4286530474566532,1.223096168812046,0.7157802850932733,1,64.29914972967775,63.38525861634735,75.60996125869875,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,1.0321775537839182,0.06824344511905445,6,0.027860269805218437,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,229.55080185990076,64.89351547063492,166.7827392317347,1.7515890003547698,0.37941934385537357,1,396.3335410916354,66.6451044709897,753.2852607232626,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_78,3.6511688943729075,5.931837063110739,5,2.6527981809136643,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,1.0084981313987775,0.02518259986123768,6,0.010280753342785796,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,229.55080185990076,63.40477842413303,166.7827392317347,0.6463560689283486,0.3755447522781637,1,396.3335410916354,64.05113449306138,753.2852607232626,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_78,5.949550162110158,12.107233397703222,6,4.942757336859328,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,229.55080185990076,374.0511737276547,166.7827392317347,310.75360874803846,0.693439542970667,1,396.3335410916354,684.8047824756932,753.2852607232626,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.9987899290092586,0.046028995155458545,6,0.018791258583985386,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,98.55734383950625,100.36855446297128,1.3236705511925042,1.8883364818119135,0.45248327711281533,1,99.88101439069875,102.2568909447832,112.48258003926152,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_78,0.9807661670879005,0.03226502584422959,6,0.01317214164267909,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.9845202501743431,0.025440586680070605,6,0.01038607602053655,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,98.55734383950625,98.93459222955947,1.3236705511925042,1.0436983858635998,0.8276597597786464,1,99.88101439069875,99.97829061542308,112.48258003926152,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_78,0.9890075970173191,0.028650282835310372,6,0.011696428988821618,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,98.55734383950625,99.38552640793094,1.3236705511925042,1.1753759583372165,0.6500617186873971,1,99.88101439069875,100.56090236626815,112.48258003926152,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,1.0240429046231614,0.06003119314570099,6,0.0245076319762384,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,102.79528155880061,102.90622988864389,2.7961741290747173,2.4627757282309743,0.9768408105728618,1,105.59145568787532,105.36900561687487,116.15060125666287,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_78,1.0229388329835847,0.068157919248323,6,0.02782535401470189,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,1.014391943929211,0.05433802285139054,6,0.022183404936266513,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,102.79528155880061,101.93640335565952,2.7961741290747173,2.22921379346344,0.8152820398944065,1,105.59145568787532,104.16561714912297,116.15060125666287,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_78,1.0123468169355585,0.0674292162199814,6,0.027527862249125592,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,102.79528155880061,101.73088822771894,2.7961741290747173,2.7662791355347354,0.7921945400957451,1,105.59145568787532,104.49716736325367,116.15060125666287,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,1.0328397222591539,0.03952942060319391,6,0.016137818384280918,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,100.49015468400951,103.79022345361179,1.3688753376790428,1.6216918656988408,0.15184857141410413,1,101.85903002168855,105.41191531931062,115.9531068512417,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_78,1,0.03336691150826966,6,0.013621984581310087,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,1.0164315430946333,0.06586414167437477,6,0.026888923241433178,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,100.49015468400951,102.14136299128619,1.3688753376790428,2.702072055818078,0.601685681780534,1,101.85903002168855,104.84343504710426,115.9531068512417,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_78,1.0040789549524867,0.07824137048682306,6,0.03194190574479526,leaf_1_log2-1,1,967514 MM WT,leaf,ns,100.49015468400951,100.90004949813401,1.3688753376790428,3.209847049196528,0.9099059847334008,1,101.85903002168855,104.10989654733054,115.9531068512417,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.9709420920319326,0.016045797495787828,6,0.006550669396784716,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,100.47766545845039,97.5701210175047,1.5461273199857568,0.6582777809667041,0.12875668026177353,1,102.02379277843615,98.2283987984714,114.07560694035863,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_78,0.9998757169237286,0.03768750305192431,6,0.015385858692799721,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,1.0069260572778052,0.0614002688220818,6,0.025066554780636525,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,100.47766545845039,101.18615525120647,1.5461273199857568,2.5189419673013638,0.8163691232317356,1,102.02379277843615,103.70509721850783,114.07560694035863,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_78,0.977875864409368,0.011027684258953506,6,0.004502033246493021,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,100.47766545845039,98.26689687625691,1.5461273199857568,0.4524100173326376,0.2202506568033049,1,102.02379277843615,98.71930689358955,114.07560694035863,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,1.0764319816559629,0.32945498822419717,6,0.13449943572732062,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,33.63511686481217,33.66652348943988,1.052158974057878,4.2066089538367875,0.9944713469201258,1,34.68727583887004,37.87313244327667,43.59811403196208,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_101,1.0754278062413039,0.07522369917117817,5,0.0336410609731498,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,1.1619680715305025,0.25789442532267354,6,0.10528495825814187,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,33.63511686481217,36.34175316305656,1.052158974057878,3.2928959569089695,0.4634456243182299,1,34.68727583887004,39.63464911996553,43.59811403196208,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_101,0.9726589688564754,0.39538685298141857,5,0.17682237613523347,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,33.63511686481217,30.420915190428474,1.052158974057878,5.530302686155269,0.5966218730359825,1,34.68727583887004,35.95121787658374,43.59811403196208,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,1.0210480110957856,0.20230263317021033,6,0.08258970414807636,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,40.7642207143318,31.934332531183323,4.613306812582908,2.5830784128223523,0.13415989216678784,1,45.377527526914704,34.517410944005675,49.91528027960618,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_101,1.3033692325836066,0.3613069240077219,6,0.14750293405890935,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,1.0916412089520364,0.14080121460084907,6,0.05748185515603215,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,40.7642207143318,34.1422078027504,4.613306812582908,1.7978044686576853,0.22607937200110195,1,45.377527526914704,35.94001227140809,49.91528027960618,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_101,1.0406447334948945,0.24121860912572055,6,0.09847708480364621,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,40.7642207143318,32.54724029145878,4.613306812582908,3.0799726738081477,0.1737251363356895,1,45.377527526914704,35.62721296526693,49.91528027960618,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,1.196068022627201,0.20979674679133983,6,0.08564916322244444,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,31.276034215973343,37.408264400319915,3.0617096583941548,2.6787661595146575,0.16799220535374956,1,34.3377438743675,40.087030559834574,48.085130006511164,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_101,0.9999999999999999,0.21889574861893757,5,0.09789315477953002,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,1.2895833269718222,0.2647712792509701,6,0.10809242211813865,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,31.276034215973343,40.33305225871945,3.0617096583941548,3.3807022926543375,0.07833852998278097,1,34.3377438743675,43.71375455137378,48.085130006511164,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_101,1.1531146850231861,0.38236822740040505,6,0.156101175163913,fruit_1_log2-1,1,967514 MM WT,fruit,ns,31.276034215973343,36.064854343726495,3.0617096583941548,4.882225695580191,0.4296997182497557,1,34.3377438743675,40.947080039306684,48.085130006511164,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,1.0832087016036918,0.2848260538172394,6,0.11627974955045624,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,43.83211659228358,33.87847241439712,9.121749100186845,3.636769425564881,0.35505111052116084,1,52.95386569247043,37.515241839962,75.7956649779732,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_101,1.4014601816076022,0.652155926191506,5,0.2916529965787086,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,1.8411752499696918,0.8866029373945183,6,0.36195413351155153,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,43.83211659228358,57.58466011565536,9.121749100186845,11.320489864320267,0.36912351288348855,1,52.95386569247043,68.90514997997563,75.7956649779732,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_101,1.167898124542685,0.2168240347704106,6,0.08851804152649732,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,43.83211659228358,36.52722170396811,9.121749100186845,2.768493295513679,0.4799038280957384,1,52.95386569247043,39.29571499948179,75.7956649779732,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.45361281925137187,0.12473549408975204,6,0.050923052222306565,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,89.45721650219787,59.18214874314934,35.77422918922799,6.643850268714809,0.44096072535836517,1,125.23144569142585,65.82599901186416,243.81197150027086,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_101,0.6856618261032564,0.6716461047611141,6,0.2741983740654375,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,1.3602079245483236,0.8295184648771784,6,0.3386494951943161,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,89.45721650219787,177.46418155704689,35.77422918922799,44.18306526138115,0.15396329348465151,1,125.23144569142585,221.64724681842804,243.81197150027086,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_101,0.4738539196659274,0.2538432441115456,6,0.10363107045433956,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,89.45721650219787,61.822973174514054,35.77422918922799,13.520582236106998,0.4954871932304986,1,125.23144569142585,75.34355541062105,243.81197150027086,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.976529736250792,1.4152814123809463,6,0.5777862171298029,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,108.71556938598117,127.4062937601338,36.410561821616334,75.3828560232299,0.8295217056005271,1,145.1261312075975,202.7891497833637,223.0680647617001,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_101,0.83327112943667,0.6835929822637806,6,0.2790756663822823,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,0.589199953784669,0.5151649214145829,6,0.21031519847445382,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,108.71556938598117,76.87198823412781,36.410561821616334,27.439492075206516,0.5020009731712396,1,145.1261312075975,104.31148030933433,223.0680647617001,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_101,0.4914531095008778,0.29468684804836126,6,0.12030540193792766,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,108.71556938598117,64.11911170139676,36.410561821616334,15.6960559532804,0.2988383834405706,1,145.1261312075975,79.81516765467717,223.0680647617001,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.7531272965817258,0.6178018666388497,6,0.2522165559006939,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,130.468422036268,98.2593299774582,46.93387950439591,32.90629605978571,0.5879542087917206,1,177.40230154066393,131.1656260372439,352.3800534392682,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_101,1,0.8811638451722927,6,0.35973363341015263,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,1.6163154227284848,2.0552040202489015,6,0.8390335278210727,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,130.468422036268,210.8781227162689,46.93387950439591,109.46738041033852,0.5219552075901329,1,177.40230154066393,320.3455031266074,352.3800534392682,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_101,1.6748955078077188,1.6243203722974457,6,0.6631260151560578,leaf_1_log2-1,1,967514 MM WT,leaf,ns,130.468422036268,218.52097397930686,46.93387950439591,86.51700480860919,0.3980765651126339,1,177.40230154066393,305.037978787916,352.3800534392682,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.6205414079118508,0.6602624237015763,6,0.26955100573369534,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,111.92128774556616,80.96105829842328,34.71252787140652,35.16789437636426,0.5449943906275947,1,146.6338156169727,116.12895267478754,593.301095956001,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_101,0.8578419666519301,0.651713109118842,6,0.26606076267065626,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,1.0533208546579242,1.3057494545823463,6,0.5330699826073645,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,111.92128774556616,137.42510980511258,34.71252787140652,69.54879946568369,0.7519863508736255,1,146.6338156169727,206.97390927079627,593.301095956001,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_101,2.295958690097296,4.502416836179127,6,1.8381039763258435,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,111.92128774556616,299.55010735745105,34.71252787140652,239.81452532982257,0.47240358236445373,1,146.6338156169727,539.3646326872736,593.301095956001,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.7145056072750983,0.6689400281624905,6,0.2730936229201852,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,14421.496803450878,3807.339313394162,7943.455480826661,1455.2161329378268,0.2549027442788304,1,22364.95228427754,5262.5554463319895,24601.447512705297,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_103,2.706415027185887,3.3333316517351044,5,1.4907112329662695,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.7868972263403509,0.7332307128875107,6,0.29934018505192583,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,14421.496803450878,4193.0878007692545,7943.455480826661,1595.074472505964,0.2705917172210319,1,22364.95228427754,5788.1622732752185,24601.447512705297,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_103,0.8181017730291799,1.213021968910673,5,0.5424799161369802,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,14421.496803450878,4359.365428481809,7943.455480826661,2890.6772604793186,0.2869267799550439,1,22364.95228427754,7250.042688961128,24601.447512705297,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,1.5449711136184252,1.3606642476296253,6,0.555488852990093,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,5643.5454412025265,8232.58655921649,1122.5851419843111,2959.997131732965,0.4427870790189503,1,6766.130583186838,11192.583690949456,15773.586575638996,0,23,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_103,1.0590978451711135,0.5160347796431844,6,0.21067031660922633,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.8198576742129904,0.5307508701732067,6,0.21667813541041933,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,5643.5454412025265,4368.721984314944,1122.5851419843111,1154.598613224606,0.44695948661692453,1,6766.130583186838,5523.32059753955,15773.586575638996,0,23,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_103,1.6088758799720113,2.4198157233820647,5,1.0821744901010248,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,5643.5454412025265,8573.111709437737,1122.5851419843111,5766.512450234076,0.6424299355700349,1,6766.130583186838,14339.624159671814,15773.586575638996,0,23,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.6537745534516411,0.18677574902165553,6,0.07625088023819841,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,5328.634617598269,3483.725717627265,2029.0373843144002,406.3130800596038,0.41949707830824284,1,7357.67200191267,3890.0387976868687,8115.414156424757,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_103,0.9999999999999999,0.8514499202537401,5,0.38077998022482756,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.7303214210141107,0.6024277681579594,6,0.24594010647844736,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,5328.634617598269,3891.61600598935,2029.0373843144002,1310.524965236859,0.5704833045659605,1,7357.67200191267,5202.140971226209,8115.414156424757,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_103,1.0707410744606298,0.7686203393308968,6,0.31378793954759293,fruit_1_log2-1,1,967514 MM WT,fruit,ns,5328.634617598269,5705.587955855278,2029.0373843144002,1672.0612772581367,0.8894423177651793,1,7357.67200191267,7377.649233113414,8115.414156424757,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,3.339555521484858,3.1036288551852,6,1.2670511743636743,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,38183.9620333328,17795.271159175652,18675.054376734017,6751.652749982816,0.35123657233736766,1,56859.01641006682,24546.923909158468,68011.59399060585,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_103,7.165806022283272,7.836658744056235,5,3.5046603336355733,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,9.408589596850044,5.3754497898187745,6,2.1945181871678465,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,38183.9620333328,50134.93622855008,18675.054376734017,11693.785581091584,0.6046133695577609,1,56859.01641006682,61828.72180964167,68011.59399060585,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_103,3.668213288813272,4.6337180247385215,6,1.8917074620910896,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,38183.9620333328,19546.5683155044,18675.054376734017,10080.217868867547,0.41233081117865095,1,56859.01641006682,29626.786184371944,68011.59399060585,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,1.2727345928240523,0.09898343629486396,6,0.040409818651616906,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,777523.3317061171,835405.9422669389,21433.927319209717,26524.463794594976,0.1218267244505931,1,798957.2590253268,861930.4060615338,948123.4466676873,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_103,1.1845508763139523,0.07998667930780448,6,0.03265442508729243,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,1.1970890950239115,0.08655183947082677,6,0.03533464050046774,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,777523.3317061171,785753.2505554985,21433.927319209717,23193.184822970838,0.7997208564224756,1,798957.2590253268,808946.4353784694,948123.4466676873,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_103,1.2172535893097458,0.14295339944207622,6,0.05836048093822537,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,777523.3317061171,798988.9545617953,21433.927319209717,38307.03812423989,0.638199375172186,1,798957.2590253268,837295.9926860352,948123.4466676873,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,1.258632139426828,0.22561310212477553,6,0.09210616324868856,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,765336.4244533308,826149.2807170689,68354.4053708883,60457.25207062119,0.5204478376377044,1,833690.8298242191,886606.5327876902,1062535.3673255574,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_103,1.165984215897257,0.2550835327680163,6,0.10413741617802545,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,1.3440859054337253,0.31235458240269576,6,0.1275182242844544,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,765336.4244533308,882239.9883270881,68354.4053708883,83701.25469614583,0.30573123689301795,1,833690.8298242191,965941.243023234,1062535.3673255574,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_103,1.1057178339184095,0.30646536263746793,6,0.12511396038313413,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,765336.4244533308,725778.3784098548,68354.4053708883,82123.12806922347,0.7191844785494816,1,833690.8298242191,807901.5064790783,1062535.3673255574,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,1.2134822547539428,0.10467576528453103,6,0.04273370223040637,leaf_1_panK4-1,1,967514 MM WT,leaf,*,656386.6079991342,796513.5010650818,18956.774766306207,28049.82985426148,0.002664219931095612,0.06127705841519907,675343.3827654404,824563.3309193433,916577.6213075466,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_103,1,0.07074249349459498,6,0.028880502032319354,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,1.1383434964306312,0.10641330438594196,6,0.0434430495981715,leaf_1_transp1-1,1,967514 MM WT,leaf,*,656386.6079991342,747193.4263599765,18956.774766306207,28515.435966881956,0.0271566985597301,0.5974473683140622,675343.3827654404,775708.8623268584,916577.6213075466,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_103,1.2248963559294228,0.10914266341942597,6,0.04455730575765345,leaf_1_log2-1,1,967514 MM WT,leaf,*,656386.6079991342,804005.564219014,18956.774766306207,29246.81878784644,0.0024434481560469488,0.05864275574512677,675343.3827654404,833252.3830068605,916577.6213075466,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,1.31883099487217,0.2729828027242356,6,0.11144476253820315,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,853941.778194888,865663.0032482671,61727.102194714986,73150.84966172016,0.9050282020170008,1,915668.880389603,938813.8529099873,1199618.233308985,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_103,1.3009737977408802,0.23035190211845818,6,0.09404077024495967,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,1.5978038556327407,0.15593229948666593,6,0.06365909469353047,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,853941.778194888,1048777.0530467131,61727.102194714986,41784.97723418215,0.028640197650140482,0.6014441506529501,915668.880389603,1090562.0302808953,1199618.233308985,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_103,1.0446305373201985,0.3782809577928352,6,0.15443255433395772,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,853941.778194888,685681.4950039181,61727.102194714986,101367.46050390849,0.19287091671689813,1,915668.880389603,787048.9555078265,1199618.233308985,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA diff --git a/runs/GC-MS analysis/mean_values_se_n_cv.csv b/runs/GC-MS analysis/mean_values_se_n_cv.csv new file mode 100644 index 0000000000000000000000000000000000000000..6a57eae52dd70a76e14d4d97d14bac2254445b1e --- /dev/null +++ b/runs/GC-MS analysis/mean_values_se_n_cv.csv @@ -0,0 +1,913 @@ +genotype,tissue,alias,met,mean_cv,sd_cv,n,se_cv +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_1,0.9791418742932401,0.25585654179238826,4,0.12792827089619413 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_10,0.14486063959112014,0.058943093899708435,4,0.029471546949854217 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_100,0.6522311086369391,0.17010409952416794,4,0.08505204976208397 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_101,0.06359354584723974,0.02317422386021438,4,0.01158711193010719 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_102,0.28391809192792306,0.0842497609217239,4,0.04212488046086195 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_103,0.7374503674900517,0.18999680073646233,4,0.09499840036823116 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_104,0.7468586294561204,0.19487787199073506,4,0.09743893599536753 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_105,0.05487605737494245,0.01853340870248143,4,0.009266704351240714 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_106,0.22258903040187264,0.07607440498314043,4,0.038037202491570214 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_107,0.390608828872897,0.1004311869540996,4,0.0502155934770498 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_108,0.5735214679991293,0.25035952947499357,4,0.12517976473749678 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_109,0.10987644715601266,0.025394865979246943,4,0.012697432989623472 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_11,0.60012915272734,0.16576272538958176,4,0.08288136269479088 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_110,0.42928490663172153,0.10200207097136174,4,0.05100103548568087 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_111,0.4177646585372515,0.13313895332571823,4,0.06656947666285912 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_112,0.05366512629838931,0.014212598961676171,4,0.0071062994808380854 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_12,0.5471001487407213,0.14379526062232725,4,0.07189763031116363 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_120,0.06320114409750217,0.02219648512493282,4,0.01109824256246641 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_121,0.23815787029596058,0.06909881975817014,4,0.03454940987908507 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_122,0.044181636358002624,0.022120215552986454,4,0.011060107776493227 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_123,0.29500872899912406,0.13211090369459208,4,0.06605545184729604 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_13,0.8149994862700114,0.18204857645004102,4,0.09102428822502051 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_14,0.5011496275175391,0.16281307354406538,4,0.08140653677203269 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_15,0.3290804491723123,0.109698317885065,4,0.0548491589425325 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_16,0.4613169659918751,0.13607244107827482,4,0.06803622053913741 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_17,0.9763369698989393,0.2850781630717218,4,0.1425390815358609 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_18,0.34044087642050536,0.051456761340001364,4,0.025728380670000682 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_19,0.0871431691182367,0.020544872307172956,4,0.010272436153586478 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_2,1.318800934199407,0.7445116287752555,4,0.3722558143876277 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_20,0.4224915686091369,0.13601969547568613,4,0.06800984773784306 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_21,0.4179329231668998,0.14079948494630007,4,0.07039974247315003 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_22,0.5092324087296431,0.19747198671315397,4,0.09873599335657698 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_23,0.25406423386195565,0.09874583245642526,4,0.04937291622821263 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_24,0.15449435847999946,0.04748694446465129,4,0.023743472232325646 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_25,0.10417086315071478,0.04115392584324879,4,0.020576962921624396 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_26,0.13045511520187847,0.06681996809290436,4,0.03340998404645218 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_27,0.14969098925167018,0.06437565063552368,4,0.03218782531776184 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_28,0.20406399970158676,0.08673579048331324,4,0.04336789524165662 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_29,0.6934306795490441,0.2613940250176334,4,0.1306970125088167 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_3,0.17974401069384163,0.04795980442457643,4,0.023979902212288216 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_30,0.18291277578061382,0.03785880394434441,4,0.018929401972172206 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_31,0.29478966838344794,0.0995859417941362,4,0.0497929708970681 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_32,0.2394704858717095,0.026030347475292474,4,0.013015173737646237 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_33,0.7547671952372681,0.17259638297595237,4,0.08629819148797618 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_34,0.17491987446715743,0.04499669659521694,4,0.02249834829760847 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_35,0.7047327527792455,0.15343240660463459,4,0.07671620330231729 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_36,0.09798648778864183,0.019482426356642903,4,0.009741213178321452 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_37,0.10402263937149518,0.021311139599660085,4,0.010655569799830043 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_38,0.519866044105356,0.09892166728209424,4,0.04946083364104712 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_39,0.8348488932201213,0.21320581931936028,4,0.10660290965968014 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_4,0.3968473456479126,0.08384189239231798,4,0.04192094619615899 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_40,0.46214340381029084,0.2832312504233632,4,0.1416156252116816 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_41,0.12728111150213417,0.044149045341985445,4,0.022074522670992722 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_42,0.04845063021371287,0.006455890971744202,4,0.003227945485872101 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_43,0.2822682093064568,0.05038470715963188,4,0.02519235357981594 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_44,0.7307579845109644,0.17622049759681083,4,0.08811024879840541 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_45,0.7298887355134204,0.19214871831078081,4,0.096074359155390407 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_46,0.706485258892824,0.19495855517601565,4,0.09747927758800783 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_47,0.6412820946320245,0.20552037085537617,4,0.10276018542768808 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_48,0.3445620535178667,0.11731629416777453,4,0.058658147083887266 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_49,0.04777521112009374,0.004239058642248306,4,0.002119529321124153 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_5,0.23611465604985993,0.0987905391636315,4,0.04939526958181575 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_50,0.154040642310707,0.07072936524946506,4,0.03536468262473253 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_51,0.06774116365061521,0.012730264837181746,4,0.006365132418590873 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_52,0.049006972155054326,0.01738621228058516,4,0.00869310614029258 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_53,0.1106283001304504,0.04343502415879473,4,0.021717512079397365 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_54,0.09361113660945841,0.038303361506300516,4,0.019151680753150258 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_55,0.24905458721273915,0.06986695767354628,4,0.03493347883677314 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_56,0.2982199623419206,0.13251298551990534,4,0.06625649275995267 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_57,0.3161331602161225,0.15166657062431657,4,0.07583328531215829 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_58,0.28437135092608157,0.13078213228628346,4,0.06539106614314173 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_59,0.5742881953210113,0.1405205538949543,4,0.07026027694747715 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_6,0.5261117740827783,0.12597978946444763,4,0.06298989473222381 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_60,0.4198144326112145,0.19058841003418273,4,0.09529420501709136 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_61,0.1762309052362299,0.05066721409094545,4,0.025333607045472724 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_62,0.8965139828522632,0.22851931071816214,4,0.11425965535908107 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_63,0.3217680352451995,0.07183343705838925,4,0.035916718529194626 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_64,0.44785362476860596,0.09246534494203337,4,0.046232672471016686 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_65,0.2521601203773707,0.06699644304196647,4,0.03349822152098324 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_66,0.22450723829354718,0.04201672670611752,4,0.02100836335305876 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_67,0.32253876799652614,0.11642528469027504,4,0.05821264234513752 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_68,0.09423939729137432,0.026862524837359746,4,0.013431262418679873 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_69,0.18281028738090627,0.03723761378342589,4,0.018618806891712945 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_7,0.40911460260144367,0.09839032474788972,4,0.04919516237394486 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_70,0.5539726445733993,0.15223132991204344,4,0.07611566495602172 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_71,0.4139255926863827,0.15245537670710224,4,0.07622768835355112 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_72,0.29642292742344073,0.0628467294746761,4,0.03142336473733805 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_73,0.34892760046767735,0.16123801947809308,4,0.08061900973904654 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_74,0.19326361575609963,0.05177879947274283,4,0.025889399736371416 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_75,0.08943389604892674,0.022834808849363775,4,0.011417404424681888 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_76,0.37422680729238567,0.12154602214906957,4,0.06077301107453478 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_77,0.06776339865499408,0.012561309249392442,4,0.006280654624696221 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_78,0.7534273342756587,0.4807278006354941,4,0.24036390031774704 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_79,0.12959986748450067,0.0441443195623927,4,0.02207215978119635 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_8,0.2440780278630908,0.10719296306350308,4,0.05359648153175154 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_80,0.0741151612617325,0.021944748669898394,4,0.010972374334949197 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_81,0.6791078485980373,0.17848016032725164,4,0.08924008016362582 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_82,0.12173555305227714,0.05085036327337423,4,0.025425181636687114 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_83,0.2516816486018037,0.08364568926214903,4,0.04182284463107452 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_84,1.2203955006653118,0.2652997299603171,4,0.13264986498015854 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_85,0.1685109395070799,0.08932579149255468,4,0.04466289574627734 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_86,0.22265320888145837,0.07520181947495617,4,0.03760090973747809 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_87,0.13600634875821332,0.05472722383852284,4,0.02736361191926142 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_88,0.09386638143545566,0.022376306941094406,4,0.011188153470547203 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_89,0.8310107783192903,0.1891415822443947,4,0.09457079112219735 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_9,0.5525870618472043,0.17478309833878877,4,0.08739154916939439 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_90,0.163734680722995,0.03916992290252729,4,0.019584961451263646 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_91,0.2965381210660341,0.14608234955091287,4,0.07304117477545644 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_92,0.2785362002873892,0.0979053307845559,4,0.04895266539227795 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_93,0.8358169796373949,0.19729983026934572,4,0.09864991513467286 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_94,0.07720425936108058,0.028317367467778708,4,0.014158683733889354 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_97,0.22507540969209633,0.09909682063759309,4,0.049548410318796546 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_98,0.44881745270051654,0.13526573550425508,4,0.06763286775212754 +panK4-1,fruit,1015695 Sl10g074590 #30.1,m_99,0.6096908766459502,0.17077848242041316,4,0.08538924121020658 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_1,0.1431379423886527,0.03639891908660404,4,0.01819945954330202 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_10,0.006147741141841056,0.001823673222087882,4,9.11836611043941e-4 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_100,0.246810500606513,0.09201443000365048,4,0.04600721500182524 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_101,0.3068342970333679,0.08068663562989631,4,0.040343317814948154 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_102,0.057053313829537114,0.015575571401924495,4,0.007787785700962248 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_103,0.03319787877500315,0.009854979681370534,4,0.004927489840685267 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_104,0.033202680156771525,0.00985654493452479,4,0.004928272467262395 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_105,0.11396410927967948,0.006053280642182501,4,0.0030266403210912505 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_106,0.04047474240788477,0.0187123623411889,4,0.00935618117059445 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_107,0.45750144191505115,0.10743806380186792,4,0.05371903190093396 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_108,0.5418909222560192,0.11299442246231454,4,0.05649721123115727 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_109,0.3103969719479036,0.07075785875431283,4,0.035378929377156414 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_11,0.5939718803308347,0.12345990510556733,4,0.061729952552783664 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_110,0.5775833009039766,0.12597694293656145,4,0.06298847146828072 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_111,0.32518890931268474,0.15120423467308025,4,0.07560211733654013 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_112,0.3576568907988443,0.1215614295451924,4,0.0607807147725962 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_12,0.6457384266772708,0.1386596218730517,4,0.06932981093652585 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_120,0.13734479146152465,0.026626487781792357,4,0.013313243890896179 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_121,0.8634266878277927,0.2730290981713331,4,0.13651454908566654 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_122,0.2227370094412218,0.02166196326189341,4,0.010830981630946705 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_123,0.1295032033967788,0.03925487460066703,4,0.019627437300333516 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_13,0.4237814031525643,0.11475039689096742,4,0.05737519844548371 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_14,0.19429433138488417,0.12474004111790629,4,0.062370020558953146 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_15,0.13347170031805639,0.03892851350105524,4,0.01946425675052762 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_16,0.4289771061108146,0.12166945112828682,4,0.06083472556414341 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_17,0.3460521524275132,0.0583244711756637,4,0.02916223558783185 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_18,0.5738930114398076,0.19701578624683777,4,0.09850789312341889 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_19,0.2017965938430261,0.0768691817523424,4,0.0384345908761712 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_2,0.18393489441640135,0.08530573725654882,4,0.04265286862827441 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_20,0.32923757105865664,0.10850310451904778,4,0.05425155225952389 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_21,0.3808392575681248,0.1576762914523985,4,0.07883814572619925 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_22,0.39283519471938366,0.10781444676284446,4,0.05390722338142223 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_23,0.3252416516752666,0.10161368291030569,4,0.050806841455152844 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_24,0.37714402107266204,0.06719220817054807,4,0.03359610408527403 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_25,0.2123464410088714,0.08933841281864399,4,0.044669206409321996 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_26,0.09677194340638026,0.05388655377930307,4,0.026943276889651535 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_27,0.0900729033215549,0.02749800729416121,4,0.013749003647080605 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_28,0.23284308298776368,0.02077513419204443,4,0.010387567096022215 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_29,0.4301848790374421,0.10950120691908237,4,0.054750603459541185 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_3,0.33701986661016786,0.15484632974312276,4,0.07742316487156138 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_30,0.07396035588610197,0.01303053810735313,4,0.006515269053676565 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_31,0.11102975370971858,0.06607933776460662,4,0.03303966888230331 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_32,0.2984740363869329,0.12067312348326283,4,0.06033656174163141 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_33,0.3501624274765841,0.13861367384946965,4,0.06930683692473483 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_34,0.26290240124862524,0.14043896738030337,4,0.070219483690151685 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_35,0.6444486952972154,0.23675794092674773,4,0.11837897046337387 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_36,0.5342758180029443,0.2165803782831564,4,0.1082901891415782 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_37,0.2655461238844004,0.04630421374466919,4,0.023152106872334596 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_38,0.39239121187479936,0.1428409994421224,4,0.0714204997210612 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_39,0.09543101192710904,0.012118357772208656,4,0.006059178886104328 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_4,0.07623881621032531,0.04186170334844091,4,0.020930851674220454 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_40,0.06450232727984108,0.013500014907862967,4,0.006750007453931483 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_41,0.1184916256923851,0.05648445517126202,4,0.02824222758563101 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_42,0.04801828393276764,0.017103552599772056,4,0.008551776299886028 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_43,0.04653818547988694,0.02016509119508918,4,0.01008254559754459 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_44,0.44929204506642556,0.07743141595833165,4,0.03871570797916583 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_45,0.6362521826906307,0.13836203223542906,4,0.06918101611771453 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_46,0.9136765855337328,0.23131129280576915,4,0.11565564640288457 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_47,0.5559334089315257,0.23259820676367285,4,0.11629910338183642 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_48,0.20284968340892393,0.03793678688635386,4,0.01896839344317693 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_49,0.0297558545511677,0.008573981668917397,4,0.004286990834458698 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_5,0.41767637264667257,0.07762575192693796,4,0.03881287596346898 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_50,0.3295172090346818,0.09953689180736887,4,0.049768445903684434 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_51,0.07800443098629575,0.02417053969136492,4,0.01208526984568246 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_52,0.07186797647879503,0.017900284743385897,4,0.008950142371692948 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_53,0.2123653280739532,0.07500436939427646,4,0.03750218469713823 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_54,0.3539700370050672,0.10790876213565476,4,0.05395438106782738 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_55,0.25128725383811806,0.10687599860077102,4,0.05343799930038551 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_56,0.2308793354223222,0.06259190686085597,4,0.031295953430427986 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_57,0.33507259265121436,0.13381624522930857,4,0.06690812261465429 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_58,0.5197785282136609,0.1077537198508513,4,0.05387685992542565 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_59,0.11803376584538111,0.03335048449133368,4,0.01667524224566684 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_6,0.39571920974495717,0.11751368967539746,4,0.05875684483769873 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_60,0.4880669726779439,0.09459346857058894,4,0.04729673428529447 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_61,0.16137400411877828,0.05699281742451084,4,0.02849640871225542 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_62,0.13774586027857771,0.04805266570992059,4,0.024026332854960294 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_63,0.859262347609179,0.22781688948380066,4,0.11390844474190033 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_64,0.20836418393546613,0.026194438691918502,4,0.013097219345959251 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_65,0.10538329195615247,0.032153018233172244,4,0.016076509116586122 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_66,0.26135268945626355,0.029152819786476363,4,0.014576409893238182 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_67,0.6559941929841226,0.27904931803121863,4,0.13952465901560931 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_68,0.208422724325727,0.027393064640168156,4,0.013696532320084078 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_69,0.30502377372316214,0.10979002623300085,4,0.05489501311650043 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_7,0.3826061977611027,0.1714871049497991,4,0.08574355247489955 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_70,0.36632129986181056,0.12328325444163853,4,0.06164162722081926 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_71,0.2859085316054281,0.08825970127030651,4,0.044129850635153255 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_72,0.35613656167891644,0.11837073277898649,4,0.059185366389493246 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_73,0.02351437417430824,0.006283488809491132,4,0.003141744404745566 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_74,0.08468367073041426,0.0035657016585962506,4,0.0017828508292981253 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_75,0.05047715602629647,0.013534665168897947,4,0.006767332584448974 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_76,0.16494562703145157,0.047047831053503374,4,0.023523915526751687 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_77,0.09663658391622848,0.03579402268307694,4,0.01789701134153847 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_78,0.0270307451582324,0.007004375380706207,4,0.0035021876903531036 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_79,0.03896226047469474,0.008244156921095598,4,0.004122078460547799 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_8,0.21228557918393287,0.05574573443773984,4,0.02787286721886992 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_80,0.10589836369056124,0.02901985677641068,4,0.01450992838820534 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_81,0.09518953632492692,0.03418396084011374,4,0.01709198042005687 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_82,0.40488881534390375,0.07969866979030178,4,0.03984933489515089 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_83,0.1467801278455172,0.06536345781030255,4,0.032681728905151274 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_84,1.4120468135403748,0.2540346520973932,4,0.1270173260486966 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_85,0.6185020206636543,0.1334692230374356,4,0.0667346115187178 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_86,0.35596770595831245,0.12768490395640048,4,0.06384245197820024 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_87,0.32602207780541576,0.09383895662403503,4,0.04691947831201752 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_88,0.2615679585388366,0.07959189557853698,4,0.03979594778926849 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_89,0.2802748249054059,0.0624197311029118,4,0.0312098655514559 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_9,0.022232950649545398,0.00431842993498031,4,0.002159214967490155 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_90,0.25683356417749814,0.0456792681166756,4,0.0228396340583378 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_91,0.22715964742734823,0.11072375601086216,4,0.05536187800543108 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_92,0.5652601083912523,0.16328184230661522,4,0.08164092115330761 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_93,0.311574829950348,0.11044289476065748,4,0.05522144738032874 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_94,0.36504821634732976,0.12901232200665275,4,0.06450616100332637 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_97,0.25616943518382246,0.08154072258304042,4,0.04077036129152021 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_98,0.536241330777052,0.11196565140236052,4,0.05598282570118026 +panK4-1,leaf,1015695 Sl10g074590 #30.1,m_99,0.28316714323504066,0.04681322641322631,4,0.023406613206613153 +MoneyMaker,fruit,967514 MM WT,m_1,0.45653967606948337,0.15287416846588717,4,0.07643708423294358 +MoneyMaker,fruit,967514 MM WT,m_10,0.0805242582658268,0.015609942567935724,4,0.007804971283967862 +MoneyMaker,fruit,967514 MM WT,m_100,0.25687910232007444,0.1297603197332286,4,0.0648801598666143 +MoneyMaker,fruit,967514 MM WT,m_101,0.15664072828201778,0.02421433273781455,4,0.012107166368907275 +MoneyMaker,fruit,967514 MM WT,m_102,0.08929127030519496,0.04960099117211138,4,0.02480049558605569 +MoneyMaker,fruit,967514 MM WT,m_103,0.8768698641873345,0.22154246850322168,4,0.11077123425161084 +MoneyMaker,fruit,967514 MM WT,m_104,0.8935424602760907,0.21841754507863,4,0.109208772539315 +MoneyMaker,fruit,967514 MM WT,m_105,0.0745879708916856,0.025174862098853792,4,0.012587431049426896 +MoneyMaker,fruit,967514 MM WT,m_106,0.20698496423054813,0.06716039760003766,4,0.03358019880001883 +MoneyMaker,fruit,967514 MM WT,m_107,0.4921184396027954,0.1175379296802108,4,0.0587689648401054 +MoneyMaker,fruit,967514 MM WT,m_108,0.4630049639268783,0.1883373525562856,4,0.0941686762781428 +MoneyMaker,fruit,967514 MM WT,m_109,0.4606723123719696,0.19673570123298803,4,0.09836785061649402 +MoneyMaker,fruit,967514 MM WT,m_11,0.7708586695810169,0.19332862905889023,4,0.09666431452944511 +MoneyMaker,fruit,967514 MM WT,m_110,0.5284789044234743,0.18329049759347246,4,0.09164524879673623 +MoneyMaker,fruit,967514 MM WT,m_111,0.3005535291100776,0.07744098106393077,4,0.038720490531965385 +MoneyMaker,fruit,967514 MM WT,m_112,0.42976367829851847,0.08798205628109829,4,0.04399102814054914 +MoneyMaker,fruit,967514 MM WT,m_12,0.6058468785662583,0.1596359465335868,4,0.0798179732667934 +MoneyMaker,fruit,967514 MM WT,m_120,0.17209302785857455,0.050747045413722755,4,0.025373522706861378 +MoneyMaker,fruit,967514 MM WT,m_121,0.11002489793923534,0.03413579326870965,4,0.017067896634354825 +MoneyMaker,fruit,967514 MM WT,m_122,0.2746660698882882,0.09690265080666906,4,0.04845132540333453 +MoneyMaker,fruit,967514 MM WT,m_123,0.5582780412538001,0.33325101205212054,4,0.16662550602606027 +MoneyMaker,fruit,967514 MM WT,m_13,0.8734526188174414,0.2422541163013684,4,0.1211270581506842 +MoneyMaker,fruit,967514 MM WT,m_14,0.9004879892823983,0.410195595286044,4,0.205097797643022 +MoneyMaker,fruit,967514 MM WT,m_15,0.2490359284871614,0.10237899109146803,4,0.051189495545734015 +MoneyMaker,fruit,967514 MM WT,m_16,0.629738625055206,0.1827818259344203,4,0.09139091296721015 +MoneyMaker,fruit,967514 MM WT,m_17,0.9396949742785091,0.22483621294197004,4,0.11241810647098502 +MoneyMaker,fruit,967514 MM WT,m_18,0.5025734696706072,0.18396606247009162,4,0.09198303123504581 +MoneyMaker,fruit,967514 MM WT,m_19,0.1643996932896449,0.051790024662604905,4,0.025895012331302453 +MoneyMaker,fruit,967514 MM WT,m_2,0.6600228857212979,0.23122477662954466,4,0.11561238831477233 +MoneyMaker,fruit,967514 MM WT,m_20,0.08902857002439829,0.009092790315743416,4,0.004546395157871708 +MoneyMaker,fruit,967514 MM WT,m_21,0.5483926543879996,0.10528291896302609,4,0.052641459481513046 +MoneyMaker,fruit,967514 MM WT,m_22,0.47938695475377724,0.11627794471945067,4,0.05813897235972534 +MoneyMaker,fruit,967514 MM WT,m_23,0.04834187691561796,0.025642538824334458,4,0.012821269412167229 +MoneyMaker,fruit,967514 MM WT,m_24,0.37162059994791174,0.1315978508099764,4,0.0657989254049882 +MoneyMaker,fruit,967514 MM WT,m_25,0.05379028842514187,0.012459425727231159,4,0.006229712863615579 +MoneyMaker,fruit,967514 MM WT,m_26,0.31098959419942773,0.16238412626290336,4,0.08119206313145168 +MoneyMaker,fruit,967514 MM WT,m_27,0.2929666544206788,0.10118586876129501,4,0.050592934380647506 +MoneyMaker,fruit,967514 MM WT,m_28,0.2091912966241598,0.112208866581988,4,0.056104433290994 +MoneyMaker,fruit,967514 MM WT,m_29,0.4944353396015754,0.21746646772842404,4,0.10873323386421202 +MoneyMaker,fruit,967514 MM WT,m_3,0.4360287580506318,0.07858717548066414,4,0.03929358774033207 +MoneyMaker,fruit,967514 MM WT,m_30,0.44144555720228945,0.23611280969096257,4,0.11805640484548129 +MoneyMaker,fruit,967514 MM WT,m_31,0.25531743671138624,0.1274572004857673,4,0.06372860024288365 +MoneyMaker,fruit,967514 MM WT,m_32,0.24423253089423666,0.11404802147635436,4,0.05702401073817718 +MoneyMaker,fruit,967514 MM WT,m_33,0.6571438816270889,0.3843903929995502,4,0.1921951964997751 +MoneyMaker,fruit,967514 MM WT,m_34,0.21183299737517589,0.09572275383035937,4,0.047861376915179686 +MoneyMaker,fruit,967514 MM WT,m_35,0.4319102100142117,0.24150855003765115,4,0.12075427501882557 +MoneyMaker,fruit,967514 MM WT,m_36,0.14985902213813979,0.045332111989247525,4,0.022666055994623763 +MoneyMaker,fruit,967514 MM WT,m_37,0.14075474871502291,0.04204533905934144,4,0.02102266952967072 +MoneyMaker,fruit,967514 MM WT,m_38,0.3169962691175314,0.14422215064473543,4,0.07211107532236771 +MoneyMaker,fruit,967514 MM WT,m_39,1.400385168056376,0.5016431805731008,4,0.2508215902865504 +MoneyMaker,fruit,967514 MM WT,m_4,0.37530420913487955,0.15491911928280236,4,0.07745955964140118 +MoneyMaker,fruit,967514 MM WT,m_40,0.36464502233075863,0.13432268338648176,4,0.06716134169324088 +MoneyMaker,fruit,967514 MM WT,m_41,0.16394147904287457,0.054656235813243234,4,0.027328117906621617 +MoneyMaker,fruit,967514 MM WT,m_42,0.0266333284486893,0.004365873695069859,4,0.0021829368475349293 +MoneyMaker,fruit,967514 MM WT,m_43,0.9687725903294386,0.5026202975971648,4,0.2513101487985824 +MoneyMaker,fruit,967514 MM WT,m_44,0.5418974088581695,0.24344149654546565,4,0.12172074827273283 +MoneyMaker,fruit,967514 MM WT,m_45,0.5519566494893826,0.22870758458573687,4,0.11435379229286843 +MoneyMaker,fruit,967514 MM WT,m_46,0.7852497268409664,0.17698861789334763,4,0.08849430894667382 +MoneyMaker,fruit,967514 MM WT,m_47,0.6696154407169976,0.20044297834554292,4,0.10022148917277146 +MoneyMaker,fruit,967514 MM WT,m_48,0.47459379221862114,0.24958548309683393,4,0.12479274154841696 +MoneyMaker,fruit,967514 MM WT,m_49,0.040559600299515816,0.00469663720528113,4,0.002348318602640565 +MoneyMaker,fruit,967514 MM WT,m_5,0.30862544241068235,0.12075473910866981,4,0.060377369554334905 +MoneyMaker,fruit,967514 MM WT,m_50,0.11847581412457914,0.03220153709846238,4,0.01610076854923119 +MoneyMaker,fruit,967514 MM WT,m_51,0.10998312469896565,0.033398537076804145,4,0.016699268538402073 +MoneyMaker,fruit,967514 MM WT,m_52,0.023135576584632295,0.009601205581250688,4,0.004800602790625344 +MoneyMaker,fruit,967514 MM WT,m_53,0.2664320036451143,0.07868251917300649,4,0.039341259586503245 +MoneyMaker,fruit,967514 MM WT,m_54,0.2506373824992118,0.06748905936031524,4,0.03374452968015762 +MoneyMaker,fruit,967514 MM WT,m_55,0.39830729977519136,0.09178215422079561,4,0.045891077110397804 +MoneyMaker,fruit,967514 MM WT,m_56,0.23443175897843804,0.033854179049232984,4,0.016927089524616492 +MoneyMaker,fruit,967514 MM WT,m_57,0.40724476090884076,0.1686505050365187,4,0.08432525251825936 +MoneyMaker,fruit,967514 MM WT,m_58,0.6093561072375596,0.20061063937463278,4,0.10030531968731639 +MoneyMaker,fruit,967514 MM WT,m_59,0.5724501959945484,0.1859503938197687,4,0.09297519690988434 +MoneyMaker,fruit,967514 MM WT,m_6,0.5106134245640704,0.1534971936375107,4,0.07674859681875534 +MoneyMaker,fruit,967514 MM WT,m_60,0.525399728766296,0.09512747362014434,4,0.04756373681007217 +MoneyMaker,fruit,967514 MM WT,m_61,0.21822575208375328,0.09866944189870655,4,0.049334720949353275 +MoneyMaker,fruit,967514 MM WT,m_62,0.593176121742765,0.16103605743014102,4,0.08051802871507051 +MoneyMaker,fruit,967514 MM WT,m_63,0.6516275647642971,0.20420702030916504,4,0.10210351015458252 +MoneyMaker,fruit,967514 MM WT,m_64,0.44703545523387667,0.09903021127632149,4,0.04951510563816074 +MoneyMaker,fruit,967514 MM WT,m_65,0.1435184763068618,0.04313804321848218,4,0.02156902160924109 +MoneyMaker,fruit,967514 MM WT,m_66,0.33382388510065614,0.10841053685967618,4,0.05420526842983809 +MoneyMaker,fruit,967514 MM WT,m_67,0.36943137511514357,0.16268423196465884,4,0.08134211598232942 +MoneyMaker,fruit,967514 MM WT,m_68,0.1594118584712459,0.021764259498809575,4,0.010882129749404787 +MoneyMaker,fruit,967514 MM WT,m_69,0.21365013024063353,0.06600097300125146,4,0.03300048650062573 +MoneyMaker,fruit,967514 MM WT,m_7,0.46813360288427225,0.1297364840805438,4,0.0648682420402719 +MoneyMaker,fruit,967514 MM WT,m_70,0.2832076436294652,0.07538428443025451,4,0.037692142215127254 +MoneyMaker,fruit,967514 MM WT,m_71,0.590012725546576,0.31023038213011006,4,0.15511519106505503 +MoneyMaker,fruit,967514 MM WT,m_72,0.39621567959678566,0.09879276605870403,4,0.049396383029352016 +MoneyMaker,fruit,967514 MM WT,m_73,0.41083858817158914,0.18652609713369295,4,0.09326304856684647 +MoneyMaker,fruit,967514 MM WT,m_74,0.2243638434764277,0.026033298281225126,4,0.013016649140612563 +MoneyMaker,fruit,967514 MM WT,m_75,0.1622923342102598,0.07921959705931733,4,0.039609798529658666 +MoneyMaker,fruit,967514 MM WT,m_76,0.3662666491289865,0.13230615235826731,4,0.06615307617913366 +MoneyMaker,fruit,967514 MM WT,m_77,0.011544080584873747,0.0019517082296691786,4,9.758541148345893e-4 +MoneyMaker,fruit,967514 MM WT,m_78,0.6076812277355401,0.3918751457159495,4,0.19593757285797475 +MoneyMaker,fruit,967514 MM WT,m_79,0.09750138377968406,0.01646093471108534,4,0.00823046735554267 +MoneyMaker,fruit,967514 MM WT,m_8,0.7004533274929795,0.27313654833241047,4,0.13656827416620523 +MoneyMaker,fruit,967514 MM WT,m_80,0.05833724964223802,0.012164491239592744,4,0.006082245619796372 +MoneyMaker,fruit,967514 MM WT,m_81,0.709738865485851,0.30237538174138845,4,0.15118769087069422 +MoneyMaker,fruit,967514 MM WT,m_82,0.34510368563829846,0.09855022291670304,4,0.04927511145835152 +MoneyMaker,fruit,967514 MM WT,m_83,0.4912204400968602,0.11292501815324474,4,0.05646250907662237 +MoneyMaker,fruit,967514 MM WT,m_84,1.1997345058145645,0.29638937428716927,4,0.14819468714358464 +MoneyMaker,fruit,967514 MM WT,m_85,0.09128954092199064,0.015185618674563616,4,0.007592809337281808 +MoneyMaker,fruit,967514 MM WT,m_86,0.2626277604694729,0.12085076489336082,4,0.06042538244668041 +MoneyMaker,fruit,967514 MM WT,m_87,0.10413367433513382,0.014453467271872007,4,0.0072267336359360035 +MoneyMaker,fruit,967514 MM WT,m_88,0.23097065147205875,0.045379106604763665,4,0.022689553302381833 +MoneyMaker,fruit,967514 MM WT,m_89,0.8020714788781488,0.176031013011603,4,0.0880155065058015 +MoneyMaker,fruit,967514 MM WT,m_9,0.0953942033420021,0.04506422680340443,4,0.022532113401702216 +MoneyMaker,fruit,967514 MM WT,m_90,0.3483528163337858,0.07480886936584256,4,0.03740443468292128 +MoneyMaker,fruit,967514 MM WT,m_91,0.09349207864258957,0.04395759819454844,4,0.02197879909727422 +MoneyMaker,fruit,967514 MM WT,m_92,0.3515550750316242,0.0911874101308897,4,0.04559370506544485 +MoneyMaker,fruit,967514 MM WT,m_93,0.7560557226550133,0.2554012945251312,4,0.1277006472625656 +MoneyMaker,fruit,967514 MM WT,m_94,0.40189076740885415,0.12582233072112842,4,0.06291116536056421 +MoneyMaker,fruit,967514 MM WT,m_97,0.5429861375797922,0.3060578817069705,4,0.15302894085348526 +MoneyMaker,fruit,967514 MM WT,m_98,0.32207155302052504,0.06355615376512029,4,0.031778076882560145 +MoneyMaker,fruit,967514 MM WT,m_99,0.4496849429835359,0.19263029463109507,4,0.09631514731554754 +MoneyMaker,leaf,967514 MM WT,m_1,0.5118987430540033,0.13923562912242332,4,0.06961781456121166 +MoneyMaker,leaf,967514 MM WT,m_10,0.035085671089461194,0.011176417242836077,4,0.0055882086214180384 +MoneyMaker,leaf,967514 MM WT,m_100,0.3987617957779114,0.09255801128709452,4,0.04627900564354726 +MoneyMaker,leaf,967514 MM WT,m_101,0.14771252394477113,0.0453172728296854,4,0.0226586364148427 +MoneyMaker,leaf,967514 MM WT,m_102,0.04038008921459113,0.0038572304352292876,4,0.0019286152176146438 +MoneyMaker,leaf,967514 MM WT,m_103,0.10304291239606435,0.0341576395715305,4,0.01707881978576525 +MoneyMaker,leaf,967514 MM WT,m_104,0.10303906540507507,0.03415754444688425,4,0.017078772223442125 +MoneyMaker,leaf,967514 MM WT,m_105,0.13379374177941727,0.0360643776377076,4,0.0180321888188538 +MoneyMaker,leaf,967514 MM WT,m_106,0.07724842342443715,0.0226751917404453,4,0.01133759587022265 +MoneyMaker,leaf,967514 MM WT,m_107,0.6169682105235668,0.12789587542392006,4,0.06394793771196003 +MoneyMaker,leaf,967514 MM WT,m_108,0.2701326755344045,0.08212616236012306,4,0.04106308118006153 +MoneyMaker,leaf,967514 MM WT,m_109,0.304091621972263,0.03934625950831942,4,0.01967312975415971 +MoneyMaker,leaf,967514 MM WT,m_11,1.0747836366851873,0.4243866299745433,4,0.21219331498727165 +MoneyMaker,leaf,967514 MM WT,m_110,0.25697280523095867,0.030618817104913116,4,0.015309408552456558 +MoneyMaker,leaf,967514 MM WT,m_111,0.39745164578224845,0.13156550456345312,4,0.06578275228172656 +MoneyMaker,leaf,967514 MM WT,m_112,1.0633531953648871,0.34105207651931047,4,0.17052603825965523 +MoneyMaker,leaf,967514 MM WT,m_12,1.223644494115569,0.4291000663513853,4,0.21455003317569266 +MoneyMaker,leaf,967514 MM WT,m_120,0.13202495620098226,0.012327945703193021,4,0.0061639728515965105 +MoneyMaker,leaf,967514 MM WT,m_121,0.8527159838208211,0.3988502114893581,4,0.19942510574467906 +MoneyMaker,leaf,967514 MM WT,m_122,0.1014428059456466,0.028998341065194628,4,0.014499170532597314 +MoneyMaker,leaf,967514 MM WT,m_123,0.4838953564154649,0.11478275891289748,4,0.05739137945644874 +MoneyMaker,leaf,967514 MM WT,m_13,0.5722878659561377,0.13577104163035314,4,0.06788552081517657 +MoneyMaker,leaf,967514 MM WT,m_14,0.2762967664224506,0.0884505191344921,4,0.04422525956724605 +MoneyMaker,leaf,967514 MM WT,m_15,0.27275525777228543,0.03150056509856281,4,0.015750282549281406 +MoneyMaker,leaf,967514 MM WT,m_16,0.33260536041835986,0.05233892762061121,4,0.026169463810305604 +MoneyMaker,leaf,967514 MM WT,m_17,0.5317481004666126,0.16835678330451667,4,0.08417839165225834 +MoneyMaker,leaf,967514 MM WT,m_18,0.3128337113402008,0.09408235479481514,4,0.04704117739740757 +MoneyMaker,leaf,967514 MM WT,m_19,0.1169602188866844,0.049232035593244995,4,0.024616017796622498 +MoneyMaker,leaf,967514 MM WT,m_2,0.5337909889959604,0.22600986685385413,4,0.11300493342692706 +MoneyMaker,leaf,967514 MM WT,m_20,0.4409712201762882,0.13507159055597803,4,0.06753579527798902 +MoneyMaker,leaf,967514 MM WT,m_21,0.42311181020114463,0.1884260741526951,4,0.09421303707634755 +MoneyMaker,leaf,967514 MM WT,m_22,0.3516842815561205,0.08353774915223865,4,0.04176887457611932 +MoneyMaker,leaf,967514 MM WT,m_23,0.3055239299426363,0.049380682734838824,4,0.024690341367419412 +MoneyMaker,leaf,967514 MM WT,m_24,0.2168135927667602,0.033441096455381174,4,0.016720548227690587 +MoneyMaker,leaf,967514 MM WT,m_25,0.305900896251862,0.08905526831788899,4,0.04452763415894449 +MoneyMaker,leaf,967514 MM WT,m_26,0.10126618617420827,0.03708552035990154,4,0.01854276017995077 +MoneyMaker,leaf,967514 MM WT,m_27,0.2111912922550016,0.10741175706816802,4,0.05370587853408401 +MoneyMaker,leaf,967514 MM WT,m_28,0.3695354462411041,0.10439473049373191,4,0.052197365246865954 +MoneyMaker,leaf,967514 MM WT,m_29,0.6885123769076202,0.14709863441684187,4,0.07354931720842094 +MoneyMaker,leaf,967514 MM WT,m_3,0.49277725611594875,0.1455946818066199,4,0.07279734090330996 +MoneyMaker,leaf,967514 MM WT,m_30,0.2028016160049509,0.01893370215116532,4,0.00946685107558266 +MoneyMaker,leaf,967514 MM WT,m_31,0.1605914433623423,0.09411397088413531,4,0.047056985442067656 +MoneyMaker,leaf,967514 MM WT,m_32,0.3246314778730885,0.08852722183307822,4,0.04426361091653911 +MoneyMaker,leaf,967514 MM WT,m_33,0.3430549255093222,0.11264164716842434,4,0.05632082358421217 +MoneyMaker,leaf,967514 MM WT,m_34,0.30666736668820005,0.13479331891613355,4,0.06739665945806678 +MoneyMaker,leaf,967514 MM WT,m_35,0.3548314009695578,0.15288848231683788,4,0.07644424115841894 +MoneyMaker,leaf,967514 MM WT,m_36,0.29279427927331175,0.12215918420418659,4,0.061079592102093294 +MoneyMaker,leaf,967514 MM WT,m_37,0.138122056421425,0.017203090001525336,4,0.008601545000762668 +MoneyMaker,leaf,967514 MM WT,m_38,0.2922872090874294,0.11571628081827955,4,0.05785814040913977 +MoneyMaker,leaf,967514 MM WT,m_39,0.11793666721291884,0.03745683541940837,4,0.018728417709704185 +MoneyMaker,leaf,967514 MM WT,m_4,0.27913624245781904,0.11196820985474931,4,0.055984104927374656 +MoneyMaker,leaf,967514 MM WT,m_40,0.07133696029138742,0.008548425499012954,4,0.004274212749506477 +MoneyMaker,leaf,967514 MM WT,m_41,0.18134784157973483,0.09449133947431897,4,0.04724566973715948 +MoneyMaker,leaf,967514 MM WT,m_42,0.049462519886395245,0.005324496099497646,4,0.002662248049748823 +MoneyMaker,leaf,967514 MM WT,m_43,0.16561247670379195,0.06968965138823814,4,0.03484482569411907 +MoneyMaker,leaf,967514 MM WT,m_44,0.7159354458418359,0.16662776730173265,4,0.08331388365086632 +MoneyMaker,leaf,967514 MM WT,m_45,0.8953702963835762,0.24029698729382565,4,0.12014849364691282 +MoneyMaker,leaf,967514 MM WT,m_46,1.083326004895171,0.2622732280294283,4,0.13113661401471416 +MoneyMaker,leaf,967514 MM WT,m_47,0.9114444321768727,0.2760427104476771,4,0.13802135522383854 +MoneyMaker,leaf,967514 MM WT,m_48,0.3634079444979527,0.10168085219630968,4,0.05084042609815484 +MoneyMaker,leaf,967514 MM WT,m_49,0.025203036201602767,0.010507577905814197,4,0.005253788952907098 +MoneyMaker,leaf,967514 MM WT,m_5,0.5282695977127362,0.17437768176621374,4,0.08718884088310687 +MoneyMaker,leaf,967514 MM WT,m_50,0.4173607708929512,0.11358837266811286,4,0.05679418633405643 +MoneyMaker,leaf,967514 MM WT,m_51,0.043688144510465196,0.017448481060999662,4,0.008724240530499831 +MoneyMaker,leaf,967514 MM WT,m_52,0.0566546833298737,0.007285456558457689,4,0.0036427282792288445 +MoneyMaker,leaf,967514 MM WT,m_53,0.3188338841132848,0.08587247880187845,4,0.04293623940093923 +MoneyMaker,leaf,967514 MM WT,m_54,0.48647220848946504,0.1314972308592131,4,0.06574861542960656 +MoneyMaker,leaf,967514 MM WT,m_55,0.21403489687260863,0.06470707116261022,4,0.03235353558130511 +MoneyMaker,leaf,967514 MM WT,m_56,0.4001838301960352,0.07815851552814117,4,0.039079257764070584 +MoneyMaker,leaf,967514 MM WT,m_57,0.19824557216643623,0.08968953223084393,4,0.044844766115421965 +MoneyMaker,leaf,967514 MM WT,m_58,0.8344788581083926,0.21339850376921832,4,0.10669925188460916 +MoneyMaker,leaf,967514 MM WT,m_59,0.3154112617060255,0.12107373318102509,4,0.06053686659051254 +MoneyMaker,leaf,967514 MM WT,m_6,0.44643537952994683,0.15093566757953691,4,0.07546783378976846 +MoneyMaker,leaf,967514 MM WT,m_60,0.25330407937620636,0.06686699204940255,4,0.033433496024701276 +MoneyMaker,leaf,967514 MM WT,m_61,0.12070638484060096,0.04194270768741219,4,0.020971353843706096 +MoneyMaker,leaf,967514 MM WT,m_62,0.07755451827915072,0.02754862874078157,4,0.013774314370390785 +MoneyMaker,leaf,967514 MM WT,m_63,1.0391508603388002,0.23620517803025962,4,0.11810258901512981 +MoneyMaker,leaf,967514 MM WT,m_64,0.11009680418147079,0.03747108325359874,4,0.01873554162679937 +MoneyMaker,leaf,967514 MM WT,m_65,0.049551299819764263,0.011270971395301704,4,0.005635485697650852 +MoneyMaker,leaf,967514 MM WT,m_66,0.15590738985302932,0.04076622757701079,4,0.020383113788505394 +MoneyMaker,leaf,967514 MM WT,m_67,0.386157389734275,0.05335571849191593,4,0.026677859245957964 +MoneyMaker,leaf,967514 MM WT,m_68,0.44969935139010103,0.06842121752823588,4,0.03421060876411794 +MoneyMaker,leaf,967514 MM WT,m_69,0.3797583818834176,0.1103788346675371,4,0.05518941733376855 +MoneyMaker,leaf,967514 MM WT,m_7,0.7109101325061914,0.264135094252861,4,0.1320675471264305 +MoneyMaker,leaf,967514 MM WT,m_70,0.4524190037134414,0.11568159768133579,4,0.057840798840667895 +MoneyMaker,leaf,967514 MM WT,m_71,0.14471932468762938,0.03132079707301068,4,0.01566039853650534 +MoneyMaker,leaf,967514 MM WT,m_72,0.25323483688323534,0.054661523730888235,4,0.027330761865444118 +MoneyMaker,leaf,967514 MM WT,m_73,0.05760577033930864,0.03005344374494445,4,0.015026721872472225 +MoneyMaker,leaf,967514 MM WT,m_74,0.08508482809520776,0.025116526536776013,4,0.012558263268388006 +MoneyMaker,leaf,967514 MM WT,m_75,0.08583857356126118,0.031257035270211043,4,0.015628517635105522 +MoneyMaker,leaf,967514 MM WT,m_76,0.1462186734677538,0.017079188155807452,4,0.008539594077903726 +MoneyMaker,leaf,967514 MM WT,m_77,0.07754476675232544,0.02882174257079712,4,0.01441087128539856 +MoneyMaker,leaf,967514 MM WT,m_78,0.016624949765271915,0.005222210932020888,4,0.002611105466010444 +MoneyMaker,leaf,967514 MM WT,m_79,0.04957976948335031,0.0036143143721601447,4,0.0018071571860800723 +MoneyMaker,leaf,967514 MM WT,m_8,0.25604168839757935,0.0322952465276536,4,0.0161476232638268 +MoneyMaker,leaf,967514 MM WT,m_80,0.060708925739193065,0.01615165744813482,4,0.00807582872406741 +MoneyMaker,leaf,967514 MM WT,m_81,0.09153536900845285,0.029312565016691876,4,0.014656282508345938 +MoneyMaker,leaf,967514 MM WT,m_82,0.35201581639164303,0.13060700509083817,4,0.06530350254541908 +MoneyMaker,leaf,967514 MM WT,m_83,0.153802707206564,0.023953755835590177,4,0.011976877917795089 +MoneyMaker,leaf,967514 MM WT,m_84,1.4770073697743935,0.19549477176334687,4,0.09774738588167343 +MoneyMaker,leaf,967514 MM WT,m_85,0.5737613387120818,0.1748827291538924,4,0.0874413645769462 +MoneyMaker,leaf,967514 MM WT,m_86,0.5129943861730327,0.13482332963321408,4,0.06741166481660704 +MoneyMaker,leaf,967514 MM WT,m_87,0.305800231011702,0.06119821281639923,4,0.030599106408199614 +MoneyMaker,leaf,967514 MM WT,m_88,0.27695458762099845,0.035212519104356764,4,0.017606259552178382 +MoneyMaker,leaf,967514 MM WT,m_89,0.6421627644414007,0.22855599362041468,4,0.11427799681020734 +MoneyMaker,leaf,967514 MM WT,m_9,0.02709216318715369,0.005663132487696772,4,0.002831566243848386 +MoneyMaker,leaf,967514 MM WT,m_90,0.24834798535024594,0.08363981310992046,4,0.04181990655496023 +MoneyMaker,leaf,967514 MM WT,m_91,0.45776289678873705,0.13970520570891054,4,0.06985260285445527 +MoneyMaker,leaf,967514 MM WT,m_92,0.6500114454161715,0.19521031057168695,4,0.09760515528584347 +MoneyMaker,leaf,967514 MM WT,m_93,0.1885969781332888,0.07731136574224048,4,0.03865568287112024 +MoneyMaker,leaf,967514 MM WT,m_94,0.35096416283615023,0.11851586850591357,4,0.059257934252956786 +MoneyMaker,leaf,967514 MM WT,m_97,0.46358992379738756,0.17143706022055333,4,0.08571853011027666 +MoneyMaker,leaf,967514 MM WT,m_98,0.6726472820079383,0.13615604267902415,4,0.06807802133951207 +MoneyMaker,leaf,967514 MM WT,m_99,0.36263963034565583,0.07849476882219085,4,0.039247384411095425 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_1,0.1610248719079469,0.027451909111139806,4,0.013725954555569903 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_10,0.019268941450431894,0.005025760292639788,4,0.002512880146319894 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_100,0.22731619425079252,0.08006026643525051,4,0.040030133217625254 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_101,0.22911942478983902,0.09833856833296417,4,0.049169284166482086 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_102,0.09629336444888789,0.024352221667115866,4,0.012176110833557933 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_103,1.0367754156727542,0.6524740365615002,4,0.3262370182807501 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_104,1.0330618553110646,0.6562366465187723,4,0.32811832325938617 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_105,0.06891660201174014,0.026303861909621487,4,0.013151930954810744 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_106,0.18292663914621693,0.08078309163316665,4,0.04039154581658332 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_107,0.39497606388041395,0.17177700031697193,4,0.08588850015848597 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_108,0.6845435327462979,0.2111304733769384,4,0.1055652366884692 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_109,0.3128555544576871,0.11002438375459941,4,0.05501219187729971 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_11,0.6475130490022062,0.22109089813328342,4,0.11054544906664171 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_110,0.39391594833356813,0.15989658770187581,4,0.07994829385093791 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_111,0.056924499876030585,0.015347252371402968,4,0.007673626185701484 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_112,0.2936398012077573,0.15998948762392726,4,0.07999474381196363 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_12,0.5657454069875123,0.19063779525640484,4,0.09531889762820242 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_120,0.16235149393855047,0.05400587524639655,4,0.027002937623198275 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_121,0.2339632495629703,0.09005681165928581,4,0.045028405829642904 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_122,0.17380557298611893,0.05405933141240215,4,0.027029665706201075 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_123,0.1679667191998866,0.048374194131134175,4,0.024187097065567088 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_13,0.8782774286911992,0.2973589874089558,4,0.1486794937044779 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_14,0.2835783938940922,0.10179555056179815,4,0.050897775280899074 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_15,0.10911668421543495,0.044243916963883925,4,0.022121958481941963 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_16,0.5483382356580899,0.13314865062782769,4,0.06657432531391384 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_17,0.8747537060506192,0.46278979434907436,4,0.23139489717453718 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_18,0.4148165559306123,0.26132105368428576,4,0.13066052684214288 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_19,0.2153781908176983,0.09184799540516639,4,0.045923997702583194 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_2,0.3422883735251995,0.13197441523287995,4,0.06598720761643997 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_20,0.09775731973419141,0.022039870360190394,4,0.011019935180095197 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_21,0.5415959653873847,0.27465754432998485,4,0.13732877216499242 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_22,0.4097578282886627,0.19778674014490213,4,0.09889337007245107 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_23,0.1425654144009612,0.06897765732515886,4,0.03448882866257943 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_24,0.31697197307991615,0.11188470984447677,4,0.05594235492223838 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_25,0.11274792196616373,0.02456089073532981,4,0.012280445367664905 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_26,0.24495703138352454,0.11357027048884487,4,0.056785135244422434 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_27,0.28247649605988456,0.052258948417357405,4,0.026129474208678703 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_28,0.07993366036665794,0.038668861107554055,4,0.019334430553777027 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_29,0.8685917488487666,0.45486952909125855,4,0.22743476454562928 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_3,0.343768839260841,0.13120199789743414,4,0.06560099894871707 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_30,0.3941219218576881,0.16407508649241603,4,0.08203754324620802 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_31,0.24692121734645947,0.08769953713194743,4,0.04384976856597372 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_32,0.21253397287371428,0.019475777881924537,4,0.009737888940962268 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_33,0.6001008911406716,0.12753208201853572,4,0.06376604100926786 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_34,0.25128143160259103,0.06564502849355046,4,0.03282251424677523 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_35,0.32974530979112493,0.08859833073239551,4,0.044299165366197754 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_36,0.19446146621718882,0.056812682468564066,4,0.028406341234282033 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_37,0.23947691310799152,0.06681205663634751,4,0.033406028318173756 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_38,0.3211148147526049,0.05711095704336774,4,0.02855547852168387 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_39,1.401987852812655,0.47533168596119946,4,0.23766584298059973 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_4,0.28537556645896334,0.083855248376973765,4,0.04192762418848688 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_40,0.5199701528800811,0.2185936080278228,4,0.1092968040139114 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_41,0.18125913688341047,0.05422441299873358,4,0.02711220649936679 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_42,0.037761737557719985,0.005015405373658759,4,0.0025077026868293795 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_43,0.5192733675040204,0.20063390502326392,4,0.10031695251163196 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_44,0.9373391190128961,0.4876031073126239,4,0.24380155365631195 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_45,0.8916399494088346,0.48620834949527814,4,0.24310417474763907 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_46,0.9028159649971672,0.45458404527263296,4,0.22729202263631648 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_47,0.6881817179859429,0.2540835099631181,4,0.12704175498155906 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_48,0.37796913304156843,0.10399437129093499,4,0.05199718564546749 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_49,0.03659449220223477,0.01084538816942143,4,0.005422694084710715 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_5,0.26959275520746007,0.05544633961512366,4,0.02772316980756183 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_50,0.10199222344962551,0.015336677452265496,4,0.007668338726132748 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_51,0.13022395215852256,0.020513663587133014,4,0.010256831793566507 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_52,0.07913500675520628,0.024893901887546647,4,0.012446950943773323 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_53,0.20801208630585233,0.09553926055605211,4,0.047769630278026054 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_54,0.2176824271590084,0.05497835182549755,4,0.027489175912748774 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_55,0.4418338623894704,0.11997893220584796,4,0.05998946610292398 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_56,0.16302872617984673,0.028585062536571608,4,0.014292531268285804 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_57,0.29237714819909305,0.1476548852564795,4,0.07382744262823975 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_58,0.24404056298668805,0.11703429705387013,4,0.05851714852693506 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_59,0.48895189911080045,0.18799734105860796,4,0.09399867052930398 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_6,0.23443721176307591,0.05163889272583322,4,0.02581944636291661 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_60,0.21654460284055121,0.11538750128542885,4,0.057693750642714425 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_61,0.2524089998582854,0.0773580107147621,4,0.03867900535738105 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_62,0.9414104201563096,0.28008951005902566,4,0.14004475502951283 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_63,0.6589588671966862,0.3894966255617836,4,0.1947483127808918 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_64,0.3851382175517105,0.2147177688773226,4,0.1073588844386613 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_65,0.19322776630166297,0.06471092367866436,4,0.03235546183933218 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_66,0.21219728782580824,0.07788043362228403,4,0.038940216811142014 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_67,0.33894624102076465,0.12980031216947632,4,0.06490015608473816 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_68,0.054074934153901535,0.011365555859486101,4,0.005682777929743051 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_69,0.5928501182837854,0.22519392526670998,4,0.11259696263335499 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_7,0.6435605185204398,0.2968235504337623,4,0.14841177521688115 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_70,0.25457507224426923,0.10037702103770699,4,0.050188510518853494 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_71,0.5976755084342305,0.3552076953514875,4,0.17760384767574375 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_72,0.44910143291100135,0.15791915425792794,4,0.07895957712896397 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_73,0.34305871579064073,0.10814403772321439,4,0.054072018861607195 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_74,0.11387325143562228,0.042061997750189595,4,0.021030998875094797 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_75,0.09561533430699826,0.02814652911522768,4,0.01407326455761384 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_76,0.20840523852909465,0.08367192504356785,4,0.041835962521783926 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_77,0.05784983788913367,0.016100827875212675,4,0.008050413937606337 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_78,0.016513515975941712,0.0049805958452637834,4,0.0024902979226318917 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_79,0.15386671011142358,0.05058749375978326,4,0.02529374687989163 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_8,0.4899255586688991,0.24378232959894605,4,0.12189116479947303 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_80,0.11720914248899222,0.07488916165817361,4,0.037444580829086804 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_81,0.583063825583724,0.24586034353213435,4,0.12293017176606717 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_82,0.19046311459388435,0.04393446724551973,4,0.021967233622759864 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_83,0.33314897951053885,0.09614732308581041,4,0.048073661542905204 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_84,1.1732213970942214,0.5032747875715372,4,0.2516373937857686 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_85,0.3285704262942539,0.09631457046695457,4,0.04815728523347729 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_86,0.13790615672040127,0.04057023403240784,4,0.02028511701620392 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_87,0.17075771448667745,0.06741907909859061,4,0.03370953954929531 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_88,0.24047170571363194,0.08104056187640594,4,0.04052028093820297 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_89,1.0641716013702227,0.48959049176922487,4,0.24479524588461243 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_9,0.24054386764449148,0.06034365356232242,4,0.03017182678116121 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_90,0.24774323165409273,0.1181518636354478,4,0.0590759318177239 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_91,0.15172046555170138,0.05815973600265346,4,0.02907986800132673 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_92,0.5535669649341137,0.13886673898252955,4,0.06943336949126477 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_93,0.5943818825616554,0.24013530939776423,4,0.12006765469888211 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_94,0.49944074463680804,0.15270046498156878,4,0.07635023249078439 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_97,0.4146352344298909,0.13781358195758814,4,0.06890679097879407 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_98,0.3360697739603135,0.17788375968105988,4,0.08894187984052994 +transp1-1,fruit,1017363 Sl10g007190 #19.2,m_99,0.8249763431192457,0.42793317172771417,4,0.21396658586385708 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_1,0.48233322358346226,0.20382643355275185,4,0.10191321677637592 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_10,0.017892933381355832,0.009869861037047891,4,0.004934930518523946 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_100,0.3666769725936657,0.07351421325487355,4,0.036757106627436774 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_101,0.38024184552328855,0.11920522234961932,4,0.05960261117480966 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_102,0.057831663262842795,0.027401115468505557,4,0.013700557734252779 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_103,0.14831684707465173,0.04497826938670452,4,0.02248913469335226 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_104,0.14831684707465173,0.04497826938670452,4,0.02248913469335226 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_105,0.2698220726711238,0.09394291018411853,4,0.046971455092059265 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_106,0.07649022391516268,0.025550444847125243,4,0.012775222423562622 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_107,0.5319177186848376,0.12454147917600486,4,0.06227073958800243 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_108,0.33535310062182594,0.10428543977795818,4,0.05214271988897909 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_109,0.35674319776296387,0.09747996995906526,4,0.04873998497953263 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_11,1.0420239773405227,0.261334750548737,4,0.1306673752743685 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_110,0.6667921131421423,0.17572860527237139,4,0.08786430263618569 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_111,0.35976379956812854,0.12313887591952238,4,0.06156943795976119 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_112,0.6893920260470846,0.32190558336994496,4,0.16095279168497248 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_12,1.1214202645065192,0.5754842883839422,4,0.2877421441919711 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_120,0.2734888522861705,0.05582689657049454,4,0.02791344828524727 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_121,1.063715402032793,0.361366454297338,4,0.180683227148669 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_122,0.159358949554156,0.05645244253412347,4,0.028226221267061737 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_123,0.18062282243574695,0.02273079828544154,4,0.01136539914272077 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_13,0.5416913881621748,0.16948844615839606,4,0.08474422307919803 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_14,0.4983878710794578,0.14141063912389717,4,0.07070531956194859 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_15,0.11122108734360092,0.034362332847033786,4,0.017181166423516893 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_16,0.216592667882417,0.07553760673001156,4,0.03776880336500578 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_17,0.449355213558705,0.1164649712824793,4,0.05823248564123965 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_18,0.5402650811705877,0.1035948001934117,4,0.05179740009670585 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_19,0.2285264388807713,0.04267664707876489,4,0.021338323539382444 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_2,0.2503951728016769,0.0863995700000744,4,0.0431997850000372 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_20,0.44113466325159817,0.1406452988622746,4,0.0703226494311373 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_21,0.3287650663853273,0.07801941390135231,4,0.039009706950676154 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_22,0.13341106383554885,0.011413068529855689,4,0.0057065342649278445 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_23,0.3263410207884416,0.08437660479785851,4,0.042188302398929255 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_24,0.44892181866500835,0.08136584949031155,4,0.04068292474515577 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_25,0.2449050251869707,0.09057611857547487,4,0.04528805928773744 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_26,0.08614789055853907,0.009153168781750652,4,0.004576584390875326 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_27,0.13225572607431324,0.03091841414292306,4,0.01545920707146153 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_28,0.2504875338661811,0.09111887795996788,4,0.04555943897998394 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_29,0.5440194224512024,0.09638252295845602,4,0.04819126147922801 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_3,0.45572288610062106,0.13369284761673406,4,0.06684642380836703 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_30,0.06098971928861817,0.01061025709360564,4,0.00530512854680282 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_31,0.12499004662848283,0.044592239109671805,4,0.022296119554835903 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_32,0.3632762357127735,0.14201249406988903,4,0.07100624703494451 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_33,0.2890210245122574,0.06501164754563596,4,0.03250582377281798 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_34,0.3108841416684508,0.10009960443446167,4,0.050049802217230835 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_35,0.3538627805638319,0.0660694276696927,4,0.03303471383484635 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_36,0.2577682613069167,0.09365275089336157,4,0.046826375446680786 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_37,0.07475795366531648,0.0183981531200336,4,0.0091990765600168 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_38,0.4348538266635929,0.16408899980318573,4,0.08204449990159286 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_39,0.1636201815045655,0.05021829494077052,4,0.02510914747038526 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_4,0.31531694582909203,0.12133867930048312,4,0.06066933965024156 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_40,0.09825528414951783,0.037121262209931664,4,0.018560631104965832 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_41,0.15515366508710063,0.03146053306795438,4,0.01573026653397719 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_42,0.03622051160817409,0.011763189397876326,4,0.005881594698938163 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_43,0.2034659953425762,0.06300551029119598,4,0.03150275514559799 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_44,0.49786553092014707,0.08520165732349669,4,0.042600828661748344 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_45,0.6856690267833284,0.14178984499672181,4,0.07089492249836091 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_46,1.1415143812223465,0.23057581833742688,4,0.11528790916871344 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_47,0.9034642712437231,0.31095818620246835,4,0.15547909310123417 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_48,0.20867849827625332,0.11665735723143435,4,0.058328678615717174 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_49,0.012336548750153243,0.0035656201286102997,4,0.0017828100643051499 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_5,0.47637765042373176,0.1785207289412847,4,0.08926036447064235 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_50,0.4643187448404458,0.08736458946318294,4,0.04368229473159147 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_51,0.013985278543609963,0.0055214886018767565,4,0.0027607443009383783 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_52,0.04079100810058443,0.008161527867944907,4,0.0040807639339724535 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_53,0.25150121583955654,0.10759631487989724,4,0.05379815743994862 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_54,0.5315205162121333,0.16202893343414645,4,0.08101446671707323 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_55,0.2339877755317798,0.07498243535784813,4,0.03749121767892406 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_56,0.1945969876878668,0.06354382873379759,4,0.031771914366898794 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_57,0.16552636009187016,0.0654430806116321,4,0.03272154030581605 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_58,0.5622008330743412,0.10766690463949138,4,0.05383345231974569 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_59,0.2694921555282011,0.11180681376470536,4,0.05590340688235268 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_6,0.2210138408898492,0.0892286604236157,4,0.04461433021180785 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_60,0.5489069980825458,0.10483898670899405,4,0.052419493354497027 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_61,0.1358554457296615,0.038973409694060546,4,0.019486704847030273 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_62,0.13896145348733213,0.01694355716131457,4,0.008471778580657285 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_63,0.9528823387696523,0.2296687984894188,4,0.1148343992447094 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_64,0.19046658708742759,0.0593904666341704,4,0.0296952333170852 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_65,0.13796825554834735,0.057982219526134464,4,0.028991109763067232 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_66,0.17043900244860577,0.034008540508806695,4,0.017004270254403347 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_67,0.41372969006354177,0.10146611547000722,4,0.05073305773500361 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_68,0.2766398556548896,0.07280114470885488,4,0.03640057235442744 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_69,0.4833894145181525,0.19565838645409298,4,0.09782919322704649 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_7,0.5550742661150568,0.23365020381702378,4,0.11682510190851189 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_70,0.3101557241088895,0.0968932378242285,4,0.04844661891211425 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_71,0.25098466095225197,0.07495943985752969,4,0.037479719928764844 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_72,0.1492463571888083,0.08033573416953825,4,0.040167867084769125 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_73,0.10733819519223729,0.038168902327240274,4,0.019084451163620137 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_74,0.09429081184482048,0.04374170795993846,4,0.02187085397996923 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_75,0.08461790134457695,0.025735946837457436,4,0.012867973418728718 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_76,0.2131693841279575,0.06088264784015103,4,0.030441323920075515 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_77,0.04664892572103958,0.01460550550377293,4,0.007302752751886465 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_78,0.0136432226816816,0.005875288255169726,4,0.002937644127584863 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_79,0.05775593341152854,0.0126125866239848,4,0.0063062933119924 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_8,0.1992473116922861,0.0397781419428112,4,0.0198890709714056 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_80,0.08919619712730265,0.03469283019717481,4,0.017346415098587406 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_81,0.0918935526960869,0.03256231927833366,4,0.01628115963916683 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_82,0.4978756420452963,0.21263902549790037,4,0.10631951274895018 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_83,0.1220868856257589,0.037929641398854096,4,0.018964820699427048 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_84,1.4416332090367918,0.22865420697451436,4,0.11432710348725718 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_85,0.6964033554670344,0.21536445090170564,4,0.10768222545085282 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_86,0.5311149096255728,0.11802112926441836,4,0.05901056463220918 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_87,0.29252321263392594,0.08910382865362437,4,0.044551914326812186 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_88,0.2225421595299799,0.0676809151079804,4,0.0338404575539902 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_89,0.5178606392358724,0.17644681948327956,4,0.08822340974163978 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_9,0.02971206642503363,0.007492798221412045,4,0.0037463991107060226 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_90,0.3139129681893559,0.09037026111956194,4,0.04518513055978097 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_91,0.2892790487722703,0.12247665608620475,4,0.06123832804310238 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_92,0.7319298654767513,0.18892988223984247,4,0.09446494111992124 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_93,0.3720432471954328,0.1900317182864776,4,0.0950158591432388 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_94,0.448872475533011,0.13302082556599276,4,0.06651041278299638 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_97,0.32987718420049467,0.09045728732998058,4,0.04522864366499029 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_98,0.6819901016442403,0.15215841603791985,4,0.07607920801895993 +transp1-1,leaf,1017363 Sl10g007190 #19.2,m_99,0.3414002365266878,0.05668719301724133,4,0.028343596508620665 +log2-1,fruit,1017361 Sl10g086080 #2,m_1,0.16343029752671995,0.04993039356621523,4,0.024965196783107615 +log2-1,fruit,1017361 Sl10g086080 #2,m_10,0.024927138126432033,0.013667702323786198,4,0.006833851161893099 +log2-1,fruit,1017361 Sl10g086080 #2,m_100,0.3252922912685446,0.11757723899446652,4,0.05878861949723326 +log2-1,fruit,1017361 Sl10g086080 #2,m_101,0.08523273522115303,0.01626441394279861,4,0.008132206971399304 +log2-1,fruit,1017361 Sl10g086080 #2,m_102,0.14468562426172965,0.044335257270816386,4,0.022167628635408193 +log2-1,fruit,1017361 Sl10g086080 #2,m_103,0.6425559975697666,0.2145804403483233,4,0.10729022017416165 +log2-1,fruit,1017361 Sl10g086080 #2,m_104,0.6873568062381621,0.24187088496652412,4,0.12093544248326206 +log2-1,fruit,1017361 Sl10g086080 #2,m_105,0.096095475952538,0.027831394880767364,4,0.013915697440383682 +log2-1,fruit,1017361 Sl10g086080 #2,m_106,0.1890586090950077,0.09407472782894673,4,0.047037363914473364 +log2-1,fruit,1017361 Sl10g086080 #2,m_107,0.5705458286356607,0.1628908248802095,4,0.08144541244010475 +log2-1,fruit,1017361 Sl10g086080 #2,m_108,0.8203767894325033,0.30766872957337266,4,0.15383436478668633 +log2-1,fruit,1017361 Sl10g086080 #2,m_109,0.17335259841915374,0.08708597932045659,4,0.04354298966022829 +log2-1,fruit,1017361 Sl10g086080 #2,m_11,0.8544766923659345,0.21883872824374703,4,0.10941936412187352 +log2-1,fruit,1017361 Sl10g086080 #2,m_110,0.5808804608436791,0.1796121084430567,4,0.08980605422152835 +log2-1,fruit,1017361 Sl10g086080 #2,m_111,0.378958334748091,0.18602717420587364,4,0.09301358710293682 +log2-1,fruit,1017361 Sl10g086080 #2,m_112,0.3160220271530918,0.09908114274431593,4,0.04954057137215796 +log2-1,fruit,1017361 Sl10g086080 #2,m_12,0.7906193691103007,0.20172184830815468,4,0.10086092415407734 +log2-1,fruit,1017361 Sl10g086080 #2,m_120,0.09365453193128,0.018967744362768834,4,0.009483872181384417 +log2-1,fruit,1017361 Sl10g086080 #2,m_121,0.17904468512588903,0.07148395108541206,4,0.03574197554270603 +log2-1,fruit,1017361 Sl10g086080 #2,m_122,0.34471508569188714,0.12291226975876435,4,0.061456134879382174 +log2-1,fruit,1017361 Sl10g086080 #2,m_123,0.3785652192405685,0.09971518924894109,4,0.04985759462447054 +log2-1,fruit,1017361 Sl10g086080 #2,m_13,0.9236450942868697,0.2970627054328226,4,0.1485313527164113 +log2-1,fruit,1017361 Sl10g086080 #2,m_14,0.17044486654344765,0.05162217970894764,4,0.02581108985447382 +log2-1,fruit,1017361 Sl10g086080 #2,m_15,0.3097424777979322,0.09610118084738765,4,0.04805059042369383 +log2-1,fruit,1017361 Sl10g086080 #2,m_16,0.17124089224640954,0.040082998723600695,4,0.020041499361800347 +log2-1,fruit,1017361 Sl10g086080 #2,m_17,1.1764107079895818,0.4057627610465241,4,0.20288138052326204 +log2-1,fruit,1017361 Sl10g086080 #2,m_18,0.6768920996166217,0.14626204791365194,4,0.07313102395682597 +log2-1,fruit,1017361 Sl10g086080 #2,m_19,0.19101904776328008,0.04325987095718232,4,0.02162993547859116 +log2-1,fruit,1017361 Sl10g086080 #2,m_2,1.5411364298995283,0.3810079951991166,4,0.1905039975995583 +log2-1,fruit,1017361 Sl10g086080 #2,m_20,0.19926264583356212,0.08890714651332984,4,0.04445357325666492 +log2-1,fruit,1017361 Sl10g086080 #2,m_21,0.3474267547200141,0.10693588974865556,4,0.05346794487432778 +log2-1,fruit,1017361 Sl10g086080 #2,m_22,0.4549778129048102,0.12168899746141688,4,0.06084449873070844 +log2-1,fruit,1017361 Sl10g086080 #2,m_23,0.1369732876917635,0.027226400154116433,4,0.013613200077058216 +log2-1,fruit,1017361 Sl10g086080 #2,m_24,0.3260685824715779,0.10806362503535138,4,0.05403181251767569 +log2-1,fruit,1017361 Sl10g086080 #2,m_25,0.12376721913967803,0.07094701760497343,4,0.03547350880248672 +log2-1,fruit,1017361 Sl10g086080 #2,m_26,0.25992855812381865,0.07379384786909605,4,0.03689692393454803 +log2-1,fruit,1017361 Sl10g086080 #2,m_27,0.1199887311047202,0.01199154753958876,4,0.00599577376979438 +log2-1,fruit,1017361 Sl10g086080 #2,m_28,0.2610445306053677,0.08569815617613605,4,0.042849078088068024 +log2-1,fruit,1017361 Sl10g086080 #2,m_29,0.4837622935189364,0.2671222706954206,4,0.1335611353477103 +log2-1,fruit,1017361 Sl10g086080 #2,m_3,0.388567177516648,0.1886422887151763,4,0.09432114435758815 +log2-1,fruit,1017361 Sl10g086080 #2,m_30,0.15850968318912073,0.04965534282941159,4,0.024827671414705797 +log2-1,fruit,1017361 Sl10g086080 #2,m_31,0.5718066401529042,0.25933326666409284,4,0.12966663333204642 +log2-1,fruit,1017361 Sl10g086080 #2,m_32,0.22739640411883194,0.07265531712680717,4,0.036327658563403586 +log2-1,fruit,1017361 Sl10g086080 #2,m_33,0.5254021566712662,0.17967061603914167,4,0.08983530801957083 +log2-1,fruit,1017361 Sl10g086080 #2,m_34,0.13322053362839922,0.032335233622867166,4,0.016167616811433583 +log2-1,fruit,1017361 Sl10g086080 #2,m_35,0.40655885334719905,0.14169698372622985,4,0.07084849186311493 +log2-1,fruit,1017361 Sl10g086080 #2,m_36,0.18741267606742518,0.07022444971754412,4,0.03511222485877206 +log2-1,fruit,1017361 Sl10g086080 #2,m_37,0.14908464450546643,0.04318973178406171,4,0.021594865892030857 +log2-1,fruit,1017361 Sl10g086080 #2,m_38,0.5213356201806386,0.1283479544244006,4,0.0641739772122003 +log2-1,fruit,1017361 Sl10g086080 #2,m_39,0.690590979683197,0.1486852431526644,4,0.0743426215763322 +log2-1,fruit,1017361 Sl10g086080 #2,m_4,0.5391335271066939,0.1689120017951065,4,0.08445600089755324 +log2-1,fruit,1017361 Sl10g086080 #2,m_40,0.3506550994825259,0.14169982787011995,4,0.07084991393505997 +log2-1,fruit,1017361 Sl10g086080 #2,m_41,0.1661948923314101,0.09020266384454498,4,0.04510133192227249 +log2-1,fruit,1017361 Sl10g086080 #2,m_42,0.12289286222028765,0.0475808858694267,4,0.02379044293471335 +log2-1,fruit,1017361 Sl10g086080 #2,m_43,1.0036113526881585,0.449788565221057,4,0.2248942826105285 +log2-1,fruit,1017361 Sl10g086080 #2,m_44,0.6802060014932264,0.27895317901404443,4,0.13947658950702221 +log2-1,fruit,1017361 Sl10g086080 #2,m_45,0.6333938740422206,0.3178984296744533,4,0.15894921483722665 +log2-1,fruit,1017361 Sl10g086080 #2,m_46,0.8036874826606645,0.22142242904830367,4,0.11071121452415184 +log2-1,fruit,1017361 Sl10g086080 #2,m_47,0.8484840498156829,0.27016737553273795,4,0.13508368776636898 +log2-1,fruit,1017361 Sl10g086080 #2,m_48,0.4481802983979717,0.15672098278885313,4,0.07836049139442657 +log2-1,fruit,1017361 Sl10g086080 #2,m_49,0.04682517334316884,0.015411629118752455,4,0.007705814559376228 +log2-1,fruit,1017361 Sl10g086080 #2,m_5,0.17157087190549752,0.04862010121999796,4,0.02431005060999898 +log2-1,fruit,1017361 Sl10g086080 #2,m_50,0.24215924952963053,0.09293394292355778,4,0.04646697146177889 +log2-1,fruit,1017361 Sl10g086080 #2,m_51,0.08460360176947065,0.030782750002849347,4,0.015391375001424673 +log2-1,fruit,1017361 Sl10g086080 #2,m_52,0.08321779360713351,0.02687087196524848,4,0.01343543598262424 +log2-1,fruit,1017361 Sl10g086080 #2,m_53,0.18561140776009127,0.057548910478899026,4,0.028774455239449513 +log2-1,fruit,1017361 Sl10g086080 #2,m_54,0.28178032073719456,0.09038957844539637,4,0.045194789222698185 +log2-1,fruit,1017361 Sl10g086080 #2,m_55,0.2408807199764703,0.1302328275087199,4,0.06511641375435995 +log2-1,fruit,1017361 Sl10g086080 #2,m_56,0.23567063677547692,0.04681430655227891,4,0.023407153276139455 +log2-1,fruit,1017361 Sl10g086080 #2,m_57,0.3074355858284116,0.1116234050392791,4,0.05581170251963955 +log2-1,fruit,1017361 Sl10g086080 #2,m_58,0.11706418163293107,0.03436222770587466,4,0.01718111385293733 +log2-1,fruit,1017361 Sl10g086080 #2,m_59,0.6192594835868166,0.1910909946916946,4,0.0955454973458473 +log2-1,fruit,1017361 Sl10g086080 #2,m_6,0.8257553099397625,0.4539245698464351,4,0.22696228492321754 +log2-1,fruit,1017361 Sl10g086080 #2,m_60,0.5347825154619268,0.09619206667711498,4,0.04809603333855749 +log2-1,fruit,1017361 Sl10g086080 #2,m_61,0.28443315093083277,0.03826189500101179,4,0.019130947500505896 +log2-1,fruit,1017361 Sl10g086080 #2,m_62,0.8987422236872958,0.3353205699477307,4,0.16766028497386534 +log2-1,fruit,1017361 Sl10g086080 #2,m_63,0.7546772396509759,0.2171434812431884,4,0.1085717406215942 +log2-1,fruit,1017361 Sl10g086080 #2,m_64,0.5793333065323844,0.22385899309698323,4,0.11192949654849162 +log2-1,fruit,1017361 Sl10g086080 #2,m_65,0.305903306136869,0.0546107838572624,4,0.0273053919286312 +log2-1,fruit,1017361 Sl10g086080 #2,m_66,0.4658904232000851,0.17025526528769375,4,0.08512763264384687 +log2-1,fruit,1017361 Sl10g086080 #2,m_67,0.417021443492897,0.10738748031319799,4,0.053693740156598994 +log2-1,fruit,1017361 Sl10g086080 #2,m_68,0.0819325167340326,0.03200357708431245,4,0.016001788542156226 +log2-1,fruit,1017361 Sl10g086080 #2,m_69,0.569112611933187,0.20904988267262123,4,0.10452494133631061 +log2-1,fruit,1017361 Sl10g086080 #2,m_7,0.5065515535318751,0.17746015597698697,4,0.08873007798849349 +log2-1,fruit,1017361 Sl10g086080 #2,m_70,0.42160762865241364,0.1309586943334039,4,0.06547934716670195 +log2-1,fruit,1017361 Sl10g086080 #2,m_71,0.31667182001173344,0.12395908528898693,4,0.061979542644493464 +log2-1,fruit,1017361 Sl10g086080 #2,m_72,0.28786049409334874,0.09936407166124069,4,0.04968203583062034 +log2-1,fruit,1017361 Sl10g086080 #2,m_73,0.4479545630656048,0.12387576152495805,4,0.061937880762479025 +log2-1,fruit,1017361 Sl10g086080 #2,m_74,0.27380703801297734,0.08601021467925558,4,0.04300510733962779 +log2-1,fruit,1017361 Sl10g086080 #2,m_75,0.11984218918427336,0.02676105434853895,4,0.013380527174269475 +log2-1,fruit,1017361 Sl10g086080 #2,m_76,0.47749888477620317,0.1196563803108631,4,0.05982819015543155 +log2-1,fruit,1017361 Sl10g086080 #2,m_77,0.04495814274204775,0.014959323819881248,4,0.007479661909940624 +log2-1,fruit,1017361 Sl10g086080 #2,m_78,0.8197193841588829,0.1763819725410111,4,0.08819098627050555 +log2-1,fruit,1017361 Sl10g086080 #2,m_79,0.11024045788739541,0.030906918371158765,4,0.015453459185579383 +log2-1,fruit,1017361 Sl10g086080 #2,m_8,0.6377476144552021,0.37047063733123764,4,0.18523531866561882 +log2-1,fruit,1017361 Sl10g086080 #2,m_80,0.04073471636295568,0.00628985121324731,4,0.003144925606623655 +log2-1,fruit,1017361 Sl10g086080 #2,m_81,0.9719578715599918,0.3837115263822286,4,0.1918557631911143 +log2-1,fruit,1017361 Sl10g086080 #2,m_82,0.08493830593787279,0.026323528743123926,4,0.013161764371561963 +log2-1,fruit,1017361 Sl10g086080 #2,m_83,0.4540576881565696,0.13999378666022913,4,0.06999689333011457 +log2-1,fruit,1017361 Sl10g086080 #2,m_84,1.2427857746127478,0.654052741946006,4,0.327026370973003 +log2-1,fruit,1017361 Sl10g086080 #2,m_85,0.1241365408789836,0.026033591204578047,4,0.013016795602289024 +log2-1,fruit,1017361 Sl10g086080 #2,m_86,0.073102903188257,0.026765845455631623,4,0.013382922727815811 +log2-1,fruit,1017361 Sl10g086080 #2,m_87,0.10260609927024601,0.028767478687498554,4,0.014383739343749277 +log2-1,fruit,1017361 Sl10g086080 #2,m_88,0.08919523622305373,0.025742897103056876,4,0.012871448551528438 +log2-1,fruit,1017361 Sl10g086080 #2,m_89,0.9869320309969379,0.256403720597213,4,0.1282018602986065 +log2-1,fruit,1017361 Sl10g086080 #2,m_9,0.2375564959884462,0.10594874162408409,4,0.052974370812042045 +log2-1,fruit,1017361 Sl10g086080 #2,m_90,0.19327853594708805,0.06482647827537559,4,0.032413239137687795 +log2-1,fruit,1017361 Sl10g086080 #2,m_91,0.21860168980059785,0.11643465974838596,4,0.05821732987419298 +log2-1,fruit,1017361 Sl10g086080 #2,m_92,0.3235542273687538,0.1136733662525549,4,0.05683668312627745 +log2-1,fruit,1017361 Sl10g086080 #2,m_93,0.5583397349627678,0.1919880914647161,4,0.09599404573235805 +log2-1,fruit,1017361 Sl10g086080 #2,m_94,0.16340543810273664,0.07542613639439763,4,0.037713068197198815 +log2-1,fruit,1017361 Sl10g086080 #2,m_97,0.5515062690023603,0.14566622296372916,4,0.07283311148186458 +log2-1,fruit,1017361 Sl10g086080 #2,m_98,0.6789962694065852,0.16715016432436508,4,0.08357508216218254 +log2-1,fruit,1017361 Sl10g086080 #2,m_99,0.5437855174632946,0.21845914430751076,4,0.10922957215375538 +log2-1,leaf,1017361 Sl10g086080 #2,m_1,0.2581579637202425,0.03488748430498691,4,0.017443742152493454 +log2-1,leaf,1017361 Sl10g086080 #2,m_10,0.03654859901047596,0.015466365372715903,4,0.007733182686357951 +log2-1,leaf,1017361 Sl10g086080 #2,m_100,0.19351484044492284,0.03469079294294789,4,0.017345396471473946 +log2-1,leaf,1017361 Sl10g086080 #2,m_101,0.7467077866848769,0.16313050914631994,4,0.08156525457315997 +log2-1,leaf,1017361 Sl10g086080 #2,m_102,0.06538165924725164,0.02000907209903071,4,0.010004536049515355 +log2-1,leaf,1017361 Sl10g086080 #2,m_103,0.0758958150714673,0.01360011861558479,4,0.006800059307792395 +log2-1,leaf,1017361 Sl10g086080 #2,m_104,0.0758958150714673,0.01360011861558479,4,0.006800059307792395 +log2-1,leaf,1017361 Sl10g086080 #2,m_105,0.16735508042165906,0.06632592756821798,4,0.03316296378410899 +log2-1,leaf,1017361 Sl10g086080 #2,m_106,0.03559402832958688,0.011452663260387914,4,0.005726331630193957 +log2-1,leaf,1017361 Sl10g086080 #2,m_107,0.5181817729639296,0.13170908631824507,4,0.06585454315912254 +log2-1,leaf,1017361 Sl10g086080 #2,m_108,0.05544121334536738,0.016836060021217437,4,0.008418030010608719 +log2-1,leaf,1017361 Sl10g086080 #2,m_109,0.2745913988980013,0.08617276156396195,4,0.043086380781980974 +log2-1,leaf,1017361 Sl10g086080 #2,m_11,0.5992433392191372,0.23971113723333343,4,0.11985556861666671 +log2-1,leaf,1017361 Sl10g086080 #2,m_110,0.4622075895617972,0.123743241237204,4,0.061871620618602 +log2-1,leaf,1017361 Sl10g086080 #2,m_111,0.37439136951559365,0.1267609234258326,4,0.0633804617129163 +log2-1,leaf,1017361 Sl10g086080 #2,m_112,0.7534521960272081,0.26825059940217644,4,0.13412529970108822 +log2-1,leaf,1017361 Sl10g086080 #2,m_12,0.7147477110935923,0.20734611303105666,4,0.10367305651552833 +log2-1,leaf,1017361 Sl10g086080 #2,m_120,0.22841482745484265,0.09949876351320729,4,0.04974938175660364 +log2-1,leaf,1017361 Sl10g086080 #2,m_121,0.8942054341095061,0.4446688706406403,4,0.22233443532032016 +log2-1,leaf,1017361 Sl10g086080 #2,m_122,0.15684225737405078,0.02991288000095903,4,0.014956440000479515 +log2-1,leaf,1017361 Sl10g086080 #2,m_123,0.1734447056848702,0.0806610012673944,4,0.0403305006336972 +log2-1,leaf,1017361 Sl10g086080 #2,m_13,0.3742396179978301,0.10292990952941006,4,0.05146495476470503 +log2-1,leaf,1017361 Sl10g086080 #2,m_14,0.34276213860727606,0.09230732717296285,4,0.046153663586481423 +log2-1,leaf,1017361 Sl10g086080 #2,m_15,0.1837749058975055,0.06867140799088121,4,0.03433570399544061 +log2-1,leaf,1017361 Sl10g086080 #2,m_16,0.4738727489234156,0.26371982642045955,4,0.13185991321022977 +log2-1,leaf,1017361 Sl10g086080 #2,m_17,0.4211903761022803,0.08431616533760244,4,0.04215808266880122 +log2-1,leaf,1017361 Sl10g086080 #2,m_18,0.4903990291109643,0.21051117156507154,4,0.10525558578253577 +log2-1,leaf,1017361 Sl10g086080 #2,m_19,0.26912972465807966,0.11551929703331587,4,0.057759648516657935 +log2-1,leaf,1017361 Sl10g086080 #2,m_2,0.41808527022643405,0.12462354838968591,4,0.062311774194842955 +log2-1,leaf,1017361 Sl10g086080 #2,m_20,0.3980164320785645,0.0914930823299419,4,0.04574654116497095 +log2-1,leaf,1017361 Sl10g086080 #2,m_21,0.3336481199202317,0.1407435836758613,4,0.07037179183793064 +log2-1,leaf,1017361 Sl10g086080 #2,m_22,0.5246258823320242,0.1632044769474758,4,0.0816022384737379 +log2-1,leaf,1017361 Sl10g086080 #2,m_23,0.4728596978004485,0.08059877994177307,4,0.040299389970886536 +log2-1,leaf,1017361 Sl10g086080 #2,m_24,0.27607121709213206,0.14017435726001756,4,0.07008717863000878 +log2-1,leaf,1017361 Sl10g086080 #2,m_25,0.19550617439780676,0.08056819125356357,4,0.040284095626781785 +log2-1,leaf,1017361 Sl10g086080 #2,m_26,0.07992146879459967,0.019169613960295605,4,0.009584806980147803 +log2-1,leaf,1017361 Sl10g086080 #2,m_27,0.24213267967443142,0.08170783483073117,4,0.040853917415365586 +log2-1,leaf,1017361 Sl10g086080 #2,m_28,0.3992757216109137,0.18871928674546712,4,0.09435964337273356 +log2-1,leaf,1017361 Sl10g086080 #2,m_29,0.3977630687261737,0.14377240285353993,4,0.07188620142676996 +log2-1,leaf,1017361 Sl10g086080 #2,m_3,0.4692511724592624,0.098111106744202,4,0.049055553372101 +log2-1,leaf,1017361 Sl10g086080 #2,m_30,0.09471496156673496,0.03381001432520247,4,0.016905007162601234 +log2-1,leaf,1017361 Sl10g086080 #2,m_31,0.10581336050276857,0.020501289728651936,4,0.010250644864325968 +log2-1,leaf,1017361 Sl10g086080 #2,m_32,0.25128985360200357,0.11260642496426937,4,0.056303212482134685 +log2-1,leaf,1017361 Sl10g086080 #2,m_33,0.2948941209551702,0.08843550452468334,4,0.04421775226234167 +log2-1,leaf,1017361 Sl10g086080 #2,m_34,0.33810384496976004,0.18199672157204447,4,0.09099836078602223 +log2-1,leaf,1017361 Sl10g086080 #2,m_35,0.5747152402682362,0.26483244154669755,4,0.13241622077334878 +log2-1,leaf,1017361 Sl10g086080 #2,m_36,0.48101678287066996,0.24702466706877907,4,0.12351233353438953 +log2-1,leaf,1017361 Sl10g086080 #2,m_37,0.29401467047158986,0.08240878229771424,4,0.04120439114885712 +log2-1,leaf,1017361 Sl10g086080 #2,m_38,0.46500963183575833,0.18318692620727453,4,0.09159346310363727 +log2-1,leaf,1017361 Sl10g086080 #2,m_39,0.18959611874059829,0.057247564966880195,4,0.028623782483440097 +log2-1,leaf,1017361 Sl10g086080 #2,m_4,0.237617679070265,0.05726454907097943,4,0.028632274535489714 +log2-1,leaf,1017361 Sl10g086080 #2,m_40,0.07875275327451306,0.018643690689541147,4,0.009321845344770574 +log2-1,leaf,1017361 Sl10g086080 #2,m_41,0.2414819309492023,0.10988294366597313,4,0.05494147183298657 +log2-1,leaf,1017361 Sl10g086080 #2,m_42,0.0675162774044684,0.023544433911411398,4,0.011772216955705699 +log2-1,leaf,1017361 Sl10g086080 #2,m_43,0.1997039732469804,0.08721065165329596,4,0.04360532582664798 +log2-1,leaf,1017361 Sl10g086080 #2,m_44,0.3235500835698449,0.04849591975441666,4,0.02424795987720833 +log2-1,leaf,1017361 Sl10g086080 #2,m_45,0.5291250581305441,0.10362222467585641,4,0.051811112337928206 +log2-1,leaf,1017361 Sl10g086080 #2,m_46,0.837393587427082,0.252690630637643,4,0.1263453153188215 +log2-1,leaf,1017361 Sl10g086080 #2,m_47,0.5066213222684348,0.19282440260354317,4,0.09641220130177158 +log2-1,leaf,1017361 Sl10g086080 #2,m_48,0.23118026350545037,0.08567537280974703,4,0.042837686404873516 +log2-1,leaf,1017361 Sl10g086080 #2,m_49,0.023027577869650137,0.0027381028470592657,4,0.0013690514235296328 +log2-1,leaf,1017361 Sl10g086080 #2,m_5,0.45887345380690503,0.13060506250222187,4,0.06530253125111093 +log2-1,leaf,1017361 Sl10g086080 #2,m_50,0.31522736208072183,0.06198575225998832,4,0.03099287612999416 +log2-1,leaf,1017361 Sl10g086080 #2,m_51,0.028065286161360913,0.015244499423763455,4,0.007622249711881727 +log2-1,leaf,1017361 Sl10g086080 #2,m_52,0.11740354361793595,0.03770738068521351,4,0.018853690342606755 +log2-1,leaf,1017361 Sl10g086080 #2,m_53,0.1901273063418087,0.058168223275946604,4,0.029084111637973302 +log2-1,leaf,1017361 Sl10g086080 #2,m_54,0.29879053774521136,0.14034330492171662,4,0.07017165246085831 +log2-1,leaf,1017361 Sl10g086080 #2,m_55,0.1390945659705468,0.04210726136566689,4,0.021053630682833446 +log2-1,leaf,1017361 Sl10g086080 #2,m_56,0.2583141889364348,0.1462000993203263,4,0.07310004966016315 +log2-1,leaf,1017361 Sl10g086080 #2,m_57,0.2168106557439167,0.08688307226061659,4,0.043441536130308295 +log2-1,leaf,1017361 Sl10g086080 #2,m_58,0.44595978117100854,0.08027468399885357,4,0.040137341999426784 +log2-1,leaf,1017361 Sl10g086080 #2,m_59,0.2190554628664354,0.03689507349335215,4,0.018447536746676076 +log2-1,leaf,1017361 Sl10g086080 #2,m_6,0.43730793259773143,0.14307199928298964,4,0.07153599964149482 +log2-1,leaf,1017361 Sl10g086080 #2,m_60,0.39204613285878565,0.07923229196008794,4,0.03961614598004397 +log2-1,leaf,1017361 Sl10g086080 #2,m_61,0.09600340066561258,0.04627858273119918,4,0.02313929136559959 +log2-1,leaf,1017361 Sl10g086080 #2,m_62,0.15528950610360748,0.10082468857774324,4,0.05041234428887162 +log2-1,leaf,1017361 Sl10g086080 #2,m_63,0.8211033917604329,0.28416516341295434,4,0.14208258170647717 +log2-1,leaf,1017361 Sl10g086080 #2,m_64,0.12352432000833641,0.033281530419049715,4,0.016640765209524858 +log2-1,leaf,1017361 Sl10g086080 #2,m_65,0.15424830521688726,0.010460112967247569,4,0.0052300564836237845 +log2-1,leaf,1017361 Sl10g086080 #2,m_66,0.11397845738843299,0.018923168724511608,4,0.009461584362255804 +log2-1,leaf,1017361 Sl10g086080 #2,m_67,0.7026275337514513,0.3034011728284497,4,0.15170058641422485 +log2-1,leaf,1017361 Sl10g086080 #2,m_68,0.22908234232515212,0.06973718803767359,4,0.034868594018836796 +log2-1,leaf,1017361 Sl10g086080 #2,m_69,0.19858463162039747,0.038482633551635045,4,0.019241316775817523 +log2-1,leaf,1017361 Sl10g086080 #2,m_7,0.35371771932346674,0.08206562706142599,4,0.041032813530712996 +log2-1,leaf,1017361 Sl10g086080 #2,m_70,0.3784698549922872,0.15994929067310057,4,0.07997464533655028 +log2-1,leaf,1017361 Sl10g086080 #2,m_71,0.23363084457292074,0.10923689183120276,4,0.05461844591560138 +log2-1,leaf,1017361 Sl10g086080 #2,m_72,0.3486031747198919,0.10295307586578151,4,0.051476537932890754 +log2-1,leaf,1017361 Sl10g086080 #2,m_73,0.044017910089381426,0.006857016270455052,4,0.003428508135227526 +log2-1,leaf,1017361 Sl10g086080 #2,m_74,0.05760737468222367,0.017001201367074413,4,0.008500600683537207 +log2-1,leaf,1017361 Sl10g086080 #2,m_75,0.07668633106862283,0.028582036868397772,4,0.014291018434198886 +log2-1,leaf,1017361 Sl10g086080 #2,m_76,0.11666845176337112,0.05016187718076917,4,0.025080938590384586 +log2-1,leaf,1017361 Sl10g086080 #2,m_77,0.06417667666056859,0.019566530959479467,4,0.009783265479739733 +log2-1,leaf,1017361 Sl10g086080 #2,m_78,0.015209236060939584,0.003135850406569202,4,0.001567925203284601 +log2-1,leaf,1017361 Sl10g086080 #2,m_79,0.04085956789125967,0.0017541182978096136,4,8.770591489048068e-4 +log2-1,leaf,1017361 Sl10g086080 #2,m_8,0.10368334854598177,0.04123182797418493,4,0.020615913987092466 +log2-1,leaf,1017361 Sl10g086080 #2,m_80,0.05950672324104667,0.01842306497338922,4,0.00921153248669461 +log2-1,leaf,1017361 Sl10g086080 #2,m_81,0.044105562188889356,0.013186849515757812,4,0.006593424757878906 +log2-1,leaf,1017361 Sl10g086080 #2,m_82,0.49638520743930103,0.09985240167972376,4,0.04992620083986188 +log2-1,leaf,1017361 Sl10g086080 #2,m_83,0.17055842235700105,0.024289857891410242,4,0.012144928945705121 +log2-1,leaf,1017361 Sl10g086080 #2,m_84,1.5269773148878847,0.11994698023505733,4,0.059973490117528665 +log2-1,leaf,1017361 Sl10g086080 #2,m_85,0.6191572090364365,0.22108027152245036,4,0.11054013576122518 +log2-1,leaf,1017361 Sl10g086080 #2,m_86,0.3115546079950747,0.11748076035081405,4,0.058740380175407024 +log2-1,leaf,1017361 Sl10g086080 #2,m_87,0.4214801388547635,0.10891044207384774,4,0.05445522103692387 +log2-1,leaf,1017361 Sl10g086080 #2,m_88,0.36119839058730685,0.0666859795382499,4,0.03334298976912495 +log2-1,leaf,1017361 Sl10g086080 #2,m_89,0.3360360891885371,0.052073460453762,4,0.026036730226881 +log2-1,leaf,1017361 Sl10g086080 #2,m_9,0.01630452653479851,0.0075104488862697445,4,0.0037552244431348723 +log2-1,leaf,1017361 Sl10g086080 #2,m_90,0.257674305447514,0.06861645101916061,4,0.034308225509580306 +log2-1,leaf,1017361 Sl10g086080 #2,m_91,0.23953340772179815,0.08860768032861652,4,0.04430384016430826 +log2-1,leaf,1017361 Sl10g086080 #2,m_92,0.5657148629624508,0.1824405084271084,4,0.0912202542135542 +log2-1,leaf,1017361 Sl10g086080 #2,m_93,0.4778012482429281,0.2957863190350501,4,0.14789315951752505 +log2-1,leaf,1017361 Sl10g086080 #2,m_94,0.4051390140362886,0.18150833126822613,4,0.09075416563411307 +log2-1,leaf,1017361 Sl10g086080 #2,m_97,0.3833232579461351,0.13815001383996398,4,0.06907500691998199 +log2-1,leaf,1017361 Sl10g086080 #2,m_98,0.5757329009444423,0.1503015485114691,4,0.07515077425573455 +log2-1,leaf,1017361 Sl10g086080 #2,m_99,0.21669010935879726,0.027212368696708993,4,0.013606184348354497 diff --git a/runs/GC-MS analysis/mean_values_se_n_levene.csv b/runs/GC-MS analysis/mean_values_se_n_levene.csv new file mode 100644 index 0000000000000000000000000000000000000000..7fe892887da8374c23b6addf7f06f2bc23a91ac3 --- /dev/null +++ b/runs/GC-MS analysis/mean_values_se_n_levene.csv @@ -0,0 +1,3649 @@ +tissue,treatment,alias,genotype,met,mean_fc,sd,n,se,group,treatment2,group1,tissue2,p.signif,mean1,mean2,se1,se2,p.value,adj.p.value,tot_val1,tot_val2,y.position,na,n_treat,percent_na,RT_mean,Compound_Name,component,mean_rt,median_rt,sd_rt,max_rt,min_rt,rt_span,exclude,Compound_Class +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.26533006147401533,0.24008492854904492,6,0.0980142616462863,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.21117230593547814,0.26533006147401533,0.11614368767932232,0.0980142616462863,0.7304160108754447,1,0.32731599361480046,0.3633443231203016,0.936606103757331,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.8,967514 MM WT,MoneyMaker,m_16,0.21117230593547814,0.2597051808084695,5,0.11614368767932232,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.5670054386385578,0.696768761390484,6,0.2844546556862884,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.21117230593547814,0.5670054386385578,0.11614368767932232,0.2844546556862884,0.2871323952543439,1,0.32731599361480046,0.8514600943248463,0.936606103757331,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_16,0.3186750083491952,0.2989194514484323,5,0.1336808426471285,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.21117230593547814,0.3186750083491952,0.11614368767932232,0.1336808426471285,0.5609610618777103,1,0.32731599361480046,0.4523558509963237,0.936606103757331,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.49779423711954435,0.3445348198350792,6,0.14065575120294616,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.4381551668755624,0.49779423711954435,0.2074310020384654,0.14065575120294616,0.8173600061700013,1,0.6455861689140278,0.6384499883224906,0.7679969488440761,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.6,967514 MM WT,MoneyMaker,m_16,0.4381551668755624,0.5081001118284575,6,0.2074310020384654,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.29267690260285817,0.1382482681492621,6,0.05643961913152599,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.4381551668755624,0.29267690260285817,0.2074310020384654,0.05643961913152599,0.5249090991987335,1,0.6455861689140278,0.3491165217343842,0.7679969488440761,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_16,0.4093750366555383,0.7074224546538088,6,0.2888040077481671,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.4381551668755624,0.4093750366555383,0.2074310020384654,0.2888040077481671,0.9372474311457342,1,0.6455861689140278,0.6981790444037055,0.7679969488440761,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.35652711529715003,0.2535122976532377,6,0.10349596212850029,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.45362960813645725,0.35652711529715003,0.31174923534574356,0.10349596212850029,0.7796835635133436,1,0.7653788434822009,0.4600230774256503,1.0822879320158254,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,1,967514 MM WT,MoneyMaker,m_16,0.45362960813645725,0.6970924821666628,5,0.31174923534574356,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.49806742812146226,0.6146321050919713,6,0.2509225061680027,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.45362960813645725,0.49806742812146226,0.31174923534574356,0.2509225061680027,0.9142746104153716,1,0.7653788434822009,0.748989934289465,1.0822879320158254,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_16,0.7252586230906202,0.6335347947933673,6,0.2586394969237665,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.45362960813645725,0.7252586230906202,0.31174923534574356,0.2586394969237665,0.5207811798705873,1,0.7653788434822009,0.9838981200143866,1.0822879320158254,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.5558148279605963,0.33945590427856887,6,0.13858229260959049,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.251035199147432,0.5558148279605963,0.08765112759276526,0.13858229260959049,0.09937419338451674,1,0.3386863267401973,0.6943971205701869,0.7638368326272056,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.4,967514 MM WT,MoneyMaker,m_16,0.251035199147432,0.19599387960193063,5,0.08765112759276526,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.47958792605491085,0.34081793097335056,6,0.13913833767930125,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.251035199147432,0.47958792605491085,0.08765112759276526,0.13913833767930125,0.2013567638600885,1,0.3386863267401973,0.6187262637342121,0.7638368326272056,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_16,0.41977039813697165,0.4545661455440126,6,0.1855758518210907,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.251035199147432,0.41977039813697165,0.08765112759276526,0.1855758518210907,0.43793570338517807,1,0.3386863267401973,0.6053462499580624,0.7638368326272056,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.2930151687042741,0.17395044097959955,6,0.07101497015535663,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.38005358501303027,0.2930151687042741,0.19621375477046443,0.07101497015535663,0.6904651971715914,1,0.5762673397834948,0.3640301388596307,0.8922454592889649,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.8,967514 MM WT,MoneyMaker,m_16,0.38005358501303027,0.48062357970322644,6,0.19621375477046443,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.6050227533505742,0.5048630629474999,6,0.20610948236666654,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.38005358501303027,0.6050227533505742,0.19621375477046443,0.20610948236666654,0.4475901251603429,1,0.5762673397834948,0.8111322357172408,0.8922454592889649,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_16,0.657139172976522,0.26245003132624756,6,0.10714477662112787,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.38005358501303027,0.657139172976522,0.19621375477046443,0.10714477662112787,0.25146104413762105,1,0.5762673397834948,0.7642839495976499,0.8922454592889649,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.5886363649678923,0.5153358692226954,6,0.2103849876248743,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.23212077533481,0.5886363649678923,0.07507223709476436,0.2103849876248743,0.15959939798770595,1,0.30719301242957436,0.7990213525927665,0.8789234878520432,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.6,967514 MM WT,MoneyMaker,m_16,0.23212077533481,0.1838886747314121,6,0.07507223709476436,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.4515589070286266,0.2461617609269768,6,0.10049511807601244,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.23212077533481,0.4515589070286266,0.07507223709476436,0.10049511807601244,0.11323340224541804,1,0.30719301242957436,0.5520540251046391,0.8789234878520432,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_16,0.2845347870077453,0.37956486100088965,6,0.154956705623767,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.23212077533481,0.2845347870077453,0.07507223709476436,0.154956705623767,0.7694000864639232,1,0.30719301242957436,0.4394914926315123,0.8789234878520432,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.39186791629745266,0.43454519154441346,6,0.1774023315772987,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.5481815606499026,0.39186791629745266,0.1787357764366494,0.1774023315772987,0.5486746250676318,1,0.726917337086552,0.5692702478747513,0.7996090707952073,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,1,967514 MM WT,MoneyMaker,m_16,0.5481815606499026,0.43781145104995994,6,0.1787357764366494,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.387424645236018,0.5278797187457089,6,0.2155059927484805,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.5481815606499026,0.387424645236018,0.1787357764366494,0.2155059927484805,0.5789628585605571,1,0.726917337086552,0.6029306379844985,0.7996090707952073,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_16,0.25400921515973446,0.20730273186714132,6,0.08463098589324904,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.5481815606499026,0.25400921515973446,0.1787357764366494,0.08463098589324904,0.17967990867735015,1,0.726917337086552,0.3386402010529835,0.7996090707952073,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_16,0.35433288956646786,0.3819401315020626,6,0.1559264057452601,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.38409002330700565,0.35433288956646786,0.1313814781898604,0.1559264057452601,0.8869494332863685,1,0.515471501496866,0.510259295311728,0.731666220781368,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.4,967514 MM WT,MoneyMaker,m_16,0.38409002330700565,0.32181758321775483,6,0.1313814781898604,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_16,0.4548898132323396,0.42555833965902845,6,0.17373346465843834,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.38409002330700565,0.4548898132323396,0.1313814781898604,0.17373346465843834,0.7523354396057963,1,0.515471501496866,0.628623277890778,0.731666220781368,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_16,0.4786072486653326,0.4569372744315835,6,0.186543861135911,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.38409002330700565,0.4786072486653326,0.1313814781898604,0.186543861135911,0.6884115150829714,1,0.515471501496866,0.6651511098012436,0.731666220781368,0,24,0,4.410817610062893,benzyl_alchohol,benzyl_alcohol_165_135_rt4.53,4.433312883,4.43,0.027667675,4.59,4.39,0.2,FALSE,alcohol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,0.04614256327257057,0.05232562922047772,6,0.02136184867670599,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.08225653739198328,0.04614256327257057,0.03649235528790331,0.02136184867670599,0.4230184518472303,1,0.11874889267988659,0.06750441194927656,0.15216806952535633,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.8,967514 MM WT,MoneyMaker,m_26,0.08225653739198328,0.08159938708282571,5,0.03649235528790331,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,0.10085747670049867,0.09179985032229676,6,0.03747713195891616,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.08225653739198328,0.10085747670049867,0.03649235528790331,0.03747713195891616,0.7303921022368592,1,0.11874889267988659,0.13833460865941483,0.15216806952535633,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_26,0.03999763352650385,0.025740436260311667,5,0.01151147304971147,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.08225653739198328,0.03999763352650385,0.03649235528790331,0.01151147304971147,0.32181130444866496,1,0.11874889267988659,0.051509106576215324,0.15216806952535633,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,0.0374287089803215,0.020796654483846037,6,0.008490198640397777,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.09026901009733719,0.0374287089803215,0.022502404825955637,0.008490198640397777,0.06762353558951527,1,0.11277141492329283,0.045918907620719276,0.12404855641562212,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.6,967514 MM WT,MoneyMaker,m_26,0.09026901009733719,0.05511940980913301,6,0.022502404825955637,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,0.0681891464668493,0.05250320857992215,6,0.021434345146620844,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.09026901009733719,0.0681891464668493,0.022502404825955637,0.021434345146620844,0.49367704231521137,1,0.11277141492329283,0.08962349161347015,0.12404855641562212,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_26,0.09618314613090795,0.03929805539254243,6,0.016043363932559642,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.09026901009733719,0.09618314613090795,0.022502404825955637,0.016043363932559642,0.8352953542438365,1,0.11277141492329283,0.1122265100634676,0.12404855641562212,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,0.08784710453327989,0.07466273704762257,6,0.030480934761044846,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.11373037678601597,0.08784710453327989,0.037763918917147955,0.030480934761044846,0.6080408900090926,1,0.15149429570316392,0.11832803929432473,0.16664372527348031,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,1,967514 MM WT,MoneyMaker,m_26,0.11373037678601597,0.08444268979553309,5,0.037763918917147955,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,0.09573302224665199,0.06638872364243072,6,0.027103082933100188,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.11373037678601597,0.09573302224665199,0.037763918917147955,0.027103082933100188,0.7092741182571208,1,0.15149429570316392,0.12283610517975219,0.16664372527348031,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_26,0.04644131924980691,0.03932077802456697,6,0.0160526404082385,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.11373037678601597,0.04644131924980691,0.037763918917147955,0.0160526404082385,0.1572797924525559,1,0.15149429570316392,0.06249395965804541,0.16664372527348031,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,0.05622164687049221,0.029662327421462666,6,0.0121095944609915,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.16306897029008632,0.05622164687049221,0.06544507966821886,0.0121095944609915,0.17911095460720772,1,0.22851404995830518,0.06833124133148372,0.2996785332896323,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.4,967514 MM WT,MoneyMaker,m_26,0.16306897029008632,0.14633964693102675,5,0.06544507966821886,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,0.1816600147224113,0.22235246946839549,6,0.09077501554089076,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.16306897029008632,0.1816600147224113,0.06544507966821886,0.09077501554089076,0.8718803426416253,1,0.22851404995830518,0.27243503026330207,0.2996785332896323,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_26,0.1363480471225126,0.1210176343731591,6,0.049405242348823035,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.16306897029008632,0.1363480471225126,0.06544507966821886,0.049405242348823035,0.7530684941806982,1,0.22851404995830518,0.18575328947133565,0.2996785332896323,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,0.024940280577251988,0.019865961284991213,6,0.00811024473301895,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.049431853585261,0.024940280577251988,0.021165253537278446,0.00811024473301895,0.3187098096283921,1,0.07059710712253944,0.03305052531027094,0.09243360046273137,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.8,967514 MM WT,MoneyMaker,m_26,0.049431853585261,0.051844071442968924,6,0.021165253537278446,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,0.032093925418183934,0.020783546194978936,6,0.008484847203876876,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.049431853585261,0.032093925418183934,0.021165253537278446,0.008484847203876876,0.4734564516779711,1,0.07059710712253944,0.04057877262206081,0.09243360046273137,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_26,0.061346512502305085,0.055564307071882695,6,0.022684033372905248,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.049431853585261,0.061346512502305085,0.021165253537278446,0.022684033372905248,0.7090278802927802,1,0.07059710712253944,0.08403054587521033,0.09243360046273137,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,0.032124143393519544,0.03665032799675809,6,0.014962433749616349,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.030582449923569694,0.032124143393519544,0.016450643136958057,0.014962433749616349,0.9461064324513127,1,0.04703309306052775,0.047086577143135896,0.1689320309775802,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.6,967514 MM WT,MoneyMaker,m_26,0.030582449923569694,0.04029568162616524,6,0.016450643136958057,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,0.10698567177832181,0.1141190371788809,6,0.04658890183766016,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.030582449923569694,0.10698567177832181,0.016450643136958057,0.04658890183766016,0.17118066443018048,1,0.04703309306052775,0.15357457361598198,0.1689320309775802,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_26,0.09439806524938692,0.11062257289253166,6,0.04516147627009013,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.030582449923569694,0.09439806524938692,0.016450643136958057,0.04516147627009013,0.2303273203631236,1,0.04703309306052775,0.13955954151947705,0.1689320309775802,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,0.032841582279564095,0.031196044461592066,6,0.012735731820679623,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.034703405534005194,0.032841582279564095,0.013443449330845327,0.012735731820679623,0.9219085297006784,1,0.04814685486485052,0.04557731410024372,0.15671068584071107,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,1,967514 MM WT,MoneyMaker,m_26,0.034703405534005194,0.032929591243531,6,0.013443449330845327,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,0.089176995720335,0.1305266069193098,6,0.05328726413485687,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.034703405534005194,0.089176995720335,0.013443449330845327,0.05328726413485687,0.36222688268296727,1,0.04814685486485052,0.14246425985519187,0.15671068584071107,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_26,0.04392252164302324,0.04154724240066637,6,0.016961590683559773,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.034703405534005194,0.04392252164302324,0.013443449330845327,0.016961590683559773,0.679620318331059,1,0.04814685486485052,0.060884112326583015,0.15671068584071107,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_26,0.03802806423622725,0.04045747989018311,6,0.016516697001643373,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.05373528466887256,0.03802806423622725,0.020601069504092268,0.016516697001643373,0.5657619575850923,1,0.07433635417296483,0.05454476123787062,0.1300182548339642,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.4,967514 MM WT,MoneyMaker,m_26,0.05373528466887256,0.05046210844063734,6,0.020601069504092268,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_26,0.08772041754776579,0.07465553842987624,6,0.030477995937656207,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.05373528466887256,0.08772041754776579,0.020601069504092268,0.030477995937656207,0.3802661594925826,1,0.07433635417296483,0.118198413485422,0.1300182548339642,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_26,0.04466301449802157,0.03329753641288315,6,0.013593662317217776,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.05373528466887256,0.04466301449802157,0.020601069504092268,0.013593662317217776,0.7220164790728669,1,0.07433635417296483,0.05825667681523934,0.1300182548339642,0,24,0,4.531341719077568,ethanolamine,ethanolamine_174_rt4.63,4.551717791,4.55,0.021903128,4.73,4.54,0.19,FALSE,alcohol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.3509576631574625,0.4838745385956879,6,0.1975409531806801,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.24176739827667176,0.3509576631574625,0.1127512803637199,0.1975409531806801,0.6444289813842035,1,0.35451867864039166,0.5484986163381427,0.7695688157342724,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_3,0.24176739827667176,0.2521195274434149,5,0.1127512803637199,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.3759062376939201,0.365874224917546,6,0.14936752684737908,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.24176739827667176,0.3759062376939201,0.1127512803637199,0.14936752684737908,0.49217821517154436,1,0.35451867864039166,0.5252737645412993,0.7695688157342724,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_3,0.41396924031185406,0.6387077156558779,5,0.2856387739920299,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.24176739827667176,0.41396924031185406,0.1127512803637199,0.2856387739920299,0.5981930820250578,1,0.35451867864039166,0.699608014303884,0.7695688157342724,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.279974915214152,0.32182760317967385,6,0.13138556882218436,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.1321379263720681,0.279974915214152,0.051810286278762815,0.13138556882218436,0.33246223008606907,1,0.1839482126508309,0.4113604840363364,0.7711891285064068,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_3,0.1321379263720681,0.12690876481048954,6,0.051810286278762815,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.32734841511296975,0.3310576557273021,6,0.1351537219956452,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.1321379263720681,0.32734841511296975,0.051810286278762815,0.1351537219956452,0.22295177611855627,1,0.1839482126508309,0.462502137108615,0.7711891285064068,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_3,0.5372065986590526,0.4014087286677032,6,0.1638744272558625,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.1321379263720681,0.5372065986590526,0.051810286278762815,0.1638744272558625,0.05660013720615858,1,0.1839482126508309,0.7010810259149152,0.7711891285064068,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.33489983840944976,0.12770358716646665,6,0.05213477114681293,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.25358633129948377,0.33489983840944976,0.16344607092343494,0.05213477114681293,0.6562313299713642,1,0.4170324022229187,0.3870346095562627,0.7213756273564704,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_3,0.25358633129948377,0.36547652524005236,5,0.16344607092343494,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.3660789910905694,0.30289669909857264,6,0.1236570595941394,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.25358633129948377,0.3660789910905694,0.16344607092343494,0.1236570595941394,0.5983810393133167,1,0.4170324022229187,0.4897360506847088,0.7213756273564704,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_3,0.44304134738092926,0.5211404002374422,6,0.21275467748858917,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.25358633129948377,0.44304134738092926,0.16344607092343494,0.21275467748858917,0.4983397366042511,1,0.4170324022229187,0.6557960248695185,0.7213756273564704,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.14835412023197406,0.15120803888385076,6,0.061730423378725405,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.2302231147207691,0.14835412023197406,0.1460047634527979,0.061730423378725405,0.6259123792547114,1,0.37622787817356695,0.21008454361069945,0.6523978924648782,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_3,0.2302231147207691,0.32647657611923303,5,0.1460047634527979,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.45945029748891836,0.3273466142604711,6,0.13363869566097095,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.2302231147207691,0.45945029748891836,0.1460047634527979,0.13363869566097095,0.2777850540247397,1,0.37622787817356695,0.5930889931498893,0.6523978924648782,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_3,0.31896207400528204,0.3455995718344849,6,0.1410904343864715,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.2302231147207691,0.31896207400528204,0.1460047634527979,0.1410904343864715,0.6725835387495808,1,0.37622787817356695,0.46005250839175355,0.6523978924648782,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.336247481698249,0.22742600593268156,6,0.09284627812904163,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.3182812837631292,0.336247481698249,0.15128044450176417,0.09284627812904163,0.9217803018566647,1,0.4695617282648934,0.4290937598272906,0.5165179010913827,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_3,0.3182812837631292,0.37055989709075116,6,0.15128044450176417,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.17367595289186688,0.09713995401000476,6,0.03965722016032272,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.3182812837631292,0.17367595289186688,0.15128044450176417,0.03965722016032272,0.39271993911499375,1,0.4695617282648934,0.2133331730521896,0.5165179010913827,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_3,0.2848401576093994,0.14216513480262413,6,0.05803867324673594,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.3182812837631292,0.2848401576093994,0.15128044450176417,0.05803867324673594,0.8428601920538566,1,0.4695617282648934,0.34287883085613535,0.5165179010913827,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.2750861367660502,0.18642236467720244,6,0.07610661168369874,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.330569526727754,0.2750861367660502,0.17586538131900242,0.07610661168369874,0.7807860685911179,1,0.5064349080467565,0.35119274844974896,0.5570783988514322,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_3,0.330569526727754,0.43078044765154877,6,0.17586538131900242,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.22718992594794243,0.2197823830796699,6,0.0897257821663491,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.330569526727754,0.22718992594794243,0.17586538131900242,0.0897257821663491,0.6157781811100393,1,0.5064349080467565,0.31691570811429154,0.5570783988514322,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_3,0.36370295420772264,0.21877053256907303,6,0.08931269592519293,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.330569526727754,0.36370295420772264,0.17586538131900242,0.08931269592519293,0.8710864222737175,1,0.5064349080467565,0.45301565013291556,0.5570783988514322,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.5147221406249518,0.5047520077901123,6,0.20606414428851583,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.20183293815143466,0.5147221406249518,0.08723983431598287,0.20606414428851583,0.2063438482909004,1,0.2890727724674175,0.7207862849134676,0.7928649134048145,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_3,0.20183293815143466,0.21369307931910392,6,0.08723983431598287,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.23938376168412664,0.18831282001881008,6,0.07687838684510834,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.20183293815143466,0.23938376168412664,0.08723983431598287,0.07687838684510834,0.7534997049557823,1,0.2890727724674175,0.31626214852923495,0.7928649134048145,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_3,0.19055377496195944,0.22032757335453793,6,0.0899483551640415,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.20183293815143466,0.19055377496195944,0.08723983431598287,0.0899483551640415,0.9300557154200424,1,0.2890727724674175,0.28050213012600095,0.7928649134048145,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_3,0.5032234614205051,0.2226080014932948,6,0.09087933605321467,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.3439130001784489,0.5032234614205051,0.17224044280057915,0.09087933605321467,0.4382766421719505,1,0.516153442979028,0.5941027974737197,0.6535130772210918,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_3,0.3439130001784489,0.4219011979324513,6,0.17224044280057915,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_3,0.37167685582049026,0.3907545702879371,6,0.15952488531099174,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.3439130001784489,0.37167685582049026,0.17224044280057915,0.15952488531099174,0.9082154096038872,1,0.516153442979028,0.531201741131482,0.6535130772210918,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_3,0.2620491844537752,0.298788787962651,6,0.12198001189552193,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.3439130001784489,0.2620491844537752,0.17224044280057915,0.12198001189552193,0.707118033422329,1,0.516153442979028,0.3840291963492971,0.6535130772210918,0,24,0,8.951278825995807,2-aminoadipic_acid,adipic_acid_2-amino_260_217_9.05,8.952147239,8.95,0.016582838,9.04,8.88,0.16,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.0797079580995479,0.07963287155168869,6,0.0325099836757053,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.4235172892897837,0.0797079580995479,0.2272779965768643,0.0325099836757053,0.20587790615123658,1,0.650795285866648,0.1122179417752532,0.7158748144533129,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_17,0.4235172892897837,0.5082090501358331,5,0.2272779965768643,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,0.17875025306867257,0.17890086583408873,6,0.07303597263927165,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.4235172892897837,0.17875025306867257,0.2272779965768643,0.07303597263927165,0.353819501744274,1,0.650795285866648,0.25178622570794423,0.7158748144533129,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_17,0.24014430926362448,0.3791566459861604,5,0.16956400690917547,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.4235172892897837,0.24014430926362448,0.2272779965768643,0.16956400690917547,0.537376733205285,1,0.650795285866648,0.40970831617279996,0.7158748144533129,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.20539645873100354,0.24471418928111607,6,0.09990414942626584,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.258062766506531,0.20539645873100354,0.060481752580506594,0.09990414942626584,0.6636581614250963,1,0.31854451908703757,0.3053006081572694,0.35039897099574135,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_17,0.258062766506531,0.1481494325715009,6,0.060481752580506594,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,0.1798914091617574,0.18093516071924284,6,0.0738664700484352,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.258062766506531,0.1798914091617574,0.060481752580506594,0.0738664700484352,0.43269655599148815,1,0.31854451908703757,0.2537578792101926,0.35039897099574135,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_17,0.20770519107405735,0.2194682238153154,6,0.08959752718374299,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.258062766506531,0.20770519107405735,0.060481752580506594,0.08959752718374299,0.6526783509268816,1,0.31854451908703757,0.29730271825780036,0.35039897099574135,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.11965684176936264,0.09832508082466358,6,0.04014104615639007,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.4045920272779531,0.11965684176936264,0.11638161723483471,0.04014104615639007,0.0690256384158286,1,0.5209736445127878,0.15979788792575272,0.5730710089640667,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_17,0.4045920272779531,0.2602372074684515,5,0.11638161723483471,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,0.27999657377280124,0.24757436039984937,6,0.10107180939592282,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.4045920272779531,0.27999657377280124,0.11638161723483471,0.10107180939592282,0.44105024435843354,1,0.5209736445127878,0.38106838316872405,0.5730710089640667,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_17,0.11974634750264257,0.09720840712129376,6,0.03968516602598339,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.4045920272779531,0.11974634750264257,0.11638161723483471,0.03968516602598339,0.0690769334210835,1,0.5209736445127878,0.15943151352862595,0.5730710089640667,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.1615711683177977,0.17457657045603817,6,0.07127058644372172,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.16872734237088682,0.1615711683177977,0.12527520992631902,0.07127058644372172,0.9618990196978734,1,0.29400255229720584,0.23284175476151941,0.32599948871497786,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_17,0.16872734237088682,0.2801238852908058,5,0.12527520992631902,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,0.09240395088619972,0.05941395092258958,6,0.024255643893851056,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.16872734237088682,0.09240395088619972,0.12527520992631902,0.024255643893851056,0.5798321405678607,1,0.29400255229720584,0.11665959478005078,0.32599948871497786,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_17,0.21134785240687637,0.20824415224273848,6,0.08501531915219442,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.16872734237088682,0.21134785240687637,0.12527520992631902,0.08501531915219442,0.7861364556923242,1,0.29400255229720584,0.29636317155907077,0.32599948871497786,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.06776077944427561,0.040640309023002724,6,0.016591336682563972,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.07875174365840909,0.06776077944427561,0.026641978207228915,0.016591336682563972,0.7348453507629432,1,0.105393721865638,0.08435211612683959,0.14961655469029728,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_17,0.07875174365840909,0.06525925234606018,6,0.026641978207228915,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,0.044936903634246995,0.034651511909711503,6,0.014146420499127912,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.07875174365840909,0.044936903634246995,0.026641978207228915,0.014146420499127912,0.2964039364944982,1,0.105393721865638,0.05908332413337491,0.14961655469029728,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_17,0.10742548709758874,0.070029840390462,6,0.0285895626208633,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.07875174365840909,0.10742548709758874,0.026641978207228915,0.0285895626208633,0.4800378156525744,1,0.105393721865638,0.13601504971845205,0.14961655469029728,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.10729082731801132,0.0855138270155671,6,0.034910873690127776,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.042972044006669506,0.10729082731801132,0.016991018699854456,0.034910873690127776,0.14013319380352485,1,0.05996306270652396,0.1422017010081391,0.16049507851031708,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_17,0.042972044006669506,0.04161932602473065,6,0.016991018699854456,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,0.0664861123038869,0.037793881319993596,6,0.015429287438881513,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.042972044006669506,0.0664861123038869,0.016991018699854456,0.015429287438881513,0.32994947694402854,1,0.05996306270652396,0.08191539974276842,0.16049507851031708,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_17,0.10837483052796,0.09192882658971724,6,0.03752978629960098,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.042972044006669506,0.10837483052796,0.016991018699854456,0.03752978629960098,0.15660823534145604,1,0.05996306270652396,0.14590461682756098,0.16049507851031708,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.07057356011944964,0.03706218952680243,6,0.015130575515164781,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.08623686711707161,0.07057356011944964,0.013078430203875332,0.015130575515164781,0.4520391178742441,1,0.09931529732094695,0.08570413563461442,0.1931310743230577,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_17,0.08623686711707161,0.03203548063609833,6,0.013078430203875332,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,0.13096737789707205,0.10926273808102774,6,0.044606326032980405,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.08623686711707161,0.13096737789707205,0.013078430203875332,0.044606326032980405,0.37396056028662944,1,0.09931529732094695,0.17557370393005245,0.1931310743230577,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_17,0.0828699953397134,0.08002548240764099,6,0.03267026638646538,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.08623686711707161,0.0828699953397134,0.013078430203875332,0.03267026638646538,0.9266343911695749,1,0.09931529732094695,0.11554026172617878,0.1931310743230577,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_17,0.06864508191720094,0.049134426259121296,6,0.020059045523209012,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.08352904712731624,0.06864508191720094,0.035243942019939425,0.020059045523209012,0.7231955674852522,1,0.11877298914725566,0.08870412744040995,0.19124252300021263,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_17,0.08352904712731624,0.08632967447308666,6,0.035243942019939425,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_17,0.13434865923850658,0.09677488130496642,6,0.039508179852595804,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.08352904712731624,0.13434865923850658,0.035243942019939425,0.039508179852595804,0.36003360173638976,1,0.11877298914725566,0.1738568390911024,0.19124252300021263,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_17,0.08652254365333507,0.054383096072128954,6,0.022201806001578672,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.08352904712731624,0.08652254365333507,0.035243942019939425,0.022201806001578672,0.9443849833505398,1,0.11877298914725566,0.10872434965491375,0.19124252300021263,0,24,0,7.300876826722338,4-aminobutyric_acid,butyric_acid_4-amino_174_304_rt7.40,7.308841463,7.31,0.028616341,7.53,7.07,0.46,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,0.046056659628102646,0.04624408708133084,6,0.01887906949501533,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.03730009211899539,0.046056659628102646,0.017310553358594757,0.01887906949501533,0.7403028067291162,1,0.05461064547759015,0.06493572912311797,0.12349717783772346,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_85,0.03730009211899539,0.038707574037955175,5,0.017310553358594757,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.023006027467292262,0.02265608838739906,6,0.009249309352753846,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.03730009211899539,0.023006027467292262,0.017310553358594757,0.009249309352753846,0.4929878115434029,1,0.05461064547759015,0.03225533682004611,0.12349717783772346,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_85,0.07747589733716316,0.07780234027679013,5,0.03479426433349451,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.03730009211899539,0.07747589733716316,0.017310553358594757,0.03479426433349451,0.3419590338807255,1,0.05461064547759015,0.11227016167065768,0.12349717783772346,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,0.05281752357277484,0.027011871253814726,6,0.011027550261599827,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.02293880276609735,0.05281752357277484,0.00816792139610665,0.011027550261599827,0.056737530932602205,1,0.031106724162204002,0.06384507383437467,0.16594674058650216,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_85,0.02293880276609735,0.020007239679622493,6,0.00816792139610665,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.10461546408857121,0.11327716551939553,6,0.04624520917188528,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.02293880276609735,0.10461546408857121,0.00816792139610665,0.04624520917188528,0.13903635545091828,1,0.031106724162204002,0.1508606732604565,0.16594674058650216,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_85,0.08443344014604186,0.10153111520882331,6,0.041449904212891645,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.02293880276609735,0.08443344014604186,0.00816792139610665,0.041449904212891645,0.2011822871768085,1,0.031106724162204002,0.1258833443589335,0.16594674058650216,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,0.07026579312554453,0.06724261447162222,6,0.02745168240436039,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.040431097076059075,0.07026579312554453,0.018509839142993326,0.02745168240436039,0.3926135800820282,1,0.0589409362190524,0.09771747552990492,0.10748922308289542,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_85,0.040431097076059075,0.04138925857631953,5,0.018509839142993326,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.045441473474704584,0.017242589693153797,6,0.0070392577653998626,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.040431097076059075,0.045441473474704584,0.018509839142993326,0.0070392577653998626,0.8100434046433365,1,0.0589409362190524,0.052480731240104446,0.10748922308289542,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_85,0.055127683448953545,0.04512917466356549,6,0.018423908406445692,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.040431097076059075,0.055127683448953545,0.018509839142993326,0.018423908406445692,0.587536938080528,1,0.0589409362190524,0.07355159185539924,0.10748922308289542,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,0.02637115202239119,0.017939836335174163,6,0.007323907515036346,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.0645788517075799,0.02637115202239119,0.031210392817504044,0.007323907515036346,0.2930891571989065,1,0.09578924452508394,0.03369505953742754,0.15193847386787507,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_85,0.0645788517075799,0.06978855994441023,5,0.031210392817504044,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.09772610889840945,0.09895883799077043,6,0.04039977643602241,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.0645788517075799,0.09772610889840945,0.031210392817504044,0.04039977643602241,0.5326873346763507,1,0.09578924452508394,0.13812588533443187,0.15193847386787507,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_85,0.07033627994463006,0.11150354466788888,6,0.045521131491326625,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.0645788517075799,0.07033627994463006,0.031210392817504044,0.045521131491326625,0.9193486827054429,1,0.09578924452508394,0.11585741143595668,0.15193847386787507,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,0.018776464082502182,0.011709006675724186,6,0.004780181958394359,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.021653142862792112,0.018776464082502182,0.00902794794034845,0.004780181958394359,0.7857635690239506,1,0.030681090803140562,0.02355664604089654,0.05464642294552379,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_85,0.021653142862792112,0.022113865878264045,6,0.00902794794034845,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.02444767859255766,0.02574204213677051,6,0.010509144695385289,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.021653142862792112,0.02444767859255766,0.00902794794034845,0.010509144695385289,0.8442805688948071,1,0.030681090803140562,0.034956823287942945,0.05464642294552379,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_85,0.039557971487999,0.024790293217429604,6,0.010120594826113535,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.021653142862792112,0.039557971487999,0.00902794794034845,0.010120594826113535,0.21655408655574482,1,0.030681090803140562,0.049678566314112535,0.05464642294552379,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,0.08396062153737027,0.06007516044632217,6,0.02452558155155331,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.10281113172172922,0.08396062153737027,0.023870079011854426,0.02452558155155331,0.5938719510190298,1,0.12668121073358365,0.10848620308892358,0.13934933180694203,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_85,0.10281113172172922,0.05846951369896143,6,0.023870079011854426,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.07409772624229076,0.0854740066222874,6,0.03489461708264574,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.10281113172172922,0.07409772624229076,0.023870079011854426,0.03489461708264574,0.5144256149105647,1,0.12668121073358365,0.1089923433249365,0.13934933180694203,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_85,0.09743253002024359,0.03553893783021613,6,0.014508710614087246,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.10281113172172922,0.09743253002024359,0.023870079011854426,0.014508710614087246,0.8519667780605361,1,0.12668121073358365,0.11194124063433084,0.13934933180694203,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,0.03303064142146517,0.0169981758916504,6,0.006939476248770327,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.02726534313306354,0.03303064142146517,0.009842995611787763,0.006939476248770327,0.6435752753651187,1,0.0371083387448513,0.03997011767023549,0.05711273557632699,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_85,0.02726534313306354,0.024110316789333956,6,0.009842995611787763,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.03947700200534077,0.030480633945269432,6,0.012443666700411039,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.02726534313306354,0.03947700200534077,0.009842995611787763,0.012443666700411039,0.4602082527494178,1,0.0371083387448513,0.05192066870575181,0.05711273557632699,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_85,0.027485253083748534,0.026999299182520912,6,0.011022417734986538,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.02726534313306354,0.027485253083748534,0.009842995611787763,0.011022417734986538,0.9884232695127937,1,0.0371083387448513,0.038507670818735074,0.05711273557632699,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_85,0.0389172938927301,0.019274438231784007,6,0.007868756457777144,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.05052473405215648,0.0389172938927301,0.025988843567657068,0.007868756457777144,0.6841766856285314,1,0.07651357761981355,0.046786050350507244,0.15899702553718006,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_85,0.05052473405215648,0.06365940574577256,6,0.025988843567657068,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_85,0.1036635038973428,0.10013329521736532,6,0.040879246591002706,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.05052473405215648,0.1036635038973428,0.025988843567657068,0.040879246591002706,0.30284210469488954,1,0.07651357761981355,0.1445427504883455,0.15899702553718006,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_85,0.03816729286269904,0.03814282876191384,6,0.015571744635507192,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.05052473405215648,0.03816729286269904,0.025988843567657068,0.015571744635507192,0.693829844154789,1,0.07651357761981355,0.05373903749820624,0.15899702553718006,0,24,0,7.25062893081761,4-hydroxyproline,proline_4-hydroxy_230_140_rt7.34,7.258650307,7.25,0.034863319,7.45,7.05,0.4,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,0.14369677216267088,0.15904824171101065,6,0.06493117277980337,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.14620747798472422,0.14369677216267088,0.06361402106588207,0.06493117277980337,0.9785724813385189,1,0.2098214990506063,0.20862794494247425,0.23668784165556503,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_5,0.14620747798472422,0.14224527542541593,5,0.06361402106588207,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,0.07104271719482484,0.08317992606836201,6,0.03395806261831931,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.14620747798472422,0.07104271719482484,0.06361402106588207,0.03395806261831931,0.3361651382417876,1,0.2098214990506063,0.10500077981314415,0.23668784165556503,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_5,0.16188353480545006,0.11915386936392391,5,0.0532872303359727,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.14620747798472422,0.16188353480545006,0.06361402106588207,0.0532872303359727,0.8550126964894849,1,0.2098214990506063,0.21517076514142275,0.23668784165556503,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,0.25010809242626325,0.1475307576884337,6,0.060229179617141484,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.10595819294264645,0.25010809242626325,0.03452807001100758,0.060229179617141484,0.07166670065454063,1,0.14048626295365402,0.3103372720434047,0.3413709992477452,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_5,0.10595819294264645,0.0845761533300625,6,0.03452807001100758,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,0.12834893803656713,0.12180474361914555,6,0.0497265783529053,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.10595819294264645,0.12834893803656713,0.03452807001100758,0.0497265783529053,0.7201237310247679,1,0.14048626295365402,0.17807551638947244,0.3413709992477452,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_5,0.07653099127038428,0.04600838611675056,6,0.018782844979164746,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.10595819294264645,0.07653099127038428,0.03452807001100758,0.018782844979164746,0.4762444492681034,1,0.14048626295365402,0.09531383624954902,0.3413709992477452,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,0.2675379842245397,0.3053100379784768,6,0.12464230106617025,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.26100624209999096,0.2675379842245397,0.06925739655385188,0.12464230106617025,0.9646364842378932,1,0.33026363865384284,0.39218028529071,0.431398313819781,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_5,0.26100624209999096,0.1548642466390725,5,0.06925739655385188,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,0.20720517435179753,0.161606808783198,6,0.06597570341306098,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.26100624209999096,0.20720517435179753,0.06925739655385188,0.06597570341306098,0.587880220958922,1,0.33026363865384284,0.2731808777648585,0.431398313819781,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_5,0.23404373492663302,0.11513276521992971,6,0.04700275457741362,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.26100624209999096,0.23404373492663302,0.06925739655385188,0.04700275457741362,0.756390294142635,1,0.33026363865384284,0.28104648950404665,0.431398313819781,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,0.20710339295236993,0.1623488431124712,6,0.06627863765945227,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.21292433407271547,0.20710339295236993,0.07187457826779288,0.06627863765945227,0.9538726428549702,1,0.28479891234050836,0.2733820306118222,0.31327880357455923,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_5,0.21292433407271547,0.16071644286091397,5,0.07187457826779288,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,0.1703105674788008,0.11334319469153932,6,0.04627216546853372,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.21292433407271547,0.1703105674788008,0.07187457826779288,0.04627216546853372,0.6333252135757059,1,0.28479891234050836,0.21658273294733452,0.31327880357455923,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_5,0.15274604325002628,0.1740626464337642,6,0.07106077784020007,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.21292433407271547,0.15274604325002628,0.07187457826779288,0.07106077784020007,0.5664631198472332,1,0.28479891234050836,0.22380682109022634,0.31327880357455923,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,0.039087376571411404,0.031541168271790945,6,0.01287662802619169,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.06948346099124691,0.039087376571411404,0.02766739623312042,0.01287662802619169,0.3520983967996138,1,0.09715085722436734,0.05196400459760309,0.16231584215801753,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_5,0.06948346099124691,0.0677710032825464,6,0.02766739623312042,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,0.05107680166577463,0.04770137860966448,6,0.01947400627016501,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.06948346099124691,0.05107680166577463,0.02766739623312042,0.01947400627016501,0.5996671217426663,1,0.09715085722436734,0.07055080793593964,0.16231584215801753,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_5,0.09995304554332396,0.11661239514284923,6,0.047606810963964685,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.06948346099124691,0.09995304554332396,0.02766739623312042,0.047606810963964685,0.5950792610175424,1,0.09715085722436734,0.14755985650728864,0.16231584215801753,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,0.05456251320050084,0.053506834710166276,6,0.02184407379855787,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.034631721480141785,0.05456251320050084,0.016085526846939705,0.02184407379855787,0.48084490322344453,1,0.05071724832708149,0.07640658699905871,0.23908004589257636,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_5,0.034631721480141785,0.03940133301884224,6,0.016085526846939705,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,0.10326823164840711,0.1880993137004117,6,0.07679122325561896,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.034631721480141785,0.10326823164840711,0.016085526846939705,0.07679122325561896,0.41862748054665483,1,0.05071724832708149,0.18005945490402608,0.23908004589257636,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_5,0.13214623002716866,0.2086947287446178,6,0.08519926623880984,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.034631721480141785,0.13214623002716866,0.016085526846939705,0.08519926623880984,0.308587357447421,1,0.05071724832708149,0.2173454962659785,0.23908004589257636,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,0.043804500827247995,0.04367219086766528,6,0.017829097262535884,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.06413063485225783,0.043804500827247995,0.016837516192478925,0.017829097262535884,0.42658675565526105,1,0.08096815104473676,0.06163359808978388,0.13212340016524338,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_5,0.06413063485225783,0.0412433232074228,6,0.016837516192478925,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,0.08409250622076632,0.08822982628221222,6,0.03601967574763675,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.06413063485225783,0.08409250622076632,0.016837516192478925,0.03601967574763675,0.6308556217329231,1,0.08096815104473676,0.12011218196840306,0.13212340016524338,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_5,0.05413065088753514,0.03947797178828823,6,0.016116814493549285,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.06413063485225783,0.05413065088753514,0.016837516192478925,0.016116814493549285,0.6770069827404854,1,0.08096815104473676,0.07024746538108442,0.13212340016524338,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_5,0.05796836128420576,0.04961449276111526,6,0.02025503185195701,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.06045377256546717,0.05796836128420576,0.020392598795850075,0.02025503185195701,0.9327982271228383,1,0.08084637136131724,0.07822339313616278,0.09976116446076048,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_5,0.06045377256546717,0.04995146157912734,6,0.020392598795850075,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_5,0.06756435926995596,0.04705051480717348,6,0.01920829223547325,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.06045377256546717,0.06756435926995596,0.020392598795850075,0.01920829223547325,0.8047971067016186,1,0.08084637136131724,0.08677265150542922,0.09976116446076048,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_5,0.05969090991808009,0.07593677303166675,6,0.03100105777352033,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.06045377256546717,0.05969090991808009,0.020392598795850075,0.03100105777352033,0.984064514597402,1,0.08084637136131724,0.09069196769160043,0.09976116446076048,0,24,0,3.277071129707113,L-alanine,alanine_116_218_rt3.38,3.313719512,3.31,0.027136453,3.52,3.3,0.22,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.23451754453130283,0.3897566911940035,6,0.15911750287680373,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.10870403321661817,0.23451754453130283,0.03930811259749626,0.15911750287680373,0.47380841642519544,1,0.14801214581411443,0.39363504740810656,0.43299855214891725,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_9,0.10870403321661817,0.08789561183521748,5,0.03930811259749626,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.28056743932930184,0.23139063242789235,6,0.09446483011803916,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.10870403321661817,0.28056743932930184,0.03930811259749626,0.09446483011803916,0.13927285351208718,1,0.14801214581411443,0.375032269447341,0.43299855214891725,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_9,0.220917945085718,0.29885618387783114,5,0.13365254852940142,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.10870403321661817,0.220917945085718,0.03930811259749626,0.13365254852940142,0.4594368539788232,1,0.14801214581411443,0.3545704936151194,0.43299855214891725,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.3967225246974582,0.33663488005810066,6,0.13743061429422718,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.343496881994502,0.3967225246974582,0.07847607141916078,0.13743061429422718,0.7453363514058251,1,0.4219729534136628,0.5341531389916854,0.5875684528908539,0,23,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_9,0.343496881994502,0.19222633199515443,6,0.07847607141916078,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.2552940787590794,0.19532215803897962,6,0.07973993710912591,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.343496881994502,0.2552940787590794,0.07847607141916078,0.07973993710912591,0.44876713341959196,1,0.4219729534136628,0.3350340158682053,0.5875684528908539,0,23,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_9,0.18739238158745394,0.1384992271450712,5,0.06193873734551267,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.343496881994502,0.18739238158745394,0.07847607141916078,0.06193873734551267,0.15335336030023414,1,0.4219729534136628,0.2493311189329666,0.5875684528908539,0,23,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.14415812307658007,0.10997921994446257,6,0.044898828528876035,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.07616883436534119,0.14415812307658007,0.026518224471377007,0.044898828528876035,0.22901271383398747,1,0.10268705883671819,0.1890569516054561,0.3589602042885568,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_9,0.07616883436534119,0.05929655256059742,5,0.026518224471377007,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.23295834807650195,0.22870667813832599,6,0.09336911036764055,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.07616883436534119,0.23295834807650195,0.026518224471377007,0.09336911036764055,0.15913066599107756,1,0.10268705883671819,0.3263274584441425,0.3589602042885568,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_9,0.12630130087902472,0.10730010086994972,6,0.04380508274675704,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.07616883436534119,0.12630130087902472,0.026518224471377007,0.04380508274675704,0.3562615379671354,1,0.10268705883671819,0.17010638362578176,0.3589602042885568,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.3626588687975597,0.24958051465140738,6,0.10189081843952819,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.2414459082718025,0.3626588687975597,0.13669340894924095,0.10189081843952819,0.4979060261314202,1,0.37813931722104344,0.4645496872370879,0.5110046559607967,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_9,0.2414459082718025,0.30565575448668086,5,0.13669340894924095,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.274521018089525,0.21359970287433766,6,0.08720171354203744,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.2414459082718025,0.274521018089525,0.13669340894924095,0.08720171354203744,0.8441705209847838,1,0.37813931722104344,0.36172273163156243,0.5110046559607967,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_9,0.18932902034821528,0.19133888580373068,6,0.07811377302863337,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.2414459082718025,0.18932902034821528,0.13669340894924095,0.07811377302863337,0.7510574596387154,1,0.37813931722104344,0.2674427933768486,0.5110046559607967,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.0126629604392976,0.013518130094542016,6,0.005518753501364878,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.01497815582926254,0.0126629604392976,0.0030631767665919344,0.005518753501364878,0.7235019006420236,1,0.018041332595854474,0.018181713940662477,0.019999885334728726,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_9,0.01497815582926254,0.0075032200700986835,6,0.0030631767665919344,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.005791648085628672,0.005951802959309191,6,0.0024298133833157384,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,0.01497815582926254,0.005791648085628672,0.0030631767665919344,0.0024298133833157384,0.04190841053351085,0.9638934422707495,0.018041332595854474,0.00822146146894441,0.019999885334728726,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_9,0.01063753166359871,0.013221788798071578,6,0.005397772673686976,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.01497815582926254,0.01063753166359871,0.0030631767665919344,0.005397772673686976,0.5043368063559595,1,0.018041332595854474,0.016035304337285686,0.019999885334728726,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.02153167559821223,0.0150122584420282,6,0.006128728844959709,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.022065196324419167,0.02153167559821223,0.0082667300153361975,0.006128728844959709,0.9597583447662119,1,0.030331926339755365,0.02766040444317194,0.0333651189737309,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_9,0.022065196324419167,0.02024927037892384,6,0.0082667300153361975,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.023412216948898907,0.01287119145554527,6,0.005254641907959438,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.022065196324419167,0.023412216948898907,0.0082667300153361975,0.005254641907959438,0.8938352881912595,1,0.030331926339755365,0.028666858856858345,0.0333651189737309,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_9,0.018920331316754968,0.012371298741396041,6,0.005050561561992674,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.022065196324419167,0.018920331316754968,0.0082667300153361975,0.005050561561992674,0.7535133314658635,1,0.030331926339755365,0.02397089287874764,0.0333651189737309,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.010590018049528416,0.012277084847800875,6,0.005012098900994503,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.010750161148982418,0.010590018049528416,0.004683074877761197,0.005012098900994503,0.9818354268703525,1,0.015433236026743614,0.01560211695052292,0.032705053686841845,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_9,0.010750161148982418,0.011471143877761636,6,0.004683074877761197,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.0256564251680087,0.009982752935471472,6,0.004075441820029339,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.010750161148982418,0.0256564251680087,0.004683074877761197,0.004075441820029339,0.037685529394978226,0.9044527054794774,0.015433236026743614,0.02973186698803804,0.032705053686841845,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_9,0.014154685977209258,0.02892049426835465,6,0.011806742344425735,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.010750161148982418,0.014154685977209258,0.004683074877761197,0.011806742344425735,0.7969305987918851,1,0.015433236026743614,0.02596142832163499,0.032705053686841845,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_9,0.008692246803952678,0.009413835716764386,6,0.0038431823380767156,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.015335570245592697,0.008692246803952678,0.005206051844875975,0.0038431823380767156,0.33082013347284855,1,0.020541622090468673,0.012535429142029392,0.03571977714851753,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_9,0.015335570245592697,0.012752170594421141,6,0.005206051844875975,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_9,0.02109831342064683,0.027861013813186963,6,0.011374211259823653,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.015335570245592697,0.02109831342064683,0.005206051844875975,0.011374211259823653,0.658980272264756,1,0.020541622090468673,0.03247252468047048,0.03571977714851753,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_9,0.0037547378105754112,0.005629534884223192,6,0.0022982479925907993,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.015335570245592697,0.0037547378105754112,0.005206051844875975,0.0022982479925907993,0.08202822324537466,1,0.020541622090468673,0.006052985803166211,0.03571977714851753,0,24,0,9.800459290187892,L-arginine,arginine_157_256_rt9.92,9.803414634,9.8,0.029211289,9.89,9.56,0.33,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,0.11364347555871997,0.11176239832296062,6,0.04562680805348999,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.287558732478046,0.11364347555871997,0.13357063008431913,0.04562680805348999,0.273361092717452,1,0.4211293625623651,0.15927028361220996,0.4761882945715606,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_12,0.287558732478046,0.29867300866601604,5,0.13357063008431913,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,0.20876666226761964,0.10856672916413831,6,0.04432218158251269,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.287558732478046,0.20876666226761964,0.13357063008431913,0.04432218158251269,0.6002785658990131,1,0.4211293625623651,0.2530888438501323,0.4761882945715606,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_12,0.2851312393430342,0.3304175270035799,5,0.1477672102674754,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.287558732478046,0.2851312393430342,0.13357063008431913,0.1477672102674754,0.9905779127450757,1,0.4211293625623651,0.4328984496105096,0.4761882945715606,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,0.17251402994893625,0.1420946028101843,6,0.05800987868139937,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.14306524118912078,0.17251402994893625,0.045959921210006485,0.05800987868139937,0.69949276023152,1,0.18902516239912726,0.23052390863033562,0.27131815611668497,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_12,0.14306524118912078,0.1125783555830339,6,0.045959921210006485,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,0.12048293198059527,0.06520190429839447,6,0.026618565964807946,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.14306524118912078,0.12048293198059527,0.045959921210006485,0.026618565964807946,0.681887412317573,1,0.18902516239912726,0.14710149794540323,0.27131815611668497,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_12,0.22592360683855253,0.05077611552244495,6,0.02072926235843377,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.14306524118912078,0.22592360683855253,0.045959921210006485,0.02072926235843377,0.14458467829244723,1,0.18902516239912726,0.2466528691969863,0.27131815611668497,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,0.08432623975193491,0.10693553318313938,6,0.04365624861185835,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.3071561753146736,0.08432623975193491,0.10152170277599971,0.04365624861185835,0.09498064374153395,1,0.4086778780906733,0.12798248836379328,0.44954566589974065,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_12,0.3071561753146736,0.2270094285986645,5,0.10152170277599971,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,0.22795598224951674,0.14640216527205047,6,0.05976843369252254,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.3071561753146736,0.22795598224951674,0.10152170277599971,0.05976843369252254,0.524176491490769,1,0.4086778780906733,0.2877244159420393,0.44954566589974065,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_12,0.04122838102503127,0.05401200197895744,6,0.02205030747244016,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.3071561753146736,0.04122838102503127,0.10152170277599971,0.02205030747244016,0.05742553884143843,1,0.4086778780906733,0.06327868849747142,0.44954566589974065,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,0.07490988397278464,0.08711161744743451,6,0.035563168902457164,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.10913829165971131,0.07490988397278464,0.04407433447458568,0.035563168902457164,0.5620419717554337,1,0.15321262613429698,0.11047305287524181,0.19404531839001476,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_12,0.10913829165971131,0.09855320794823606,5,0.04407433447458568,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,0.1168219259538162,0.14594772430889408,6,0.059582908946197194,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.10913829165971131,0.1168219259538162,0.04407433447458568,0.059582908946197194,0.9197750888064533,1,0.15321262613429698,0.1764048349000134,0.19404531839001476,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_12,0.09024802089468704,0.1048207278865964,6,0.042792882964880756,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.10913829165971131,0.09024802089468704,0.04407433447458568,0.042792882964880756,0.7655944296978304,1,0.15321262613429698,0.1330409038595678,0.19404531839001476,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,0.4525757944102096,0.2893674694660345,6,0.11813377472536267,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.3645965083577079,0.4525757944102096,0.10914639632598781,0.11813377472536267,0.5964405891749671,1,0.47374290468369573,0.5707095691355722,0.6277805260491295,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_12,0.3645965083577079,0.2673529782622547,6,0.10914639632598781,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,0.29805744749716045,0.15939497673332656,6,0.0650727267599078,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.3645965083577079,0.29805744749716045,0.10914639632598781,0.0650727267599078,0.6144620369725897,1,0.47374290468369573,0.3631301742570683,0.6277805260491295,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_12,0.40995038337731887,0.36827525289141644,6,0.1503477424130676,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.3645965083577079,0.40995038337731887,0.10914639632598781,0.1503477424130676,0.8125419342914908,1,0.47374290468369573,0.5602981257903865,0.6277805260491295,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,0.11856650949225012,0.12667397635656263,6,0.0517144342938265,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.3293780771330605,0.11856650949225012,0.10504060979851196,0.0517144342938265,0.11309913262823326,1,0.4344186869315725,0.1702809437860766,0.4778605556247298,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_12,0.3293780771330605,0.2572958962771452,6,0.10504060979851196,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,0.21256764201778341,0.1558143071520145,6,0.06361092452462119,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.3293780771330605,0.21256764201778341,0.10504060979851196,0.06361092452462119,0.36857855069357326,1,0.4344186869315725,0.2761785665424046,0.4778605556247298,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_12,0.12780818192103116,0.13472012806814146,6,0.054999261974891446,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.3293780771330605,0.12780818192103116,0.10504060979851196,0.054999261974891446,0.12979453117000925,1,0.4344186869315725,0.1828074438959226,0.4778605556247298,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,0.29439668127778135,0.2257265720122143,6,0.09215248713625457,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.12856624554432006,0.29439668127778135,0.03242929534455852,0.09215248713625457,0.13877558047416183,1,0.16099554088887857,0.3865491684140359,0.42520408525543957,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_12,0.12856624554432006,0.07943522631218235,6,0.03242929534455852,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,0.2013331282828108,0.2244528675542722,6,0.09163249946874351,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.12856624554432006,0.2013331282828108,0.03242929534455852,0.09163249946874351,0.48137248826308066,1,0.16099554088887857,0.2929656277515543,0.42520408525543957,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_12,0.11504418801046752,0.17248514084841005,6,0.07041676388178203,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.12856624554432006,0.11504418801046752,0.03242929534455852,0.07041676388178203,0.8664516379901883,1,0.16099554088887857,0.18546095189224954,0.42520408525543957,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_12,0.2662481971351249,0.2379322737254397,6,0.09713544399459068,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.3573482027489143,0.2662481971351249,0.11249847242669767,0.09713544399459068,0.5538926808207004,1,0.46984667517561196,0.36338364112971555,0.5553900880358603,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_12,0.3573482027489143,0.2755638542879721,6,0.11249847242669767,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_12,0.3371068911861628,0.4110076949882293,6,0.16779318884643746,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.3573482027489143,0.3371068911861628,0.11249847242669767,0.16779318884643746,0.9224489925792418,1,0.46984667517561196,0.5049000800326002,0.5553900880358603,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_12,0.16740361270280313,0.17876364591543678,6,0.0729799528420644,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.3573482027489143,0.16740361270280313,0.11249847242669767,0.0729799528420644,0.19192245030387878,1,0.46984667517561196,0.24038356554486753,0.5553900880358603,0,24,0,7.7426778242677825,L-asparagine,asparagine_188_216_rt7.84,7.750304878,7.75,0.030384525,8.01,7.53,0.48,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,0.14746427303627754,0.17379800687429764,6,0.07095273919245873,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.36462916096029696,0.14746427303627754,0.12381745409882285,0.07095273919245873,0.1751420779068184,1,0.4884466150591198,0.21841701222873627,0.5372912765650318,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_13,0.36462916096029696,0.27686424416592786,5,0.12381745409882285,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,0.18980461180176653,0.08007873685996,6,0.03269200742558421,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.36462916096029696,0.18980461180176653,0.12381745409882285,0.03269200742558421,0.23569231503946123,1,0.4884466150591198,0.22249661922735073,0.5372912765650318,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_13,0.21552282148249305,0.33072871585728736,5,0.14790637815362143,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.36462916096029696,0.21552282148249305,0.12381745409882285,0.14790637815362143,0.46241198725921473,1,0.4884466150591198,0.3634291996361145,0.5372912765650318,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,0.07616597618162031,0.11517598489299484,6,0.04702039893505686,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.162928146824154,0.07616597618162031,0.02446262408046827,0.04702039893505686,0.14267966740642343,1,0.18739077090462225,0.12318637511667718,0.26234072252323964,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_13,0.162928146824154,0.059920946766667794,6,0.02446262408046827,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,0.11561743982486779,0.09089794765019273,6,0.037108931734864896,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.162928146824154,0.11561743982486779,0.02446262408046827,0.037108931734864896,0.31592133288088176,1,0.18739077090462225,0.15272637155973268,0.26234072252323964,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_13,0.18867063992319313,0.12203584723016665,6,0.049820926007024695,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.162928146824154,0.18867063992319313,0.02446262408046827,0.049820926007024695,0.656338989548287,1,0.18739077090462225,0.23849156593021784,0.26234072252323964,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,0.14209593479208582,0.1368218419275987,6,0.05585728306505907,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.24625862250744568,0.14209593479208582,0.07179363151490596,0.05585728306505907,0.28537978514091283,1,0.31805225402235165,0.1979532178571449,0.34985747942458684,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_13,0.24625862250744568,0.16053544041890094,5,0.07179363151490596,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,0.15426620870460428,0.08006959858098354,6,0.03268827673881429,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.24625862250744568,0.15426620870460428,0.07179363151490596,0.03268827673881429,0.29051101658769585,1,0.31805225402235165,0.18695448544341858,0.34985747942458684,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_13,0.11568071512277205,0.09411671186759192,6,0.038422986724024374,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.24625862250744568,0.11568071512277205,0.07179363151490596,0.038422986724024374,0.15824248087416676,1,0.31805225402235165,0.15410370184679642,0.34985747942458684,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,0.06250529097669033,0.036784715567748955,6,0.01501729724573296,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1798886967797017,0.06250529097669033,0.07083104400004209,0.01501729724573296,0.17438806400573773,1,0.2507197407797438,0.07752258822242329,0.2757917148577182,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_13,0.1798886967797017,0.15838302930137274,5,0.07083104400004209,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,0.05149005980793856,0.03163449700383818,6,0.012914729321501135,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1798886967797017,0.05149005980793856,0.07083104400004209,0.012914729321501135,0.14460788267823205,1,0.2507197407797438,0.0644047891294397,0.2757917148577182,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_13,0.09895707671364613,0.0796823165441534,6,0.03253016950935102,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1798886967797017,0.09895707671364613,0.07083104400004209,0.03253016950935102,0.34139693984842256,1,0.2507197407797438,0.13148724622299715,0.2757917148577182,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,0.0503587608840886,0.05212111800198263,6,0.021278357321374685,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.0688247906559818,0.0503587608840886,0.02066180822005501,0.021278357321374685,0.5474910628465706,1,0.0894865988760368,0.07163711820546328,0.09843525876364048,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_13,0.0688247906559818,0.050610887302377894,6,0.02066180822005501,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,0.029948500949713353,0.023592490008363116,6,0.009631593713700013,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.0688247906559818,0.029948500949713353,0.02066180822005501,0.009631593713700013,0.13144117909042885,1,0.0894865988760368,0.03958009466341336,0.09843525876364048,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_13,0.06079852168219076,0.05985131235102365,6,0.024434195949324097,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.0688247906559818,0.06079852168219076,0.02066180822005501,0.024434195949324097,0.8071633094141252,1,0.0894865988760368,0.08523271763151485,0.09843525876364048,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,0.08033333449698077,0.0451169854111495,6,0.018418932164984834,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.09723267763772665,0.08033333449698077,0.022453531742315635,0.018418932164984834,0.5740001070237446,1,0.11968620938004229,0.0987522666619656,0.13165483031804653,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_13,0.09723267763772665,0.05499969569205864,6,0.022453531742315635,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,0.04834301308178738,0.03951912633454557,6,0.01613361576670366,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.09723267763772665,0.04834301308178738,0.022453531742315635,0.01613361576670366,0.11053187351980279,1,0.11968620938004229,0.06447662884849104,0.13165483031804653,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_13,0.07867246212205463,0.08557730012208371,6,0.03493678647735361,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.09723267763772665,0.07867246212205463,0.022453531742315635,0.03493678647735361,0.6660715878370982,1,0.11968620938004229,0.11360924859940824,0.13165483031804653,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,0.07079889222376456,0.025941541723015073,6,0.01059059006041788,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.0969009314193312,0.07079889222376456,0.03808870711512455,0.01059059006041788,0.5345524295910171,1,0.13498963853445575,0.08138948228418244,0.1697707173309309,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_13,0.0969009314193312,0.09329789739437022,6,0.03808870711512455,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,0.09806227156465264,0.05977047238484084,6,0.024401193171328807,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.0969009314193312,0.09806227156465264,0.03808870711512455,0.024401193171328807,0.9801093085689563,1,0.13498963853445575,0.12246346473598144,0.1697707173309309,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_13,0.11668722270097476,0.09222278190470369,6,0.037649793054416965,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.0969009314193312,0.11668722270097476,0.03808870711512455,0.037649793054416965,0.719496706858499,1,0.13498963853445575,0.15433701575539172,0.1697707173309309,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_13,0.0654233009426058,0.058572150649692095,6,0.023911980371528644,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.10966758507200296,0.0654233009426058,0.01916080701922518,0.023911980371528644,0.18076570566648428,1,0.12882839209122815,0.08933528131413444,0.17124822551129001,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_13,0.10966758507200296,0.04693420025703999,6,0.01916080701922518,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_13,0.11761346834456592,0.09324408100385485,6,0.03806673666569771,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.10966758507200296,0.11761346834456592,0.01916080701922518,0.03806673666569771,0.8571149029030989,1,0.12882839209122815,0.15568020501026364,0.17124822551129001,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_13,0.04174812174944117,0.048826486138152665,6,0.01993332949525833,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,0.10966758507200296,0.04174812174944117,0.01916080701922518,0.01993332949525833,0.03391474668618635,0.8139539204684725,0.12882839209122815,0.061681451244699495,0.17124822551129001,0,24,0,7.381691022964509,L-aspartic_acid,aspartic_acid_232_218_rt7.48,7.391280488,7.39,0.028026182,7.59,7.16,0.43,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,0.09421417714575246,0.06369575407463564,6,0.02600368271077664,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.22195837070213792,0.09421417714575246,0.10918370259540322,0.02600368271077664,0.3125324999288232,1,0.33114207329754114,0.12021785985652911,0.397135983475807,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_47,0.22195837070213792,0.24414218103844182,5,0.10918370259540322,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,0.14337063572024875,0.07162128582959659,6,0.02923926750075651,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.22195837070213792,0.14337063572024875,0.10918370259540322,0.02923926750075651,0.5205930158340877,1,0.33114207329754114,0.17260990322100525,0.397135983475807,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_47,0.23769286909657494,0.27579627362686077,5,0.12333984315415862,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.22195837070213792,0.23769286909657494,0.10918370259540322,0.12333984315415862,0.926284459530818,1,0.33114207329754114,0.3610327122507336,0.397135983475807,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,0.12743616085016432,0.14870082664132173,6,0.06070685826688286,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.10804235139803227,0.12743616085016432,0.038009949223729314,0.06070685826688286,0.7931041858556513,1,0.14605230062176158,0.18814301911704717,0.24735944142669666,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_47,0.10804235139803227,0.09310498074723436,6,0.038009949223729314,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,0.15909992348377192,0.045127042104250614,6,0.018423037792751083,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.10804235139803227,0.15909992348377192,0.038009949223729314,0.018423037792751083,0.26481296098667034,1,0.14605230062176158,0.177522961276523,0.24735944142669666,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_47,0.15010275727571532,0.18314703073990757,6,0.07476946220309984,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.10804235139803227,0.15010275727571532,0.038009949223729314,0.07476946220309984,0.6305789151348232,1,0.14605230062176158,0.22487221947881514,0.24735944142669666,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,0.12646076976281728,0.10001943553351941,6,0.040832763569719856,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.20329927738744766,0.12646076976281728,0.05934520245619116,0.040832763569719856,0.3198400301520063,1,0.2626444798436388,0.16729353333253713,0.2889089278280027,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_47,0.20329927738744766,0.13269990683053093,5,0.05934520245619116,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,0.13986050415910223,0.13785036007410859,6,0.056277173840082795,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.20329927738744766,0.13986050415910223,0.05934520245619116,0.056277173840082795,0.4583713041674453,1,0.2626444798436388,0.19613767799918502,0.2889089278280027,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_47,0.060870741249395656,0.04779157305419391,6,0.019510827997953485,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.20329927738744766,0.060870741249395656,0.05934520245619116,0.019510827997953485,0.07299652293983232,1,0.2626444798436388,0.08038156924734914,0.2889089278280027,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,0.09225920912415964,0.07684310730612315,6,0.03137106719165596,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.08556945509048726,0.09225920912415964,0.05506421073135387,0.03137106719165596,0.9191272059881627,1,0.14063366582184111,0.1236302763158156,0.21920416350773522,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_47,0.08556945509048726,0.12312731832268066,5,0.05506421073135387,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,0.153678603435094,0.11169161000736992,6,0.04559790884466527,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.08556945509048726,0.153678603435094,0.05506421073135387,0.04559790884466527,0.36780123986515534,1,0.14063366582184111,0.1992765122797593,0.21920416350773522,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_47,0.08163762255592033,0.051724148144232554,6,0.021116295055582535,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.08556945509048726,0.08163762255592033,0.05506421073135387,0.021116295055582535,0.9493443851412706,1,0.14063366582184111,0.10275391761150286,0.21920416350773522,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,0.10713807305308465,0.09932519051677563,6,0.040549339228471155,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.0615593584168197,0.10713807305308465,0.020505835165396245,0.040549339228471155,0.34749356194140807,1,0.08206519358221595,0.1476874122815558,0.3477398923014833,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_47,0.0615593584168197,0.050228832904840696,6,0.020505835165396245,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,0.19630266296170393,0.2935089127297469,6,0.11982451185782633,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.0615593584168197,0.19630266296170393,0.020505835165396245,0.11982451185782633,0.31550215670353343,1,0.08206519358221595,0.31612717481953023,0.3477398923014833,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_47,0.13799436718211355,0.13248151335567135,6,0.05408535134551827,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.0615593584168197,0.13799436718211355,0.020505835165396245,0.05408535134551827,0.23157346318449343,1,0.08206519358221595,0.19207971852763184,0.3477398923014833,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,0.043874024435146465,0.0400241381904528,6,0.01633978599354177,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.17151619589191128,0.043874024435146465,0.050619966955072204,0.01633978599354177,0.05310965976907638,1,0.22213616284698348,0.06021381042868823,0.24434977913168185,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_47,0.17151619589191128,0.12399308983647278,6,0.050619966955072204,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,0.05630056738890232,0.0493956609507083,6,0.020165694139459258,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.17151619589191128,0.05630056738890232,0.050619966955072204,0.020165694139459258,0.07502755957331965,1,0.22213616284698348,0.07646626152836158,0.24434977913168185,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_47,0.04793398546341421,0.051924156080793364,6,0.02119794795376269,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.17151619589191128,0.04793398546341421,0.050619966955072204,0.02119794795376269,0.06069422938205608,1,0.22213616284698348,0.0691319334171769,0.24434977913168185,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,0.07841182168371945,0.11529158198944028,6,0.0470675912520633,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.14594873060481076,0.07841182168371945,0.04981917954043253,0.0470675912520633,0.3477374288551218,1,0.19576791014524328,0.12547941293578274,0.21534470115976762,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_47,0.14594873060481076,0.12203156927816304,6,0.04981917954043253,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,0.10991576014785938,0.1370944166706968,6,0.0559685612379525,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.14594873060481076,0.10991576014785938,0.04981917954043253,0.0559685612379525,0.6410780246035566,1,0.19576791014524328,0.16588432138581188,0.21534470115976762,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_47,0.06367994388326885,0.0853167920914349,6,0.03483043451918913,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.14594873060481076,0.06367994388326885,0.04981917954043253,0.03483043451918913,0.20913927991436643,1,0.19576791014524328,0.09851037840245798,0.21534470115976762,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_47,0.1474799344976346,0.12392210285722564,6,0.050590986642149366,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.1746390842736786,0.1474799344976346,0.055511902346936856,0.050590986642149366,0.7252324166440616,1,0.23015098662061545,0.19807092113978397,0.30076647094939074,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_47,0.1746390842736786,0.13597583540120325,6,0.055511902346936856,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_47,0.18590989399226462,0.2143650630055191,6,0.08751417050718147,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.1746390842736786,0.18590989399226462,0.055511902346936856,0.08751417050718147,0.9159319362534787,1,0.23015098662061545,0.2734240644994461,0.30076647094939074,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_47,0.07293890706276618,0.05268573094085686,6,0.021508859588443868,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.1746390842736786,0.07293890706276618,0.055511902346936856,0.021508859588443868,0.13485102994144585,1,0.23015098662061545,0.09444776665121005,0.30076647094939074,0,24,0,7.959079497907949,L-glutamine,glutamine_227_203_rt8.06,7.963658537,7.96,0.033798835,8.2,7.77,0.43,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,0.3273322596097822,0.30285050997947377,6,0.12363820296522926,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.09262120839268735,0.3273322596097822,0.07099555781550461,0.12363820296522926,0.13937855852757391,1,0.16361676620819196,0.45097046257501144,0.4960675088325126,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_53,0.09262120839268735,0.15875089337598478,5,0.07099555781550461,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,0.1847296539822374,0.18136421800898542,6,0.07404163195348366,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.09262120839268735,0.1847296539822374,0.07099555781550461,0.07404163195348366,0.39272370602692797,1,0.16361676620819196,0.2587712859357211,0.4960675088325126,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_53,0.20346379461253655,0.19316329579649524,5,0.08638525203177254,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.09262120839268735,0.20346379461253655,0.07099555781550461,0.08638525203177254,0.35162482579204707,1,0.16361676620819196,0.2898490466443091,0.4960675088325126,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,0.13627827705091036,0.10814265418603644,6,0.0441490536976741,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.11994828451220625,0.13627827705091036,0.03659350255174859,0.0441490536976741,0.7818218265303978,1,0.15654178706395483,0.18042733074858447,0.28985245103378393,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_53,0.11994828451220625,0.08963540915301822,6,0.03659350255174859,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,0.14986282945865714,0.08926242400196653,6,0.03644123200146333,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.11994828451220625,0.14986282945865714,0.03659350255174859,0.03644123200146333,0.5752353922816928,1,0.15654178706395483,0.18630406146012046,0.28985245103378393,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_53,0.19090746525178515,0.17782012725212276,6,0.0725947629607457,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.11994828451220625,0.19090746525178515,0.03659350255174859,0.0725947629607457,0.4102206504347661,1,0.15654178706395483,0.26350222821253083,0.28985245103378393,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,0.20839503843140075,0.21465013785233722,6,0.08763055182604922,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.15098090221311722,0.20839503843140075,0.08620129565257609,0.08763055182604922,0.6516436893320574,1,0.2371821978656933,0.29602559025744996,0.325628149283195,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_53,0.15098090221311722,0.19275195682771723,5,0.08620129565257609,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,0.1794898733015046,0.23027605650186384,6,0.09400980640164584,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.15098090221311722,0.1794898733015046,0.08620129565257609,0.09400980640164584,0.8281282992994022,1,0.2371821978656933,0.2734996797031504,0.325628149283195,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_53,0.23787346722160238,0.13958525046953998,6,0.056985439878159835,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.15098090221311722,0.23787346722160238,0.08620129565257609,0.056985439878159835,0.42757810382388106,1,0.2371821978656933,0.2948589070997622,0.325628149283195,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,0.1195986072387949,0.11021608492277152,6,0.04499552825134143,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1393712514771968,0.1195986072387949,0.0533080984284888,0.04499552825134143,0.7837459799527164,1,0.1926793499056856,0.16459413549013632,0.4989340720437049,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_53,0.1393712514771968,0.11920053183735067,5,0.0533080984284888,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,0.11259643251409812,0.10000113759670194,6,0.04082529346829511,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1393712514771968,0.11259643251409812,0.0533080984284888,0.04082529346829511,0.7006366307500577,1,0.1926793499056856,0.15342172598239323,0.4989340720437049,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_53,0.27230415185398155,0.44402458384012483,6,0.1812722772766592,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1393712514771968,0.27230415185398155,0.0533080984284888,0.1812722772766592,0.5087473106971009,1,0.1926793499056856,0.4535764291306408,0.4989340720437049,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,0.1478382302228821,0.10683260218421588,6,0.043614227207512096,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.06735163149165424,0.1478382302228821,0.03498791407168243,0.043614227207512096,0.1819741597091893,1,0.10233954556333667,0.19145245743039419,0.21585195135050897,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_53,0.06735163149165424,0.08570253663996534,6,0.03498791407168243,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,0.08872333697452284,0.07202281678493458,6,0.029403191826841563,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.06735163149165424,0.08872333697452284,0.03498791407168243,0.029403191826841563,0.6503663352881699,1,0.10233954556333667,0.1181265288013644,0.21585195135050897,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_53,0.1537854547871483,0.1039651429940024,6,0.04244359189513255,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.06735163149165424,0.1537854547871483,0.03498791407168243,0.04244359189513255,0.14827964320747317,1,0.10233954556333667,0.19622904668228086,0.21585195135050897,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,0.12214114404354907,0.06899641860241915,6,0.028167669942566694,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.13802270666114178,0.12214114404354907,0.052249044981007485,0.028167669942566694,0.796086131257153,1,0.19027175164214927,0.15030881398611576,0.25064497416233383,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_53,0.13802270666114178,0.12798349975119472,6,0.052249044981007485,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,0.08589691138992143,0.0758142828664397,6,0.030951051372967747,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.13802270666114178,0.08589691138992143,0.052249044981007485,0.030951051372967747,0.4153065439320567,1,0.19027175164214927,0.11684796276288918,0.25064497416233383,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_53,0.15060862761104543,0.18922415993826686,6,0.07725043980925804,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.13802270666114178,0.15060862761104543,0.052249044981007485,0.07725043980925804,0.8956903473829222,1,0.19027175164214927,0.22785906742030348,0.25064497416233383,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,0.11366595045674203,0.10295269208452056,6,0.042030260542158,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.10704920174003447,0.11366595045674203,0.0240640082166217,0.042030260542158,0.8947229670401242,1,0.13111320995665618,0.15569621099890002,0.25452730494241754,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_53,0.10704920174003447,0.05894454129686497,6,0.0240640082166217,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,0.17025058263474802,0.14975660114668649,6,0.06113787640381335,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.10704920174003447,0.17025058263474802,0.0240640082166217,0.06113787640381335,0.3704304795834999,1,0.13111320995665618,0.23138845903856137,0.25452730494241754,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_53,0.12549059113950856,0.11241926570713273,6,0.045894973040139724,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.10704920174003447,0.12549059113950856,0.0240640082166217,0.045894973040139724,0.7316704217561087,1,0.13111320995665618,0.1713855641796483,0.25452730494241754,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_53,0.102710873617476,0.0604440908540188,6,0.024676196759795595,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.11405379060126486,0.102710873617476,0.05485342688641327,0.024676196759795595,0.8558127945038096,1,0.16890721748767812,0.1273870703772716,0.18579793923644594,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_53,0.11405379060126486,0.1343629065147763,6,0.05485342688641327,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_53,0.09390579119760245,0.10575299689206437,6,0.0431734801926155,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.11405379060126486,0.09390579119760245,0.05485342688641327,0.0431734801926155,0.7790792334793359,1,0.16890721748767812,0.13707927139021794,0.18579793923644594,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_53,0.08354299054789897,0.10120406507636248,6,0.04131638655541853,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.11405379060126486,0.08354299054789897,0.05485342688641327,0.04131638655541853,0.6669986006834769,1,0.16890721748767812,0.1248593771033175,0.18579793923644594,0,24,0,3.592033542976939,L-glycine,glycine_102_147_rt3.70,3.630552147,3.63,0.028246086,3.84,3.6,0.24,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,0.07313210205571592,0.07961161974668554,6,0.032501307662643496,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.22084563892002249,0.07313210205571592,0.11650915173233282,0.032501307662643496,0.280589806676399,1,0.3373547906523553,0.10563340971835941,0.37109026971759085,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_59,0.22084563892002249,0.2605223832743336,5,0.11650915173233282,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,0.04424976840213982,0.028430431487809972,6,0.011606675052048404,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.22084563892002249,0.04424976840213982,0.11650915173233282,0.011606675052048404,0.2046225070025671,1,0.3373547906523553,0.05585644345418823,0.37109026971759085,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_59,0.1539887646653451,0.217290312442905,5,0.09717518189490079,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.22084563892002249,0.1539887646653451,0.11650915173233282,0.09717518189490079,0.6714808047883601,1,0.3373547906523553,0.2511639465602459,0.37109026971759085,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,0.10077387026893048,0.09914284386486437,6,0.040474896519556575,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.10465387820140266,0.10077387026893048,0.020175225622508022,0.040474896519556575,0.9339235061050484,1,0.12482910382391069,0.14124876678848705,0.19805401869685485,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_59,0.10465387820140266,0.049419008220669754,6,0.020175225622508022,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,0.08786621451116261,0.07258446694091866,6,0.029632484542860826,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.10465387820140266,0.08786621451116261,0.020175225622508022,0.029632484542860826,0.6509370509681968,1,0.12482910382391069,0.11749869905402344,0.19805401869685485,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_59,0.1301641421573115,0.12219271192107004,6,0.049884965748920145,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.10465387820140266,0.1301641421573115,0.020175225622508022,0.049884965748920145,0.6507407567666813,1,0.12482910382391069,0.18004910790623166,0.19805401869685485,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,0.05036622418273651,0.06436178630481539,6,0.026275589230141356,fruit_1_panK4-1,1,967514 MM WT,fruit,*,0.19109605508564878,0.05036622418273651,0.05028763651322697,0.026275589230141356,0.04702456020904283,1,0.24138369159887574,0.07664181341287786,0.26552206075876333,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_59,0.19109605508564878,0.11244657367137602,5,0.05028763651322697,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,0.08841422108919332,0.05919540020637776,6,0.024166420937577926,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.19109605508564878,0.08841422108919332,0.05028763651322697,0.024166420937577926,0.11689229351630627,1,0.24138369159887574,0.11258064202677125,0.26552206075876333,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_59,0.05592880409065685,0.022990390972263578,6,0.009385787811522436,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.19109605508564878,0.05592880409065685,0.05028763651322697,0.009385787811522436,0.05361132271026058,1,0.24138369159887574,0.06531459190217928,0.26552206075876333,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,0.04214771227324432,0.030851876438579322,6,0.012595225813652343,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.09827555361214975,0.04214771227324432,0.041278745240223624,0.012595225813652343,0.25297536120696384,1,0.13955429885237336,0.05474293808689666,0.1535097287376107,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_59,0.09827555361214975,0.09230208038303592,5,0.041278745240223624,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,0.02120131755081404,0.029262081551414777,6,0.011946194768779228,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.09827555361214975,0.02120131755081404,0.041278745240223624,0.011946194768779228,0.13695199303073982,1,0.13955429885237336,0.03314751231959327,0.1535097287376107,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_59,0.0768192969576269,0.06348658632728978,6,0.025918290335502515,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.09827555361214975,0.0768192969576269,0.041278745240223624,0.025918290335502515,0.6732155354431522,1,0.13955429885237336,0.10273758729312941,0.1535097287376107,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,0.13920841080363452,0.0942473548360967,6,0.03847632149257757,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.13163036434842246,0.13920841080363452,0.046477849312385,0.03847632149257757,0.9026276010798252,1,0.17810821366080745,0.1776847322962121,0.1959190350268882,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_59,0.13163036434842246,0.11384701515730923,6,0.046477849312385,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,0.09853242944422365,0.08845008188862273,6,0.036109594722418925,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.13163036434842246,0.09853242944422365,0.046477849312385,0.036109594722418925,0.587003495016821,1,0.17810821366080745,0.13464202416664256,0.1959190350268882,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_59,0.12229449732279189,0.09766575836833011,6,0.03987187889072749,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.13163036434842246,0.12229449732279189,0.046477849312385,0.03987187889072749,0.8819293043416718,1,0.17810821366080745,0.16216637621351937,0.1959190350268882,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,0.10221941837196676,0.055086666484585135,6,0.022489037419684863,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.073556722238312,0.10221941837196676,0.04020546174675539,0.022489037419684863,0.5514589914678131,1,0.11376218398506739,0.12470845579165162,0.15020710949799965,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_59,0.073556722238312,0.09848286615253876,6,0.04020546174675539,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,0.060165094516348404,0.09856558622925213,6,0.040239232076660664,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.073556722238312,0.060165094516348404,0.04020546174675539,0.040239232076660664,0.8186307321009496,1,0.11376218398506739,0.10040432659300907,0.15020710949799965,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_59,0.09923273911847175,0.09141294520689695,6,0.037319178606982466,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.073556722238312,0.09923273911847175,0.04020546174675539,0.037319178606982466,0.6498305866666954,1,0.11376218398506739,0.13655191772545422,0.15020710949799965,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,0.1235119735005034,0.07838028604908884,6,0.03199861778560909,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.08353505402577695,0.1235119735005034,0.03580801420375302,0.03199861778560909,0.4248169936399864,1,0.11934306822952997,0.1555105912861125,0.20109939235614127,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_59,0.08353505402577695,0.08771136350152736,6,0.03580801420375302,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,0.12417980051053161,0.09008827088197033,6,0.0367783825784098,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.08353505402577695,0.12417980051053161,0.03580801420375302,0.0367783825784098,0.4468552443243894,1,0.11934306822952997,0.16095818308894141,0.20109939235614127,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_59,0.13149515301415246,0.12571387951730886,6,0.05132247640052139,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.08353505402577695,0.13149515301415246,0.03580801420375302,0.05132247640052139,0.46321239891252664,1,0.11934306822952997,0.18281762941467386,0.20109939235614127,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_59,0.06576582283451031,0.05963451771544903,6,0.024345689909969024,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.1457136470079158,0.06576582283451031,0.06832115729711574,0.024345689909969024,0.3109674353240375,1,0.21403480430503155,0.09011151274447933,0.23543828473553471,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_59,0.1457136470079158,0.16735197401436108,6,0.06832115729711574,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_59,0.1264040466867332,0.13957282276496852,6,0.056980366289014144,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.1457136470079158,0.1264040466867332,0.06832115729711574,0.056980366289014144,0.8326717875303011,1,0.21403480430503155,0.18338441297574734,0.23543828473553471,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_59,0.032755621210207364,0.04600993693114798,6,0.01878347809649132,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.1457136470079158,0.032755621210207364,0.06832115729711574,0.01878347809649132,0.16412842192142815,1,0.21403480430503155,0.051539099306698685,0.23543828473553471,0,24,0,10.978577405857742,L-histidine,histidine_154_254_rt11.10,10.98859756,10.99,0.019118205,11.17,10.94,0.23,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,0.2088129121992509,0.2731635939003062,6,0.11151857022676494,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.09602916474519456,0.2088129121992509,0.0449359517685595,0.11151857022676494,0.3815548712318116,1,0.14096511651375407,0.32033148242601583,0.3710872360583589,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_60,0.09602916474519456,0.10047984278815095,5,0.0449359517685595,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,0.21451622931311606,0.14137844616836237,6,0.05771750895667123,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.09602916474519456,0.21451622931311606,0.0449359517685595,0.05771750895667123,0.1403335037454522,1,0.14096511651375407,0.2722337382697873,0.3710872360583589,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_60,0.24609101773344233,0.20406583334046366,5,0.09126101504688394,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.09602916474519456,0.24609101773344233,0.0449359517685595,0.09126101504688394,0.1920018056694006,1,0.14096511651375407,0.33735203278032627,0.3710872360583589,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,0.32443684728412997,0.1889317812398415,6,0.07713107670545785,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.23459252618612392,0.32443684728412997,0.11161594861568207,0.07713107670545785,0.5246326293080004,1,0.346208474801806,0.40156792398958785,0.44172471638854666,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_60,0.23459252618612392,0.2734021212651275,6,0.11161594861568207,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,0.18070463762747332,0.18925250613850078,6,0.0772620120970447,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.23459252618612392,0.18070463762747332,0.11161594861568207,0.0772620120970447,0.7007439061807508,1,0.346208474801806,0.257966649724518,0.44172471638854666,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_60,0.11166078129989276,0.10688764993115164,6,0.04363670035609251,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.23459252618612392,0.11166078129989276,0.11161594861568207,0.04363670035609251,0.34168269756597824,1,0.346208474801806,0.15529748165598528,0.44172471638854666,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,0.14393532995577918,0.16808959647568908,6,0.06862229040596064,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.17012991739347466,0.14393532995577918,0.106646783866427,0.06862229040596064,0.8422103160393011,1,0.27677670125990167,0.2125576203617398,0.401469515545521,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_60,0.17012991739347466,0.23846945830705862,5,0.106646783866427,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,0.26309681856805694,0.2495429146212807,6,0.10187546829150758,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.17012991739347466,0.26309681856805694,0.106646783866427,0.10187546829150758,0.5445220220565714,1,0.27677670125990167,0.3649722868595645,0.401469515545521,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_60,0.12136805375185404,0.05176850199238902,6,0.021134402438267905,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.17012991739347466,0.12136805375185404,0.106646783866427,0.021134402438267905,0.6753972108452233,1,0.27677670125990167,0.14250245619012195,0.401469515545521,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,0.35313874857689165,0.2868068630351745,6,0.11708841152741331,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.14588200680257643,0.35313874857689165,0.06952537904432138,0.11708841152741331,0.16689813763268432,1,0.2154073858468978,0.470227160104305,0.5172498761147355,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_60,0.14588200680257643,0.15546347370454197,5,0.06952537904432138,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,0.14217748119149973,0.14162542251191085,6,0.05781833662670991,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.14588200680257643,0.14217748119149973,0.06952537904432138,0.05781833662670991,0.9682924723459605,1,0.2154073858468978,0.19999581781820963,0.5172498761147355,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_60,0.12789834495406457,0.1174639197830787,6,0.04795444444262622,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.14588200680257643,0.12789834495406457,0.06952537904432138,0.04795444444262622,0.837150472867465,1,0.2154073858468978,0.1758527893966908,0.5172498761147355,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,0.30429219461945317,0.3087606214563332,6,0.126050995872108,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.21284975865767894,0.30429219461945317,0.05055877959110548,0.126050995872108,0.5237312544505647,1,0.2634085382487844,0.43034319049156117,0.47337750954071733,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_60,0.21284975865767894,0.12384321201604835,6,0.05055877959110548,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,0.2658716107730136,0.22384615171187075,6,0.09138480876328577,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.21284975865767894,0.2658716107730136,0.05055877959110548,0.09138480876328577,0.6257166813429529,1,0.2634085382487844,0.35725641953629933,0.47337750954071733,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_60,0.25149836500792766,0.2732575370893114,6,0.11155692237307703,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.21284975865767894,0.25149836500792766,0.05055877959110548,0.11155692237307703,0.7615792949162559,1,0.2634085382487844,0.3630552873810047,0.47337750954071733,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,0.372116014585255,0.21754457178057496,6,0.08881219952911287,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,0.058322446534352666,0.372116014585255,0.023214530805275167,0.08881219952911287,0.015441174005271894,0.37058817612652545,0.08153697733962784,0.4609282141143679,0.5070210355258047,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_60,0.058322446534352666,0.056863755091045624,6,0.023214530805275167,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,0.219318968650457,0.18539405711498408,6,0.07568680687935203,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.058322446534352666,0.219318968650457,0.023214530805275167,0.07568680687935203,0.08875606605058872,1,0.08153697733962784,0.295005775529809,0.5070210355258047,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_60,0.1384165978223416,0.09738331280460921,6,0.039756570972189334,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.058322446534352666,0.1384165978223416,0.023214530805275167,0.039756570972189334,0.11983713328432842,1,0.08153697733962784,0.17817316879453093,0.5070210355258047,2,24,8.333333333333332,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,0.2339257282018918,0.20186625483893625,6,0.08241155344033825,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.0922337679407003,0.2339257282018918,0.06305530378735796,0.08241155344033825,0.2040163976925817,1,0.15528907172805828,0.3163372816422301,0.3479710098064531,1,24,4.166666666666666,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_60,0.0922337679407003,0.1544533198552106,6,0.06305530378735796,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,0.13763275560989527,0.06596090564710612,6,0.026928426967879244,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.0922337679407003,0.13763275560989527,0.06305530378735796,0.026928426967879244,0.5297858417433019,1,0.15528907172805828,0.16456118257777452,0.3479710098064531,1,24,4.166666666666666,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_60,0.18506266744217878,0.10310383342129732,6,0.04209196373451554,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.0922337679407003,0.18506266744217878,0.06305530378735796,0.04209196373451554,0.2528438706740877,1,0.15528907172805828,0.22715463117669432,0.3479710098064531,1,24,4.166666666666666,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_60,0.23380863787559192,0.2069617513835599,6,0.08449178119374537,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.0977977698855705,0.23380863787559192,0.05392613912630219,0.08449178119374537,0.20976300566075523,1,0.1517239090118727,0.31830041906933726,0.35013046097627104,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_60,0.0977977698855705,0.13209152465777582,6,0.05392613912630219,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_60,0.15901531471449146,0.11772835199836267,6,0.04806239844245947,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.0977977698855705,0.15901531471449146,0.05392613912630219,0.04806239844245947,0.4168106817741073,1,0.1517239090118727,0.20707771315695092,0.35013046097627104,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_60,0.17484914437343715,0.10502380053338234,6,0.042875787025771085,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.0977977698855705,0.17484914437343715,0.05392613912630219,0.042875787025771085,0.2908289559652166,1,0.1517239090118727,0.21772493139920823,0.35013046097627104,0,24,0,6.554106382978723,L-homoserine,homoserine_218_128_rt6.64,6.56202454,6.56,0.033777769,6.88,6.37,0.51,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.1930524714820269,0.20405756322691496,6,0.08330615134360968,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.24798476838353817,0.1930524714820269,0.12336430622023568,0.08330615134360968,0.7226223307798784,1,0.37134907460377387,0.27635862282563656,0.40848398206415126,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_64,0.24798476838353817,0.27585097470554715,5,0.12336430622023568,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.11470175318696112,0.0871919714394195,6,0.03559597328231698,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.24798476838353817,0.11470175318696112,0.12336430622023568,0.03559597328231698,0.34999620808446624,1,0.37134907460377387,0.15029772646927808,0.40848398206415126,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_64,0.17778439489053594,0.13517421218763248,5,0.060451745451305355,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.24798476838353817,0.17778439489053594,0.12336430622023568,0.060451745451305355,0.628163377769074,1,0.37134907460377387,0.2382361403418413,0.40848398206415126,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.1766398094482474,0.2253140181047361,6,0.09198406270880241,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.07294293719374068,0.1766398094482474,0.02443486848454012,0.09198406270880241,0.3198016053557819,1,0.09737780567828079,0.2686238721570498,0.2954862593727548,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_64,0.07294293719374068,0.059852959719136956,6,0.02443486848454012,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.1809146472512022,0.1600328523630547,6,0.06533313839527287,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.07294293719374068,0.1809146472512022,0.02443486848454012,0.06533313839527287,0.1697434211042275,1,0.09737780567828079,0.2462477856464751,0.2954862593727548,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_64,0.12453118818074967,0.06975828329103884,6,0.028478699899260468,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.07294293719374068,0.12453118818074967,0.02443486848454012,0.028478699899260468,0.19989226238586236,1,0.09737780567828079,0.15300988808001015,0.2954862593727548,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.11250083408303047,0.09038180085458408,6,0.03689821568792927,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.3355810714382311,0.11250083408303047,0.1472671372886569,0.03689821568792927,0.2078915594258953,1,0.48284820872688805,0.14939904977095975,0.5311330295995769,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_64,0.3355810714382311,0.32929932982923094,5,0.1472671372886569,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.19964131565257257,0.16554143959567294,6,0.06758200971586033,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.3355810714382311,0.19964131565257257,0.1472671372886569,0.06758200971586033,0.4354774201824906,1,0.48284820872688805,0.2672233253684329,0.5311330295995769,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_64,0.15912355384824953,0.15724671176545463,6,0.06419570125931068,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.3355810714382311,0.15912355384824953,0.1472671372886569,0.06419570125931068,0.3177313045542834,1,0.48284820872688805,0.2233192551075602,0.5311330295995769,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.055259975375008784,0.03708439420474778,6,0.015139640536976272,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.0719572437673552,0.055259975375008784,0.03117940200319188,0.015139640536976272,0.6474887828860159,1,0.10313664577054707,0.07039961591198506,0.11936198142059215,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_64,0.0719572437673552,0.06971926237693016,5,0.03117940200319188,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.05039856099759669,0.062453894003925786,6,0.02549669545991401,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.0719572437673552,0.05039856099759669,0.03117940200319188,0.02549669545991401,0.6066711995253845,1,0.10313664577054707,0.07589525645751069,0.11936198142059215,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_64,0.08223386774135706,0.06436530188362716,6,0.02627702445918125,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.0719572437673552,0.08223386774135706,0.03117940200319188,0.02627702445918125,0.8071212897765607,1,0.10313664577054707,0.1085108922005383,0.11936198142059215,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.09936909603895787,0.08850738085565614,6,0.03613298692775566,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.11989209063577588,0.09936909603895787,0.012176415866901739,0.03613298692775566,0.6094079031593715,1,0.13206850650267762,0.13550208296671354,0.17517900683206886,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_64,0.11989209063577588,0.029826005769838147,6,0.012176415866901739,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.06082870952976697,0.04325028944063278,6,0.017656856726205598,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,0.11989209063577588,0.06082870952976697,0.012176415866901739,0.017656856726205598,0.02261660635662778,0.5427985525590667,0.13206850650267762,0.07848556625597257,0.17517900683206886,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_64,0.11742994987238482,0.10244670627941141,6,0.04182369270222321,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.11989209063577588,0.11742994987238482,0.012176415866901739,0.04182369270222321,0.9568088957042631,1,0.13206850650267762,0.15925364257460803,0.17517900683206886,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.04436359827860836,0.05603406524036235,6,0.0228758113421185,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.019734374351902655,0.04436359827860836,0.008044236105344561,0.0228758113421185,0.3476610408189501,1,0.027778610457247215,0.06723940962072686,0.0935484291551649,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_64,0.019734374351902655,0.0197042738285676,6,0.008044236105344561,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.046627908253267236,0.041694453772695844,6,0.017021689474527642,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.019734374351902655,0.046627908253267236,0.008044236105344561,0.017021689474527642,0.19547757244772254,1,0.027778610457247215,0.06364959772779488,0.0935484291551649,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_64,0.062157051286240605,0.05606141104093767,6,0.02288697521845474,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.019734374351902655,0.062157051286240605,0.008044236105344561,0.02288697521845474,0.12919797159041638,1,0.027778610457247215,0.08504402650469535,0.0935484291551649,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.06055900108641269,0.0376297053317176,6,0.015362262872332623,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.10028375944185235,0.06055900108641269,0.023161759081011576,0.015362262872332623,0.18788303955627478,1,0.12344551852286392,0.07592126395874531,0.1801891048741978,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_64,0.10028375944185235,0.05673449129375298,6,0.023161759081011576,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.04981997835308897,0.020748914396525278,6,0.008470708831362481,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.10028375944185235,0.04981997835308897,0.023161759081011576,0.008470708831362481,0.08435602141919975,1,0.12344551852286392,0.05829068718445145,0.1801891048741978,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_64,0.12920731979553088,0.08475469015073192,6,0.03460095736283072,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.10028375944185235,0.12920731979553088,0.023161759081011576,0.03460095736283072,0.505336678642011,1,0.12344551852286392,0.1638082771583616,0.1801891048741978,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_64,0.03345343943333449,0.030019884150290513,6,0.01225556638427932,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.10237817266789799,0.03345343943333449,0.05215838352707608,0.01225556638427932,0.24934438687779886,1,0.15453655619497408,0.04570900581761381,0.1699902118144715,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_64,0.10237817266789799,0.12776142544972394,6,0.05215838352707608,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_64,0.05304725694094555,0.06101840524405072,6,0.024910659627714923,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.10237817266789799,0.05304725694094555,0.05215838352707608,0.024910659627714923,0.4210104677771842,1,0.15453655619497408,0.07795791656866047,0.1699902118144715,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_64,0.04841695825504518,0.048931202567907506,6,0.019976079798689227,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.10237817266789799,0.04841695825504518,0.05215838352707608,0.019976079798689227,0.3688672158411082,1,0.15453655619497408,0.06839303805373441,0.1699902118144715,0,24,0,5.0997489539748955,L-isoleucine,isoleucin_158_233_rt.5.21,5.126646341,5.12,0.02492387,5.33,5.11,0.22,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.15340446503182506,0.1443336407477799,6,0.058923962091706514,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.17660631985531722,0.15340446503182506,0.09924252794609757,0.058923962091706514,0.8466827266683119,1,0.2758488478014148,0.21232842712353156,0.30343373258155626,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_66,0.17660631985531722,0.22191303874639676,5,0.09924252794609757,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.12536017379894124,0.10212419204328972,6,0.041692026816676275,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.17660631985531722,0.12536017379894124,0.09924252794609757,0.041692026816676275,0.6526616767784994,1,0.2758488478014148,0.1670522006156175,0.30343373258155626,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_66,0.15741851001982363,0.13667658753280895,5,0.061123628131212214,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.17660631985531722,0.15741851001982363,0.09924252794609757,0.061123628131212214,0.8741294957143744,1,0.2758488478014148,0.21854213815103585,0.30343373258155626,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.16979826280462365,0.1780675508089122,6,0.07269577320482548,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.09085931561424883,0.16979826280462365,0.01806139492479125,0.07269577320482548,0.33517652964493955,1,0.10892071053904008,0.24249403600944913,0.26674343961039404,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_66,0.09085931561424883,0.04424120160863231,6,0.01806139492479125,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.12028992484604466,0.14373218135549234,6,0.05867841732302168,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.09085931561424883,0.12028992484604466,0.01806139492479125,0.05867841732302168,0.6488205147303818,1,0.10892071053904008,0.17896834216906635,0.26674343961039404,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_66,0.06888125490222315,0.0632488064216731,6,0.025821217095527847,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.09085931561424883,0.06888125490222315,0.01806139492479125,0.025821217095527847,0.5032269605522834,1,0.10892071053904008,0.09470247199775099,0.26674343961039404,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.1294141096779536,0.11391652051826648,6,0.04650622475717387,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.3051585100175737,0.1294141096779536,0.11654358308714469,0.04650622475717387,0.21739826421626926,1,0.4217020931047184,0.17592033443512747,0.4638723024151903,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_66,0.3051585100175737,0.2605993741242503,5,0.11654358308714469,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.20471350149173273,0.16299952805801185,6,0.06654427867609981,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.3051585100175737,0.20471350149173273,0.11654358308714469,0.06654427867609981,0.48045396644573213,1,0.4217020931047184,0.27125778016783253,0.4638723024151903,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_66,0.18948456155949436,0.17940599218684075,6,0.07324218960925091,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.3051585100175737,0.18948456155949436,0.11654358308714469,0.07324218960925091,0.42878102055517975,1,0.4217020931047184,0.2627267511687453,0.4638723024151903,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.064957130859625,0.061027647317300523,6,0.024914432688319495,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.06937549507196587,0.064957130859625,0.02883060152751059,0.024914432688319495,0.9104003393748841,1,0.09820609659947646,0.0898715635479445,0.19978999656510785,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_66,0.06937549507196587,0.06446718484772296,5,0.02883060152751059,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.11577706151118054,0.0869316043536516,6,0.03548967886465918,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.06937549507196587,0.11577706151118054,0.02883060152751059,0.03548967886465918,0.3369286681681486,1,0.09820609659947646,0.15126674037583973,0.19978999656510785,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_66,0.12052773144160533,0.14966269201915125,6,0.06109953816303814,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.06937549507196587,0.12052773144160533,0.02883060152751059,0.06109953816303814,0.4735471203128758,1,0.09820609659947646,0.18162726960464348,0.19978999656510785,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.11961918768957773,0.12679352601285157,6,0.051763240236632,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.13262178651108072,0.11961918768957773,0.016206753210097954,0.051763240236632,0.8185653681584593,1,0.14882853972117868,0.17138242792620972,0.22094041397042466,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_66,0.13262178651108072,0.03969827575195328,6,0.016206753210097954,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.09626495538283675,0.033815616881358576,6,0.013805167782795587,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.13262178651108072,0.09626495538283675,0.016206753210097954,0.013805167782795587,0.11925672766461283,1,0.14882853972117868,0.11007012316563233,0.22094041397042466,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_66,0.1705367407769387,0.07426407341450979,6,0.030318181014356443,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.13262178651108072,0.1705367407769387,0.016206753210097954,0.030318181014356443,0.3035951565079584,1,0.14882853972117868,0.20085492179129513,0.22094041397042466,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.11217726336180196,0.07489882048564778,6,0.03057731542102547,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.038769119218665736,0.11217726336180196,0.013766844057152441,0.03057731542102547,0.06505643074828339,1,0.05253596327581818,0.14275457878282743,0.15703003666111018,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_66,0.038769119218665736,0.033721743308490454,6,0.013766844057152441,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.08116523594514187,0.07593938571643925,6,0.031002124397612227,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.038769119218665736,0.08116523594514187,0.013766844057152441,0.031002124397612227,0.2520931054818865,1,0.05253596327581818,0.1121673603427541,0.15703003666111018,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_66,0.05136216399471135,0.04360489238147144,6,0.01780162277059644,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.038769119218665736,0.05136216399471135,0.013766844057152441,0.01780162277059644,0.5888329667846357,1,0.05253596327581818,0.0691637867653078,0.15703003666111018,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.10412892343977147,0.036256925408346324,6,0.014801827815433186,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.10104822576741035,0.10412892343977147,0.027248435757676683,0.014801827815433186,0.9233950315561733,1,0.12829666152508704,0.11893075125520465,0.1744173733300602,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_66,0.10104822576741035,0.0667447638953154,6,0.027248435757676683,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.048881622283497794,0.047224527002083,6,0.019279332416564925,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.10104822576741035,0.048881622283497794,0.027248435757676683,0.019279332416564925,0.15251371381327766,1,0.12829666152508704,0.06816095470006273,0.1744173733300602,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_66,0.12495207544359037,0.08232532462069798,6,0.03360917303828253,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.10104822576741035,0.12495207544359037,0.027248435757676683,0.03360917303828253,0.593268003054469,1,0.12829666152508704,0.1585612484818729,0.1744173733300602,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_66,0.021741890410754028,0.023567106566515,6,0.009621230966959429,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.09159955430481286,0.021741890410754028,0.04677226153427937,0.009621230966959429,0.19891234518260692,1,0.13837181583909222,0.03136312137771346,0.15220899742300145,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_66,0.09159955430481286,0.1145681748749895,6,0.04677226153427937,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_66,0.0647201769220281,0.06513920452818327,6,0.026592968890806746,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.09159955430481286,0.0647201769220281,0.04677226153427937,0.026592968890806746,0.6309381898193607,1,0.13837181583909222,0.09131314581283484,0.15220899742300145,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_66,0.09054823065028177,0.0602394499530581,6,0.024592652461819405,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.09159955430481286,0.09054823065028177,0.04677226153427937,0.024592652461819405,0.9846415637508928,1,0.13837181583909222,0.11514088311210117,0.15220899742300145,0,24,0,4.870774058577406,L-leucine,leucine_158_232_rt4.97,4.899207317,4.9,0.023418957,5.08,4.88,0.2,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.0800453535875963,0.07008414399987112,6,0.02861173197657059,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.11468590790554503,0.0800453535875963,0.0729473041990418,0.02861173197657059,0.67612670088832,1,0.18763321210458683,0.1086570855641669,0.2413397166973808,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_67,0.11468590790554503,0.16311513096441332,5,0.0729473041990418,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.08250036797420239,0.0743591305307848,6,0.03035698791957214,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.11468590790554503,0.08250036797420239,0.0729473041990418,0.03035698791957214,0.6994664388883375,1,0.18763321210458683,0.11285735589377453,0.2413397166973808,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_67,0.16124267309669255,0.13004316045100484,5,0.058157069355471804,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.11468590790554503,0.16124267309669255,0.0729473041990418,0.058157069355471804,0.6318336195373725,1,0.18763321210458683,0.21939974245216434,0.2413397166973808,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.12222620891413001,0.15673681378485418,6,0.06398753628041956,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.0900863552042123,0.12222620891413001,0.020951365166516526,0.06398753628041956,0.6498446600420071,1,0.11103772037072883,0.18621374519454958,0.20483511971400456,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_67,0.0900863552042123,0.051320154072686995,6,0.020951365166516526,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.10852928939528457,0.09125911589041107,6,0.03725637805150388,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.0900863552042123,0.10852928939528457,0.020951365166516526,0.03725637805150388,0.6776879614593279,1,0.11103772037072883,0.14578566744678845,0.20483511971400456,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_67,0.08503095128651794,0.14932794501883162,6,0.060962878272419745,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.0900863552042123,0.08503095128651794,0.020951365166516526,0.060962878272419745,0.939974728272692,1,0.11103772037072883,0.1459938295589377,0.20483511971400456,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.06905300095246798,0.08822019445087914,6,0.036015743568960985,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.23699118057274085,0.06905300095246798,0.08257622169387681,0.036015743568960985,0.11595122162116843,1,0.3195674022666177,0.10506874452142898,0.35152414249327946,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_67,0.23699118057274085,0.18464604503260137,5,0.08257622169387681,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.093099700667586,0.09031987013858656,6,0.03687293257899608,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.23699118057274085,0.093099700667586,0.08257622169387681,0.03687293257899608,0.16641638339688086,1,0.3195674022666177,0.12997263324658206,0.35152414249327946,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_67,0.05903694708886439,0.02878427771215821,6,0.011751132168225665,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.23699118057274085,0.05903694708886439,0.08257622169387681,0.011751132168225665,0.09712449739558299,1,0.3195674022666177,0.07078807925709005,0.35152414249327946,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.12067342435174318,0.10190913826451777,6,0.04160423147913483,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.13020431753143882,0.12067342435174318,0.05767341469646353,0.04160423147913483,0.8968647080037133,1,0.18787773222790236,0.162277655830878,0.20666550545069262,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_67,0.13020431753143882,0.12896167575582787,5,0.05767341469646353,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.07423194206802737,0.030620493526759374,6,0.0125007641354593,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.13020431753143882,0.07423194206802737,0.05767341469646353,0.0125007641354593,0.3922569088924323,1,0.18787773222790236,0.08673270620348666,0.20666550545069262,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_67,0.0848751117291165,0.08793329723891415,6,0.03589861827263743,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.13020431753143882,0.0848751117291165,0.05767341469646353,0.03589861827263743,0.5263616387691644,1,0.18787773222790236,0.12077373000175393,0.20666550545069262,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.13674766870511182,0.11191335889910188,6,0.0456884374506271,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.2029101707486557,0.13674766870511182,0.08871972078078359,0.0456884374506271,0.5272347972809577,1,0.2916298915294393,0.1824361061557389,0.32079288068238326,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_67,0.2029101707486557,0.21731804603511698,6,0.08871972078078359,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.14093639050559106,0.17831638102965947,6,0.07279735771706129,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.2029101707486557,0.14093639050559106,0.08871972078078359,0.07279735771706129,0.6014478168741116,1,0.2916298915294393,0.21373374822265234,0.32079288068238326,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_67,0.14379034268197363,0.11505357698096638,6,0.046970426114231995,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.2029101707486557,0.14379034268197363,0.08871972078078359,0.046970426114231995,0.5729980046288433,1,0.2916298915294393,0.19076076879620563,0.32079288068238326,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.09850660955919947,0.11483978614915263,6,0.04688314637262718,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.223751203901058,0.09850660955919947,0.08487227534003194,0.04688314637262718,0.23345469136535119,1,0.3086234792410899,0.14538975593182665,0.3611214908634145,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_67,0.223751203901058,0.2078937678920779,6,0.08487227534003194,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.24063158154431127,0.2147239435525183,6,0.08766068287697464,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.223751203901058,0.24063158154431127,0.08487227534003194,0.08766068287697464,0.8927155886854317,1,0.3086234792410899,0.3282922644212859,0.3611214908634145,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_67,0.08487711140986735,0.05564682922118574,6,0.02271772289928362,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.223751203901058,0.08487711140986735,0.08487227534003194,0.02271772289928362,0.16751424827276404,1,0.3086234792410899,0.10759483430915097,0.3611214908634145,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.4815734115900396,0.38414573186379003,6,0.1568268383223818,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.5345908063807713,0.4815734115900396,0.10224639316488608,0.1568268383223818,0.7837278547242968,1,0.6368371995456573,0.6384002499124214,0.7022402749036636,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_67,0.5345908063807713,0.2504514912939645,6,0.10224639316488608,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.2156543243051312,0.15313650125176825,6,0.06251771484365161,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.5345908063807713,0.2156543243051312,0.10224639316488608,0.06251771484365161,0.02790177102155946,0.669642504517427,0.6368371995456573,0.2781720391487828,0.7022402749036636,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_67,0.22073098285025483,0.2571399812031852,6,0.10497695773611024,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.5345908063807713,0.22073098285025483,0.10224639316488608,0.10497695773611024,0.05787991359219477,1,0.6368371995456573,0.3257079405863651,0.7022402749036636,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_67,0.2624992555693604,0.26505121457470765,6,0.10820670523549494,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.2515186189863339,0.2624992555693604,0.05505455574879765,0.10820670523549494,0.9303253404237999,1,0.3065731747351315,0.3707059608048553,0.6159271463343556,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_67,0.2515186189863339,0.13485556960016448,6,0.05505455574879765,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_67,0.4243009365609493,0.33223123281131106,6,0.13563283283391941,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.2515186189863339,0.4243009365609493,0.05505455574879765,0.13563283283391941,0.2786175830300138,1,0.3065731747351315,0.5599337693948687,0.6159271463343556,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_67,0.32130340231057253,0.14199505698175263,6,0.05796923926711933,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.2515186189863339,0.32130340231057253,0.05505455574879765,0.05796923926711933,0.40324724308625404,1,0.3065731747351315,0.37927264157769186,0.6159271463343556,0,24,0,9.99089770354906,L-lysine,lysine_156_174_rt10.07,9.989329268,9.99,0.024772117,10.08,9.73,0.35,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.09568305301260553,0.06563208107874596,6,0.026794184899983694,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.1829980328200948,0.09568305301260553,0.09115234083738316,0.026794184899983694,0.40285068031383,1,0.27415037365747796,0.12247723791258923,0.30156541102322576,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_74,0.1829980328200948,0.20382283042061886,5,0.09115234083738316,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.06065642139595092,0.04856121779469006,6,0.019825034147525542,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.1829980328200948,0.06065642139595092,0.09115234083738316,0.019825034147525542,0.254221138196679,1,0.27415037365747796,0.08048145554347647,0.30156541102322576,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_74,0.1209060487475587,0.15543233813380292,5,0.06951145479378322,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.1829980328200948,0.1209060487475587,0.09115234083738316,0.06951145479378322,0.6038123836174534,1,0.27415037365747796,0.1904175035413419,0.30156541102322576,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.12492703888726371,0.07611939042703297,6,0.031075611012987555,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.057340366146959885,0.12492703888726371,0.02537501938730938,0.031075611012987555,0.12418137277494423,1,0.08271538553426927,0.15600264990025126,0.1716029148902764,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_74,0.057340366146959885,0.06215584971213861,6,0.02537501938730938,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.06442141126979606,0.03918115638049336,6,0.015995640110733695,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.057340366146959885,0.06442141126979606,0.02537501938730938,0.015995640110733695,0.8190142455504552,1,0.08271538553426927,0.08041705138052975,0.1716029148902764,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_74,0.034529738586247305,0.0640873283364303,6,0.02616354223374396,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.057340366146959885,0.034529738586247305,0.02537501938730938,0.02616354223374396,0.5454456462247503,1,0.08271538553426927,0.060693280819991265,0.1716029148902764,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.021446279023116983,0.01919717498600078,6,0.007837213869770453,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.13642161824848792,0.021446279023116983,0.05447820979775522,0.007837213869770453,0.1021842795400224,1,0.19089982804624314,0.029283492892887435,0.2099898108508675,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_74,0.13642161824848792,0.12181698040027575,5,0.05447820979775522,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.07653652924879384,0.05838713457533575,6,0.02383644787546433,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.13642161824848792,0.07653652924879384,0.05447820979775522,0.02383644787546433,0.3560126325449076,1,0.19089982804624314,0.10037297712425816,0.2099898108508675,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_74,0.04730046790814705,0.06329472949546813,6,0.025839965111897515,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.13642161824848792,0.04730046790814705,0.05447820979775522,0.025839965111897515,0.19180001238302608,1,0.19089982804624314,0.07314043302004457,0.2099898108508675,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.020497702344637696,0.02190412611812434,6,0.008942322041829114,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.03971175781243712,0.020497702344637696,0.012444954892786167,0.008942322041829114,0.2471960064126303,1,0.052156712705223283,0.029440024386466812,0.1274920953153361,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_74,0.03971175781243712,0.02782776511718848,5,0.012444954892786167,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.0823145521996788,0.06481082705925449,6,0.026458909350489723,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.03971175781243712,0.0823145521996788,0.012444954892786167,0.026458909350489723,0.18829589534713423,1,0.052156712705223283,0.10877346155016852,0.1274920953153361,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_74,0.0801074025536858,0.08767826617906273,6,0.035794502278437904,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.03971175781243712,0.0801074025536858,0.012444954892786167,0.035794502278437904,0.3263737579821464,1,0.052156712705223283,0.1159019048321237,0.1274920953153361,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.07264072452835706,0.07340741846494599,6,0.029968453095679613,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.08102123797535572,0.07264072452835706,0.024691074617422818,0.029968453095679613,0.8336177465697686,1,0.10571231259277854,0.10260917762403667,0.23094178561184703,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_74,0.08102123797535572,0.06048053401367127,6,0.024691074617422818,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.028769066334347764,0.052759115752572985,6,0.02153881881237299,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.08102123797535572,0.028769066334347764,0.024691074617422818,0.02153881881237299,0.14241684124258963,1,0.10571231259277854,0.05030788514672076,0.23094178561184703,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_74,0.13956418670154802,0.17240216988400078,6,0.07038289112740381,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.08102123797535572,0.13956418670154802,0.024691074617422818,0.07038289112740381,0.4613971322259347,1,0.10571231259277854,0.20994707782895183,0.23094178561184703,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.020829993072548625,0.02292471090932776,6,0.00935897403811133,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.05041781856873473,0.020829993072548625,0.02189826228568773,0.00935897403811133,0.2553967746137883,1,0.07231608085442245,0.030188967110659954,0.10761708188437263,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_74,0.05041781856873473,0.0536395688535678,6,0.02189826228568773,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.08489069138151291,0.031703793315964623,6,0.012943019422462206,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.05041781856873473,0.08489069138151291,0.02189826228568773,0.012943019422462206,0.2118714690774729,1,0.07231608085442245,0.09783371080397511,0.10761708188437263,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_74,0.04105197918465383,0.03681176643377988,6,0.015028340715545653,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.05041781856873473,0.04105197918465383,0.02189826228568773,0.015028340715545653,0.7326052729062447,1,0.07231608085442245,0.05608031990019948,0.10761708188437263,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.03880354725389242,0.028310270516859706,6,0.01155761954107748,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.06797283289463414,0.03880354725389242,0.022946318299523573,0.01155761954107748,0.29174926669565343,1,0.09091915119415772,0.0503611667949699,0.10471286933148335,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_74,0.06797283289463414,0.056206771309320926,6,0.022946318299523573,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.0735258866747494,0.05307463963831178,6,0.021667630899326367,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.06797283289463414,0.0735258866747494,0.022946318299523573,0.021667630899326367,0.8638539147585964,1,0.09091915119415772,0.09519351757407576,0.10471286933148335,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_74,0.049605606906749346,0.04630877728773281,6,0.01890547916118869,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.06797283289463414,0.049605606906749346,0.022946318299523573,0.01890547916118869,0.5510281692378896,1,0.09091915119415772,0.06851108606793804,0.10471286933148335,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_74,0.024693271813822564,0.028577495251405783,6,0.011666713582125576,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.08108753873653285,0.024693271813822564,0.04740718806557209,0.011666713582125576,0.2949156564715565,1,0.12849472680210494,0.03635998539594814,0.14273258363955169,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_74,0.08108753873653285,0.11612342090081193,6,0.04740718806557209,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_74,0.10102451587763528,0.07037966602993594,6,0.02873237834013896,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.08108753873653285,0.10102451587763528,0.04740718806557209,0.02873237834013896,0.7281568942383592,1,0.12849472680210494,0.12975689421777425,0.14273258363955169,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_74,0.05990311286361183,0.08064950324365702,6,0.03292502182598276,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.08108753873653285,0.05990311286361183,0.04740718806557209,0.03292502182598276,0.722162061946015,1,0.12849472680210494,0.09282813468959458,0.14273258363955169,0,24,0,7.659707112970711,L-methionine,methionine_176_128_rt7.76,7.66347561,7.66,0.027055828,7.89,7.45,0.44,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.12048320019923131,0.10027822063373246,6,0.04093841214447935,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.15779102314103124,0.12048320019923131,0.12077360598182325,0.04093841214447935,0.7817962798975464,1,0.2785646291228545,0.16142161234371066,0.30642109203514,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_81,0.15779102314103124,0.27005799286313203,5,0.12077360598182325,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.05517166839737775,0.06693952581718743,6,0.02732794697932839,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.15779102314103124,0.05517166839737775,0.12077360598182325,0.02732794697932839,0.4497550156138029,1,0.2785646291228545,0.08249961537670614,0.30642109203514,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_81,0.16557432402680536,0.22442750981125573,5,0.10036703359179376,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.15779102314103124,0.16557432402680536,0.12077360598182325,0.10036703359179376,0.961724542007336,1,0.2785646291228545,0.2659413576185991,0.30642109203514,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.12709103727669083,0.20041821024396447,6,0.08182039170992558,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.12116204688758787,0.12709103727669083,0.037861037402360485,0.08182039170992558,0.949392489031796,1,0.15902308428994835,0.2089114289866164,0.22980257188527806,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_81,0.12116204688758787,0.09274022276821227,6,0.037861037402360485,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.13181701952158043,0.06369953868996352,6,0.026005227773514307,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.12116204688758787,0.13181701952158043,0.037861037402360485,0.026005227773514307,0.8218281657018164,1,0.15902308428994835,0.15782224729509473,0.22980257188527806,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_81,0.1448103895232482,0.11241617638533591,6,0.04589371182979748,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.12116204688758787,0.1448103895232482,0.037861037402360485,0.04589371182979748,0.6996601193232225,1,0.15902308428994835,0.1907041013530457,0.22980257188527806,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.07791342415022173,0.07433267021944819,6,0.030346185542703824,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.23817581914499622,0.07791342415022173,0.08556444664537607,0.030346185542703824,0.13771239017046924,1,0.3237402657903723,0.10825960969292556,0.35611429236940956,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_81,0.23817581914499622,0.19132791915621475,5,0.08556444664537607,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.1296973544484125,0.08245160620140192,6,0.033660727277721986,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.23817581914499622,0.1296973544484125,0.08556444664537607,0.033660727277721986,0.2889167625370364,1,0.3237402657903723,0.16335808172613447,0.35611429236940956,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_81,0.11538685683061733,0.08346192496140119,6,0.034073188184315255,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.23817581914499622,0.11538685683061733,0.08556444664537607,0.034073188184315255,0.23725092949164944,1,0.3237402657903723,0.1494600450149326,0.35611429236940956,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.08118521701535315,0.04644936246731496,6,0.018962872820417656,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.07815593812816166,0.08118521701535315,0.024997300848133324,0.018962872820417656,0.9255053188063785,1,0.10315323897629498,0.10014808983577081,0.2825240552017299,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_81,0.07815593812816166,0.05589566395043926,5,0.024997300848133324,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.045145480655478964,0.036541862338426497,6,0.014918152830028439,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.07815593812816166,0.045145480655478964,0.024997300848133324,0.014918152830028439,0.2958611102122239,1,0.10315323897629498,0.0600636334855074,0.2825240552017299,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_81,0.206481553016014,0.12335262227346518,6,0.050358497167376795,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.07815593812816166,0.206481553016014,0.024997300848133324,0.050358497167376795,0.05531262204167125,1,0.10315323897629498,0.2568400501833908,0.2825240552017299,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.04175296662888939,0.030423636222012822,6,0.012420397477331195,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.024778219267859836,0.04175296662888939,0.01192472611905764,0.012420397477331195,0.34749022123774975,1,0.03670294538691748,0.05417336410622058,0.08874637215051212,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_81,0.024778219267859836,0.029209494314130342,6,0.01192472611905764,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.023399271361698986,0.025695672911792193,6,0.010490214538557757,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.024778219267859836,0.023399271361698986,0.01192472611905764,0.010490214538557757,0.9325530814318315,1,0.03670294538691748,0.03388948590025674,0.08874637215051212,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_81,0.05637092442201815,0.05954120637514999,6,0.024307595714811045,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.024778219267859836,0.05637092442201815,0.01192472611905764,0.024307595714811045,0.28008913131053176,1,0.03670294538691748,0.08067852013682919,0.08874637215051212,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.02062048266711051,0.025817749400959114,6,0.010540052056565982,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.03914278161082918,0.02062048266711051,0.0076782876770799015,0.010540052056565982,0.18869192390650655,1,0.04682106928790908,0.031160534723676494,0.06794518277796599,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_81,0.03914278161082918,0.01880788690714569,6,0.0076782876770799015,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.03943023175345339,0.018412775279279824,6,0.007516984030461267,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.03914278161082918,0.03943023175345339,0.0076782876770799015,0.007516984030461267,0.9791846687650421,1,0.04682106928790908,0.04694721578391466,0.06794518277796599,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_81,0.04602477626226875,0.038563717437278294,6,0.01574357171770033,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.03914278161082918,0.04602477626226875,0.0076782876770799015,0.01574357171770033,0.7056933002756984,1,0.04682106928790908,0.06176834797996908,0.06794518277796599,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.054183268422457465,0.061719452785728435,6,0.025196861088138744,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.04441199507293544,0.054183268422457465,0.015218762356639654,0.025196861088138744,0.7482357737055727,1,0.05963075742957509,0.07938012951059621,0.08731814246165584,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_81,0.04441199507293544,0.037278202290443575,6,0.015218762356639654,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.04761867987872962,0.0368278668672626,6,0.015034913689990702,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.04441199507293544,0.04761867987872962,0.015218762356639654,0.015034913689990702,0.883828587782237,1,0.05963075742957509,0.06265359356872033,0.08731814246165584,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_81,0.024875085069699116,0.0162657551149912,6,0.006640466718798994,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.04441199507293544,0.024875085069699116,0.015218762356639654,0.006640466718798994,0.27868486691532957,1,0.05963075742957509,0.03151555178849811,0.08731814246165584,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_81,0.035491298819860795,0.025613730898898412,6,0.010456761851876703,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.07681302257466527,0.035491298819860795,0.03296268608977985,0.010456761851876703,0.2772353634839674,1,0.10977570866444511,0.0459480606717375,0.12075327953088963,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_81,0.07681302257466527,0.08074176147149748,6,0.03296268608977985,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_81,0.07483195007446031,0.07577236205936283,6,0.030933937275143753,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.07681302257466527,0.07483195007446031,0.03296268608977985,0.030933937275143753,0.9659103277445072,1,0.10977570866444511,0.10576588734960406,0.12075327953088963,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_81,0.03984741132631816,0.036219547042592615,6,0.014786568161513901,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.07681302257466527,0.03984741132631816,0.03296268608977985,0.014786568161513901,0.34057605919399603,1,0.10977570866444511,0.05463397948783206,0.12075327953088963,0,24,0,8.581820083682008,L-phenylalanine,phenylalanine_192_266_rt8.69,8.588841463,8.59,0.008819902,8.66,8.53,0.13,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,0.16082342539081074,0.25676974955809206,6,0.10482581129992534,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.41956339750584953,0.16082342539081074,0.25427811020424934,0.10482581129992534,0.3873337611537862,1,0.6738415077100989,0.2656492366907361,0.7412256584811088,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_84,0.41956339750584953,0.5685831396068844,5,0.25427811020424934,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,0.1671789694436432,0.13878294062117302,6,0.056657898254141706,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.41956339750584953,0.1671789694436432,0.25427811020424934,0.056657898254141706,0.3828517969583416,1,0.6738415077100989,0.22383686769778488,0.7412256584811088,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_84,0.21932190163205156,0.19816260521670506,5,0.08862101117260139,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.41956339750584953,0.21932190163205156,0.25427811020424934,0.08862101117260139,0.4908226725166804,1,0.6738415077100989,0.30794291280465297,0.7412256584811088,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,0.3017132980752985,0.27051945376853165,6,0.11043910453822108,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.1273347533495849,0.3017132980752985,0.0457075746165641,0.11043910453822108,0.1900483002238536,1,0.17304232796614902,0.4121524026135196,0.47182307005108143,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_84,0.1273347533495849,0.1119602351907705,6,0.0457075746165641,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,0.3131676541030562,0.28355883486545075,6,0.11576240957974511,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.1273347533495849,0.3131676541030562,0.0457075746165641,0.11576240957974511,0.1821203679069578,1,0.17304232796614902,0.4289300636828013,0.47182307005108143,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_84,0.14321018004268327,0.1494454497176801,6,0.061010849364846104,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.1273347533495849,0.14321018004268327,0.0457075746165641,0.061010849364846104,0.8395399263382399,1,0.17304232796614902,0.20422102940752937,0.47182307005108143,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,0.1356699655672494,0.13847699974118569,6,0.056532998412903865,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.2961363323377147,0.1356699655672494,0.09051353579269711,0.056532998412903865,0.17704770146307997,1,0.3866498681304118,0.19220296398015324,0.425314854943453,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_84,0.2961363323377147,0.20239441891633106,5,0.09051353579269711,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,0.17800860211613748,0.1922202950236336,6,0.07847360683585783,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.2961363323377147,0.17800860211613748,0.09051353579269711,0.07847360683585783,0.3514744927701282,1,0.3866498681304118,0.2564822089519953,0.425314854943453,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_84,0.19355566970111782,0.0952165279970233,6,0.03887198477868932,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.2961363323377147,0.19355566970111782,0.09051353579269711,0.03887198477868932,0.3415893718531562,1,0.3866498681304118,0.23242765447980712,0.425314854943453,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,0.08087030399150841,0.10930149201158285,6,0.04462214725887828,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,*,0.48045431065025423,0.08087030399150841,0.14186513214909358,0.04462214725887828,0.045388001315690533,1,0.6223194427993478,0.1254924512503867,0.6845513870792826,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_84,0.48045431065025423,0.31722007912236405,5,0.14186513214909358,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,0.18331145633456,0.18161494689872013,6,0.07414399159408776,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.48045431065025423,0.18331145633456,0.14186513214909358,0.07414399159408776,0.11185116602339437,1,0.6223194427993478,0.2574554479286478,0.6845513870792826,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_84,0.4323054844173908,0.35050733577468235,6,0.1430940206250573,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.48045431065025423,0.4323054844173908,0.14186513214909358,0.1430940206250573,0.8165497082144897,1,0.6223194427993478,0.5753995050424481,0.6845513870792826,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,0.07917591797693246,0.11561446001065588,6,0.04719940565225292,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.16295815741145758,0.07917591797693246,0.060086614001710954,0.04719940565225292,0.2999577412260673,1,0.22304477141316853,0.12637532362918538,0.2831799171453731,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_84,0.16295815741145758,0.14718154467576305,6,0.060086614001710954,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,0.20706784548569482,0.12337698406783447,6,0.05036844282828069,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.16295815741145758,0.20706784548569482,0.060086614001710954,0.05036844282828069,0.58647720763275,1,0.22304477141316853,0.2574362883139755,0.2831799171453731,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_84,0.10030458516079103,0.0935869920992172,6,0.03820672953416048,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.16295815741145758,0.10030458516079103,0.060086614001710954,0.03820672953416048,0.4031711294644734,1,0.22304477141316853,0.1385113146949515,0.2831799171453731,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,0.19862080922575828,0.11045560946706603,6,0.045093313737073794,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.41035341537363274,0.19862080922575828,0.08977095673542859,0.045093313737073794,0.07105398489449402,1,0.5001243721090614,0.24371412296283207,0.5501368093199676,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_84,0.41035341537363274,0.21989303772326477,6,0.08977095673542859,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,0.19939470757938796,0.27787040456302453,6,0.11344011763335678,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.41035341537363274,0.19939470757938796,0.08977095673542859,0.11344011763335678,0.17702419879618686,1,0.5001243721090614,0.31283482521274475,0.5501368093199676,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_84,0.3149337786024871,0.24994215794247404,6,0.10203845869486387,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.41035341537363274,0.3149337786024871,0.08977095673542859,0.10203845869486387,0.49888912742287894,1,0.5001243721090614,0.416972237297351,0.5501368093199676,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,0.059338422987487816,0.05532730330683936,6,0.022587276990992805,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.08159167142636174,0.059338422987487816,0.029035410156919367,0.022587276990992805,0.5594993814417231,1,0.1106270815832811,0.08192569997848062,0.1295961276667225,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_84,0.08159167142636174,0.0711219393568765,6,0.029035410156919367,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,0.10033925504742469,0.042805828893787964,6,0.01747540646777757,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.08159167142636174,0.10033925504742469,0.029035410156919367,0.01747540646777757,0.594872871758285,1,0.1106270815832811,0.11781466151520226,0.1295961276667225,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_84,0.04786816800658622,0.06418585615783307,6,0.026203766048394767,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.08159167142636174,0.04786816800658622,0.029035410156919367,0.026203766048394767,0.40896019532326866,1,0.1106270815832811,0.07407193405498098,0.1295961276667225,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_84,0.07562709638706473,0.07239561694091735,6,0.029555386853206193,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.06382470604568329,0.07562709638706473,0.025608858777094026,0.029555386853206193,0.7691110306719287,1,0.08943356482277731,0.10518248324027092,0.11570073156429803,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_84,0.06382470604568329,0.06272863689887477,6,0.025608858777094026,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_84,0.03877080558816829,0.058446033429448555,6,0.023860493231966165,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.06382470604568329,0.03877080558816829,0.025608858777094026,0.023860493231966165,0.49057948698886233,1,0.08943356482277731,0.06263129882013446,0.11570073156429803,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_84,0.06983209162378934,0.08047149473508851,6,0.032852350156671636,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.06382470604568329,0.06983209162378934,0.025608858777094026,0.032852350156671636,0.88835988113161,1,0.08943356482277731,0.10268444178046097,0.11570073156429803,0,24,0,5.428870292887029,L-proline,proline_142_130_rt.5.53,5.438902439,5.44,0.027736981,5.45,5.23,0.22,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.131743623602542,0.09782444177316414,6,0.039936661119475976,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.22214888704403765,0.131743623602542,0.17040344710008412,0.039936661119475976,0.6301470969701621,1,0.3925523341441218,0.17168028472201796,0.43225896401471564,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_98,0.22214888704403765,0.3810336913160775,5,0.17040344710008412,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,0.08327158947783597,0.04823614766106219,6,0.019692324821191105,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.22214888704403765,0.08327158947783597,0.17040344710008412,0.019692324821191105,0.462468532804963,1,0.3925523341441218,0.10296391429902707,0.43225896401471564,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_98,0.2569470033916274,0.30414033145648806,5,0.13601569116720497,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.22214888704403765,0.2569470033916274,0.17040344710008412,0.13601569116720497,0.877341070403103,1,0.3925523341441218,0.39296269455883237,0.43225896401471564,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.16957337095070354,0.22906983274423745,6,0.09351736761467798,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.09450274084849886,0.16957337095070354,0.0445250858918891,0.09351736761467798,0.4915954046291201,1,0.13902782674038797,0.2630907385653815,0.2893998124219197,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_98,0.09450274084849886,0.10906374118872234,6,0.0445250858918891,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,0.17911228727670717,0.11395087335715903,6,0.04652024924492434,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.09450274084849886,0.17911228727670717,0.0445250858918891,0.04652024924492434,0.2182666560505553,1,0.13902782674038797,0.2256325365216315,0.2893998124219197,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_98,0.07417992637129693,0.05551080023939141,6,0.022662189300012542,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.09450274084849886,0.07417992637129693,0.0445250858918891,0.022662189300012542,0.6956392352438114,1,0.13902782674038797,0.09684211567130947,0.2893998124219197,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.06610637781003481,0.050369026626255906,6,0.020563069012497773,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.30951268483994354,0.06610637781003481,0.093056491227176,0.020563069012497773,0.05762518160720739,1,0.40256917606711956,0.08666944682253258,0.4428260936738316,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_98,0.30951268483994354,0.20808064013157837,5,0.093056491227176,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,0.11196185895765572,0.12457381897678285,6,0.05085704863382634,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.30951268483994354,0.11196185895765572,0.093056491227176,0.05085704863382634,0.109470058930265,1,0.40256917606711956,0.16281890759148204,0.4428260936738316,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_98,0.1256684099127127,0.09702610235656024,6,0.039610740417437514,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.30951268483994354,0.1256684099127127,0.093056491227176,0.039610740417437514,0.12405642290242828,1,0.40256917606711956,0.1652791503301502,0.4428260936738316,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.144735507645627,0.06180175111539885,6,0.025230459240534724,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.14425978433728331,0.144735507645627,0.059868063742448324,0.025230459240534724,0.9944199605839299,1,0.20412784807973164,0.16996596688616172,0.3092767810945638,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_98,0.14425978433728331,0.13386906020940492,5,0.059868063742448324,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,0.1298816076948394,0.0956169225481972,6,0.03903544516971711,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.14425978433728331,0.1298816076948394,0.059868063742448324,0.03903544516971711,0.8462033784320316,1,0.20412784807973164,0.1689170528645565,0.3092767810945638,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_98,0.22287239849310225,0.14277662137087213,6,0.0582883115928648,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.14425978433728331,0.22287239849310225,0.059868063742448324,0.0582883115928648,0.3718153882637709,1,0.20412784807973164,0.28116071008596705,0.3092767810945638,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.14628559766384072,0.11705581569424528,6,0.04778783664602867,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.11403902219404127,0.14628559766384072,0.02577172802867924,0.04778783664602867,0.5696354511201944,1,0.13981075022272052,0.1940734343098694,0.21348077774085636,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_98,0.11403902219404127,0.06312758346004753,6,0.02577172802867924,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,0.08403452213021219,0.059488977844760475,6,0.02428627350656609,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.11403902219404127,0.08403452213021219,0.02577172802867924,0.02428627350656609,0.41671398607438737,1,0.13981075022272052,0.10832079563677828,0.21348077774085636,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_98,0.13402049008526631,0.12683491889348644,6,0.051780138809388566,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.11403902219404127,0.13402049008526631,0.02577172802867924,0.051780138809388566,0.7394418771385459,1,0.13981075022272052,0.18580062889465487,0.21348077774085636,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.0688713897380917,0.08146007465614348,6,0.03325593621942923,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.15675623985337758,0.0688713897380917,0.04723943274589003,0.03325593621942923,0.16260081031006354,1,0.2039956725992676,0.10212732595752094,0.22439523985919438,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_98,0.15675623985337758,0.1157125059659534,6,0.04723943274589003,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,0.06554903543597253,0.07527505464945267,6,0.030730912375212915,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.15675623985337758,0.06554903543597253,0.04723943274589003,0.030730912375212915,0.14163779390208794,1,0.2039956725992676,0.09627994781118544,0.22439523985919438,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_98,0.10004300349455002,0.08407366536317991,6,0.03432293015754909,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.15675623985337758,0.10004300349455002,0.04723943274589003,0.03432293015754909,0.356454154472745,1,0.2039956725992676,0.13436593365209912,0.22439523985919438,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.08128650326792952,0.10139833162841005,6,0.04139569554318626,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.05941213939322395,0.08128650326792952,0.01702564453179223,0.04139569554318626,0.6407673563795193,1,0.07643778392501618,0.12268219881111578,0.13495041869222738,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_98,0.05941213939322395,0.04170414164489757,6,0.01702564453179223,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,0.06258448537845303,0.049205605861603295,6,0.020088104474238186,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.05941213939322395,0.06258448537845303,0.01702564453179223,0.020088104474238186,0.9065582638891825,1,0.07643778392501618,0.08267258985269121,0.13495041869222738,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_98,0.09063396725172772,0.047735278823787176,6,0.01948784597462696,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.05941213939322395,0.09063396725172772,0.01702564453179223,0.01948784597462696,0.25587020586425724,1,0.07643778392501618,0.11012181322635467,0.13495041869222738,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_98,0.02967770932898084,0.01675370580768304,6,0.006839671754921095,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.046502982914736236,0.02967770932898084,0.020446170086326754,0.006839671754921095,0.46432934843090423,1,0.066949153001063,0.036517381083901936,0.1469479443061692,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_98,0.046502982914736236,0.05008268390565763,6,0.020446170086326754,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_98,0.09926785323767866,0.08406939561623218,6,0.034321187040656974,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.046502982914736236,0.09926785323767866,0.020446170086326754,0.034321187040656974,0.22244712644001688,1,0.066949153001063,0.13358904027833562,0.1469479443061692,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_98,0.051084771677912144,0.036368128270617445,6,0.01484722619385006,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.046502982914736236,0.051084771677912144,0.020446170086326754,0.01484722619385006,0.8600753649904072,1,0.066949153001063,0.06593199787176221,0.1469479443061692,0,24,0,5.737071129707113,L-serine,serine_204_218_rt5.84,5.749817073,5.75,0.026848189,5.76,5.55,0.21,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,0.14106316522348342,0.12170422700357786,6,0.04968554261643658,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.292425575577692,0.14106316522348342,0.14875674665179478,0.04968554261643658,0.3797277934306474,1,0.4411823222294868,0.19074870783991998,0.4853005544524355,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_107,0.292425575577692,0.3326301976251274,5,0.14875674665179478,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,0.09355963629880797,0.03922951239704183,6,0.01601538137182325,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.292425575577692,0.09355963629880797,0.14875674665179478,0.01601538137182325,0.25304540965622985,1,0.4411823222294868,0.10957501767063121,0.4853005544524355,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_107,0.17399808296911612,0.22725642128886475,5,0.10163216126504639,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.292425575577692,0.17399808296911612,0.14875674665179478,0.10163216126504639,0.5317790810840864,1,0.4411823222294868,0.2756302442341625,0.4853005544524355,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,0.11679696044855008,0.1730540580127786,6,0.07064902334155104,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.07882412851141729,0.11679696044855008,0.016597552194195904,0.07064902334155104,0.6210249868334753,1,0.09542168070561319,0.18744598379010113,0.20619058216911126,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_107,0.07882412851141729,0.040655533854991294,6,0.016597552194195904,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,0.12451045726234027,0.059770958303687845,6,0.024401391546867403,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.07882412851141729,0.12451045726234027,0.016597552194195904,0.024401391546867403,0.1567242709922057,1,0.09542168070561319,0.14891184880920766,0.20619058216911126,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_107,0.10816308205746454,0.08977473921615604,6,0.03665038381183483,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.07882412851141729,0.10816308205746454,0.016597552194195904,0.03665038381183483,0.4896476480312477,1,0.09542168070561319,0.14481346586929938,0.20619058216911126,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,0.06467401500603505,0.04559284284470033,6,0.01861320014873648,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.25338365296545096,0.06467401500603505,0.1029705512867857,0.01861320014873648,0.14123601815834003,1,0.35635420425223663,0.08328721515477153,0.39198962467746035,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_107,0.25338365296545096,0.2302491523578813,5,0.1029705512867857,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,0.10298746313979328,0.10672169549916502,6,0.04356894974293907,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.25338365296545096,0.10298746313979328,0.1029705512867857,0.04356894974293907,0.23211519875026662,1,0.35635420425223663,0.14655641288273236,0.39198962467746035,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_107,0.10465753101964885,0.09808221694460525,6,0.04004189739254084,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.25338365296545096,0.10465753101964885,0.1029705512867857,0.04004189739254084,0.23389804305786072,1,0.35635420425223663,0.1446994284121897,0.39198962467746035,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,0.05214340934995095,0.057529069616055376,6,0.023486144322731172,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.07693904464242296,0.05214340934995095,0.03399201912538455,0.023486144322731172,0.566369151594934,1,0.11093106376780751,0.07562955367268212,0.1968149914009206,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_107,0.07693904464242296,0.0760084654568328,5,0.03399201912538455,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,0.12289288505165419,0.09487862174338312,6,0.03873403512830366,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.07693904464242296,0.12289288505165419,0.03399201912538455,0.03873403512830366,0.39576868158645184,1,0.11093106376780751,0.16162692017995783,0.1968149914009206,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_107,0.12218810121995578,0.13897086542839682,6,0.05673461823542657,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.07693904464242296,0.12218810121995578,0.03399201912538455,0.05673461823542657,0.5133134444371951,1,0.11093106376780751,0.17892271945538235,0.1968149914009206,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,0.03287516747114183,0.023966770834800564,6,0.009784393221246503,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.051119788548870414,0.03287516747114183,0.02114165079277304,0.009784393221246503,0.45903326980466885,1,0.07226143934164345,0.04265956069238833,0.13212152211534284,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_107,0.051119788548870414,0.0517862567624014,6,0.02114165079277304,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,0.02982992666890098,0.029840336640787914,6,0.01218226642046784,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.051119788548870414,0.02982992666890098,0.02114165079277304,0.01218226642046784,0.408375609629096,1,0.07226143934164345,0.04201219308936882,0.13212152211534284,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_107,0.09351800185380761,0.06513798935027734,6,0.026592472796504042,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.051119788548870414,0.09351800185380761,0.02114165079277304,0.026592472796504042,0.24185835913532988,1,0.07226143934164345,0.12011047465031166,0.13212152211534284,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,0.05064730888764942,0.04305710746171402,6,0.01757799051356359,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,0.15211481265719895,0.05064730888764942,0.023867365966673923,0.01757799051356359,0.007359935517509725,0.16927851690272366,0.1759821786238729,0.06822529940121301,0.1935803964862602,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_107,0.15211481265719895,0.05846286812262008,6,0.023867365966673923,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,0.03584125401342194,0.04181560226994515,6,0.017071148141421938,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,0.15211481265719895,0.03584125401342194,0.023867365966673923,0.017071148141421938,0.003252968217965779,0.07807123723117869,0.1759821786238729,0.05291240215484388,0.1935803964862602,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_107,0.06207292751399174,0.06932330185231551,6,0.02830111947051816,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,0.15211481265719895,0.06207292751399174,0.023867365966673923,0.02830111947051816,0.035964962280135834,0.7912291701629883,0.1759821786238729,0.0903740469845099,0.1935803964862602,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,0.049357019440770866,0.053266377209215676,6,0.021745907434865576,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.02731670116165789,0.049357019440770866,0.00856935536903241,0.021745907434865576,0.3793341401711689,1,0.0358860565306903,0.07110292687563644,0.10127956009343901,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_107,0.02731670116165789,0.020990548078708843,6,0.00856935536903241,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,0.06864728087134438,0.057379411092478176,6,0.023425046486327435,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.02731670116165789,0.06864728087134438,0.00856935536903241,0.023425046486327435,0.14612808729429502,1,0.0358860565306903,0.09207232735767182,0.10127956009343901,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_107,0.05250073678546167,0.032021309509069534,6,0.01307264486549188,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.02731670116165789,0.05250073678546167,0.00856935536903241,0.01307264486549188,0.14306089843752803,1,0.0358860565306903,0.06557338165095354,0.10127956009343901,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_107,0.04096099025764044,0.06025471522353644,6,0.024598884482395656,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.05158394687196669,0.04096099025764044,0.01701571822191706,0.024598884482395656,0.7307485002569819,1,0.06859966509388375,0.06555987474003609,0.09094849707666551,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_107,0.05158394687196669,0.04167982725067465,6,0.01701571822191706,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_107,0.06115533107360497,0.052725562646729826,6,0.021525120814272766,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.05158394687196669,0.06115533107360497,0.01701571822191706,0.021525120814272766,0.7348273328433202,1,0.06859966509388375,0.08268045188787773,0.09094849707666551,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_107,0.035395728672674785,0.02800805004787717,6,0.011434238551272173,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.05158394687196669,0.035395728672674785,0.01701571822191706,0.011434238551272173,0.45060088789952657,1,0.06859966509388375,0.04682996722394696,0.09094849707666551,0,24,0,5.902238493723849,L-threonine,threonine_219_291_rt6.01,5.914390244,5.92,0.035931003,5.92,5.65,0.27,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.07848664590636252,0.08582273455890158,6,0.035036984666605465,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.19753901161469703,0.07848664590636252,0.12850372876001462,0.035036984666605465,0.4157592022039079,1,0.32604274037471165,0.11352363057296799,0.35864701441218283,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_110,0.19753901161469703,0.2873430728695875,5,0.12850372876001462,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.07838951704192147,0.03633237643515362,6,0.01483263056814101,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.19753901161469703,0.07838951704192147,0.12850372876001462,0.01483263056814101,0.40786280717166357,1,0.32604274037471165,0.09322214761006248,0.35864701441218283,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_110,0.09159796418547232,0.10974238666431857,5,0.04907828731889654,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.19753901161469703,0.09159796418547232,0.12850372876001462,0.04907828731889654,0.4750782864444582,1,0.32604274037471165,0.14067625150436885,0.35864701441218283,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.10888680230915597,0.1074874651230309,6,0.04388157388277147,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.092496794051914355,0.10888680230915597,0.028098789606524337,0.04388157388277147,0.7606809353582034,1,0.1205955836584387,0.15276837619192743,0.1680452138111202,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_110,0.092496794051914355,0.06882769692580393,6,0.028098789606524337,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.03443336666628446,0.033176506047515604,6,0.01354425187746226,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.092496794051914355,0.03443336666628446,0.028098789606524337,0.01354425187746226,0.10379231419199167,1,0.1205955836584387,0.047977618543746714,0.1680452138111202,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_110,0.10450495303308993,0.10371626866032273,6,0.04234198937386749,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.092496794051914355,0.10450495303308993,0.028098789606524337,0.04234198937386749,0.8186752087669038,1,0.1205955836584387,0.14684694240695742,0.1680452138111202,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.09418600874209575,0.05331488341793701,6,0.021765710011652947,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1419260822068476,0.09418600874209575,0.053899333620181816,0.021765710011652947,0.44684964098480323,1,0.19582541582702942,0.1159517187537487,0.21540795740973237,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_110,0.1419260822068476,0.12052257391666638,5,0.053899333620181816,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.09968319083714598,0.03716771321584256,6,0.015173655380818853,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1419260822068476,0.09968319083714598,0.053899333620181816,0.015173655380818853,0.48712798619052555,1,0.19582541582702942,0.11485684621796484,0.21540795740973237,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_110,0.05165751134916766,0.04078552736883823,6,0.016650621823995307,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1419260822068476,0.05165751134916766,0.053899333620181816,0.016650621823995307,0.17332230980643532,1,0.19582541582702942,0.06830813317316298,0.21540795740973237,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.028216220624721622,0.020011784285664372,6,0.00816977672375408,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,*,0.1503236334751487,0.028216220624721622,0.04309723981485633,0.00816977672375408,0.045903207913099216,1,0.19342087329000504,0.0363859973484757,0.22833370642251924,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_110,0.1503236334751487,0.09636835786862921,5,0.04309723981485633,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.05240472577570632,0.046503435528508844,6,0.018984948055210206,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1503236334751487,0.05240472577570632,0.04309723981485633,0.018984948055210206,0.08672784082764716,1,0.19342087329000504,0.07138967383091652,0.22833370642251924,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_110,0.1597762452683952,0.11708524590522602,6,0.047799851479349544,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1503236334751487,0.1597762452683952,0.04309723981485633,0.047799851479349544,0.8864713227856605,1,0.19342087329000504,0.20757609674774474,0.22833370642251924,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.11753404172838515,0.10462897739041149,6,0.04271460115261767,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.11740413001918881,0.11753404172838515,0.031789134906404615,0.04271460115261767,0.9981051492470407,1,0.14919326492559343,0.16024864288100282,0.20352734582328308,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_110,0.11740413001918881,0.07786715988518879,6,0.031789134906404615,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.12557008593376687,0.1456338588412145,6,0.05945477390558136,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.11740413001918881,0.12557008593376687,0.031789134906404615,0.05945477390558136,0.9067185939112581,1,0.14919326492559343,0.18502485983934824,0.20352734582328308,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_110,0.11878548633942887,0.11412305280006724,6,0.046590541208144626,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.11740413001918881,0.11878548633942887,0.031789134906404615,0.046590541208144626,0.9810056382026653,1,0.14919326492559343,0.1653760275475735,0.20352734582328308,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.054604226158506096,0.048362162741780075,6,0.019743770262466848,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.04529628429102931,0.054604226158506096,0.012012889557369087,0.019743770262466848,0.6973628183574536,1,0.0573091738483984,0.07434799642097295,0.12435502707461372,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_110,0.04529628429102931,0.02942544975196273,6,0.012012889557369087,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.08450687233764424,0.06991615872588085,6,0.028543152275640957,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.04529628429102931,0.08450687233764424,0.012012889557369087,0.028543152275640957,0.24759329387356865,1,0.0573091738483984,0.1130500246132852,0.12435502707461372,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_110,0.06438217956058989,0.04386334036109013,6,0.01790713371644961,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.04529628429102931,0.06438217956058989,0.012012889557369087,0.01790713371644961,0.3997859209181731,1,0.0573091738483984,0.0822893132770395,0.12435502707461372,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.1833612941588557,0.10774499902662163,6,0.04398671165864887,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.15515886272204785,0.1833612941588557,0.03491730749019848,0.04398671165864887,0.6269679313777703,1,0.19007617021224632,0.22734800581750456,0.29586969358609216,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_110,0.15515886272204785,0.08552958654284741,6,0.03491730749019848,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.11395335933780874,0.1288758268799551,6,0.05261333600585844,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.15515886272204785,0.11395335933780874,0.03491730749019848,0.05261333600585844,0.5309314920379935,1,0.19007617021224632,0.1665666953436672,0.29586969358609216,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_110,0.23570845369641077,0.08147981460111677,6,0.033263995018218424,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.15515886272204785,0.23570845369641077,0.03491730749019848,0.033263995018218424,0.12589358709327003,1,0.19007617021224632,0.2689724487146292,0.29586969358609216,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_110,0.07196179914858192,0.045402426932010236,6,0.018535463177903635,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.1155800231850151,0.07196179914858192,0.03955377979761177,0.018535463177903635,0.3508416773630198,1,0.15513380298262688,0.09049726232648556,0.1706471832808896,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_110,0.1155800231850151,0.09688657790255452,6,0.03955377979761177,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_110,0.07681887836997259,0.04944908737557475,6,0.020187505386076582,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.1155800231850151,0.07681887836997259,0.03955377979761177,0.020187505386076582,0.4100320357575462,1,0.15513380298262688,0.09700638375604917,0.1706471832808896,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_110,0.05150476022224493,0.03013651292853255,6,0.01230317988361552,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.1155800231850151,0.05150476022224493,0.03955377979761177,0.01230317988361552,0.1732022095919594,1,0.15513380298262688,0.06380794010586045,0.1706471832808896,0,24,0,12.811029411764704,L-tryptophan,tryptophan_202_291_rt12.94,12.81395062,12.81,0.005270099,12.82,12.79,0.03,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,0.1813988269621473,0.09800061084953017,6,0.040008581843735,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.2646315883326971,0.1813988269621473,0.10869827745244307,0.040008581843735,0.5040627486325713,1,0.37332986578514016,0.22140740880588228,0.4106628523636542,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_112,0.2646315883326971,0.24305673742079537,5,0.10869827745244307,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,0.170422161408834,0.19727068479301113,6,0.08053541982538238,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.2646315883326971,0.170422161408834,0.10869827745244307,0.08053541982538238,0.5065720029514984,1,0.37332986578514016,0.2509575812342164,0.4106628523636542,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_112,0.05715946319585532,0.06613055772935077,5,0.029574484494560488,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.2646315883326971,0.05715946319585532,0.10869827745244307,0.029574484494560488,0.1300735328003487,1,0.37332986578514016,0.08673394769041581,0.4106628523636542,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,0.1865267793356454,0.15446510228286459,6,0.06306011394330521,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.09991544939923387,0.1865267793356454,0.04121655814721463,0.06306011394330521,0.28119768646925325,1,0.1411320075464485,0.24958689327895062,0.2745455826068457,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_112,0.09991544939923387,0.10095953641442866,6,0.04121655814721463,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,0.11539838447507826,0.14273803326829843,6,0.058272558065956846,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.09991544939923387,0.11539838447507826,0.04121655814721463,0.058272558065956846,0.8331062825527316,1,0.1411320075464485,0.1736709425410351,0.2745455826068457,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_112,0.09685179315170012,0.09560484961624315,6,0.03903051641588598,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.09991544939923387,0.09685179315170012,0.04121655814721463,0.03903051641588598,0.958023968287955,1,0.1411320075464485,0.1358823095675861,0.2745455826068457,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,0.18826829969941752,0.09794980724432097,6,0.03998784135875894,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.20924120710877378,0.18826829969941752,0.07475462166680434,0.03998784135875894,0.8125860889600427,1,0.2839958287755781,0.22825614105817646,0.34131678778756896,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_112,0.20924120710877378,0.16715641567925316,5,0.07475462166680434,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,0.261536989366113,0.11941507330327025,6,0.04875099953167697,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.20924120710877378,0.261536989366113,0.07475462166680434,0.04875099953167697,0.5760439992882596,1,0.2839958287755781,0.31028798889778997,0.34131678778756896,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_112,0.1628229193863376,0.1320877924044664,6,0.05392461544026904,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.20924120710877378,0.1628229193863376,0.07475462166680434,0.05392461544026904,0.6288167574289987,1,0.2839958287755781,0.21674753482660664,0.34131678778756896,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,0.2196020893372516,0.22181264758478741,6,0.09055463417975278,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.11853597668340185,0.2196020893372516,0.041172778717853985,0.09055463417975278,0.3438713473111383,1,0.15970875540125584,0.31015672351700435,0.3411723958687048,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_112,0.11853597668340185,0.09206513203567815,5,0.041172778717853985,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,0.06524522275919664,0.04256193404675125,6,0.017375836813421888,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.11853597668340185,0.06524522275919664,0.041172778717853985,0.017375836813421888,0.28270142764832645,1,0.15970875540125584,0.08262105957261853,0.3411723958687048,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_112,0.23522936899023397,0.16582772561671053,6,0.06769888549453262,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.11853597668340185,0.23522936899023397,0.041172778717853985,0.06769888549453262,0.17898376436502555,1,0.15970875540125584,0.30292825448476657,0.3411723958687048,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,0.3427437407096448,0.559173450671649,6,0.22828160530947997,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.3399080922556166,0.3427437407096448,0.2541068261292859,0.22828160530947997,0.9935416591109505,1,0.5940149183849025,0.5710253460191248,1.3734599000319725,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_112,0.3399080922556166,0.6224320641748743,6,0.2541068261292859,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,0.0741361285051408,0.07760434323090379,6,0.03168184045658733,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.3399080922556166,0.0741361285051408,0.2541068261292859,0.03168184045658733,0.3455364838667783,1,0.5940149183849025,0.10581796896172813,1.3734599000319725,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_112,0.9871072120329722,0.6405236793273215,6,0.2614926970870026,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.3399080922556166,0.9871072120329722,0.2541068261292859,0.2614926970870026,0.10631308071636271,1,0.5940149183849025,1.2485999091199749,1.3734599000319725,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,0.8217117607645367,0.9028222445375325,6,0.3685756379251954,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.42080686254123806,0.8217117607645367,0.284046967662694,0.3685756379251954,0.4103939151863213,1,0.704853830203932,1.190287398689732,1.3093161385587053,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_112,0.42080686254123806,0.695770133758434,6,0.284046967662694,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,0.2690511958120337,0.22586740399784208,6,0.09220998155362974,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.42080686254123806,0.2690511958120337,0.284046967662694,0.09220998155362974,0.6293569210624033,1,0.704853830203932,0.36126117736566343,1.3093161385587053,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_112,0.177762244137595,0.1690556933306553,6,0.06901669779542312,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.42080686254123806,0.177762244137595,0.284046967662694,0.06901669779542312,0.4397873293282072,1,0.704853830203932,0.24677894193301814,1.3093161385587053,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,0.41359492046547497,0.7019631458765034,6,0.28657525427271785,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.09282064895905018,0.41359492046547497,0.038213260213220454,0.28657525427271785,0.316061478297185,1,0.13103390917227065,0.7001701747381928,0.7701871922120122,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_112,0.09282064895905018,0.09360298893058801,6,0.038213260213220454,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,0.08731589828351434,0.1087825859644052,6,0.04441030475220664,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.09282064895905018,0.08731589828351434,0.038213260213220454,0.04441030475220664,0.9270396134315608,1,0.13103390917227065,0.13172620303572097,0.7701871922120122,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_112,0.1567064950895678,0.1179582736752328,6,0.04815626357398229,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.09282064895905018,0.1567064950895678,0.038213260213220454,0.04815626357398229,0.3244125804811188,1,0.13103390917227065,0.20486275866355008,0.7701871922120122,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_112,0.06816118098505353,0.07861839727414961,6,0.032095826286180414,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.3180419223616764,0.06816118098505353,0.16353848755475545,0.032095826286180414,0.18996161518324936,1,0.4815804099164318,0.10025700727123393,0.529738450908075,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_112,0.3180419223616764,0.4005858478156478,6,0.16353848755475545,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_112,0.14677143819870184,0.05488408033751052,6,0.02240633197146999,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.3180419223616764,0.14677143819870184,0.16353848755475545,0.02240633197146999,0.3453856212492262,1,0.4815804099164318,0.16917777017017183,0.529738450908075,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_112,0.06033086154883138,0.06925676430135398,6,0.028273955629086463,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.3180419223616764,0.06033086154883138,0.16353848755475545,0.028273955629086463,0.17790934537409384,1,0.4815804099164318,0.08860481717791785,0.529738450908075,0,24,0,10.65112970711297,L-tyrosine,tyrosine_218_280_rt10.78,10.66560976,10.67,0.024146666,10.75,10.39,0.36,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.15274364934420634,0.1591033237015452,6,0.06495365990827445,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.14880548607298305,0.15274364934420634,0.08194665159251938,0.06495365990827445,0.9708735627227374,1,0.23075213766550243,0.2176973092524808,0.2538273514320527,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_122,0.14880548607298305,0.18323828348936474,5,0.08194665159251938,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.0767305001837757,0.09495487678960374,6,0.03876516612056247,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.14880548607298305,0.0767305001837757,0.08194665159251938,0.03876516612056247,0.4580765855124508,1,0.23075213766550243,0.11549566630433816,0.2538273514320527,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_122,0.1084936270111772,0.1001902588021332,5,0.04480644587297329,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.14880548607298305,0.1084936270111772,0.08194665159251938,0.04480644587297329,0.6806335871987981,1,0.23075213766550243,0.15330007288415048,0.2538273514320527,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.15406362146728628,0.1590291077643801,6,0.06492336137880163,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.07612603904755932,0.15406362146728628,0.0228526032830902,0.06492336137880163,0.29924000488536323,1,0.09897864233064953,0.21898698284608792,0.24088568113069672,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_122,0.07612603904755932,0.05597721733782262,6,0.0228526032830902,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.09939102942661789,0.09035883366898984,6,0.03688883937367365,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.07612603904755932,0.09939102942661789,0.0228526032830902,0.03688883937367365,0.6058573129537113,1,0.09897864233064953,0.13627986880029153,0.24088568113069672,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_122,0.06427537786688993,0.0695180574806443,6,0.0283806281228416,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.07612603904755932,0.06427537786688993,0.0228526032830902,0.0283806281228416,0.7520080416431362,1,0.09897864233064953,0.09265600598973153,0.24088568113069672,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.10873343856137636,0.11770008919845606,6,0.04805086020271388,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.25736601391187175,0.10873343856137636,0.10002749933635659,0.04805086020271388,0.23044302181901055,1,0.3573935132482283,0.15678429876409025,0.3931328645730512,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_122,0.25736601391187175,0.22366828813540846,5,0.10002749933635659,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.13259855778880433,0.12058528349946007,6,0.049228735843754846,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.25736601391187175,0.13259855778880433,0.10002749933635659,0.049228735843754846,0.3065936016447236,1,0.3573935132482283,0.18182729363255917,0.3931328645730512,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_122,0.1609084239078374,0.14255343401744547,6,0.05819719573737522,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.25736601391187175,0.1609084239078374,0.10002749933635659,0.05819719573737522,0.4338362519149619,1,0.3573935132482283,0.21910561964521263,0.3931328645730512,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.13305597826255924,0.09811830036673881,6,0.04005662838794095,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.17375024254925037,0.13305597826255924,0.050177582092892505,0.04005662838794095,0.5436952012442354,1,0.22392782464214286,0.17311260665050018,0.24632060710635717,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_122,0.17375024254925037,0.11220048450628381,5,0.050177582092892505,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.135494844559141,0.09936135635105693,6,0.040564103868489694,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.17375024254925037,0.135494844559141,0.050177582092892505,0.040564103868489694,0.5693316700015291,1,0.22392782464214286,0.17605894842763067,0.24632060710635717,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_122,0.07585766570979839,0.06216499459344266,6,0.025378752769468254,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.17375024254925037,0.07585766570979839,0.050177582092892505,0.025378752769468254,0.1323886864366605,1,0.22392782464214286,0.10123641847926665,0.24632060710635717,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.08940116103451852,0.09176494679901574,6,0.03746288265520552,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.11478744809935885,0.08940116103451852,0.014231244834024402,0.03746288265520552,0.5483379768847074,1,0.12901869293338325,0.12686404368972404,0.15653422549017,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_122,0.11478744809935885,0.03485928824797886,6,0.014231244834024402,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.07104563144875553,0.03890514895000058,6,0.015882960549079693,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.11478744809935885,0.07104563144875553,0.014231244834024402,0.015882960549079693,0.06771707031945118,1,0.12901869293338325,0.08692859199783523,0.15653422549017,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_122,0.10782801534406117,0.08444818218703729,6,0.034475826010638824,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.11478744809935885,0.10782801534406117,0.014231244834024402,0.034475826010638824,0.8575396937269122,1,0.12901869293338325,0.14230384135469998,0.15653422549017,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.05163493824368929,0.040050172529283695,6,0.01635041446786284,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.020729940957797677,0.05163493824368929,0.007445732213341497,0.01635041446786284,0.1291514704577264,1,0.028175673171139174,0.06798535271155212,0.13395419572654643,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_122,0.020729940957797677,0.018238244684090285,6,0.007445732213341497,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.07641157169046682,0.06656330861632496,6,0.02717435695023319,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.020729940957797677,0.07641157169046682,0.007445732213341497,0.02717435695023319,0.097636384418307,1,0.028175673171139174,0.10358592864070001,0.13395419572654643,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_122,0.08017771626152677,0.10189589590392441,6,0.04159882530806089,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.020729940957797677,0.08017771626152677,0.007445732213341497,0.04159882530806089,0.2151551189021564,1,0.028175673171139174,0.12177654156958766,0.13395419572654643,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.10999278216097134,0.04597778416297298,6,0.018770351783850198,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.0764580275394701,0.10999278216097134,0.012787713894116703,0.018770351783850198,0.17460364807010867,1,0.08924574143358681,0.12876313394482153,0.20188853600588652,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_122,0.0764580275394701,0.03132337401728479,6,0.012787713894116703,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.02737703639649025,0.04268928494461666,6,0.017427827599764478,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.0764580275394701,0.02737703639649025,0.012787713894116703,0.017427827599764478,0.048784793786771606,1,0.08924574143358681,0.04480486399625473,0.20188853600588652,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_122,0.16011066783895758,0.05737774153824644,6,0.023424364893666495,leaf_1_log2-1,1,967514 MM WT,leaf,*,0.0764580275394701,0.16011066783895758,0.012787713894116703,0.023424364893666495,0.014518966102431828,0.3484551864583639,0.08924574143358681,0.1835350327326241,0.20188853600588652,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_122,0.02735607416580373,0.029748338449853636,6,0.012144708316293152,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.0812296132296606,0.02735607416580373,0.042113602812187116,0.012144708316293152,0.26633496243497745,1,0.12334321604184773,0.03950078248209688,0.13567753764603252,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_122,0.0812296132296606,0.10315683812009714,6,0.042113602812187116,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_122,0.05574347280420455,0.04928269645948436,6,0.020119576579033967,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.0812296132296606,0.05574347280420455,0.042113602812187116,0.020119576579033967,0.6015960932908071,1,0.12334321604184773,0.07586304938323851,0.13567753764603252,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_122,0.044460581245372145,0.03591737174205084,6,0.014663205611647318,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.0812296132296606,0.044460581245372145,0.042113602812187116,0.014663205611647318,0.44021930596843983,1,0.12334321604184773,0.05912378685701947,0.13567753764603252,0,24,0,4.326589958158996,L-valine,valine_144_218_rt4.42,4.347987805,4.35,0.021312166,4.5,4.33,0.17,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,0.1375095691226703,0.18780029941240267,6,0.07666915118371502,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.1672309303318626,0.1375095691226703,0.11184282398237717,0.07666915118371502,0.8324719179239131,1,0.27907375431423975,0.2141787203063853,0.30698112974566377,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_8,0.1672309303318626,0.2500881572201391,5,0.11184282398237717,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.10848690480878968,0.0810901680155582,6,0.03310492246577906,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.1672309303318626,0.10848690480878968,0.11184282398237717,0.03310492246577906,0.6372092783304828,1,0.27907375431423975,0.14159182727456876,0.30698112974566377,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_8,0.17161297483629992,0.11544637105334894,5,0.051629186686190445,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.1672309303318626,0.17161297483629992,0.11184282398237717,0.051629186686190445,0.9728500627830788,1,0.27907375431423975,0.22324216152249038,0.30698112974566377,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,0.09678252373856759,0.08000417582902976,6,0.03266156801217171,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.14457290163529216,0.09678252373856759,0.046984284413040873,0.03266156801217171,0.4254244393833567,1,0.19155718604833302,0.1294440917507393,0.21071290465316633,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_8,0.14457290163529216,0.11508752274175116,6,0.046984284413040873,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.1277283006364717,0.1227724552801199,6,0.050121644984160024,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.14457290163529216,0.1277283006364717,0.046984284413040873,0.050121644984160024,0.8112877320506433,1,0.19155718604833302,0.17784994562063172,0.21071290465316633,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_8,0.12091244856623203,0.057686687814018055,6,0.02355049168259543,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.14457290163529216,0.12091244856623203,0.046984284413040873,0.02355049168259543,0.6655277682934564,1,0.19155718604833302,0.14446294024882744,0.21071290465316633,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,0.11728274041166568,0.12080536733927999,6,0.04931858469512005,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.18229209819579073,0.11728274041166568,0.07538401884130744,0.04931858469512005,0.4935363853696696,1,0.25767611703709814,0.16660132510678574,0.36367517175984254,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_8,0.18229209819579073,0.16856379054628837,5,0.07538401884130744,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.1469900086664434,0.06737524818016849,6,0.027505829889132288,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.18229209819579073,0.1469900086664434,0.07538401884130744,0.027505829889132288,0.678132183870354,1,0.25767611703709814,0.17449583855557568,0.36367517175984254,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_8,0.23638093004677896,0.23082243003418032,6,0.09423286246216875,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.18229209819579073,0.23638093004677896,0.07538401884130744,0.09423286246216875,0.6647157087373029,1,0.25767611703709814,0.33061379250894773,0.36367517175984254,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,0.16843446969166856,0.1308666449820451,6,0.05342608409266119,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.04938118110515903,0.16843446969166856,0.02504281970404705,0.05342608409266119,0.08332353215381848,1,0.07442400080920608,0.22186055378432976,0.3021596080238995,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_8,0.04938118110515903,0.055997447206520376,5,0.02504281970404705,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.043369249161876754,0.050329374427436895,6,0.02054688107011678,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.04938118110515903,0.043369249161876754,0.02504281970404705,0.02054688107011678,0.8572631477031367,1,0.07442400080920608,0.06391613023199354,0.3021596080238995,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_8,0.1831544627136866,0.22421671363597648,6,0.09153609003531293,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.04938118110515903,0.1831544627136866,0.02504281970404705,0.09153609003531293,0.2104932380443678,1,0.07442400080920608,0.27469055274899956,0.3021596080238995,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,0.10541872581613425,0.08099106080538855,6,0.03306446211665466,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.04081305673141222,0.10541872581613425,0.018018519262733658,0.03306446211665466,0.12587478452862416,1,0.05883157599414588,0.1384831879327889,0.1600762530380241,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_8,0.04081305673141222,0.044136178114207204,6,0.018018519262733658,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.04678457864543306,0.04611308677271296,6,0.018825588842971842,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.04081305673141222,0.04678457864543306,0.018018519262733658,0.018825588842971842,0.8233764833506596,1,0.05883157599414588,0.0656101674884049,0.1600762530380241,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_8,0.10356851877320301,0.10276919366234177,6,0.0419553476250007,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.04081305673141222,0.10356851877320301,0.018018519262733658,0.0419553476250007,0.21300476089619766,1,0.05883157599414588,0.14552386639820372,0.1600762530380241,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,0.05014549175380726,0.038916547642839285,6,0.015887614045944617,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.05697733512385931,0.05014549175380726,0.017631681131695436,0.015887614045944617,0.7793989050796002,1,0.07460901625555474,0.06603310579975188,0.1072486936666414,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_8,0.05697733512385931,0.04318862208011166,6,0.017631681131695436,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.07376422700092104,0.058137623543580555,6,0.0237345854232984,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.05697733512385931,0.07376422700092104,0.017631681131695436,0.0237345854232984,0.5837437297997132,1,0.07460901625555474,0.09749881242421944,0.1072486936666414,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_8,0.06273253041750644,0.0514413634517913,6,0.021000848688324046,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.05697733512385931,0.06273253041750644,0.017631681131695436,0.021000848688324046,0.8380978205413043,1,0.07460901625555474,0.08373337910583048,0.1072486936666414,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,0.038933476415160394,0.039461587451199015,6,0.016110125615942227,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.05529999665402996,0.038933476415160394,0.03153163240424199,0.016110125615942227,0.6571335189566319,1,0.08683162905827195,0.05504360203110262,0.09978810826549969,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_8,0.05529999665402996,0.07723641014740043,6,0.03153163240424199,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.06403811474715286,0.02786389148923556,6,0.011375386066151,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.05529999665402996,0.06403811474715286,0.03153163240424199,0.011375386066151,0.8026797742118885,1,0.08683162905827195,0.07541350081330386,0.09978810826549969,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_8,0.07352184304055731,0.04211804291807532,6,0.01719461901898786,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.05529999665402996,0.07352184304055731,0.03153163240424199,0.01719461901898786,0.626053938438567,1,0.08683162905827195,0.09071646205954517,0.09978810826549969,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_8,0.05788973783512352,0.050801902563490854,6,0.020739789873856884,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.05852650935629292,0.05788973783512352,0.025965625945442123,0.020739789873856884,0.9851073028374681,1,0.08449213530173505,0.0786295277089804,0.1749304119453544,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_8,0.05852650935629292,0.06360253441830524,6,0.025965625945442123,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_8,0.09930383992837943,0.14629285336825337,6,0.05972380729467003,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.05852650935629292,0.09930383992837943,0.025965625945442123,0.05972380729467003,0.5515746096814995,1,0.08449213530173505,0.15902764722304946,0.1749304119453544,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_8,0.05227753458144805,0.05484102993282869,6,0.022388756717354855,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.05852650935629292,0.05227753458144805,0.025965625945442123,0.022388756717354855,0.8590942994522787,1,0.08449213530173505,0.07466629129880291,0.1749304119453544,0,24,0,6.351236897274633,beta-alanine,alanine_beta_248_290_rt6.44,6.355092025,6.35,0.021953039,6.52,6.2,0.32,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,0.18708562071396295,0.24853120167473566,6,0.10146243821064041,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.193940427251258,0.18708562071396295,0.08029009257913011,0.10146243821064041,0.9589222644842423,1,0.27423051983038815,0.28854805892460333,0.3880179924265468,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_7,0.193940427251258,0.17953410492668637,5,0.08029009257913011,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,0.1318412982517043,0.07427135255083281,6,0.03032115270931637,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.193940427251258,0.1318412982517043,0.08029009257913011,0.03032115270931637,0.5009245871342434,1,0.27423051983038815,0.16216245096102067,0.3880179924265468,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_7,0.2223781138831736,0.29150615479335873,5,0.13036551559550524,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.193940427251258,0.2223781138831736,0.08029009257913011,0.13036551559550524,0.8581858286651431,1,0.27423051983038815,0.3527436294786789,0.3880179924265468,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,0.34079756750101176,0.2541290432692282,6,0.1037477474718795,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.12224703106675512,0.34079756750101176,0.035944661434821785,0.1037477474718795,0.09223846246772478,1,0.1581916925015769,0.44454531497289124,0.4889998464701804,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_7,0.12224703106675512,0.08804607949241003,6,0.035944661434821785,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,0.09506048142546113,0.13247976487682545,6,0.05408463753201852,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.12224703106675512,0.09506048142546113,0.035944661434821785,0.05408463753201852,0.6856269753629309,1,0.1581916925015769,0.14914511895747964,0.4889998464701804,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_7,0.18356824573140507,0.171836073195731,6,0.07015178312218041,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.12224703106675512,0.18356824573140507,0.035944661434821785,0.07015178312218041,0.46056984026248615,1,0.1581916925015769,0.25372002885358547,0.4889998464701804,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,0.1286871174037608,0.07476114694185439,6,0.030521110432129718,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1754668892032391,0.1286871174037608,0.059917066417378886,0.030521110432129718,0.5125704515702549,1,0.23538395562061798,0.1592082278358905,0.3476568972761619,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_7,0.1754668892032391,0.13397863352162898,5,0.059917066417378886,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,0.1954808147097048,0.10473797876829267,6,0.04275910077879587,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1754668892032391,0.1954808147097048,0.059917066417378886,0.04275910077879587,0.7929948593852156,1,0.23538395562061798,0.23823991548850065,0.3476568972761619,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_7,0.23279916271995593,0.20392629686694094,6,0.08325256207655488,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1754668892032391,0.23279916271995593,0.059917066417378886,0.08325256207655488,0.5904088180371299,1,0.23538395562061798,0.3160517247965108,0.3476568972761619,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,0.12894352363312775,0.08467784734549738,6,0.03456958641895927,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.14344361543419634,0.12894352363312775,0.05395252017560365,0.03456958641895927,0.8274301062527203,1,0.1973961356098,0.16351311005208702,0.3587576538913388,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_7,0.14344361543419634,0.12064150267007864,5,0.05395252017560365,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,0.1361331383390675,0.12045799822872891,6,0.04917677184957762,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.14344361543419634,0.1361331383390675,0.05395252017560365,0.04917677184957762,0.9225177032449201,1,0.1973961356098,0.18530991018864512,0.3587576538913388,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_7,0.23091754960327052,0.23325455204706477,6,0.09522577211612836,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.14344361543419634,0.23091754960327052,0.05395252017560365,0.09522577211612836,0.448017471026421,1,0.1973961356098,0.32614332171939886,0.3587576538913388,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,0.1190047851315265,0.14833015552186948,6,0.060555532416042154,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.26030969561091616,0.1190047851315265,0.04633452665764666,0.060555532416042154,0.09558413531828203,1,0.3066442222685628,0.17956031754756865,0.3373086444954191,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_7,0.26030969561091616,0.11349594778461922,6,0.04633452665764666,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,0.15681516523213065,0.024366746431840648,6,0.00994768257496538,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.26030969561091616,0.15681516523213065,0.04633452665764666,0.00994768257496538,0.07614126370216578,1,0.3066442222685628,0.16676284780709605,0.3373086444954191,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_7,0.0730156383144176,0.04091443498237925,6,0.0167032481368512,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,0.26030969561091616,0.0730156383144176,0.04633452665764666,0.0167032481368512,0.008209460629235837,0.19702705510166008,0.3066442222685628,0.0897188864512688,0.3373086444954191,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,0.10589245391976794,0.07634608977461027,6,0.03116816063408526,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.14828577556372755,0.10589245391976794,0.04941630176176202,0.03116816063408526,0.48772129869420144,1,0.19770207732548956,0.1370606145538532,0.3158261771534923,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_7,0.14828577556372755,0.12104472429171434,6,0.04941630176176202,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,0.23313917725953828,0.1322125052435812,6,0.05397552924363655,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.14828577556372755,0.23313917725953828,0.04941630176176202,0.05397552924363655,0.27338607841379026,1,0.19770207732548956,0.28711470650317483,0.3158261771534923,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_7,0.14236686683140817,0.21719850051382686,6,0.08867091652608429,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.14828577556372755,0.14236686683140817,0.04941630176176202,0.08867091652608429,0.9549633600290105,1,0.19770207732548956,0.23103778335749248,0.3158261771534923,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,0.18229848068845214,0.15055752530014843,6,0.061464852320255406,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.10379355561726948,0.18229848068845214,0.0486772908920819,0.061464852320255406,0.3415136225952059,1,0.1524708465093514,0.24376333300870756,0.26813966630957836,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_7,0.10379355561726948,0.11923452474662762,6,0.0486772908920819,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,0.15716182512433718,0.18303417274590128,6,0.0747233881199816,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.10379355561726948,0.15716182512433718,0.0486772908920819,0.0747233881199816,0.5649832114975104,1,0.1524708465093514,0.23188521324431877,0.26813966630957836,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_7,0.053541576051052774,0.036701661991435756,6,0.014983390765186188,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.10379355561726948,0.053541576051052774,0.0486772908920819,0.014983390765186188,0.3622817612424658,1,0.1524708465093514,0.06852496681623896,0.26813966630957836,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_7,0.18096301891644004,0.1785913101675303,6,0.07290959706759577,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.24383811269689168,0.18096301891644004,0.11097080753343572,0.07290959706759577,0.6475715052843155,1,0.3548089202303274,0.2538726159840358,0.3902898122533602,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_7,0.24383811269689168,0.271821854801517,6,0.11097080753343572,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_7,0.22595166349464893,0.25545182391457255,6,0.10428777040900002,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.24383811269689168,0.22595166349464893,0.11097080753343572,0.10428777040900002,0.9088343484077268,1,0.3548089202303274,0.33023943390364896,0.3902898122533602,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_7,0.19398001763692774,0.16987860144145495,6,0.06935264862486593,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.24383811269689168,0.19398001763692774,0.11097080753343572,0.06935264862486593,0.7126691426033986,1,0.3548089202303274,0.26333266626179364,0.3902898122533602,0,24,0,6.693018867924528,beta-cyano-L-alanine,alanine_3_cyano_141_100_rt6.78,6.697177914,6.7,0.027068938,6.9,6.47,0.43,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,0.015313177158589708,0.01272397629833941,6,0.0051945415716997765,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.06269377904916125,0.015313177158589708,0.035509564774832685,0.0051945415716997765,0.2545350221178026,1,0.09820334382399393,0.020507718730289483,0.10802367820639333,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_79,0.06269377904916125,0.0794018006879579,5,0.035509564774832685,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,0.007353742139148078,0.00952430361403103,6,0.003888280668286961,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.06269377904916125,0.007353742139148078,0.035509564774832685,0.003888280668286961,0.19461233831073174,1,0.09820334382399393,0.01124202280743504,0.10802367820639333,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_79,0.037998031220233396,0.07438120452305112,5,0.033264285912371426,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.06269377904916125,0.037998031220233396,0.035509564774832685,0.033264285912371426,0.6255164941674151,1,0.09820334382399393,0.07126231713260482,0.10802367820639333,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,0.024757843240929223,0.028430277152079533,6,0.011606612044750294,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.01448806296456584,0.024757843240929223,0.004998237791570115,0.011606612044750294,0.4439512513156384,1,0.019486300756135954,0.03636445528567952,0.04446869278798844,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_79,0.01448806296456584,0.01224313220244224,6,0.004998237791570115,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,0.02737096651068797,0.02885670396148439,6,0.011780700060697787,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.01448806296456584,0.02737096651068797,0.004998237791570115,0.011780700060697787,0.34882615001310685,1,0.019486300756135954,0.03915166657138576,0.04446869278798844,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_79,0.030280798622369726,0.024850773334089606,6,0.010145285730347037,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.01448806296456584,0.030280798622369726,0.004998237791570115,0.010145285730347037,0.20363234169769306,1,0.019486300756135954,0.04042608435271676,0.04446869278798844,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,0.03364174361831973,0.02714292396431246,6,0.011081052306621183,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.037041837912328825,0.03364174361831973,0.019126274073703486,0.011081052306621183,0.8823856299885475,1,0.05616811198603231,0.04472279592494091,0.06178492318463555,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_79,0.037041837912328825,0.04276764898509282,5,0.019126274073703486,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,0.018395107719813897,0.017363821644772168,6,0.00708875050239766,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.037041837912328825,0.018395107719813897,0.019126274073703486,0.00708875050239766,0.40180424854726415,1,0.05616811198603231,0.025483858222211556,0.06178492318463555,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_79,0.032312977182413626,0.0258644640265734,6,0.010559123222612675,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.037041837912328825,0.032312977182413626,0.019126274073703486,0.010559123222612675,0.8354363772087358,1,0.05616811198603231,0.0428721004050263,0.06178492318463555,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,0.012115110228032503,0.007245262440679085,6,0.0029578660053692723,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.029315864834175098,0.012115110228032503,0.013651030940597107,0.0029578660053692723,0.28018827870413593,1,0.0429668957747722,0.015072976233401775,0.05467244567874102,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_79,0.029315864834175098,0.030524633146128025,5,0.013651030940597107,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,0.04221480920794115,0.0183403441270053,6,0.0074874141363688645,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.029315864834175098,0.04221480920794115,0.013651030940597107,0.0074874141363688645,0.4376042638931448,1,0.0429668957747722,0.049702223344310015,0.05467244567874102,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_79,0.017538717347605665,0.012019974523535879,6,0.004907134050652709,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.029315864834175098,0.017538717347605665,0.013651030940597107,0.004907134050652709,0.4535355377701886,1,0.0429668957747722,0.022445851398258373,0.05467244567874102,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,0.015361614625952017,0.015526596943642624,6,0.006338706658963542,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.010569880484622226,0.015361614625952017,0.005582348488961281,0.006338706658963542,0.5832097290504368,1,0.016152228973583507,0.021700321284915558,0.023870353413407115,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_79,0.010569880484622226,0.01367390536435183,6,0.005582348488961281,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,0.010239337865982709,0.009610456440139983,6,0.0039234524122645715,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.010569880484622226,0.010239337865982709,0.005582348488961281,0.0039234524122645715,0.962423855102336,1,0.016152228973583507,0.014162790278247281,0.023870353413407115,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_79,0.011487111905523836,0.009514042731243495,6,0.0038840916804302995,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.010569880484622226,0.011487111905523836,0.005582348488961281,0.0038840916804302995,0.895705059283924,1,0.016152228973583507,0.015371203585954136,0.023870353413407115,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,0.01854326266623252,0.014868353628902422,6,0.006069979951011589,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.02834969042046942,0.01854326266623252,0.009289520678991279,0.006069979951011589,0.4008494312132882,1,0.037639211099460695,0.024613242617244107,0.041403132209406765,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_79,0.02834969042046942,0.02275458561856136,6,0.009289520678991279,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,0.01868880957618117,0.015494950958168652,6,0.006325787239493749,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.02834969042046942,0.01868880957618117,0.009289520678991279,0.006325787239493749,0.4127718368531006,1,0.037639211099460695,0.025014596815674917,0.041403132209406765,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_79,0.011249665358446329,0.016590182255736868,6,0.006772913544388491,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.02834969042046942,0.011249665358446329,0.009289520678991279,0.006772913544388491,0.1705499045179066,1,0.037639211099460695,0.018022578902834818,0.041403132209406765,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,0.008610818515805363,0.008642736087981388,6,0.003528382232848737,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.007425942068723712,0.008610818515805363,0.002928018301683338,0.003528382232848737,0.8014980403686718,1,0.010353960370407051,0.0121392007486541,0.03357949921095915,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_79,0.007425942068723712,0.007172150796654757,6,0.002928018301683338,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,0.027009126965526004,0.008616546795543018,6,0.003517690498982314,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.007425942068723712,0.027009126965526004,0.002928018301683338,0.003517690498982314,0.0017381285104638015,0.04171508425113123,0.010353960370407051,0.03052681746450832,0.03357949921095915,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_79,0.014830500699635133,0.026142166829789565,6,0.010672494917282695,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.007425942068723712,0.014830500699635133,0.002928018301683338,0.010672494917282695,0.5293847767117057,1,0.010353960370407051,0.02550299561691783,0.03357949921095915,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_79,0.027599837537060672,0.02253602804508928,6,0.009200294923253373,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.013570660502552437,0.027599837537060672,0.00534006218663912,0.009200294923253373,0.22361974709360066,1,0.018910722689191556,0.03680013246031404,0.05696791684784387,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_79,0.013570660502552437,0.013080427551996834,6,0.00534006218663912,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_79,0.033653952835363134,0.04442164953159511,6,0.018135062480858565,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.013570660502552437,0.033653952835363134,0.00534006218663912,0.018135062480858565,0.3298877193529028,1,0.018910722689191556,0.051789015316221695,0.05696791684784387,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_79,0.009331734670323074,0.004618773062235641,6,0.001885606206698242,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.013570660502552437,0.009331734670323074,0.00534006218663912,0.001885606206698242,0.4814586670994263,1,0.018910722689191556,0.011217340877021316,0.05696791684784387,0,24,0,7.922327044025157,ornithine,ornithine_142_348_rt8.03,7.930429448,7.93,0.03507223,8.18,7.72,0.46,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,0.1805483912384318,0.2180370839060077,6,0.08901326676235351,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.31719166395872156,0.1805483912384318,0.12677923990438847,0.08901326676235351,0.40523328321909113,1,0.44397090386311,0.2695616580007853,1.4126727828871268,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_89,0.31719166395872156,0.2834869985619666,5,0.12677923990438847,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,0.09489823982737167,0.10539912613205886,6,0.0430290130597981,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.31719166395872156,0.09489823982737167,0.12677923990438847,0.0430290130597981,0.15865595758980897,1,0.44397090386311,0.13792725288716978,1.4126727828871268,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_89,0.8454949551320772,0.9810815988728293,5,0.43875302931076543,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.31719166395872156,0.8454949551320772,0.12677923990438847,0.43875302931076543,0.30316161952847914,1,0.44397090386311,1.2842479844428425,1.4126727828871268,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,0.23894294676824615,0.22338404963350092,6,0.09119615637977148,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.1938576258431998,0.23894294676824615,0.0525303968208222,0.09119615637977148,0.6796825728568028,1,0.246388022664022,0.33013910314801764,0.3631530134628194,0,23,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_89,0.1938576258431998,0.12867266819693404,6,0.0525303968208222,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,0.13204640821420988,0.14213750889980306,6,0.05802739501913672,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.1938576258431998,0.13204640821420988,0.0525303968208222,0.05802739501913672,0.44820468865633345,1,0.246388022664022,0.1900738032333466,0.3631530134628194,0,23,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_89,0.11031330129586792,0.10418994082810398,5,0.046595158052664246,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.1938576258431998,0.11031330129586792,0.0525303968208222,0.046595158052664246,0.26457108430464943,1,0.246388022664022,0.15690845934853215,0.3631530134628194,0,23,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,0.10939845889037818,0.10494063503815225,6,0.04284183485451783,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1720529259486363,0.10939845889037818,0.0885810465305022,0.04284183485451783,0.5484375306597398,1,0.2606339724791385,0.152240293744896,0.2866973697270524,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,1,967514 MM WT,MoneyMaker,m_89,0.1720529259486363,0.1980732415602748,5,0.0885810465305022,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,0.19550552453930084,0.15704579452163842,6,0.064113677137998,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1720529259486363,0.19550552453930084,0.0885810465305022,0.064113677137998,0.8358068464286994,1,0.2606339724791385,0.25961920167729885,0.2866973697270524,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_89,0.13532890315471793,0.092764842097176,6,0.0378710882013223,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1720529259486363,0.13532890315471793,0.0885810465305022,0.0378710882013223,0.7174647199729605,1,0.2606339724791385,0.17319999135604025,0.2866973697270524,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,0.09977236994714762,0.0825566993079427,6,0.033703631358806795,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.11132844069727899,0.09977236994714762,0.041498632560279254,0.033703631358806795,0.8341616334765198,1,0.15282707325755823,0.1334760013059544,0.16810978058331408,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_89,0.11132844069727899,0.09279376337807056,5,0.041498632560279254,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,0.08196756451751848,0.04210822452109945,6,0.017190610675207368,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.11132844069727899,0.08196756451751848,0.041498632560279254,0.017190610675207368,0.5403213411971846,1,0.15282707325755823,0.09915817519272585,0.16810978058331408,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_89,0.10109694852339102,0.10554521659175695,6,0.04308865424022293,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.11132844069727899,0.10109694852339102,0.041498632560279254,0.04308865424022293,0.8680039632553408,1,0.15282707325755823,0.14418560276361395,0.16810978058331408,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,0.12419688963683069,0.10026735767274704,6,0.04093397735922768,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.09861958571936658,0.12419688963683069,0.052408604600605445,0.04093397735922768,0.7090350822388469,1,0.15102819031997203,0.16513086699605836,0.19716969082637842,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_89,0.09861958571936658,0.1283743394027623,6,0.052408604600605445,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,0.12117720175508288,0.09976286907046056,6,0.04072802074978572,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.09861958571936658,0.12117720175508288,0.052408604600605445,0.04072802074978572,0.7414141588650421,1,0.15102819031997203,0.1619052225048686,0.19716969082637842,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_89,0.12761446330038048,0.12646889499397798,6,0.05163071017814532,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.09861958571936658,0.12761446330038048,0.052408604600605445,0.05163071017814532,0.701769090214589,1,0.15102819031997203,0.1792451734785258,0.19716969082637842,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,0.13116869146364785,0.10150407738799051,6,0.04143886606875878,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.11411203663516038,0.13116869146364785,0.03188556717856355,0.04143886606875878,0.7514190558302464,1,0.14599760381372393,0.17260755753240664,0.18986831328564732,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_89,0.11411203663516038,0.07810336974671536,6,0.03188556717856355,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,0.0615998063990153,0.03499687762112083,6,0.014287415460395605,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.11411203663516038,0.0615998063990153,0.03188556717856355,0.014287415460395605,0.1769895240396199,1,0.14599760381372393,0.07588722185941091,0.18986831328564732,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_89,0.0913078549077803,0.08023255419284123,6,0.03275480308877668,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.11411203663516038,0.0913078549077803,0.03188556717856355,0.03275480308877668,0.6286699873628836,1,0.14599760381372393,0.12406265799655698,0.18986831328564732,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,0.05459992002199732,0.05567727843024105,6,0.022730153736826426,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.11255261616817809,0.05459992002199732,0.04275283298994589,0.022730153736826426,0.2672697970614948,1,0.15530544915812397,0.07733007375882374,0.18997575552520649,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,1,967514 MM WT,MoneyMaker,m_89,0.11255261616817809,0.1047226258837947,6,0.04275283298994589,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,0.135847417367749,0.09028283960727522,6,0.03685781492789325,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.11255261616817809,0.135847417367749,0.04275283298994589,0.03685781492789325,0.6887338450514902,1,0.15530544915812397,0.17270523229564225,0.18997575552520649,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_89,0.1356306357020721,0.07637986120612315,6,0.03118194776326691,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.11255261616817809,0.1356306357020721,0.04275283298994589,0.03118194776326691,0.6728595821214929,1,0.15530544915812397,0.166812583465339,0.18997575552520649,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_89,0.06917605949634442,0.09964247905388958,6,0.0406788717313317,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.18136084339519756,0.06917605949634442,0.059204588726205314,0.0406788717313317,0.1533110026456957,1,0.24056543212140288,0.10985493122767612,0.31844433731622096,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_89,0.18136084339519756,0.1450210328105365,6,0.059204588726205314,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_89,0.19550765269098166,0.23022068091916034,6,0.0939871994146737,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.18136084339519756,0.19550765269098166,0.059204588726205314,0.0939871994146737,0.901644392266234,1,0.24056543212140288,0.2894948521056554,0.31844433731622096,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_89,0.11798532759782694,0.06782094993091384,6,0.027687786866930825,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.18136084339519756,0.11798532759782694,0.059204588726205314,0.027687786866930825,0.3641394830093203,1,0.24056543212140288,0.14567311446475778,0.31844433731622096,0,24,0,8.187933194154489,pyroglutamic_acid,pyroglutamic_acid_156_258_rt8.30,8.192317073,8.19,0.009631082,8.3,8.18,0.12,FALSE,amino_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,0.09580045322439797,0.06698007204306522,6,0.027344499906727764,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.13542402750528626,0.09580045322439797,0.04104687968547359,0.027344499906727764,0.4474505002863105,1,0.17647090719075986,0.12314495313112572,0.2509208996193292,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_97,0.13542402750528626,0.09178361324097414,5,0.04104687968547359,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,0.1605467707714446,0.16549521345608811,6,0.06756313797340008,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.13542402750528626,0.1605467707714446,0.04104687968547359,0.06756313797340008,0.7587724680816472,1,0.17647090719075986,0.22810990874484469,0.2509208996193292,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_97,0.13254967975877036,0.1763796872781286,5,0.07887939412081008,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.13542402750528626,0.13254967975877036,0.04104687968547359,0.07887939412081008,0.9752582382184565,1,0.17647090719075986,0.21142907387958043,0.2509208996193292,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,0.0934392411941487,0.06782061788873958,6,0.027687651311280825,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.09991881883551623,0.0934392411941487,0.02680549705206648,0.027687651311280825,0.8698309811095428,1,0.1267243158875827,0.12112689250542953,0.19329412768821636,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_97,0.09991881883551623,0.06565979007924155,6,0.02680549705206648,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,0.1200734955732694,0.1363102797699805,6,0.05564843868874544,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.09991881883551623,0.1200734955732694,0.02680549705206648,0.05564843868874544,0.7534779788332862,1,0.1267243158875827,0.17572193426201485,0.19329412768821636,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_97,0.07402080721608999,0.049516621118524305,6,0.020215075921184367,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.09991881883551623,0.07402080721608999,0.02680549705206648,0.020215075921184367,0.45963635421446836,1,0.1267243158875827,0.09423588313727435,0.19329412768821636,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,0.05681259445612644,0.05181119138839946,6,0.021151830311210103,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1189601480839773,0.05681259445612644,0.052748998829793996,0.021151830311210103,0.3215161473846818,1,0.1717091469137713,0.07796442476733655,0.18888006160514842,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,1,967514 MM WT,MoneyMaker,m_97,0.1189601480839773,0.11795034712847624,5,0.052748998829793996,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,0.11321987725481608,0.043588530817038965,6,0.017794943189887568,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1189601480839773,0.11321987725481608,0.052748998829793996,0.017794943189887568,0.9219509001879851,1,0.1717091469137713,0.13101482044470364,0.18888006160514842,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_97,0.08170571177211301,0.05948073826782632,6,0.024282909713368574,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1189601480839773,0.08170571177211301,0.052748998829793996,0.024282909713368574,0.5462042122347717,1,0.1717091469137713,0.10598862148548159,0.18888006160514842,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,0.06570132561231416,0.06385829964320894,6,0.026070041661269163,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.22170225868044274,0.06570132561231416,0.07612733437748793,0.026070041661269163,0.11096955833010584,1,0.29782959305793066,0.09177136727358333,0.3276125523637238,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_97,0.22170225868044274,0.17022589461391965,5,0.07612733437748793,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,0.12306434779697943,0.2192723475003103,6,0.08951756101299979,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.22170225868044274,0.12306434779697943,0.07612733437748793,0.08951756101299979,0.4230354943796377,1,0.29782959305793066,0.21258190880997924,0.3276125523637238,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_97,0.14046331985210037,0.17170445300403303,6,0.0700980494039292,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.22170225868044274,0.14046331985210037,0.07612733437748793,0.0700980494039292,0.45334706905329014,1,0.29782959305793066,0.21056136925602958,0.3276125523637238,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,0.2906093360504366,0.24824293661258048,6,0.1013447544918151,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.30656206186101,0.2906093360504366,0.0557488002059919,0.1013447544918151,0.8938094663818069,1,0.36231086206700186,0.3919540905422517,0.4311494995964769,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_97,0.30656206186101,0.13655611427704586,6,0.0557488002059919,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,0.1133146447491602,0.08329654881720809,6,0.034005673656164914,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,0.30656206186101,0.1133146447491602,0.0557488002059919,0.034005673656164914,0.017515869568684138,0.4203808696484193,0.36231086206700186,0.1473203184053251,0.4311494995964769,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_97,0.24278478566085523,0.2814265292707854,6,0.11489189946597644,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.30656206186101,0.24278478566085523,0.0557488002059919,0.11489189946597644,0.6323205070210313,1,0.36231086206700186,0.3576766851268317,0.4311494995964769,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,0.29181528921884886,0.2717935632804594,6,0.11095925756832933,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.1528030161080923,0.29181528921884886,0.052262888548319,0.11095925756832933,0.29379371322263975,1,0.2050659046564113,0.40277454678717817,0.4488211502211592,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_97,0.1528030161080923,0.1280174094273278,6,0.052262888548319,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,0.17165927020474303,0.1642668442620517,6,0.06706165834987624,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.1528030161080923,0.17165927020474303,0.052262888548319,0.06706165834987624,0.8292090465235229,1,0.2050659046564113,0.23872092855461927,0.4488211502211592,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_97,0.26003426555396014,0.3624876463087605,6,0.1479849619198209,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.1528030161080923,0.26003426555396014,0.052262888548319,0.1479849619198209,0.5190442875434027,1,0.2050659046564113,0.40801922747378105,0.4488211502211592,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,0.2751866630564371,0.23633329499014566,6,0.09648266365941882,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.23961540182152105,0.2751866630564371,0.09803143762890465,0.09648266365941882,0.8011806598304593,1,0.33764683945042573,0.3716693267158559,0.4207209251288448,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,1,967514 MM WT,MoneyMaker,m_97,0.23961540182152105,0.2401270009422908,6,0.09803143762890465,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,0.15628877476885691,0.08536631345986104,6,0.03485065153319053,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.23961540182152105,0.15628877476885691,0.09803143762890465,0.03485065153319053,0.45258326816041894,1,0.33764683945042573,0.19113942630204744,0.4207209251288448,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_97,0.26965824055334725,0.2763399881415759,6,0.11281532774560254,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.23961540182152105,0.26965824055334725,0.09803143762890465,0.11281532774560254,0.8447952874320837,1,0.33764683945042573,0.3824735682989498,0.4207209251288448,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_97,0.2006765968053584,0.15538707982877703,6,0.06343650970027004,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.18161879088568267,0.2006765968053584,0.06133107481157632,0.06343650970027004,0.833345993865896,1,0.242949865697259,0.26411310650562847,0.42248333305729135,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_97,0.18161879088568267,0.15022983866482392,6,0.06133107481157632,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_97,0.22189682629866117,0.19586969145803534,6,0.07996346669142725,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.18161879088568267,0.22189682629866117,0.06133107481157632,0.07996346669142725,0.6983487984754598,1,0.242949865697259,0.30186029299008843,0.42248333305729135,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_97,0.2848225936746402,0.2431196062998719,6,0.09925316365017013,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.18161879088568267,0.2848225936746402,0.06133107481157632,0.09925316365017013,0.40120097376104313,1,0.242949865697259,0.3840757573248103,0.42248333305729135,0,24,0,6.595094339622642,O-acetylserine,serine-o-acetyl_174_132_rt6.69,6.60006135,6.6,0.025276177,6.78,6.38,0.4,FALSE,amino_acid_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.060946702171928026,0.04455526929282901,6,0.018189612519954497,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.03681074442612555,0.060946702171928026,0.019165936364660255,0.018189612519954497,0.38545706800179214,1,0.055976680790785806,0.07913631469188252,0.16815460865003581,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_123,0.03681074442612555,0.04285633656381553,5,0.019165936364660255,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,0.07275146038467313,0.052486855643985184,6,0.021427669088480514,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.03681074442612555,0.07275146038467313,0.019165936364660255,0.021427669088480514,0.24276304770371518,1,0.055976680790785806,0.09417912947315364,0.16815460865003581,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_123,0.09493306719029118,0.129546059060276,5,0.05793475885519593,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.03681074442612555,0.09493306719029118,0.019165936364660255,0.05793475885519593,0.3857436576710299,1,0.055976680790785806,0.1528678260454871,0.16815460865003581,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.16938038184406815,0.23611662489519583,6,0.09639420846356091,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.08316848535615813,0.16938038184406815,0.048537004158967674,0.09639420846356091,0.44932930033132035,1,0.1317054895151258,0.26577459030762907,0.29368209478185986,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_123,0.08316848535615813,0.11889089383281576,6,0.048537004158967674,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,0.03972724026926892,0.042905911849343,6,0.017516265163287484,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.08316848535615813,0.03972724026926892,0.048537004158967674,0.017516265163287484,0.4307450341274913,1,0.1317054895151258,0.0572435054325564,0.29368209478185986,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_123,0.1556216247921599,0.27278031614111803,6,0.11136209773680354,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.08316848535615813,0.1556216247921599,0.048537004158967674,0.11136209773680354,0.5701149173860243,1,0.1317054895151258,0.26698372252896346,0.29368209478185986,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.086796691207138,0.03057736766784778,6,0.012483158077283856,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.10966189641367308,0.086796691207138,0.055440328002131695,0.012483158077283856,0.7061845299444196,1,0.16510222441580477,0.09927984928442185,0.18763140584910218,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_123,0.10966189641367308,0.12396834210765158,5,0.055440328002131695,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,0.12325942565078656,0.11589657757738286,6,0.04731457966657904,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.10966189641367308,0.12325942565078656,0.055440328002131695,0.04731457966657904,0.856438738724894,1,0.16510222441580477,0.1705740053173656,0.18763140584910218,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_123,0.05252865321413632,0.05266422734172305,6,0.021500080780858667,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.10966189641367308,0.05252865321413632,0.055440328002131695,0.021500080780858667,0.37916710254658986,1,0.16510222441580477,0.07402873399499499,0.18763140584910218,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.1238466842680687,0.1514790948702898,6,0.06184108152180914,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.44797774316996225,0.1238466842680687,0.2135960608410952,0.06184108152180914,0.20868815905047938,1,0.6615738040110575,0.18568776578987783,0.7277311844121633,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_123,0.44797774316996225,0.4776153117668698,5,0.2135960608410952,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,0.18642043625638247,0.1535994420401425,6,0.06270670962909139,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.44797774316996225,0.18642043625638247,0.2135960608410952,0.06270670962909139,0.2961803228320695,1,0.6615738040110575,0.24912714588547386,0.7277311844121633,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_123,0.14511532715233813,0.19225298735159468,6,0.07848695342285922,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.44797774316996225,0.14511532715233813,0.2135960608410952,0.07848695342285922,0.23983398386216115,1,0.6615738040110575,0.22360228057519735,0.7277311844121633,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.13845345481270832,0.13324253500686842,6,0.05439603713362546,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.16000669438904103,0.13845345481270832,0.049838504733865786,0.05439603713362546,0.7761903784654722,1,0.2098451991229068,0.19284949194633377,0.2308297190351975,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_123,0.16000669438904103,0.12207890614125509,6,0.049838504733865786,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,0.08523125362639898,0.057488321117603616,6,0.023469508817899273,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.16000669438904103,0.08523125362639898,0.049838504733865786,0.023469508817899273,0.21614878114973918,1,0.2098451991229068,0.10870076244429826,0.2308297190351975,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_123,0.14404678235243717,0.095826602574477,6,0.039121046681990256,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.16000669438904103,0.14404678235243717,0.049838504733865786,0.039121046681990256,0.8065045158080906,1,0.2098451991229068,0.18316782903442744,0.2308297190351975,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.1850148287749175,0.06024180439479741,6,0.024593613658634477,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,0.07326808422917568,0.1850148287749175,0.03576989987070827,0.024593613658634477,0.030332749068972858,0.7279859776553486,0.10903798409988394,0.20960844243355198,0.2764370745261719,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_123,0.07326808422917568,0.08761800283368124,6,0.03576989987070827,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,0.17005548612903817,0.19902335700186574,6,0.0812509452583908,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.07326808422917568,0.17005548612903817,0.03576989987070827,0.0812509452583908,0.31237384515944067,1,0.10903798409988394,0.251306431387429,0.2764370745261719,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_123,0.06581197072530191,0.04713223509880246,6,0.01924165440482699,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.07326808422917568,0.06581197072530191,0.03576989987070827,0.01924165440482699,0.8591088227531497,1,0.10903798409988394,0.0850536251301289,0.2764370745261719,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.1844959192053345,0.1622612265156565,6,0.0662428683335864,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.12609733565527118,0.1844959192053345,0.048252186734712474,0.0662428683335864,0.4938929162504686,1,0.17434952238998364,0.2507387875389209,0.27581266629281304,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_123,0.12609733565527118,0.11819323647353673,6,0.048252186734712474,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,0.09343856474630068,0.15090491276867996,6,0.06160667266041197,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.12609733565527118,0.09343856474630068,0.048252186734712474,0.06160667266041197,0.6857421240302184,1,0.17434952238998364,0.15504523740671264,0.27581266629281304,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_123,0.06529558963775257,0.1120180834051546,6,0.04573119105119279,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.12609733565527118,0.06529558963775257,0.048252186734712474,0.04573119105119279,0.3819937668991039,1,0.17434952238998364,0.11102678068894536,0.27581266629281304,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_123,0.11053283791378161,0.08229678218159694,6,0.03359752063631386,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.07923322404764217,0.11053283791378161,0.02713665441676786,0.03359752063631386,0.4859469060176752,1,0.10636987846441004,0.14413035855009548,0.17594851399475217,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_123,0.07923322404764217,0.06647095664732469,6,0.02713665441676786,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_123,0.11093333526745146,0.12007364248245737,6,0.049019859273232304,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.07923322404764217,0.11093333526745146,0.02713665441676786,0.049019859273232304,0.5874477260338049,1,0.10636987846441004,0.15995319454068377,0.17594851399475217,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_123,0.08984307755386116,0.14544779770015667,6,0.05937881476282275,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.07923322404764217,0.08984307755386116,0.02713665441676786,0.05937881476282275,0.8754922586414504,1,0.10636987846441004,0.14922189231668392,0.17594851399475217,0,24,0,7.97891592920354,D-Xylose,xylose_307_217_rt8.06,7.980914634,7.98,0.037347876,8.2,7.72,0.48,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.1740778879846682,0.1934215857083149,6,0.07896403170422912,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.16188362609342039,0.1740778879846682,0.07811576497968702,0.07896403170422912,0.9150128206650396,1,0.23999939107310742,0.25304191968889733,0.43858692731184773,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_44,0.16188362609342039,0.17467216060897767,5,0.07811576497968702,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.16555512141556816,0.11786828041566938,6,0.04811952397961226,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.16188362609342039,0.16555512141556816,0.07811576497968702,0.04811952397961226,0.9692244889076087,1,0.23999939107310742,0.2136746453951804,0.43858692731184773,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_44,0.21971970862183793,0.40024650780880605,5,0.17899567984347814,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.16188362609342039,0.21971970862183793,0.07811576497968702,0.17899567984347814,0.778038782687186,1,0.23999939107310742,0.39871538846531607,0.43858692731184773,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.2505692951222194,0.2620931259717839,6,0.1069990706203107,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.15778253849189813,0.2505692951222194,0.03928361360166324,0.1069990706203107,0.4451839960168186,1,0.19706615209356138,0.35756836574253015,1.2306627352856907,0,23,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_44,0.15778253849189813,0.09622480857673184,6,0.03928361360166324,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.2379818244103089,0.15570750122378613,6,0.06356732118701056,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.15778253849189813,0.2379818244103089,0.03928361360166324,0.06356732118701056,0.3132568789453505,1,0.19706615209356138,0.3015491455973195,1.2306627352856907,0,23,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_44,0.6045775796702022,1.149801191889345,5,0.514206725134971,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.15778253849189813,0.6045775796702022,0.03928361360166324,0.514206725134971,0.43463174055819787,1,0.19706615209356138,1.1187843048051733,1.2306627352856907,0,23,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.11669546232798107,0.03357617778554597,6,0.013707417181259876,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.11756690284059576,0.11669546232798107,0.04797247693593476,0.013707417181259876,0.9867881678492472,1,0.16553937977653052,0.13040287950924095,0.1991421248604334,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_44,0.11756690284059576,0.10726971947779095,5,0.04797247693593476,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.11921255926668017,0.15144150632140657,6,0.06182573606098654,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.11756690284059576,0.11921255926668017,0.04797247693593476,0.06182573606098654,0.9836895564807064,1,0.16553937977653052,0.18103829532766672,0.1991421248604334,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_44,0.07880430800629441,0.07836849477888154,6,0.031993804019704565,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.11756690284059576,0.07880430800629441,0.04797247693593476,0.031993804019704565,0.5223915746063977,1,0.16553937977653052,0.11079811202599898,0.1991421248604334,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.10647491953143362,0.07469856298462801,6,0.030495560638581585,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1645863639419119,0.10647491953143362,0.11366212052045603,0.030495560638581585,0.6442163905767493,1,0.27824848446236794,0.1369704801700152,0.3060733329086048,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_44,0.1645863639419119,0.25415622795051346,5,0.11366212052045603,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.11124105156796975,0.07059428238008708,6,0.02881999509819376,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1645863639419119,0.11124105156796975,0.11366212052045603,0.02881999509819376,0.6701801991859844,1,0.27824848446236794,0.1400610466661635,0.3060733329086048,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_44,0.15121333960847183,0.14331535733561046,6,0.058508249629480626,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1645863639419119,0.15121333960847183,0.11366212052045603,0.058508249629480626,0.9200617235769897,1,0.27824848446236794,0.20972158923795245,0.3060733329086048,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.1467247994523874,0.11229868910080662,6,0.04584574784673715,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.16517223104994283,0.1467247994523874,0.08128044244529009,0.04584574784673715,0.8482919283111525,1,0.24645267349523292,0.19257054729912454,0.27109794084475625,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_44,0.16517223104994283,0.19909561005861653,6,0.08128044244529009,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.10890687447831926,0.09726085060933497,6,0.03970657599032217,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.16517223104994283,0.10890687447831926,0.08128044244529009,0.03970657599032217,0.5529804292247615,1,0.24645267349523292,0.14861345046864144,0.27109794084475625,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_44,0.1294252783342348,0.09969759307459625,6,0.04070137193606579,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.16517223104994283,0.1294252783342348,0.08128044244529009,0.04070137193606579,0.7052807628037161,1,0.24645267349523292,0.1701266502703006,0.27109794084475625,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.09412087297272158,0.10116697197600678,6,0.041301243360610314,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.09877785231073322,0.09412087297272158,0.02213038684979697,0.041301243360610314,0.9233844246535736,1,0.12090823916053019,0.1354221163333319,0.17209443217542056,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_44,0.09877785231073322,0.05420815559240141,6,0.02213038684979697,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.09270910224249522,0.15613141081599646,6,0.06374038155334165,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.09877785231073322,0.09270910224249522,0.02213038684979697,0.06374038155334165,0.9311729180961007,1,0.12090823916053019,0.15644948379583687,0.17209443217542056,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_44,0.07144872136195213,0.044455478193943375,6,0.018148872974430925,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.09877785231073322,0.07144872136195213,0.02213038684979697,0.018148872974430925,0.3629918868419695,1,0.12090823916053019,0.08959759433638305,0.17209443217542056,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.1427306640839522,0.15332436739615216,6,0.06259441087593239,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.22296203069198262,0.1427306640839522,0.06234414332222433,0.06259441087593239,0.38515800572073144,1,0.28530617401420694,0.2053250749598846,0.31383679141562765,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_44,0.22296203069198262,0.15271133959039285,6,0.06234414332222433,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.0859890429717763,0.080422018856604785,6,0.03283215171386146,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.22296203069198262,0.0859890429717763,0.06234414332222433,0.03283215171386146,0.08984283122569807,1,0.28530617401420694,0.11882119468563776,0.31383679141562765,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_44,0.10297334425489717,0.09343964777664379,6,0.03814657646636033,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.22296203069198262,0.10297334425489717,0.06234414332222433,0.03814657646636033,0.13798725720946378,1,0.28530617401420694,0.1411199207212575,0.31383679141562765,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_44,0.10647750216037737,0.12325865376198294,6,0.05032013468320674,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.09824393385900117,0.10647750216037737,0.025819822134466076,0.05032013468320674,0.8881094324649657,1,0.12406375599346725,0.1567976368435841,0.17247740052794253,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_44,0.09824393385900117,0.06324538947886071,6,0.025819822134466076,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_44,0.07352147908341526,0.1393217615403699,6,0.056877870973269996,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.09824393385900117,0.07352147908341526,0.025819822134466076,0.056877870973269996,0.7040861819943949,1,0.12406375599346725,0.13039935005668526,0.17247740052794253,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_44,0.09501160598175096,0.061818469146421015,6,0.02523728434811944,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.09824393385900117,0.09501160598175096,0.025819822134466076,0.02523728434811944,0.9304330030206408,1,0.12406375599346725,0.1202488903298704,0.17247740052794253,0,24,0,9.557933194154488,D-glucose,glucose_160_319_rt9.68,9.554512195,9.53,0.051544309,9.75,9.36,0.39,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.16021137914587713,0.1327235354329887,6,0.054184156444837595,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.15089778392263695,0.16021137914587713,0.07410101391551811,0.054184156444837595,0.921790118454117,1,0.22499879783815507,0.21439553559071473,0.35106296258927666,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_72,0.15089778392263695,0.16569490431675638,5,0.07410101391551811,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.1249658284726531,0.11113145448385162,6,0.04536922630979503,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.15089778392263695,0.1249658284726531,0.07410101391551811,0.04536922630979503,0.7742717759283582,1,0.22499879783815507,0.17033505478244812,0.35106296258927666,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_72,0.2421309245288402,0.17221574669144954,5,0.07701722327959314,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.15089778392263695,0.2421309245288402,0.07410101391551811,0.07701722327959314,0.41817057035820127,1,0.22499879783815507,0.3191481478084333,0.35106296258927666,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.14311195960122736,0.051957423503036185,6,0.02121152932202146,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.21700634366041416,0.14311195960122736,0.05547442127002331,0.02121152932202146,0.2568545513293249,1,0.2724807649304375,0.16432348892324883,0.2997288414234813,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_72,0.21700634366041416,0.13588402588775506,6,0.05547442127002331,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.07096335794637894,0.07135882563764896,6,0.029132118576079072,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,0.21700634366041416,0.07096335794637894,0.05547442127002331,0.029132118576079072,0.049896212217388866,1,0.2724807649304375,0.10009547652245801,0.2997288414234813,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_72,0.10785077472269496,0.07504377593347607,6,0.030636493234794792,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.21700634366041416,0.10785077472269496,0.05547442127002331,0.030636493234794792,0.12429906847568897,1,0.2724807649304375,0.13848726795748975,0.2997288414234813,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.11032886621204492,0.1460764699002762,6,0.05963546911378371,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.10366427735030861,0.11032886621204492,0.035701295653288785,0.05963546911378371,0.925983994337956,1,0.1393655730035974,0.16996433532582864,0.21032131697500595,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_72,0.10366427735030861,0.07983052396557148,5,0.035701295653288785,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.12327795749937287,0.14877224320878954,6,0.06073601395846239,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.10366427735030861,0.12327795749937287,0.035701295653288785,0.06073601395846239,0.7878747508293835,1,0.1393655730035974,0.18401397145783527,0.21032131697500595,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_72,0.1561414743307117,0.08587843167563018,6,0.03505972291929369,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.10366427735030861,0.1561414743307117,0.035701295653288785,0.03505972291929369,0.32208516806224285,1,0.1393655730035974,0.1912011972500054,0.21032131697500595,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.1324125580049449,0.1407915928334266,6,0.057477927085930684,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.19770112681657775,0.1324125580049449,0.06973484804874767,0.057477927085930684,0.49000698316797986,1,0.26743597486532544,0.18989048509087558,0.294179572351858,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_72,0.19770112681657775,0.15593186063761838,5,0.06973484804874767,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.1581231681429728,0.09841438346649573,6,0.04017750380725195,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.19770112681657775,0.1581231681429728,0.06973484804874767,0.04017750380725195,0.6389995096975658,1,0.26743597486532544,0.19830067195022477,0.294179572351858,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_72,0.08912956232383899,0.09391389703914838,6,0.038340187917031573,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.19770112681657775,0.08912956232383899,0.06973484804874767,0.038340187917031573,0.21904284668630436,1,0.26743597486532544,0.12746975024087057,0.294179572351858,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.12086426891141862,0.13361103587590137,6,0.05454647698344261,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.08166574411791398,0.12086426891141862,0.030122912401888864,0.05454647698344261,0.547298742865433,1,0.11178865651980285,0.17541074589486122,0.22877882122994894,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_72,0.08166574411791398,0.07378576495118296,6,0.030122912401888864,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.14650681837052884,0.15057975657976086,6,0.06147392820215201,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.08166574411791398,0.14650681837052884,0.030122912401888864,0.06147392820215201,0.37396262927013546,1,0.11178865651980285,0.20798074657268084,0.22877882122994894,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_72,0.13469651052172038,0.09951952339174874,6,0.04062867529245985,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.08166574411791398,0.13469651052172038,0.030122912401888864,0.04062867529245985,0.32110799960972014,1,0.11178865651980285,0.17532518581418022,0.22877882122994894,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.05945657112213761,0.06206112538332399,6,0.025336348342005478,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.10585233352388405,0.05945657112213761,0.038842232442950625,0.025336348342005478,0.34440229490221724,1,0.14469456596683467,0.0847929194641431,0.18616573968040778,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_72,0.10585233352388405,0.09514364995580754,6,0.038842232442950625,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.11657634717352972,0.12900295135167378,6,0.05266523435411371,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.10585233352388405,0.11657634717352972,0.038842232442950625,0.05266523435411371,0.8733731569121002,1,0.14469456596683467,0.16924158152764343,0.18616573968040778,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_72,0.08523993919291646,0.057090055753237307,6,0.02330691766374576,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.10585233352388405,0.08523993919291646,0.038842232442950625,0.02330691766374576,0.6609064965064482,1,0.14469456596683467,0.10854685685666222,0.18616573968040778,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.043351570018781795,0.06680830038327995,6,0.027274374420270288,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.05205082283474153,0.043351570018781795,0.018282744481210693,0.027274374420270288,0.7972012777645026,1,0.07033356731595222,0.07062594443905208,0.10932459535818084,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_72,0.05205082283474153,0.04478339507665135,6,0.018282744481210693,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.07355849108024433,0.06326420784413851,6,0.025827504699920064,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.05205082283474153,0.07355849108024433,0.018282744481210693,0.025827504699920064,0.5137949186510788,1,0.07033356731595222,0.0993859957801644,0.10932459535818084,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_72,0.06445991209894664,0.047871466040068186,6,0.01954344417285671,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.05205082283474153,0.06445991209894664,0.018282744481210693,0.01954344417285671,0.6528465460616477,1,0.07033356731595222,0.08400335627180334,0.10932459535818084,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_72,0.06839450167261878,0.07113632574001583,6,0.02904128337324196,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.09343655320546973,0.06839450167261878,0.022632139212774283,0.02904128337324196,0.5127508078336334,1,0.11606869241824401,0.09743578504586073,0.2620011453989715,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_72,0.09343655320546973,0.055437192858931554,6,0.022632139212774283,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_72,0.1811114072556661,0.1397959367646051,6,0.057071452197944336,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.09343655320546973,0.1811114072556661,0.022632139212774283,0.057071452197944336,0.1992797365506823,1,0.11606869241824401,0.23818285945361045,0.2620011453989715,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_72,0.1215310775824318,0.11758233041073844,6,0.048002785378941065,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.09343655320546973,0.1215310775824318,0.022632139212774283,0.048002785378941065,0.6126439645450402,1,0.11606869241824401,0.16953386296137285,0.2620011453989715,0,24,0,14.114063157894735,D-maltose,maltose_160_480_rt14.24,14.1157764,14.12,0.017307504,14.19,13.92,0.27,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.09036934217043198,0.07370446320178171,6,0.030089721101684088,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.12150326899278122,0.09036934217043198,0.07210295659198691,0.030089721101684088,0.7055850877769333,1,0.19360622558476814,0.12045906327211607,0.21296684814324499,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_71,0.12150326899278122,0.1612271123183993,5,0.07210295659198691,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.06558889039248812,0.10319774686403627,6,0.04213030373696529,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.12150326899278122,0.06558889039248812,0.07210295659198691,0.04213030373696529,0.5259143639462879,1,0.19360622558476814,0.10771919412945341,0.21296684814324499,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_71,0.12651026671378443,0.11747723974254631,5,0.05253741877467469,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.12150326899278122,0.12651026671378443,0.07210295659198691,0.05253741877467469,0.9567458177433559,1,0.19360622558476814,0.17904768548845912,0.21296684814324499,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.11745340302862028,0.0805572828298334,6,0.032887372999693396,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.10189582028450173,0.11745340302862028,0.048993910353050715,0.032887372999693396,0.7981559872089363,1,0.15088973063755245,0.1503407760283137,0.1864923636605773,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_71,0.10189582028450173,0.12001008086863628,6,0.048993910353050715,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.1188823759900195,0.12408168659109443,6,0.05065613642868714,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.10189582028450173,0.1188823759900195,0.048993910353050715,0.05065613642868714,0.814402427635918,1,0.15088973063755245,0.16953851241870663,0.1864923636605773,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_71,0.056459293858502534,0.05252127115451021,6,0.021441719161817797,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.10189582028450173,0.056459293858502534,0.048993910353050715,0.021441719161817797,0.4242563817689784,1,0.15088973063755245,0.07790101302032033,0.1864923636605773,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.03654750926671557,0.03225672213648742,6,0.013168751668188837,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.0961078239417346,0.03654750926671557,0.041011601904037534,0.013168751668188837,0.22729701527719115,1,0.13711942584577214,0.04971626093490441,0.15083136843034936,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_71,0.0961078239417346,0.09170472972358773,5,0.041011601904037534,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.05921363763387218,0.08074268953782635,6,0.03296306497127205,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.0961078239417346,0.05921363763387218,0.041011601904037534,0.03296306497127205,0.5027708895774221,1,0.13711942584577214,0.09217670260514424,0.15083136843034936,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_71,0.05451759632639227,0.01815076618190439,6,0.007410019264371766,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.0961078239417346,0.05451759632639227,0.041011601904037534,0.007410019264371766,0.3715406917312004,1,0.13711942584577214,0.06192761559076403,0.15083136843034936,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.08705766721465746,0.08187131696205303,6,0.033423825187783224,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.19055241660007588,0.08705766721465746,0.08754983929811523,0.033423825187783224,0.3182178065031919,1,0.2781022558981911,0.12048149240244069,0.30591248148801026,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_71,0.19055241660007588,0.19576739208976815,5,0.08754983929811523,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.09187359696282082,0.07673116333315928,6,0.03132536625606573,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.19055241660007588,0.09187359696282082,0.08754983929811523,0.03132536625606573,0.3369150247735941,1,0.2781022558981911,0.12319896321888656,0.30591248148801026,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_71,0.08730838494698763,0.07484804502287579,6,0.030556586425151293,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.19055241660007588,0.08730838494698763,0.08754983929811523,0.030556586425151293,0.31642213852408646,1,0.2781022558981911,0.11786497137213892,0.30591248148801026,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.06700005628847139,0.03884140237920378,6,0.015856936120528964,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.04055850360431834,0.06700005628847139,0.015204022056113582,0.015856936120528964,0.25650064306232,1,0.055762525660431925,0.08285699240900035,0.10248169142901008,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_71,0.04055850360431834,0.03724209607549942,6,0.015204022056113582,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.04063486173330758,0.03779581199362458,6,0.015430075633090805,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.04055850360431834,0.04063486173330758,0.015204022056113582,0.015430075633090805,0.9972568433988602,1,0.055762525660431925,0.056064937366398386,0.10248169142901008,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_71,0.06868189497170252,0.05997154091411308,6,0.024483279054670282,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.04055850360431834,0.06868189497170252,0.015204022056113582,0.024483279054670282,0.35654723273938754,1,0.055762525660431925,0.0931651740263728,0.10248169142901008,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.015221227969827241,0.022157220991941364,6,0.009045647591390081,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.06953234680544733,0.015221227969827241,0.021296871729988304,0.009045647591390081,0.052630794843513566,1,0.09082921853543563,0.024266875561217323,0.0999121403889792,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_71,0.06953234680544733,0.05216646885597539,6,0.021296871729988304,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.04442206688213971,0.03395961709386441,6,0.013863955623377526,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.06953234680544733,0.04442206688213971,0.021296871729988304,0.013863955623377526,0.3500948742734344,1,0.09082921853543563,0.05828602250551724,0.0999121403889792,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_71,0.05487072240164936,0.061984639272655497,6,0.025305123018080834,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.06953234680544733,0.05487072240164936,0.021296871729988304,0.025305123018080834,0.6672595994531514,1,0.09082921853543563,0.08017584541973019,0.0999121403889792,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.10271804387873555,0.040456867672692014,6,0.01651644706489924,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.05066094789297434,0.10271804387873555,0.01688658852785664,0.01651644706489924,0.05211301737410439,1,0.06754753642083097,0.1192344909436348,0.13115794003799827,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_71,0.05066094789297434,0.041363525389584925,6,0.01688658852785664,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.07771704778164105,0.0669135292351883,6,0.027317333919169344,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.05066094789297434,0.07771704778164105,0.01688658852785664,0.027317333919169344,0.42304232806456443,1,0.06754753642083097,0.10503438170081039,0.13115794003799827,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_71,0.06491153996383596,0.06863792039118435,6,0.02802131366069574,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.05066094789297434,0.06491153996383596,0.01688658852785664,0.02802131366069574,0.6743677675224697,1,0.06754753642083097,0.0929328536245317,0.13115794003799827,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_71,0.05648334968570393,0.04283867629234691,6,0.017488816362085446,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.04391117519955645,0.05648334968570393,0.016280610423546248,0.017488816362085446,0.6102995066255164,1,0.0601917856231027,0.07397216604778938,0.08136938265256832,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_71,0.04391117519955645,0.039879188238725424,6,0.016280610423546248,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_71,0.04011906578110628,0.02680237130753392,6,0.010942022266678416,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.04391117519955645,0.04011906578110628,0.016280610423546248,0.010942022266678416,0.8511222930854496,1,0.0601917856231027,0.0510610880477847,0.08136938265256832,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_71,0.04796091373222559,0.037602506494076954,6,0.015351158993363225,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.04391117519955645,0.04796091373222559,0.016280610423546248,0.015351158993363225,0.8600107963850427,1,0.0601917856231027,0.06331207272558881,0.08136938265256832,0,24,0,14.274117647058825,cellobiose,malt_o_cellobiose_204_361_rt14.40,14.27691358,14.28,0.02184883,14.39,14.03,0.36,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.1532633637788273,0.17315202236494703,6,0.07068901712085021,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.14592431123629696,0.1532633637788273,0.06976694569892533,0.07068901712085021,0.9427269395755795,1,0.2156912569352223,0.2239523808996775,0.3285201272478029,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_29,0.14592431123629696,0.1560036331653336,5,0.06976694569892533,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.18421632072443309,0.19056848108082258,6,0.07779925661754085,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.14592431123629696,0.18421632072443309,0.06976694569892533,0.07779925661754085,0.7225087985995537,1,0.2156912569352223,0.26201557734197395,0.3285201272478029,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_29,0.18933605422962926,0.24444383624456975,5,0.10931860690473696,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.14592431123629696,0.18933605422962926,0.06976694569892533,0.10931860690473696,0.7479092949993722,1,0.2156912569352223,0.29865466113436623,0.3285201272478029,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.2020063909979816,0.19036774183988092,6,0.0777173051655974,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.1702486777415717,0.2020063909979816,0.04028685393744921,0.0777173051655974,0.7267671618519408,1,0.21053553167902092,0.279723696163579,0.3076960657799369,0,23,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_29,0.1702486777415717,0.09868223548878594,6,0.04028685393744921,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.18690501909635696,0.11171356897133382,6,0.04560687355416389,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.1702486777415717,0.18690501909635696,0.04028685393744921,0.04560687355416389,0.7899559249313028,1,0.21053553167902092,0.23251189265052086,0.3076960657799369,0,23,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_29,0.12504883576993678,0.16580248168137926,5,0.07414912397554553,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.1702486777415717,0.12504883576993678,0.04028685393744921,0.07414912397554553,0.6106676567138865,1,0.21053553167902092,0.19919795974548232,0.3076960657799369,0,23,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.0645940021869853,0.03925616699687372,6,0.016026263066637614,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.14715774567565898,0.0645940021869853,0.05702618251384702,0.016026263066637614,0.22651547950698697,1,0.204183928189506,0.08062026525362291,0.22460232100845662,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_29,0.14715774567565898,0.12751442059827178,5,0.05702618251384702,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.13049130202538084,0.1606888246726748,6,0.06560093796926691,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.14715774567565898,0.13049130202538084,0.05702618251384702,0.06560093796926691,0.8522055527305239,1,0.204183928189506,0.19609223999464775,0.22460232100845662,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_29,0.08889260902623757,0.07867491217799409,6,0.032118898399060646,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.14715774567565898,0.08889260902623757,0.05702618251384702,0.032118898399060646,0.40544774543131445,1,0.204183928189506,0.1210115074252982,0.22460232100845662,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.17067206247517333,0.07934877039245385,6,0.032393999863128874,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.20101909528177905,0.17067206247517333,0.10796257398885781,0.032393999863128874,0.7991172382383813,1,0.30898166927063686,0.2030660623383022,0.33987983619770057,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_29,0.20101909528177905,0.2414116544649367,5,0.10796257398885781,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.08648155799356176,0.04932043322018946,6,0.020134982547079468,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.20101909528177905,0.08648155799356176,0.10796257398885781,0.020134982547079468,0.3522855229828779,1,0.30898166927063686,0.10661654054064124,0.33987983619770057,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_29,0.17762309260613915,0.23309170585195477,6,0.09515929043536615,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.20101909528177905,0.17762309260613915,0.10796257398885781,0.09515929043536615,0.8746488055738725,1,0.30898166927063686,0.2727823830415053,0.33987983619770057,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.08510274069539421,0.11646159416839004,6,0.047545246723941434,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.09560283723673872,0.08510274069539421,0.05554167298674507,0.047545246723941434,0.8887234897937111,1,0.1511445102234838,0.13264798741933564,0.2145999077815065,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_29,0.09560283723673872,0.13604875827804955,6,0.05554167298674507,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.12128832052732985,0.07681615572689914,6,0.03136006425551246,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.09560283723673872,0.12128832052732985,0.05554167298674507,0.03136006425551246,0.6978554330322344,1,0.1511445102234838,0.15264838478284232,0.2145999077815065,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_29,0.13779754455864968,0.1403393033983488,6,0.0572932806972653,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.09560283723673872,0.13779754455864968,0.05554167298674507,0.0572932806972653,0.6085029711595165,1,0.1511445102234838,0.19509082525591498,0.2145999077815065,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.06490760918663296,0.06934711630429141,6,0.028310841679825654,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.059671214095097756,0.06490760918663296,0.01595673313676756,0.028310841679825654,0.8760427924736751,1,0.07562794723186532,0.09321845086645862,0.11833403030790307,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_29,0.059671214095097756,0.039085854146840585,6,0.01595673313676756,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.08439707884962437,0.05677748782007497,6,0.02317931233937841,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.059671214095097756,0.08439707884962437,0.01595673313676756,0.02317931233937841,0.40276434610037337,1,0.07562794723186532,0.10757639118900278,0.11833403030790307,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_29,0.04488237975930698,0.04707885852755692,6,0.019219863510865173,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.059671214095097756,0.04488237975930698,0.01595673313676756,0.019219863510865173,0.5674179632914871,1,0.07562794723186532,0.06410224327017215,0.11833403030790307,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.09076132947490063,0.13990869194125186,6,0.057117484306051326,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.1062057672484249,0.09076132947490063,0.06664859629395684,0.057117484306051326,0.8639224581263674,1,0.17285436354238173,0.14787881378095197,0.19013979989661992,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_29,0.1062057672484249,0.16325505299294418,6,0.06664859629395684,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.07411662226821969,0.06673536480499952,6,0.027244598595123307,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.1062057672484249,0.07411662226821969,0.06664859629395684,0.027244598595123307,0.6700326860973118,1,0.17285436354238173,0.101361220863343,0.19013979989661992,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_29,0.07099690789729103,0.06051058173764502,6,0.024703341549367434,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.1062057672484249,0.07099690789729103,0.06664859629395684,0.024703341549367434,0.6370358931890954,1,0.17285436354238173,0.09570024944665846,0.19013979989661992,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_29,0.08706676500072048,0.07280654621741811,6,0.02972314802783918,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.07538011298420526,0.08706676500072048,0.026562117948034775,0.02972314802783918,0.7754562328059558,1,0.10194223093224003,0.11678991302855966,0.12846890433141564,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_29,0.07538011298420526,0.06506363546030813,6,0.026562117948034775,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_29,0.06670669712985718,0.04915465243351147,6,0.020067302824326422,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.07538011298420526,0.06670669712985718,0.026562117948034775,0.020067302824326422,0.8001223172347742,1,0.10194223093224003,0.0867739999541836,0.12846890433141564,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_29,0.05563172364926805,0.02084685878456691,6,0.008510694460341008,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.07538011298420526,0.05563172364926805,0.026562117948034775,0.008510694460341008,0.5054234506879535,1,0.10194223093224003,0.06414241810960905,0.12846890433141564,0,24,0,9.391169102296452,fructose,fructose_307_217_rt9.48,9.412926829,9.405,0.026882512,9.53,9.33,0.2,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,0.11933813006210352,0.13487193150196009,6,0.055061235467234446,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.047785035101195916,0.11933813006210352,0.029517302037291995,0.055061235467234446,0.28725242313609606,1,0.07730233713848791,0.17439936552933796,0.4007914737243476,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_30,0.047785035101195916,0.06600269386777793,5,0.029517302037291995,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,0.19617761468327874,0.289438841416902,6,0.11816291220229141,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.047785035101195916,0.19617761468327874,0.029517302037291995,0.11816291220229141,0.27177006177573404,1,0.07730233713848791,0.3143405268855701,0.4007914737243476,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_30,0.24775017654479173,0.26073829112641905,5,0.11660570865916063,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.047785035101195916,0.24775017654479173,0.029517302037291995,0.11660570865916063,0.16362636560132898,1,0.07730233713848791,0.36435588520395235,0.4007914737243476,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,0.06511389574895987,0.08146291075460266,6,0.03325709405177678,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.056536760011312547,0.06511389574895987,0.026361180795036573,0.03325709405177678,0.8440893586137977,1,0.08289794080634912,0.09837098980073665,0.20472908882177987,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_30,0.056536760011312547,0.06457144196509498,6,0.026361180795036573,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,0.07167339444999166,0.09082383469650458,6,0.037078675248220484,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.056536760011312547,0.07167339444999166,0.026361180795036573,0.037078675248220484,0.7469473910640207,1,0.08289794080634912,0.10875206969821213,0.20472908882177987,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_30,0.112908936750021,0.1793232658516289,6,0.07320841672432432,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.056536760011312547,0.112908936750021,0.026361180795036573,0.07320841672432432,0.4948832174474024,1,0.08289794080634912,0.18611735347434533,0.20472908882177987,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,0.24543194715113761,0.5151911209385501,6,0.21032589438532442,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.10623563523453358,0.24543194715113761,0.07892267433218814,0.21032589438532442,0.5570717646673475,1,0.18515830956672172,0.45575784153646204,0.6453851507644313,2,24,8.333333333333332,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_30,0.10623563523453358,0.1764764647728505,5,0.07892267433218814,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,0.12030314171035801,0.05432766002555482,6,0.022179174330334707,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.10623563523453358,0.12030314171035801,0.07892267433218814,0.022179174330334707,0.8709937495011298,1,0.18515830956672172,0.14248231604069272,0.6453851507644313,2,24,8.333333333333332,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_30,0.3575474498764221,0.561340558916739,6,0.2291663235457881,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.10623563523453358,0.3575474498764221,0.07892267433218814,0.2291663235457881,0.33884544694407975,1,0.18515830956672172,0.5867137734222102,0.6453851507644313,2,24,8.333333333333332,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,0.03946866904232597,0.03812793993998224,6,0.015565666299406594,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.17825325771894943,0.03946866904232597,0.09822747854289651,0.015565666299406594,0.2321175468597438,1,0.27648073626184594,0.05503433534173256,0.4141689786060495,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_30,0.17825325771894943,0.2196433192803186,5,0.09822747854289651,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,0.06656676790895048,0.026021679933047506,6,0.010623306347664455,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.17825325771894943,0.06656676790895048,0.09822747854289651,0.010623306347664455,0.3201429206671963,1,0.27648073626184594,0.07719007425661494,0.4141689786060495,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_30,0.26577094654262584,0.27127194239997404,6,0.11074630673560093,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.17825325771894943,0.26577094654262584,0.09822747854289651,0.11074630673560093,0.5689302698814969,1,0.27648073626184594,0.37651725327822677,0.4141689786060495,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,0.045904612237875675,0.03734627053773314,6,0.015246551102230489,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.07392796147694931,0.045904612237875675,0.020004056384688197,0.015246551102230489,0.29304820023284883,1,0.09393201786163752,0.06115116334010616,0.10332521964780128,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_30,0.07392796147694931,0.048999730928350076,6,0.020004056384688197,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,0.025869825802058728,0.02557620830532469,6,0.01044144331719646,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.07392796147694931,0.025869825802058728,0.020004056384688197,0.01044144331719646,0.06791627912602902,1,0.09393201786163752,0.03631126911925519,0.10332521964780128,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_30,0.033559778440679956,0.02927050501432136,6,0.011949633633110626,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.07392796147694931,0.033559778440679956,0.020004056384688197,0.011949633633110626,0.1206687721697237,1,0.09393201786163752,0.045509412073790584,0.10332521964780128,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,0.04542454342577629,0.03736147672787611,6,0.015252759003360827,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.06319937860449414,0.04542454342577629,0.023870940309266692,0.015252759003360827,0.546836569551632,1,0.08707031891376082,0.06067730242913712,0.09577735080513691,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_30,0.06319937860449414,0.05847162343813826,6,0.023870940309266692,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,0.039225534515893314,0.05946427277341486,6,0.024276187703423453,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.06319937860449414,0.039225534515893314,0.023870940309266692,0.024276187703423453,0.49741167891310023,1,0.08707031891376082,0.06350172221931677,0.09577735080513691,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_30,0.016441173144270998,0.009046030819932905,6,0.0036930266177210257,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.06319937860449414,0.016441173144270998,0.023870940309266692,0.0036930266177210257,0.10803629475893856,1,0.08707031891376082,0.020134199761992023,0.09577735080513691,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,0.041025391060036366,0.035179731321050255,6,0.014362065170796785,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.06228651265224102,0.041025391060036366,0.01244795151629839,0.014362065170796785,0.289947670889346,1,0.0747344641685394,0.05538745623083315,0.08220791058539335,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_30,0.06228651265224102,0.030491129557835214,6,0.01244795151629839,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,0.032027950469620516,0.009575985693997174,6,0.003909379789080756,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.06228651265224102,0.032027950469620516,0.01244795151629839,0.003909379789080756,0.05968585297269089,1,0.0747344641685394,0.03593733025870127,0.08220791058539335,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_30,0.040575012487658935,0.023186540220105068,6,0.009465865406629498,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.06228651265224102,0.040575012487658935,0.01244795151629839,0.009465865406629498,0.19726698044524196,1,0.0747344641685394,0.05004087789428843,0.08220791058539335,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_30,0.044086876323491474,0.04114768696477603,6,0.016798472859911998,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.029654132282743717,0.044086876323491474,0.011344181708318602,0.016798472859911998,0.49494553774651473,1,0.04099831399106232,0.06088534918340347,0.07624214310513067,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_30,0.029654132282743717,0.027787456734794963,6,0.011344181708318602,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_30,0.05098852886885644,0.04488080108506377,6,0.018322510317625974,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.029654132282743717,0.05098852886885644,0.011344181708318602,0.018322510317625974,0.3500203139733665,1,0.04099831399106232,0.06931103918648242,0.07624214310513067,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_30,0.023127399282419248,0.02054044291020068,6,0.008385600703460004,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.029654132282743717,0.023127399282419248,0.011344181708318602,0.008385600703460004,0.6543489698081494,1,0.04099831399106232,0.03151299998587925,0.07624214310513067,0,24,0,8.438305084745762,fucose,fucose_117_160_rt8.54,8.440555556,8.45,0.04098553,8.54,8.22,0.32,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,0.06947285305168349,0.0339117903413347,6,0.013844430433418835,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.11584417132348195,0.06947285305168349,0.045347748899772104,0.013844430433418835,0.37523817121695474,1,0.16119192022325404,0.08331728348510233,0.17731111224557947,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_37,0.11584417132348195,0.10140064916648173,5,0.045347748899772104,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,0.10595336786323946,0.12772573643667764,6,0.052143813548511594,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.11584417132348195,0.10595336786323946,0.045347748899772104,0.052143813548511594,0.8893441608318882,1,0.16119192022325404,0.15809718141175105,0.17731111224557947,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_37,0.09732982157655057,0.0722547669530403,5,0.03231331412108069,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.11584417132348195,0.09732982157655057,0.045347748899772104,0.03231331412108069,0.7489478383036599,1,0.16119192022325404,0.12964313569763125,0.17731111224557947,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,0.10702661619563318,0.06845827266246544,6,0.02794797278256053,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.08938303289074952,0.10702661619563318,0.030521793123879107,0.02794797278256053,0.6789645140321589,1,0.11990482601462862,0.1349745889781937,0.1484720478760131,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_37,0.08938303289074952,0.074762819188292,6,0.030521793123879107,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,0.07192171993892875,0.04188807802375779,6,0.017100736244016028,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.08938303289074952,0.07192171993892875,0.030521793123879107,0.017100736244016028,0.6313831399678044,1,0.11990482601462862,0.08902245618294477,0.1484720478760131,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_37,0.05480710749376039,0.05344561888680817,6,0.021819082543322585,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.08938303289074952,0.05480710749376039,0.030521793123879107,0.021819082543322585,0.38066097964896906,1,0.11990482601462862,0.07662619003708297,0.1484720478760131,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,0.04977296853182726,0.04719466225785763,6,0.019267140185789778,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.04847730710702693,0.04977296853182726,0.024890610700314564,0.019267140185789778,0.9681813724642918,1,0.0733679178073415,0.06904010871761704,0.10566954975617653,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_37,0.04847730710702693,0.05565709752738701,5,0.024890610700314564,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,0.07767845291505508,0.04503331566955294,6,0.018384774136014484,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.04847730710702693,0.07767845291505508,0.024890610700314564,0.018384774136014484,0.3739371928119195,1,0.0733679178073415,0.09606322705106957,0.10566954975617653,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_37,0.05145622364425736,0.027811981941963014,6,0.01135419408221823,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.04847730710702693,0.05145622364425736,0.024890610700314564,0.01135419408221823,0.9170607273511259,1,0.0733679178073415,0.06281041772647558,0.10566954975617653,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,0.1294120393494634,0.1300054661291074,6,0.05307450929816575,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.15617795545329657,0.1294120393494634,0.04362513471839766,0.05307450929816575,0.7059590315493207,1,0.19980309017169423,0.18248654864762914,0.21978339918886367,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_37,0.15617795545329657,0.09754876675792332,5,0.04362513471839766,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,0.13005806006467333,0.07275972129244299,6,0.029704031832266987,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.15617795545329657,0.13005806006467333,0.04362513471839766,0.029704031832266987,0.6351929153033207,1,0.19980309017169423,0.15976209189694032,0.21978339918886367,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_37,0.11603217201433196,0.09756038300681347,6,0.03982885957953131,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.15617795545329657,0.11603217201433196,0.04362513471839766,0.03982885957953131,0.5145387153683927,1,0.19980309017169423,0.15586103159386328,0.21978339918886367,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,0.054090421274299416,0.03584709904118206,6,0.01463451690165136,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.12038838516734929,0.054090421274299416,0.052844271791803676,0.01463451690165136,0.27389006661903487,1,0.17323265695915296,0.06872493817595078,0.4247799586127826,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_37,0.12038838516734929,0.12944150171886953,6,0.052844271791803676,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,0.2544883294204025,0.3225372215738556,6,0.13167526931849077,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.12038838516734929,0.2544883294204025,0.052844271791803676,0.13167526931849077,0.37803701641515364,1,0.17323265695915296,0.3861635987388933,0.4247799586127826,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_37,0.09615721418515943,0.07869791176436149,6,0.032128287940876514,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.12038838516734929,0.09615721418515943,0.052844271791803676,0.032128287940876514,0.7051246692881636,1,0.17323265695915296,0.12828550212603596,0.4247799586127826,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,0.11137946894383144,0.16023197239231712,6,0.06541442880681636,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.16618529251313507,0.11137946894383144,0.06576464932920174,0.06541442880681636,0.5677359999299629,1,0.2319499418423368,0.1767938977506478,0.2551449360265705,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_37,0.16618529251313507,0.16108983396961227,6,0.06576464932920174,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,0.10078709480379788,0.08129254893451385,6,0.03318754412996521,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.16618529251313507,0.10078709480379788,0.06576464932920174,0.03318754412996521,0.40261747742178833,1,0.2319499418423368,0.1339746389337631,0.2551449360265705,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_37,0.08158301209836627,0.07130646822259769,6,0.02911074375089128,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.16618529251313507,0.08158301209836627,0.06576464932920174,0.02911074375089128,0.27851153374616316,1,0.2319499418423368,0.11069375584925756,0.2551449360265705,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,0.3618097670438633,0.3673419868948678,6,0.14996673816542858,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.1990981273595198,0.3618097670438633,0.07790435496451564,0.14996673816542858,0.3655872858623154,1,0.27700248232403546,0.5117765052092919,0.5973503893810763,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_37,0.1990981273595198,0.19082591840372082,6,0.07790435496451564,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,0.06387249759293138,0.06619002181087726,6,0.027021963250056447,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.1990981273595198,0.06387249759293138,0.07790435496451564,0.027021963250056447,0.15064020999066557,1,0.27700248232403546,0.09089446084298783,0.5973503893810763,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_37,0.42085975662190217,0.2992934808557746,6,0.12218605190634892,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.1990981273595198,0.42085975662190217,0.07790435496451564,0.12218605190634892,0.16230089248613394,1,0.27700248232403546,0.5430458085282511,0.5973503893810763,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_37,0.16259358399785082,0.1556497134090125,6,0.06354372941041958,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.14591821695077742,0.16259358399785082,0.057403017383879595,0.06354372941041958,0.8495415121653156,1,0.20332123433465701,0.2261373134082704,0.3402276366579358,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_37,0.14591821695077742,0.14060810228661752,6,0.057403017383879595,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_37,0.22019012500192106,0.21826846207744463,6,0.08910772650529329,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.14591821695077742,0.22019012500192106,0.057403017383879595,0.08910772650529329,0.5021317513498792,1,0.20332123433465701,0.30929785150721434,0.3402276366579358,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_37,0.09784281087561945,0.076706590880935,6,0.03131533459445266,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.14591821695077742,0.09784281087561945,0.057403017383879595,0.03131533459445266,0.48390173307185136,1,0.20332123433465701,0.12915814547007212,0.3402276366579358,0,24,0,10.255135699373696,galacturonic_acid,galacturonic_acid_333_160_rt10.41,10.25158537,10.25,0.023391546,10.39,10.02,0.37,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.07281132937640655,0.02993439245515959,6,0.012220664545893264,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,0.013652698697211463,0.07281132937640655,0.007469124874288347,0.012220664545893264,0.0032677782593851586,0.07842667822524381,0.02112182357149981,0.08503199392229982,0.13249284517981583,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_52,0.013652698697211463,0.016701470951343316,5,0.007469124874288347,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,0.043542449890898505,0.0538809303807851,6,0.021996797716557936,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.013652698697211463,0.043542449890898505,0.007469124874288347,0.021996797716557936,0.24474969114850276,1,0.02112182357149981,0.06553924760745644,0.13249284517981583,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_52,0.08611267251921388,0.07677621811779015,5,0.034335368553345944,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.013652698697211463,0.08611267251921388,0.007469124874288347,0.034335368553345944,0.10215639759384776,1,0.02112182357149981,0.12044804107255982,0.13249284517981583,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.051441124204751,0.0867562185045811,6,0.035418077891604595,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.041354766407492694,0.051441124204751,0.020428947363079715,0.035418077891604595,0.8113669275218318,1,0.06178371377057241,0.08685920209635559,0.10246021706778145,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_52,0.041354766407492694,0.05004049702172121,6,0.020428947363079715,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,0.03183301204857525,0.013754981279135433,6,0.0056154475925694804,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.041354766407492694,0.03183301204857525,0.020428947363079715,0.0056154475925694804,0.669565431110114,1,0.06178371377057241,0.03744845964114473,0.10246021706778145,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_52,0.06414465629655323,0.07103764121166642,6,0.02900099558324808,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.041354766407492694,0.06414465629655323,0.020428947363079715,0.02900099558324808,0.5366390373323755,1,0.06178371377057241,0.09314565187980131,0.10246021706778145,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.06645588936792408,0.10479134331870239,6,0.04278088676527201,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.03033034762129354,0.06645588936792408,0.00903746539238976,0.04278088676527201,0.4433914127366538,1,0.0393678130136833,0.1092367761331961,0.12199419846466165,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_52,0.03033034762129354,0.020208386961685313,5,0.00903746539238976,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,0.06625911618336255,0.05648025879404752,6,0.023057969097626467,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.03033034762129354,0.06625911618336255,0.00903746539238976,0.023057969097626467,0.19359059666932177,1,0.0393678130136833,0.08931708528098903,0.12199419846466165,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_52,0.07453117347092401,0.08909441671832702,6,0.03637264331513203,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.03033034762129354,0.07453117347092401,0.00903746539238976,0.03637264331513203,0.2858415837742867,1,0.0393678130136833,0.11090381678605604,0.12199419846466165,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.04948164554123924,0.03146074338172035,6,0.012843794702309626,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.027948431491772396,0.04948164554123924,0.016802994160084978,0.012843794702309626,0.3388265969795805,1,0.04475142565185737,0.062325440243548864,0.07604162081313526,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_52,0.027948431491772396,0.037572637167482,5,0.016802994160084978,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,0.045964531440352875,0.05674050643809584,6,0.023164214753406444,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.027948431491772396,0.045964531440352875,0.016802994160084978,0.023164214753406444,0.5452433155317394,1,0.04475142565185737,0.06912874619375932,0.07604162081313526,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_52,0.05645689697813413,0.011043786980395378,6,0.004508607154993481,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.027948431491772396,0.05645689697813413,0.016802994160084978,0.004508607154993481,0.16757100829272376,1,0.04475142565185737,0.06096550413312761,0.07604162081313526,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.021836536434269044,0.01496708566494073,6,0.006110287135938244,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.01748178073608601,0.021836536434269044,0.010881757916284556,0.006110287135938244,0.7362874535637212,1,0.028363538652370568,0.027946823570207287,0.2013603570272245,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_52,0.01748178073608601,0.026654754399388667,6,0.010881757916284556,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,0.02035007776181567,0.013409169212665838,6,0.005474270407611493,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.01748178073608601,0.02035007776181567,0.010881757916284556,0.005474270407611493,0.8202465844043608,1,0.028363538652370568,0.025824348169427164,0.2013603570272245,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_52,0.0994902899005657,0.2046905818741713,6,0.08356458012418383,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.01748178073608601,0.0994902899005657,0.010881757916284556,0.08356458012418383,0.37377905592744526,1,0.028363538652370568,0.18305487002474952,0.2013603570272245,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.041355216725670475,0.02902889634071063,6,0.011850997305147803,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.04282428468823148,0.041355216725670475,0.026517037706087633,0.011850997305147803,0.9610894731712463,1,0.06934132239431912,0.05320621403081828,0.14305718182499305,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_52,0.04282428468823148,0.06495321187005643,6,0.026517037706087633,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,0.08473876219641181,0.11099427073991773,6,0.04531322128085459,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.04282428468823148,0.08473876219641181,0.026517037706087633,0.04531322128085459,0.44753962715006823,1,0.06934132239431912,0.1300519834772664,0.14305718182499305,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_52,0.04247304005660638,0.059587022839870815,6,0.02432630020820842,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.04282428468823148,0.04247304005660638,0.026517037706087633,0.02432630020820842,0.9924054696741452,1,0.06934132239431912,0.06679934026481481,0.14305718182499305,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.03793038447719269,0.033567030686688856,6,0.013703682893788757,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.042447114236983184,0.03793038447719269,0.014218410426570502,0.013703682893788757,0.8236969914050096,1,0.056665524663553686,0.051634067370981446,0.10933139939605097,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_52,0.042447114236983184,0.034827850498565835,6,0.014218410426570502,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,0.07331558594418992,0.06387435277516623,6,0.02607659532494732,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.042447114236983184,0.07331558594418992,0.014218410426570502,0.02607659532494732,0.3300691428889463,1,0.056665524663553686,0.09939218126913724,0.10933139939605097,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_52,0.042527575821626064,0.04563957699792082,6,0.01863227928689502,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.042447114236983184,0.042527575821626064,0.014218410426570502,0.01863227928689502,0.9973330122278667,1,0.056665524663553686,0.06115985510852108,0.10933139939605097,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_52,0.027261075783177862,0.034126879362868866,6,0.013932240158757702,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.07839211013563278,0.027261075783177862,0.025138053580070912,0.013932240158757702,0.1140426895441765,1,0.1035301637157037,0.041193315941935565,0.11509600374680479,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_52,0.07839211013563278,0.061575404397917644,6,0.025138053580070912,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_52,0.07985251020278235,0.06069889588018877,6,0.024780220476131085,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.07839211013563278,0.07985251020278235,0.025138053580070912,0.024780220476131085,0.9678131689649799,1,0.1035301637157037,0.10463273067891343,0.11509600374680479,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_52,0.045834395696528286,0.031937536661176075,6,0.013038444743552086,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.07839211013563278,0.045834395696528286,0.025138053580070912,0.013038444743552086,0.28556301502884096,1,0.1035301637157037,0.05887284044008037,0.11509600374680479,0,24,0,4.660901467505241,glycerol,glycerol_117_205_rt4.75,4.683558282,4.68,0.032785893,4.95,4.67,0.28,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.3913910043624846,0.3489893672386893,6,0.1424743125652602,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.5275527222277054,0.3913910043624846,0.14202124638057317,0.1424743125652602,0.5157133767238503,1,0.6695739686082787,0.5338653169277447,0.7365313654691066,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_43,0.5275527222277054,0.3175691611562076,5,0.14202124638057317,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.3614392527627002,0.24237312617932977,6,0.09894841441709355,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.5275527222277054,0.3614392527627002,0.14202124638057317,0.09894841441709355,0.36741282044706125,1,0.6695739686082787,0.4603876671797938,0.7365313654691066,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_43,0.3307323280359496,0.20590342892931612,5,0.09208281277724951,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.5275527222277054,0.3307323280359496,0.14202124638057317,0.09208281277724951,0.28376179831997034,1,0.6695739686082787,0.4228151408131991,0.7365313654691066,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.7115291748535558,1.07121387125401,6,0.4373212316606263,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.6923212793428505,0.7115291748535558,0.46826819693755645,0.4373212316606263,0.9766767722427313,1,1.160589476280407,1.1488504065141822,1.2766484239084477,3,24,12.5,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_43,0.6923212793428505,1.1470181452701176,6,0.46826819693755645,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.4972198304742091,0.3015276010234019,6,0.12309812764547359,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.6923212793428505,0.4972198304742091,0.46826819693755645,0.12309812764547359,0.7016886149809551,1,1.160589476280407,0.6203179581196827,1.2766484239084477,3,24,12.5,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_43,0.7597435845202456,0.7493070978494033,6,0.30590334172945743,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.6923212793428505,0.7597435845202456,0.46826819693755645,0.30590334172945743,0.9068205670032622,1,1.160589476280407,1.065646926249703,1.2766484239084477,3,24,12.5,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.3073999915196383,0.22973774213202483,6,0.09379004048042694,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.8961156917701282,0.3073999915196383,0.4899637418489128,0.09379004048042694,0.2991705874978323,1,1.386079433619041,0.40119003200006526,1.5246873769809453,1,24,4.166666666666666,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_43,0.8961156917701282,1.0955922332843275,5,0.4899637418489128,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.6365818043215177,0.35503169801272855,6,0.1449410837741789,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.8961156917701282,0.6365818043215177,0.4899637418489128,0.1449410837741789,0.6344125598001589,1,1.386079433619041,0.7815228880956966,1.5246873769809453,1,24,4.166666666666666,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_43,0.3034960133156555,0.2878356472072993,6,0.11750841090693954,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.8961156917701282,0.3034960133156555,0.4899637418489128,0.11750841090693954,0.2984468700399965,1,1.386079433619041,0.42100442422259504,1.5246873769809453,1,24,4.166666666666666,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.30624671799788156,0.22472471199791308,6,0.09174347949813198,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.46761950511822076,0.30624671799788156,0.20978215798329036,0.09174347949813198,0.5095914737545653,1,0.6774016631015112,0.39799019749601355,0.7451418294116624,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_43,0.46761950511822076,0.46908716571723746,5,0.20978215798329036,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.2299531503699145,0.22917392584206997,6,0.09355986344391719,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.46761950511822076,0.2299531503699145,0.20978215798329036,0.09355986344391719,0.3436107295159424,1,0.6774016631015112,0.3235130138138317,0.7451418294116624,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_43,0.3611447790819684,0.39882883296208527,6,0.1628211892444689,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.46761950511822076,0.3611447790819684,0.20978215798329036,0.1628211892444689,0.6990027148197906,1,0.6774016631015112,0.5239659683264373,0.7451418294116624,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.06245271649903309,0.030160953970495456,6,0.012313157897214032,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.0624044052136569,0.06245271649903309,0.0175219174027978,0.012313157897214032,0.9982494395984622,1,0.0799263226164547,0.07476587439624713,0.16987106122578047,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_43,0.0624044052136569,0.04291975695204727,6,0.0175219174027978,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.04309691498276617,0.031590909961056644,6,0.012896934985799198,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.0624044052136569,0.04309691498276617,0.0175219174027978,0.012896934985799198,0.3974802170235672,1,0.0799263226164547,0.055993849968565365,0.16987106122578047,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_43,0.11106093037250246,0.1062277739270007,6,0.04336730710547976,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.0624044052136569,0.11106093037250246,0.0175219174027978,0.04336730710547976,0.33487041081401236,1,0.0799263226164547,0.15442823747798223,0.16987106122578047,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.06422173901320138,0.04701117205244598,6,0.019192230623113607,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.08208846843719304,0.06422173901320138,0.03247961350794258,0.019192230623113607,0.6482762305825339,1,0.11456808194513562,0.08341396963631499,0.1260248901396492,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_43,0.08208846843719304,0.0795584801372673,6,0.03247961350794258,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.03735228830955665,0.037967834816188616,6,0.015500303656323343,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.08208846843719304,0.03735228830955665,0.03247961350794258,0.015500303656323343,0.25297766738635646,1,0.11456808194513562,0.05285259196587999,0.1260248901396492,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_43,0.05651021926352473,0.041814635470374895,6,0.01707075344715016,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.08208846843719304,0.05651021926352473,0.03247961350794258,0.01707075344715016,0.5065891916615312,1,0.11456808194513562,0.07358097271067489,0.1260248901396492,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.03986559133372514,0.03425639194253076,6,0.013985113447998234,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.06498724239472746,0.03986559133372514,0.019379111979826415,0.013985113447998234,0.32029520902196085,1,0.08436635437455388,0.05385070478172337,0.12425348910099787,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_43,0.06498724239472746,0.047468936018831405,6,0.019379111979826415,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.07656284362995895,0.08914886990275375,6,0.036394873734584554,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.06498724239472746,0.07656284362995895,0.019379111979826415,0.036394873734584554,0.7863779745210695,1,0.08436635437455388,0.1129577173645435,0.12425348910099787,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_43,0.07902960145812443,0.0328868316160352,6,0.013425992786019292,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.06498724239472746,0.07902960145812443,0.019379111979826415,0.013425992786019292,0.5662557241056616,1,0.08436635437455388,0.09245559424414372,0.12425348910099787,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_43,0.0927510784335237,0.08319928880116412,6,0.03396596742088448,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.07523713046590474,0.0927510784335237,0.037647880292001015,0.03396596742088448,0.7370193303893386,1,0.11288501075790576,0.12671704585440818,0.27154703781968165,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_43,0.07523713046590474,0.09221809661278543,6,0.037647880292001015,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_43,0.09273671402070612,0.07561830853787847,6,0.030871045188357826,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.07523713046590474,0.09273671402070612,0.037647880292001015,0.030871045188357826,0.7270268100462902,1,0.11288501075790576,0.12360775920906394,0.27154703781968165,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_43,0.16842787322923272,0.1921210010557235,6,0.07843307024320514,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.07523713046590474,0.16842787322923272,0.037647880292001015,0.07843307024320514,0.318744995694604,1,0.11288501075790576,0.24686094347243787,0.27154703781968165,0,24,0,8.971058315334773,levoglucosan,"glucose_1,6_ah_betaD_204_217_rt9.11",8.909072848,8.89,0.049656836,9.14,8.88,0.26,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.019880674178513507,0.023037526066536588,6,0.009405030633180246,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.01660672396494576,0.019880674178513507,0.0066338435835287405,0.009405030633180246,0.7828142055550824,1,0.0232405675484745,0.029285704811693753,0.08149214173682379,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_80,0.01660672396494576,0.014833725204871069,5,0.0066338435835287405,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.05464595672552893,0.04761271251786416,6,0.019437808489765417,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.01660672396494576,0.05464595672552893,0.0066338435835287405,0.019437808489765417,0.11243325989596563,1,0.0232405675484745,0.07408376521529435,0.08149214173682379,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_80,0.025325193907854704,0.02605049174995769,5,0.01165013408004057,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.01660672396494576,0.025325193907854704,0.0066338435835287405,0.01165013408004057,0.5383015540801626,1,0.0232405675484745,0.036975327987895275,0.08149214173682379,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.036731328817723084,0.013588819420803163,6,0.005547612297965033,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,0.01533920825579608,0.036731328817723084,0.007010407266334538,0.005547612297965033,0.039000901196000026,0.9360216287040006,0.02234961552213062,0.04227894111568812,0.04650683522725693,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_80,0.01533920825579608,0.01717192069161911,6,0.007010407266334538,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.02942532146845474,0.012993632154059362,6,0.005304628113811017,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.01533920825579608,0.02942532146845474,0.007010407266334538,0.005304628113811017,0.14242175369965573,1,0.02234961552213062,0.03472994958226576,0.04650683522725693,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_80,0.019867675176316674,0.019786993118135497,6,0.00807800611389904,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.01533920825579608,0.019867675176316674,0.007010407266334538,0.00807800611389904,0.6811486374919535,1,0.02234961552213062,0.027945681290215713,0.04650683522725693,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.030855081505384258,0.026368924870140312,6,0.010765068499604825,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.05051649237098532,0.030855081505384258,0.019871683766864892,0.010765068499604825,0.4164225928856003,1,0.07038817613785021,0.04162015000498909,0.07754072989716215,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_80,0.05051649237098532,0.044434435730088984,5,0.019871683766864892,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.039616822358989966,0.024100480605888056,6,0.009838980006711285,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.05051649237098532,0.039616822358989966,0.019871683766864892,0.009838980006711285,0.6407365895277244,1,0.07038817613785021,0.049455802365701254,0.07754072989716215,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_80,0.04479181471401772,0.06295129341647768,6,0.025699757919766048,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.05051649237098532,0.04479181471401772,0.019871683766864892,0.025699757919766048,0.864100645610883,1,0.07038817613785021,0.07049157263378376,0.07754072989716215,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.030472250175838028,0.01774003725981793,6,0.007242339884085904,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.060281752380572054,0.030472250175838028,0.026523107958561623,0.007242339884085904,0.3318147816388257,1,0.08680486033913368,0.03771459005992393,0.1309446240422678,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_80,0.060281752380572054,0.059307472369909464,5,0.026523107958561623,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.07750593267133048,0.10173866152049098,6,0.04153463463982205,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.060281752380572054,0.07750593267133048,0.026523107958561623,0.04153463463982205,0.7355084833755176,1,0.08680486033913368,0.11904056731115253,0.1309446240422678,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_80,0.019614830366066188,0.024499693582561922,6,0.010001958021969381,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.060281752380572054,0.019614830366066188,0.026523107958561623,0.010001958021969381,0.20936804690077748,1,0.08680486033913368,0.029616788388035567,0.1309446240422678,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.021368225423053167,0.023564709587037443,6,0.00962025240418544,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.02586846368560658,0.021368225423053167,0.014570261931932532,0.00962025240418544,0.802617845234195,1,0.04043872561753911,0.030988477827238604,0.04448259817929303,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_80,0.02586846368560658,0.035689707151932946,6,0.014570261931932532,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.027452127876667287,0.009531372783245524,6,0.003891166644533777,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.02586846368560658,0.027452127876667287,0.014570261931932532,0.003891166644533777,0.9199581530814303,1,0.04043872561753911,0.03134329452120106,0.04448259817929303,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_80,0.024842722055574622,0.014632665782115976,6,0.005973760790477913,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.02586846368560658,0.024842722055574622,0.014570261931932532,0.005973760790477913,0.9499834188132069,1,0.04043872561753911,0.030816482846052536,0.04448259817929303,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.029091324649059985,0.035141354604877585,6,0.014346397942025677,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.036675484308825355,0.029091324649059985,0.007758578456910189,0.014346397942025677,0.6548055836808884,1,0.04443406276573554,0.043437722591085665,0.0488774690423091,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_80,0.036675484308825355,0.019004558348780044,6,0.007758578456910189,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.015962006491759235,0.013507314801105407,6,0.005514338176308517,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.036675484308825355,0.015962006491759235,0.007758578456910189,0.005514338176308517,0.057458014911309044,1,0.04443406276573554,0.021476344668067752,0.0488774690423091,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_80,0.03054617449596823,0.030250690574388266,6,0.012349792712345304,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.036675484308825355,0.03054617449596823,0.007758578456910189,0.012349792712345304,0.6848248223466797,1,0.04443406276573554,0.04289596720831353,0.0488774690423091,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.030253347297190647,0.02077982916224228,6,0.008483329731616538,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.03168314924999005,0.030253347297190647,0.01043447981629216,0.008483329731616538,0.9175158467693878,1,0.04211762906628221,0.03873667702880718,0.0650920136440707,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_80,0.03168314924999005,0.025559151281285747,6,0.01043447981629216,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.04364703573574732,0.03803450616989963,6,0.015527522122498777,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.03168314924999005,0.04364703573574732,0.01043447981629216,0.015527522122498777,0.5388677767784873,1,0.04211762906628221,0.059174557858246095,0.0650920136440707,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_80,0.022951540644005803,0.014677147610974267,6,0.005991920421066017,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.03168314924999005,0.022951540644005803,0.01043447981629216,0.005991920421066017,0.4887897564938405,1,0.04211762906628221,0.02894346106507182,0.0650920136440707,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_80,0.01698366482520434,0.011837840191834953,6,0.004832778021101028,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.026790862295424118,0.01698366482520434,0.009131618776238332,0.004832778021101028,0.37171092010621243,1,0.035922481071662446,0.02181644284630537,0.042992917645466665,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_80,0.026790862295424118,0.022367806527402067,6,0.009131618776238332,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_80,0.030872986624638443,0.006751443247751338,6,0.002756265164058275,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.026790862295424118,0.030872986624638443,0.009131618776238332,0.002756265164058275,0.6838502501475792,1,0.035922481071662446,0.03362925178869672,0.042992917645466665,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_80,0.02808658531943305,0.026939207154691863,6,0.010997885267354821,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.026790862295424118,0.02808658531943305,0.009131618776238332,0.010997885267354821,0.9296254889312796,1,0.035922481071662446,0.03908447058678787,0.042992917645466665,0,24,0,14.817079831932771,palatinose,palatinose_204_361_rt14.95,14.81975309,14.82,0.023377821,14.87,14.62,0.25,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.039778417145556556,0.041691002351964865,6,0.01702028043791455,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.09005786464271433,0.039778417145556556,0.027672919406937006,0.01702028043791455,0.1667704897201486,1,0.11773078404965133,0.05679869758347111,0.12950386245461648,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_68,0.09005786464271433,0.061878528929784314,5,0.027672919406937006,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,0.059286679067795424,0.04935644122330975,6,0.02014968275279634,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.09005786464271433,0.059286679067795424,0.027672919406937006,0.02014968275279634,0.39612340414401703,1,0.11773078404965133,0.07943636182059177,0.12950386245461648,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_68,0.04698970659749646,0.05406291359913258,5,0.024177669973871652,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.09005786464271433,0.04698970659749646,0.027672919406937006,0.024177669973871652,0.2754948318253166,1,0.11773078404965133,0.07116737657136811,0.12950386245461648,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.0923843000384726,0.06620563843717972,6,0.027028338711047244,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.03471794010812087,0.0923843000384726,0.014412144533416387,0.027028338711047244,0.0982970523469247,1,0.04913008464153726,0.11941263874951985,0.13135390262447186,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_68,0.03471794010812087,0.03530240020611209,6,0.014412144533416387,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,0.03517724186759227,0.04749509758957791,6,0.019389792396359525,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.03471794010812087,0.03517724186759227,0.014412144533416387,0.019389792396359525,0.9852365754292047,1,0.04913008464153726,0.05456703426395179,0.13135390262447186,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_68,0.03451087531340624,0.04481246644540539,6,0.018294612817805974,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.03471794010812087,0.03451087531340624,0.014412144533416387,0.018294612817805974,0.9930904847486455,1,0.04913008464153726,0.05280548813121222,0.13135390262447186,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.1215801930992979,0.17475609793674887,6,0.07134387823081315,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.06563205963390298,0.1215801930992979,0.024658334612480272,0.07134387823081315,0.485884654693178,1,0.09029039424638324,0.19292407133011105,0.21221647846312217,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_68,0.06563205963390298,0.055137712405441824,5,0.024658334612480272,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,0.06709482738168937,0.05596837043979915,6,0.02284899155209621,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.06563205963390298,0.06709482738168937,0.024658334612480272,0.02284899155209621,0.9662760989084962,1,0.09029039424638324,0.08994381893378559,0.21221647846312217,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_68,0.09122916609244285,0.09525838662348458,6,0.0388890734913833,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.06563205963390298,0.09122916609244285,0.024658334612480272,0.0388890734913833,0.5931725584308241,1,0.09029039424638324,0.13011823958382615,0.21221647846312217,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.04732627572644418,0.04161838533577677,6,0.016990634665197173,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.17929878262027196,0.04732627572644418,0.06742882562533924,0.016990634665197173,0.12246064439824951,1,0.24672760824561119,0.06431691039164135,0.27140036907017234,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_68,0.17929878262027196,0.1507754377412383,5,0.06742882562533924,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,0.07374638708622605,0.06496006494041447,6,0.026519835460345732,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.17929878262027196,0.07374638708622605,0.06742882562533924,0.026519835460345732,0.2024362290075332,1,0.24672760824561119,0.10026622254657178,0.27140036907017234,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_68,0.11744415419480614,0.18107072636391042,6,0.07392181449111637,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.17929878262027196,0.11744415419480614,0.06742882562533924,0.07392181449111637,0.5517681668548715,1,0.24672760824561119,0.1913659686859225,0.27140036907017234,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.08298008596628821,0.08278673225664639,6,0.03379754191686544,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.08414221037474297,0.08298008596628821,0.03887601238447212,0.03379754191686544,0.9824537454345218,1,0.12301822275921509,0.11677762788315366,0.13532004503513662,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_68,0.08414221037474297,0.09522639357607625,6,0.03887601238447212,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,0.06804553569629908,0.07026280638480308,6,0.028684670589789258,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.08414221037474297,0.06804553569629908,0.03887601238447212,0.028684670589789258,0.7464707091687613,1,0.12301822275921509,0.09673020628608833,0.13532004503513662,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_68,0.08444606481386001,0.0349752018724197,6,0.014278566373043845,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.08414221037474297,0.08444606481386001,0.03887601238447212,0.014278566373043845,0.9943721259486806,1,0.12301822275921509,0.09872463118690386,0.13532004503513662,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.07599648812023248,0.07232837954865698,6,0.029527937302760647,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.11180667841080472,0.07599648812023248,0.04800696659547903,0.029527937302760647,0.5422841003450052,1,0.15981364500628376,0.10552442542299312,0.17579500950691215,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_68,0.11180667841080472,0.11759257225776056,6,0.04800696659547903,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,0.06017456085816142,0.062393817566408424,6,0.025472169357000387,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.11180667841080472,0.06017456085816142,0.04800696659547903,0.025472169357000387,0.37127816408876685,1,0.15981364500628376,0.08564673021516181,0.17579500950691215,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_68,0.04971924287871373,0.03990596828828559,6,0.016291543332997722,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.11180667841080472,0.04971924287871373,0.04800696659547903,0.016291543332997722,0.2656116143849987,1,0.15981364500628376,0.06601078621171146,0.17579500950691215,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.07616066436786384,0.08970202316899065,6,0.036620697609890264,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.09614296538984994,0.07616066436786384,0.02820240028703639,0.036620697609890264,0.6752746757960183,1,0.12434536567688634,0.1127813619777541,0.13677990224457498,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_68,0.09614296538984994,0.06908149022496099,6,0.02820240028703639,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,0.0663865630499932,0.052072896722567354,6,0.021258671066489418,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.09614296538984994,0.0663865630499932,0.02820240028703639,0.021258671066489418,0.42063214767941204,1,0.12434536567688634,0.08764523411648262,0.13677990224457498,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_68,0.044789495180328265,0.05601035177778258,6,0.022866130361559333,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.09614296538984994,0.044789495180328265,0.02820240028703639,0.022866130361559333,0.1888785900833009,1,0.12434536567688634,0.0676556255418876,0.13677990224457498,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_68,0.060270544167642624,0.0945508537311615,6,0.03860022439764545,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.06226323457289921,0.060270544167642624,0.0239230847298159,0.03860022439764545,0.9660318162385448,1,0.08618631930271511,0.09887076856528806,0.10875784542181688,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_68,0.06226323457289921,0.058599350661416916,6,0.0239230847298159,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_68,0.056949720233644786,0.061012646475983076,6,0.02490830862049613,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.06226323457289921,0.056949720233644786,0.0239230847298159,0.02490830862049613,0.880790193803697,1,0.08618631930271511,0.08185802885414092,0.10875784542181688,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_68,0.0560978638612993,0.035790642862374954,6,0.014611468763167237,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.06226323457289921,0.0560978638612993,0.0239230847298159,0.014611468763167237,0.8312485728768704,1,0.08618631930271511,0.07070933262446653,0.10875784542181688,0,24,0,8.057372881355933,pectin,lyxose_xylose_307_217_rt8.16,8.063292683,8.06,0.03577554,8.26,7.83,0.43,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.7055541384042051,0.6093052438350165,6,0.24874782416631272,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.3730784509552642,0.7055541384042051,0.13026497841765095,0.24874782416631272,0.2729244982891242,1,0.5033434293729151,0.9543019625705178,1.0497321588275697,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_93,0.3730784509552642,0.29128134682941054,5,0.13026497841765095,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.5606426942714688,0.5882616977765641,6,0.24015683246265196,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.3730784509552642,0.5606426942714688,0.13026497841765095,0.24015683246265196,0.512894971013276,1,0.5033434293729151,0.8007995267341208,1.0497321588275697,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_93,0.15004295337779885,0.17241014756628648,5,0.0771041619937973,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.3730784509552642,0.15004295337779885,0.13026497841765095,0.0771041619937973,0.18737045663138502,1,0.5033434293729151,0.22714711537159615,1.0497321588275697,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.5535795671915644,0.8867981388344074,6,0.3620338241656823,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.44904505626643876,0.5535795671915644,0.15032467397856594,0.3620338241656823,0.7977748772881798,1,0.5993697302450047,0.9156133913572467,1.0071747304929715,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_93,0.44904505626643876,0.36821874699772256,6,0.15032467397856594,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.42595178994841226,0.3759416670717432,6,0.1534775428961739,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.44904505626643876,0.42595178994841226,0.15032467397856594,0.1534775428961739,0.9165237352453572,1,0.5993697302450047,0.5794293328445862,1.0071747304929715,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_93,0.6433025955681597,0.274061806431023,6,0.11188526395690329,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.44904505626643876,0.6433025955681597,0.15032467397856594,0.11188526395690329,0.3262752119834346,1,0.5993697302450047,0.755187859525063,1.0071747304929715,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.8434064346751673,0.4645846957686738,6,0.18966590782323497,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.5829255457113124,0.8434064346751673,0.2397841526505747,0.18966590782323497,0.41883653563426826,1,0.8227096983618871,1.0330723424984023,1.1363795767482425,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_93,0.5829255457113124,0.5361736652538714,5,0.2397841526505747,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.4933684070037617,0.47855292668127986,6,0.19536841421411089,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.5829255457113124,0.4933684070037617,0.2397841526505747,0.19536841421411089,0.7793583945545862,1,0.8227096983618871,0.6887368212178726,1.1363795767482425,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_93,0.359112490560494,0.3987862251144507,6,0.16280379466351175,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.5829255457113124,0.359112490560494,0.2397841526505747,0.16280379466351175,0.4642542899062442,1,0.8227096983618871,0.5219162852240058,1.1363795767482425,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.19265844933331588,0.16801349111293773,6,0.06859122052172227,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.45370153728321,0.19265844933331588,0.39286706917123965,0.06859122052172227,0.5465358769905502,1,0.8465686064544496,0.26124966985503817,0.9312254670998947,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_93,0.45370153728321,0.8784774727880038,5,0.39286706917123965,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.4873694871176972,0.3587640916085623,6,0.1464648270790163,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.45370153728321,0.4873694871176972,0.39286706917123965,0.1464648270790163,0.9390494542845274,1,0.8465686064544496,0.6338343141967135,0.9312254670998947,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_93,0.5563201910460859,0.32687722011302545,6,0.13344706630272252,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.45370153728321,0.5563201910460859,0.39286706917123965,0.13344706630272252,0.814637250408724,1,0.8465686064544496,0.6897672573488084,0.9312254670998947,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.26261549568388826,0.18143502732394506,6,0.07407053973526485,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.23681198343126766,0.26261549568388826,0.08308775688935846,0.07407053973526485,0.821416201588115,1,0.3198997403206261,0.3366860354191531,0.38957221676944137,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_93,0.23681198343126766,0.20352260825134588,6,0.08308775688935846,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.27017162329876127,0.2057202427113776,6,0.08398493740073089,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.23681198343126766,0.27017162329876127,0.08308775688935846,0.08398493740073089,0.7834155727984222,1,0.3198997403206261,0.35415656069949214,0.38957221676944137,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_93,0.18947426121336022,0.14486169364942011,6,0.059139538786075606,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.23681198343126766,0.18947426121336022,0.08308775688935846,0.059139538786075606,0.6535175009903057,1,0.3198997403206261,0.24861379999943584,0.38957221676944137,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.1725955956738681,0.2058677803525512,6,0.08404516939051909,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.31136115697886696,0.1725955956738681,0.1368678770951605,0.08404516939051909,0.4118679813660274,1,0.4482290340740275,0.25664076506438716,0.6105014297098482,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_93,0.31136115697886696,0.33525646106110424,6,0.1368678770951605,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.4472486060954911,0.26393911783023727,6,0.10775269364073448,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.31136115697886696,0.4472486060954911,0.1368678770951605,0.10775269364073448,0.4543756720198835,1,0.4482290340740275,0.5550012997362256,0.6105014297098482,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_93,0.3539945692456425,0.3430696790085805,6,0.14005760996523922,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.31136115697886696,0.3539945692456425,0.1368678770951605,0.14005760996523922,0.8320373640886047,1,0.4482290340740275,0.49405217921088174,0.6105014297098482,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.29488563710163596,0.1527101952803957,6,0.06234367615962423,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.2046064267359657,0.29488563710163596,0.10240321895501506,0.06234367615962423,0.4723502428129348,1,0.30700964569098077,0.3572293132612602,0.3929522445873862,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_93,0.2046064267359657,0.25083563445828927,6,0.10240321895501506,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.1324869708518339,0.12037167017259533,6,0.04914152856824202,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.2046064267359657,0.1324869708518339,0.10240321895501506,0.04914152856824202,0.5451412006027878,1,0.30700964569098077,0.18162849942007592,0.3929522445873862,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_93,0.15212753517774383,0.19139529027656493,6,0.07813680005824246,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.2046064267359657,0.15212753517774383,0.10240321895501506,0.07813680005824246,0.6928746262243957,1,0.30700964569098077,0.23026433523598627,0.3929522445873862,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_93,0.19831042021040612,0.20851713606800326,6,0.08512676433218305,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.26343551713662305,0.19831042021040612,0.07451497184742716,0.08512676433218305,0.5777927773168148,1,0.3379504889840502,0.28343718454258915,0.7369939899599157,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_93,0.26343551713662305,0.1825236592240501,6,0.07451497184742716,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_93,0.5450701123769904,0.30600109508912593,6,0.12492442395020566,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.26343551713662305,0.5450701123769904,0.07451497184742716,0.12492442395020566,0.08816588943046488,1,0.3379504889840502,0.6699945363271961,0.7369939899599157,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_93,0.4230385543375124,0.17592012774945953,6,0.07181909141190125,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.26343551713662305,0.4230385543375124,0.07451497184742716,0.07181909141190125,0.15409701739816553,1,0.3379504889840502,0.49485764574941365,0.7369939899599157,0,24,0,16.904147368421054,raffinose,raffinose_437_451_rt16.91,16.90124224,16.9,0.023842131,16.99,16.77,0.22,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,0.12775883285382195,0.1537156242621037,6,0.06275414082258934,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.09960989615712963,0.12775883285382195,0.05632651066641092,0.06275414082258934,0.7461665722008544,1,0.15593640682354054,0.1905129736764113,0.4481451826725384,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_94,0.09960989615712963,0.1259499067854618,5,0.05632651066641092,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,0.24125000361705518,0.3512905257978838,6,0.14341375661313763,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.09960989615712963,0.24125000361705518,0.05632651066641092,0.14341375661313763,0.39094138176393356,1,0.15593640682354054,0.3846637602301928,0.4481451826725384,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_94,0.2573198866958036,0.33559987069914543,5,0.1500848248246858,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.09960989615712963,0.2573198866958036,0.05632651066641092,0.1500848248246858,0.36951289300306595,1,0.15593640682354054,0.4074047115204894,0.4481451826725384,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,0.130478782034678,0.15164814533135634,6,0.061910096083541685,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.09312269194331124,0.130478782034678,0.027938674069929833,0.061910096083541685,0.5995383994101611,1,0.12106136601324108,0.1923888781182197,0.2598785097587676,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_94,0.09312269194331124,0.06843549556125547,6,0.027938674069929833,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,0.06617976454698653,0.08522469652489614,6,0.03479283666159038,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.09312269194331124,0.06617976454698653,0.027938674069929833,0.03479283666159038,0.5600343616574559,1,0.12106136601324108,0.1009726012085769,0.2598785097587676,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_94,0.14308825345925857,0.2282065581332221,6,0.09316493723053011,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.09312269194331124,0.14308825345925857,0.027938674069929833,0.09316493723053011,0.6261421271723167,1,0.12106136601324108,0.23625319068978867,0.2598785097587676,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,0.10210542224763637,0.08145381192424063,6,0.03325337946983626,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.11799424824212439,0.10210542224763637,0.10016254009117123,0.03325337946983626,0.886351239829152,1,0.2181567883332956,0.13535880171747264,0.2858668277742817,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_94,0.11799424824212439,0.22397024844290686,5,0.10016254009117123,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,0.15208003106169313,0.04037323270733094,6,0.016482303233267576,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.11799424824212439,0.15208003106169313,0.10016254009117123,0.016482303233267576,0.7530768175511061,1,0.2181567883332956,0.1685623342949607,0.2858668277742817,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_94,0.16665839069986302,0.22834276546381438,6,0.09322054364039305,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.11799424824212439,0.16665839069986302,0.10016254009117123,0.09322054364039305,0.7305660372861023,1,0.2181567883332956,0.25987893434025605,0.2858668277742817,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,0.08247900869284641,0.048912514932761615,6,0.019968450603588102,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.22447518604944827,0.08247900869284641,0.10822321506001938,0.019968450603588102,0.2623488755268617,1,0.33269840110946763,0.1024474592964345,0.5572545877315576,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_94,0.22447518604944827,0.24199446561778232,5,0.10822321506001938,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,0.08537114286831075,0.07178196429847922,6,0.029304864210992192,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.22447518604944827,0.08537114286831075,0.10822321506001938,0.029304864210992192,0.27439233808794583,1,0.33269840110946763,0.11467600707930295,0.5572545877315576,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_94,0.36266211633925544,0.35256231753760775,6,0.143932963416706,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.22447518604944827,0.36266211633925544,0.10822321506001938,0.143932963416706,0.46305923710555275,1,0.33269840110946763,0.5065950797559614,0.5572545877315576,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,0.02444993223112002,0.0233123633491511,6,0.009517232483963353,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.04600723984229327,0.02444993223112002,0.011216857776313158,0.009517232483963353,0.17431579530899322,1,0.057224097618606425,0.033967164715083376,0.09845575453327828,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_94,0.04600723984229327,0.027475578069336804,6,0.011216857776313158,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,0.025091279518234828,0.01114637563713174,6,0.0045504887987270854,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.04600723984229327,0.025091279518234828,0.011216857776313158,0.0045504887987270854,0.13021201355732764,1,0.057224097618606425,0.029641768316961914,0.09845575453327828,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_94,0.057290688520030976,0.07890919233796494,6,0.032214542873858346,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.04600723984229327,0.057290688520030976,0.011216857776313158,0.032214542873858346,0.7517124447672208,1,0.057224097618606425,0.08950523139388933,0.09845575453327828,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,0.05599730443573033,0.060366601959836265,6,0.02464456205121564,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.0601819225360772,0.05599730443573033,0.01583789993048986,0.02464456205121564,0.8897307410443688,1,0.07601982246656706,0.08064186648694598,0.08870605313564058,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_94,0.0601819225360772,0.03879477342696132,6,0.01583789993048986,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,0.025646066575473563,0.012843876880519108,6,0.0052434907794002604,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.0601819225360772,0.025646066575473563,0.01583789993048986,0.0052434907794002604,0.0832395260574195,1,0.07601982246656706,0.030889557354873823,0.08870605313564058,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_94,0.027358114259559956,0.021488004684082903,6,0.008772441177756328,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.0601819225360772,0.027358114259559956,0.01583789993048986,0.008772441177756328,0.10834051896500675,1,0.07601982246656706,0.03613055543731628,0.08870605313564058,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,0.03657243192363224,0.025611333730389214,6,0.010455783211930868,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.022877703010932542,0.03657243192363224,0.008760277030166134,0.010455783211930868,0.3397744473307991,1,0.031637980041098676,0.047028215135563115,0.05173103664911943,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_94,0.022877703010932542,0.021458208729331026,6,0.008760277030166134,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,0.017193437320416043,0.014690855752902491,6,0.00599751674657365,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.022877703010932542,0.017193437320416043,0.008760277030166134,0.00599751674657365,0.6055661538562143,1,0.031637980041098676,0.02319095406698969,0.05173103664911943,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_94,0.01738903969693843,0.021796299412015215,6,0.008898301973393715,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.022877703010932542,0.01738903969693843,0.008760277030166134,0.008898301973393715,0.6696090220461506,1,0.031637980041098676,0.026287341670332143,0.05173103664911943,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_94,0.05851369492928823,0.05464126997820738,6,0.022307205057377568,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.046517660409327734,0.05851369492928823,0.013346639847832527,0.022307205057377568,0.6564928380921334,1,0.05986430025716026,0.08082089998666579,0.08890298998533237,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_94,0.046517660409327734,0.03269245740788701,6,0.013346639847832527,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_94,0.041284824035450716,0.04951458183261064,6,0.020214243386196346,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.046517660409327734,0.041284824035450716,0.013346639847832527,0.020214243386196346,0.8339659542318093,1,0.05986430025716026,0.06149906742164706,0.08890298998533237,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_94,0.053726630901373085,0.04574109266348423,6,0.018673722883816586,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.046517660409327734,0.053726630901373085,0.013346639847832527,0.018673722883816586,0.760582291848627,1,0.05986430025716026,0.07240035378518966,0.08890298998533237,0,24,0,8.304651162790698,rhamnose,rhamnose_117_160_rt8.43,8.336463415,8.34,0.044539138,8.45,8.11,0.34,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.290960842747738,0.2939670975859197,6,0.12001156504207533,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.3604018895406516,0.290960842747738,0.18136505453192497,0.12001156504207533,0.7585984866771269,1,0.5417669440725765,0.4109724077898133,0.7652757260845495,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_104,0.3604018895406516,0.4055445906763406,5,0.18136505453192497,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.3344284326531752,0.3035486752364273,6,0.12392322773784181,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.3604018895406516,0.3344284326531752,0.18136505453192497,0.12392322773784181,0.9090500857659519,1,0.5417669440725765,0.458351660391017,0.7652757260845495,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_104,0.4649584615619271,0.5159654051025002,5,0.23074674396948144,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.3604018895406516,0.4649584615619271,0.18136505453192497,0.23074674396948144,0.731367850662836,1,0.5417669440725765,0.6957052055314086,0.7652757260845495,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.24489022099876334,0.25679268718415194,6,0.10483517554655158,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.33023802838363897,0.24489022099876334,0.24472510239450834,0.10483517554655158,0.7581934203949603,1,0.5749631307781473,0.3497253965453149,0.6324594438559621,0,23,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_104,0.33023802838363897,0.5994516281169111,6,0.24472510239450834,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.25754925987338834,0.2272002674463594,6,0.0927541207779087,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.33023802838363897,0.25754925987338834,0.24472510239450834,0.0927541207779087,0.7899560854954564,1,0.5749631307781473,0.35030338065129707,0.6324594438559621,0,23,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_104,0.2953197819441159,0.42290414717636826,5,0.18912848421058703,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.33023802838363897,0.2953197819441159,0.24472510239450834,0.18912848421058703,0.9126383367327427,1,0.5749631307781473,0.48444826615470293,0.6324594438559621,0,23,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.1108099625694204,0.07067837911408152,6,0.028854327446080585,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.14902865725308329,0.1108099625694204,0.11154438548282442,0.028854327446080585,0.7548730764783447,1,0.2605730427359077,0.13966429001550099,0.4173327955033555,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_104,0.14902865725308329,0.24942082844803612,5,0.11154438548282442,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.2640276475901214,0.28258735079182484,6,0.11536580286747447,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.14902865725308329,0.2640276475901214,0.11154438548282442,0.11536580286747447,0.4918882215351714,1,0.2605730427359077,0.37939345045759587,0.4173327955033555,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_104,0.25265213203003767,0.1622895671922254,6,0.06625443836634626,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.14902865725308329,0.25265213203003767,0.11154438548282442,0.06625443836634626,0.45200171853391924,1,0.2605730427359077,0.3189065703963839,0.4173327955033555,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.44470380888213507,0.4583222500738708,6,0.18710927507420888,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.6410122743924904,0.44470380888213507,0.3554210316249802,0.18710927507420888,0.6419755039492647,1,0.9964333060174706,0.631813083956344,1.3957941715834783,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_104,0.6410122743924904,0.7947455873465583,5,0.3554210316249802,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.34290491675197315,0.5763869096653742,6,0.23530897051663807,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.6410122743924904,0.34290491675197315,0.3554210316249802,0.23530897051663807,0.5063660741154312,1,0.9964333060174706,0.5782138872686112,1.3957941715834783,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_104,0.8614537465875042,0.9980447077883813,6,0.4074500457611124,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.6410122743924904,0.8614537465875042,0.3554210316249802,0.4074500457611124,0.6930215303984663,1,0.9964333060174706,1.2689037923486166,1.3957941715834783,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.023586665569377423,0.022705352936420495,6,0.00926942152067232,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.02159635168769129,0.023586665569377423,0.007309924475195238,0.00926942152067232,0.869652467031875,1,0.028906276162886525,0.032856087090049745,0.057144583190862505,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_104,0.02159635168769129,0.01790558502251044,6,0.007309924475195238,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.022484822161901914,0.027842100972693507,6,0.011366490125024383,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.02159635168769129,0.022484822161901914,0.007309924475195238,0.011366490125024383,0.9490964524635436,1,0.028906276162886525,0.0338513122869263,0.057144583190862505,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_104,0.03459491578775934,0.04251017260874268,6,0.017354705294842936,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.02159635168769129,0.03459491578775934,0.007309924475195238,0.017354705294842936,0.5131552200194929,1,0.028906276162886525,0.051949621082602274,0.057144583190862505,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.05510431553920784,0.06774865546697996,6,0.02765827277561982,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.05939488064474974,0.05510431553920784,0.036325527006508956,0.02765827277561982,0.9271146554784803,1,0.0957204076512587,0.08276258831482766,0.13083693454222084,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_104,0.05939488064474974,0.088979005803637,6,0.036325527006508956,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.07256088779819218,0.09246764897661237,6,0.037749759617914574,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.05939488064474974,0.07256088779819218,0.036325527006508956,0.037749759617914574,0.8066681732353691,1,0.0957204076512587,0.11031064741610676,0.13083693454222084,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_104,0.11100392366534839,0.019445872244282257,6,0.007938744100306915,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.05939488064474974,0.11100392366534839,0.036325527006508956,0.007938744100306915,0.21896764309560846,1,0.0957204076512587,0.1189426677656553,0.13083693454222084,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.030050483732751026,0.02296553544559679,6,0.009375640585252141,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.025231288042276773,0.030050483732751026,0.005756505963636528,0.009375640585252141,0.6725359647414171,1,0.0309877940059133,0.039426124318003165,0.04336873674980349,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_104,0.025231288042276773,0.014100502312197867,6,0.005756505963636528,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.0227217199977446,0.03134566473600984,6,0.012796814041929413,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.025231288042276773,0.0227217199977446,0.005756505963636528,0.012796814041929413,0.8631643389558686,1,0.0309877940059133,0.03551853403967401,0.04336873674980349,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_104,0.029452229734703888,0.024250776586001336,6,0.009900338083656122,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.025231288042276773,0.029452229734703888,0.005756505963636528,0.009900338083656122,0.7219722482358432,1,0.0309877940059133,0.03935256781836001,0.04336873674980349,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_104,0.06504180513704864,0.08446475027077387,6,0.03448258990250055,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.04478141072924524,0.06504180513704864,0.022850917054254904,0.03448258990250055,0.6364311507075098,1,0.06763232778350015,0.09952439503954918,0.16898147476407724,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_104,0.04478141072924524,0.055973086937586576,6,0.022850917054254904,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_104,0.03288727957223466,0.026996361757900017,6,0.011021218536406691,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.04478141072924524,0.03288727957223466,0.022850917054254904,0.011021218536406691,0.6530440126472302,1,0.06763232778350015,0.04390849810864135,0.16898147476407724,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_104,0.13141670757517362,0.05438556745062276,6,0.022202814937623855,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,0.04478141072924524,0.13141670757517362,0.022850917054254904,0.022202814937623855,0.02160660721283264,0.5185585731079834,0.06763232778350015,0.15361952251279748,0.16898147476407724,0,24,0,13.6383857442348,sucrose,sucrose_437_361_rt13.77,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.0927187569546083,0.10846198042128016,6,0.04427941808731261,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.19206099382448943,0.0927187569546083,0.0845453976547271,0.04427941808731261,0.3372458055095258,1,0.2766063914792165,0.1369981750419209,0.6807907639140123,1,24,4.166666666666666,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.8,967514 MM WT,MoneyMaker,m_108,0.19206099382448943,0.1890492563407211,5,0.0845453976547271,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.13568981551339152,0.12438954606344108,6,0.05078181953197577,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.19206099382448943,0.13568981551339152,0.0845453976547271,0.05078181953197577,0.5862401274291447,1,0.2766063914792165,0.1864716350453673,0.6807907639140123,1,24,4.166666666666666,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_108,0.39629251980894986,0.49776701088318065,5,0.2226081746583339,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.19206099382448943,0.39629251980894986,0.0845453976547271,0.2226081746583339,0.42930902329025467,1,0.2766063914792165,0.6189006944672838,0.6807907639140123,1,24,4.166666666666666,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.07524480387820476,0.03700510416749563,6,0.015107270514817266,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.12677935905444734,0.07524480387820476,0.025719701848113154,0.015107270514817266,0.1219200037092085,1,0.1524990609025605,0.09035207439302202,0.2245804635112184,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.6,967514 MM WT,MoneyMaker,m_108,0.12677935905444734,0.06300014586439472,6,0.025719701848113154,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.1326791855466131,0.10782671688292272,6,0.04402007283378416,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.12677935905444734,0.1326791855466131,0.025719701848113154,0.04402007283378416,0.9107055084499569,1,0.1524990609025605,0.17669925838039724,0.2245804635112184,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_108,0.1489968879848268,0.135131416447481,6,0.05516716975264446,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.12677935905444734,0.1489968879848268,0.025719701848113154,0.05516716975264446,0.7257696479932061,1,0.1524990609025605,0.20416405773747126,0.2245804635112184,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.15256546963872816,0.1775773378558008,6,0.07249564460475451,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.09991540431005488,0.15256546963872816,0.025434954721459728,0.07249564460475451,0.517986309063943,1,0.12535035903151462,0.22506111424348269,0.3388240581582074,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,1,967514 MM WT,MoneyMaker,m_108,0.09991540431005488,0.056874287761813185,5,0.025434954721459728,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.11837715386641141,0.11628351638007575,6,0.04747254677129254,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.09991540431005488,0.11837715386641141,0.025434954721459728,0.04747254677129254,0.7411521862341734,1,0.12535035903151462,0.16584970063770396,0.3388240581582074,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_108,0.22591419098052834,0.20112192014103572,6,0.08210768007238742,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.09991540431005488,0.22591419098052834,0.025434954721459728,0.08210768007238742,0.19355707001771458,1,0.12535035903151462,0.3080218710529158,0.3388240581582074,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.07865672904089786,0.05191888697560814,6,0.021195796850578548,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.24766897967014123,0.07865672904089786,0.10685820410940479,0.021195796850578548,0.1905822132095976,1,0.354527183779546,0.09985252589147642,0.3899799021575006,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.4,967514 MM WT,MoneyMaker,m_108,0.24766897967014123,0.2389422083421765,5,0.10685820410940479,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.07440051614280252,0.07258426024103697,6,0.029632400157987484,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.24766897967014123,0.07440051614280252,0.10685820410940479,0.029632400157987484,0.18370680382147114,1,0.354527183779546,0.10403291630079001,0.3899799021575006,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_108,0.14475776348297323,0.11910451877237457,6,0.048624216175343,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.24766897967014123,0.14475776348297323,0.10685820410940479,0.048624216175343,0.4165163414060194,1,0.354527183779546,0.19338197965831622,0.3899799021575006,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.1129054282878903,0.10589322323310509,6,0.04323072735662337,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.1919644086456953,0.1129054282878903,0.058202098356855254,0.04323072735662337,0.3031615347734345,1,0.25016650700255055,0.15613615564451366,0.4060274815026611,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.8,967514 MM WT,MoneyMaker,m_108,0.1919644086456953,0.1425654429335746,6,0.058202098356855254,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.25049555658925676,0.19827961631115132,6,0.08094731439285822,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.1919644086456953,0.25049555658925676,0.058202098356855254,0.08094731439285822,0.5714598562732076,1,0.25016650700255055,0.331442870982115,0.4060274815026611,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_108,0.2698950012843083,0.2430405547518657,6,0.09922089099083808,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.1919644086456953,0.2698950012843083,0.058202098356855254,0.09922089099083808,0.5170395942491541,1,0.25016650700255055,0.3691158922751464,0.4060274815026611,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.16308471442299796,0.16796476219623166,6,0.06857132702478087,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.1435067634544319,0.16308471442299796,0.058958222924162335,0.06857132702478087,0.8330533493334887,1,0.20246498637859422,0.23165604144777885,0.31756945421071003,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.6,967514 MM WT,MoneyMaker,m_108,0.1435067634544319,0.14441756230545966,6,0.058958222924162335,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.23368024845979382,0.13476910167978895,6,0.055019255368124374,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.1435067634544319,0.23368024845979382,0.058958222924162335,0.055019255368124374,0.28974920157027306,1,0.20246498637859422,0.2886995038279182,0.31756945421071003,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_108,0.12163360016244473,0.09722464373192301,6,0.0396917945945157,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.1435067634544319,0.12163360016244473,0.058958222924162335,0.0396917945945157,0.7654622035147658,1,0.20246498637859422,0.16132539475696045,0.31756945421071003,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.22697505177704827,0.12293456291283579,6,0.05018782514808743,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.28166336787257557,0.22697505177704827,0.08777966892781167,0.05018782514808743,0.6034199064880873,1,0.36944303680038726,0.2771628769251357,0.406387340480426,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,1,967514 MM WT,MoneyMaker,m_108,0.28166336787257557,0.2150153986635779,6,0.08777966892781167,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.18587685533773182,0.18062756476654432,6,0.07374089452659242,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.28166336787257557,0.18587685533773182,0.08777966892781167,0.07374089452659242,0.4235047289764946,1,0.36944303680038726,0.25961774986432423,0.406387340480426,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_108,0.13275013676724953,0.12948485981183988,6,0.05286197265913659,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.28166336787257557,0.13275013676724953,0.08777966892781167,0.05286197265913659,0.18329973167827643,1,0.36944303680038726,0.18561210942638612,0.406387340480426,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_108,0.39903292885490854,0.4999080116788988,6,0.20408659115709932,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.18146061034564967,0.39903292885490854,0.07990506971906637,0.20408659115709932,0.35637230723555713,1,0.26136568006471605,0.6031195200120079,0.6634314720132087,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.4,967514 MM WT,MoneyMaker,m_108,0.18146061034564967,0.19572664867322778,6,0.07990506971906637,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_108,0.20953261610380502,0.2823835488428582,6,0.11528260107021564,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.18146061034564967,0.20953261610380502,0.07990506971906637,0.11528260107021564,0.8458736525017894,1,0.26136568006471605,0.3248152171740207,0.6634314720132087,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_108,0.29529400963475794,0.24581567026535248,6,0.1003538271550588,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.18146061034564967,0.29529400963475794,0.07990506971906637,0.1003538271550588,0.39673218940915755,1,0.26136568006471605,0.39564783678981674,0.6634314720132087,0,24,0,14.21370786516854,trehalose,trehalose_alpha_alpha_191_169_rt14.33,14.20893082,14.21,0.031069363,14.4,13.92,0.48,FALSE,carbohydrate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.13503416919033673,0.10383016524133477,6,0.042388487458355335,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.0884914028528125,0.13503416919033673,0.045679633168751864,0.042388487458355335,0.4748488972110999,1,0.13417103602156435,0.17742265664869206,0.19516492231356128,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_57,0.0884914028528125,0.1021427649525833,5,0.045679633168751864,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.11355863849786434,0.0863826365723801,6,0.03526556370643535,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.0884914028528125,0.11355863849786434,0.045679633168751864,0.03526556370643535,0.675586523660987,1,0.13417103602156435,0.14882420220429968,0.19516492231356128,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_57,0.055930966087549105,0.053857629075768486,5,0.0240858639440775,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.0884914028528125,0.055930966087549105,0.045679633168751864,0.0240858639440775,0.5513593969607935,1,0.13417103602156435,0.0800168300316266,0.19516492231356128,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.07987920525138496,0.05423102665676498,6,0.022139723922724487,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.06318125347844816,0.07987920525138496,0.028465128457634003,0.022139723922724487,0.6538370953017265,1,0.09164638193608217,0.10201892917410946,0.11222082209152041,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_57,0.06318125347844816,0.06972504018398003,6,0.028465128457634003,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.04350636784815006,0.03174531075883803,6,0.012959968847539706,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.06318125347844816,0.04350636784815006,0.028465128457634003,0.012959968847539706,0.5493134809951314,1,0.09164638193608217,0.05646633669568977,0.11222082209152041,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_57,0.02659045602781777,0.028351697520104347,6,0.011574532044331145,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.06318125347844816,0.02659045602781777,0.028465128457634003,0.011574532044331145,0.2747423394887059,1,0.09164638193608217,0.038164988072148916,0.11222082209152041,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.1024243547914691,0.07738521341868547,6,0.03159238108535954,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.07050424395803585,0.1024243547914691,0.02748091737359266,0.03159238108535954,0.4653905659183498,1,0.09798516133162852,0.13401673587682864,0.16229258810246464,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,1,967514 MM WT,MoneyMaker,m_57,0.07050424395803585,0.061449199331408175,5,0.02748091737359266,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.09075638087858935,0.07657867868695047,6,0.031263114659928995,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.07050424395803585,0.09075638087858935,0.02748091737359266,0.031263114659928995,0.6382121598800639,1,0.09798516133162852,0.12201949553851835,0.16229258810246464,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_57,0.1146979282464901,0.08044317386603456,6,0.032840788210295915,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.07050424395803585,0.1146979282464901,0.02748091737359266,0.032840788210295915,0.3291035960163864,1,0.09798516133162852,0.147538716456786,0.16229258810246464,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.09760634724345496,0.09469648497844099,6,0.038659678105385425,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.11035542495562627,0.09760634724345496,0.07284111973098634,0.038659678105385425,0.8820630952104136,1,0.18319654468661262,0.13626602534884039,0.20151619915527388,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_57,0.11035542495562627,0.16287769527568666,5,0.07284111973098634,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.06366555942041059,0.04561303269182962,6,0.01862144261931174,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.11035542495562627,0.06366555942041059,0.07284111973098634,0.01862144261931174,0.5645246904143159,1,0.18319654468661262,0.08228700203972233,0.20151619915527388,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_57,0.09791306298974518,0.06795846354686244,6,0.027743926565557346,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.11035542495562627,0.09791306298974518,0.07284111973098634,0.027743926565557346,0.879237456250251,1,0.18319654468661262,0.12565698955530252,0.20151619915527388,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.1147060166975975,0.12169845537851594,6,0.049683186360371855,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.14535028221779722,0.1147060166975975,0.0637005284837797,0.049683186360371855,0.7128336823342006,1,0.20905081070157694,0.16438920305796936,0.22995589177173464,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_57,0.14535028221779722,0.15603379113088606,6,0.0637005284837797,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.07229523119534849,0.08731836281932913,6,0.03564757234709446,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.14535028221779722,0.07229523119534849,0.0637005284837797,0.03564757234709446,0.34676299231978036,1,0.20905081070157694,0.10794280354244296,0.22995589177173464,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_57,0.11667279773660584,0.14341534042722148,6,0.058549067555706116,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.14535028221779722,0.11667279773660584,0.0637005284837797,0.058549067555706116,0.7471906506954074,1,0.20905081070157694,0.17522186529231196,0.22995589177173464,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.1904622213281583,0.13012107026688796,6,0.05312170448978521,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.12494115392090792,0.1904622213281583,0.03709873427783316,0.05312170448978521,0.3384932232188955,1,0.16203988819874107,0.2435839258179435,0.26794231839973787,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_57,0.12494115392090792,0.09087296908379101,6,0.03709873427783316,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.1308794121473853,0.06779224362492646,6,0.027676067566585947,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.12494115392090792,0.1308794121473853,0.03709873427783316,0.027676067566585947,0.9006593796207867,1,0.16203988819874107,0.15855547971397124,0.26794231839973787,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_57,0.11986296150595817,0.1166791864532498,6,0.04763407840225356,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.12494115392090792,0.11986296150595817,0.03709873427783316,0.04763407840225356,0.9347278097436469,1,0.16203988819874107,0.16749703990821174,0.26794231839973787,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.15262773417652462,0.14635080079576546,6,0.05974746423288862,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.143943236476013,0.15262773417652462,0.059366289597964576,0.05974746423288862,0.9199151891470534,1,0.2033095260739776,0.21237519840941324,0.2336127182503546,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,1,967514 MM WT,MoneyMaker,m_57,0.143943236476013,0.1454171174373099,6,0.059366289597964576,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.1415555305984575,0.1400062685451045,6,0.057157319787763436,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.143943236476013,0.1415555305984575,0.059366289597964576,0.057157319787763436,0.9774564609631051,1,0.2033095260739776,0.19871285038622094,0.2336127182503546,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_57,0.11767506290040464,0.10860752079209453,6,0.044338834694891055,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.143943236476013,0.11767506290040464,0.059366289597964576,0.044338834694891055,0.7308987975604135,1,0.2033095260739776,0.1620138975952957,0.2336127182503546,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_57,0.17598906459946648,0.17835963572887287,6,0.0728150163740697,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.15176630149236234,0.17598906459946648,0.055146235306690654,0.0728150163740697,0.7966372324271642,1,0.206912536799053,0.24880408097353618,0.3495073681966313,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_57,0.15176630149236234,0.1350801377368463,6,0.055146235306690654,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_57,0.2268738273249138,0.22256099017510883,6,0.0908601437629328,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.15176630149236234,0.2268738273249138,0.055146235306690654,0.0908601437629328,0.4992641362043361,1,0.206912536799053,0.3177339710878466,0.3495073681966313,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_57,0.09998793657464307,0.10698758208048603,6,0.04367749748522065,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.15176630149236234,0.09998793657464307,0.055146235306690654,0.04367749748522065,0.47948682815585897,1,0.206912536799053,0.1436654340598637,0.3495073681966313,0,24,0,10.381589958158996,L-gulonolactone,gulonic_acid_1-4-lactone_333_466_rt10.49,10.39073171,10.39,0.020411743,10.47,10.16,0.31,FALSE,carbohydrate_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,0.07710169079942512,0.044184279660087075,6,0.018038156636607783,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.07635979215522996,0.07710169079942512,0.023976251208287978,0.018038156636607783,0.9808931534405256,1,0.10033604336351794,0.0951398474360329,0.285020674847767,3,24,12.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_73,0.07635979215522996,0.053612527547343386,5,0.023976251208287978,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.09707286368059298,0.12243574087053144,6,0.04998418190207099,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.07635979215522996,0.09707286368059298,0.023976251208287978,0.04998418190207099,0.7195916099996778,1,0.10033604336351794,0.14705704558266397,0.285020674847767,3,24,12.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_73,0.15037905299005389,0.2431291278062615,5,0.108730651417007,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.07635979215522996,0.15037905299005389,0.023976251208287978,0.108730651417007,0.539507189088391,1,0.10033604336351794,0.2591097044070609,0.285020674847767,3,24,12.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,0.12061138377196978,0.08260476301042656,6,0.03372325328317919,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,0.03363002285169103,0.12061138377196978,0.011115599286761087,0.03372325328317919,0.04932758420105989,1,0.044745622138452124,0.15433463705514897,0.16976810076066387,2,24,8.333333333333332,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_73,0.03363002285169103,0.02722754643780929,6,0.011115599286761087,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.08356070054472957,0.09612761789679526,6,0.039243935672730115,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.03363002285169103,0.08356070054472957,0.011115599286761087,0.039243935672730115,0.2683012993426718,1,0.044745622138452124,0.12280463621745968,0.16976810076066387,2,24,8.333333333333332,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_73,0.0460240929380078,0.041747438709049164,6,0.017043320484214225,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.03363002285169103,0.0460240929380078,0.011115599286761087,0.017043320484214225,0.558191456755509,1,0.044745622138452124,0.06306741342222202,0.16976810076066387,2,24,8.333333333333332,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,0.04012755374322141,0.06058148293288153,6,0.02473228684111458,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.071742430957309,0.04012755374322141,0.03166226853157928,0.02473228684111458,0.45404894894435943,1,0.10340469948888828,0.064859840584336,0.11374516943777711,9,24,37.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,1,967514 MM WT,MoneyMaker,m_73,0.071742430957309,0.07079898475846372,5,0.03166226853157928,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.0421406022854696,0.03554925975849031,6,0.014512924523659472,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.071742430957309,0.0421406022854696,0.03166226853157928,0.014512924523659472,0.42987377081676575,1,0.10340469948888828,0.05665352680912907,0.11374516943777711,9,24,37.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_73,0.03825632356688391,0.034713202440170614,6,0.014171605552725652,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.071742430957309,0.03825632356688391,0.03166226853157928,0.014171605552725652,0.37430820468142795,1,0.10340469948888828,0.05242792911960956,0.11374516943777711,9,24,37.5,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,0.0597640790063656,0.057282493574494255,6,0.0233854800752945,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1095289883050973,0.0597640790063656,0.04156083322383391,0.0233854800752945,0.33439461091177,1,0.15108982152893122,0.08314955908166011,0.1928448337258725,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_73,0.1095289883050973,0.09293284829002435,5,0.04156083322383391,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.10297971538428359,0.0858446599040691,6,0.03504593565128794,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1095289883050973,0.10297971538428359,0.04156083322383391,0.03504593565128794,0.9069639857127888,1,0.15108982152893122,0.13802565103557152,0.1928448337258725,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_73,0.1279493796016525,0.11601789085232835,6,0.047364105603686105,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1095289883050973,0.1279493796016525,0.04156083322383391,0.047364105603686105,0.7766666863603717,1,0.15108982152893122,0.17531348520533863,0.1928448337258725,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,0.024951537330597,0.019568228376532576,6,0.007988695782125878,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.01858818896528221,0.024951537330597,0.011397256321110555,0.007988695782125878,0.6584161001992139,1,0.029985445286392763,0.03294023311272288,0.03675204392223415,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_73,0.01858818896528221,0.02791746245443104,6,0.011397256321110555,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.010322285741091694,0.0058613248562342365,6,0.0023928758524109747,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.01858818896528221,0.010322285741091694,0.011397256321110555,0.0023928758524109747,0.5071049799289444,1,0.029985445286392763,0.012715161593502668,0.03675204392223415,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_73,0.023308699477377903,0.024745356634210274,6,0.010102249542834956,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.01858818896528221,0.023308699477377903,0.011397256321110555,0.010102249542834956,0.7630532902141426,1,0.029985445286392763,0.03341094902021286,0.03675204392223415,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,0.024375719932793416,0.020508244432811042,6,0.008372455730110145,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.027268468635539556,0.024375719932793416,0.012374136143313015,0.008372455730110145,0.8508772995345806,1,0.03964260477885257,0.03274817566290356,0.0687954056397413,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_73,0.027268468635539556,0.03031031955884782,6,0.012374136143313015,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.0370331317324899,0.044898636365161795,6,0.018329791540235937,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.027268468635539556,0.0370331317324899,0.012374136143313015,0.018329791540235937,0.6695117122714188,1,0.03964260477885257,0.055362923272725836,0.0687954056397413,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_73,0.044400251134655656,0.044436258873349545,6,0.018141026719654618,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.027268468635539556,0.044400251134655656,0.012374136143313015,0.018141026719654618,0.45571336176684796,1,0.03964260477885257,0.06254127785431027,0.0687954056397413,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,0.024127225713282,0.019544712423140223,6,0.007979095434354823,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.021527310200877132,0.024127225713282,0.00604341470177839,0.007979095434354823,0.8007087745500692,1,0.02757072490265552,0.03210632114763683,0.07682933679978288,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,1,967514 MM WT,MoneyMaker,m_73,0.021527310200877132,0.014803282323391224,6,0.00604341470177839,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.04612646670356405,0.05809794060779215,6,0.023718384932602195,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.021527310200877132,0.04612646670356405,0.00604341470177839,0.023718384932602195,0.3559927623531666,1,0.02757072490265552,0.06984485163616624,0.07682933679978288,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_73,0.02055172252221545,0.02009243606637486,6,0.008202702675352001,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.021527310200877132,0.02055172252221545,0.00604341470177839,0.008202702675352001,0.925771665560049,1,0.02757072490265552,0.02875442519756745,0.07682933679978288,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_73,0.039931126455479214,0.033788926388298654,6,0.013794271434632237,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.062880609415227,0.039931126455479214,0.010510129396892555,0.013794271434632237,0.21719134739854737,1,0.07339073881211955,0.05372539789011145,0.09486202894818886,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_73,0.062880609415227,0.025744454153012263,6,0.010510129396892555,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_73,0.05862291164627679,0.06764338549235092,6,0.02761529648844034,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.062880609415227,0.05862291164627679,0.010510129396892555,0.02761529648844034,0.8898435777955572,1,0.07339073881211955,0.08623820813471714,0.09486202894818886,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_73,0.05775326564587243,0.06020640126752314,6,0.02457916039244768,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.062880609415227,0.05775326564587243,0.010510129396892555,0.02457916039244768,0.8535205788107304,1,0.07339073881211955,0.08233242603832011,0.09486202894818886,0,24,0,9.017880952380953,Methyl alpha-D-mannopyranoside,mannopyr-1-o-m_133_204_rt9.14,9.021768707,9.04,0.048719222,9.17,8.89,0.28,FALSE,carbohydrate_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.5037170232447771,0.5499630493427546,6,0.22452147471247275,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.05921539751376712,0.5037170232447771,0.038827317047974395,0.22452147471247275,0.10532346856415226,1,0.09804271456174152,0.7282384979572498,0.8010623477529749,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_33,0.05921539751376712,0.08682052030320722,5,0.038827317047974395,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.25851251028466876,0.14195187637527762,6,0.057951610858344715,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,0.05921539751376712,0.25851251028466876,0.038827317047974395,0.057951610858344715,0.0202548016495763,0.48611523958983116,0.09804271456174152,0.3164641211430135,0.8010623477529749,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_33,0.16352795874283665,0.11521822961330894,5,0.051527158732507614,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.05921539751376712,0.16352795874283665,0.038827317047974395,0.051527158732507614,0.1474481134930352,1,0.09804271456174152,0.21505511747534428,0.8010623477529749,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.10297938555326569,0.09199430299584563,6,0.03755651693046861,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.13842699534370725,0.10297938555326569,0.05016724910189886,0.03755651693046861,0.5850728063347947,1,0.18859424444560613,0.1405359024837343,0.24350387113876998,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_33,0.13842699534370725,0.12288416209874985,6,0.05016724910189886,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.12708296170471448,0.10389388801826538,6,0.04241450217310087,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.13842699534370725,0.12708296170471448,0.05016724910189886,0.04241450217310087,0.8664423442666774,1,0.18859424444560613,0.16949746387781534,0.24350387113876998,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_33,0.18503226328522196,0.0890019459829049,6,0.036334892295478004,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.13842699534370725,0.18503226328522196,0.05016724910189886,0.036334892295478004,0.4708045614049743,1,0.18859424444560613,0.22136715558069997,0.24350387113876998,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.19970569319927192,0.26776792015622275,6,0.10931579564484212,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.28008608355820624,0.19970569319927192,0.1395614126136793,0.10931579564484212,0.6622900953887203,1,0.41964749617188557,0.30902148884411407,0.6853124403091837,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,1,967514 MM WT,MoneyMaker,m_33,0.28008608355820624,0.31206880564008355,5,0.1395614126136793,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.442299171313535,0.4426525285705909,6,0.18071213805845004,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.28008608355820624,0.442299171313535,0.1395614126136793,0.18071213805845004,0.49578729074558403,1,0.41964749617188557,0.6230113093719851,0.6853124403091837,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_33,0.13587452656864593,0.1854238353243213,6,0.07569896378240704,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.28008608355820624,0.13587452656864593,0.1395614126136793,0.07569896378240704,0.39730339815725463,1,0.41964749617188557,0.21157349035105297,0.6853124403091837,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.14640882092863453,0.10053280336696471,6,0.04104234511010304,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.4382935119543001,0.14640882092863453,0.22484634095022885,0.04104234511010304,0.26664924320547756,1,0.6631398529045289,0.18745116603873757,0.7294538381949819,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_33,0.4382935119543001,0.5027717028568064,5,0.22484634095022885,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.35930919934371364,0.4125305106590738,6,0.1684148757407513,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.4382935119543001,0.35930919934371364,0.22484634095022885,0.1684148757407513,0.785916226395656,1,0.6631398529045289,0.527724075084465,0.7294538381949819,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_33,0.30533463052232807,0.2925600034163346,6,0.11943712125282054,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.4382935119543001,0.30533463052232807,0.22484634095022885,0.11943712125282054,0.6196907191505758,1,0.6631398529045289,0.4247717517751486,0.7294538381949819,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.07378261680625475,0.05961933743033607,6,0.0243394925845229,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.10789131569811257,0.07378261680625475,0.05271332365285973,0.0243394925845229,0.5752456797955242,1,0.1606046393509723,0.09812210939077765,0.17666510328606955,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_33,0.10789131569811257,0.12912074559568978,6,0.05271332365285973,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.06196297843690054,0.09124318629842497,6,0.03724987482280777,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.10789131569811257,0.06196297843690054,0.05271332365285973,0.03724987482280777,0.494775341144852,1,0.1606046393509723,0.0992128532597083,0.17666510328606955,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_33,0.1071240870405455,0.09690922079037181,6,0.03956302371785435,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.10789131569811257,0.1071240870405455,0.05271332365285973,0.03956302371785435,0.990958708117743,1,0.1606046393509723,0.14668711075839985,0.17666510328606955,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.07300904758251248,0.04775746139793157,6,0.019496901972599495,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.11677467600074021,0.07300904758251248,0.03971740251902804,0.019496901972599495,0.3543210179355677,1,0.15649207851976826,0.09250594955511197,0.1721412863717451,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_33,0.11677467600074021,0.09728737008034995,6,0.03971740251902804,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.10430350983754615,0.05272629343517111,6,0.02152541915740461,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.11677467600074021,0.10430350983754615,0.03971740251902804,0.02152541915740461,0.7897614481886075,1,0.15649207851976826,0.12582892899495077,0.1721412863717451,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_33,0.07248976144851316,0.04766018039501566,6,0.019457187169464464,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.11677467600074021,0.07248976144851316,0.03971740251902804,0.019457187169464464,0.34883979596676207,1,0.15649207851976826,0.09194694861797761,0.1721412863717451,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.10867213327011578,0.08404639297940555,6,0.03431179625349634,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.13667558070591398,0.10867213327011578,0.050585069444526766,0.03431179625349634,0.6579572829099014,1,0.18726065015044074,0.1429839295236121,0.20598671516548483,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,1,967514 MM WT,MoneyMaker,m_33,0.13667558070591398,0.12390760874234306,6,0.050585069444526766,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.0779485754182266,0.12881482401933247,6,0.05258843169229585,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.13667558070591398,0.0779485754182266,0.050585069444526766,0.05258843169229585,0.4396624694242245,1,0.18726065015044074,0.13053700711052246,0.20598671516548483,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_33,0.08552656849849367,0.11670187471211861,6,0.04764334084515035,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.13667558070591398,0.08552656849849367,0.050585069444526766,0.04764334084515035,0.47865641783121504,1,0.18726065015044074,0.13316990934364403,0.20598671516548483,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_33,0.139999629754772,0.16746383146273638,6,0.0683668229091906,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.10615316040014822,0.139999629754772,0.04503216604409612,0.0683668229091906,0.6893429026872193,1,0.15118532644424434,0.20836645266396261,0.25246432138087765,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_33,0.10615316040014822,0.11030582882032236,6,0.04503216604409612,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_33,0.18983984060810424,0.09717904460537842,6,0.039673178829057236,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.10615316040014822,0.18983984060810424,0.04503216604409612,0.039673178829057236,0.19386115406237206,1,0.15118532644424434,0.2295130194371615,0.25246432138087765,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_33,0.037592972632353096,0.027341527487299885,6,0.011162131855360899,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.10615316040014822,0.037592972632353096,0.04503216604409612,0.011162131855360899,0.19327649015633175,1,0.15118532644424434,0.048755104487713995,0.25246432138087765,0,24,0,15.250336134453782,galactinol,galactinol_204_191_rt15.38,15.2482716,15.25,0.024382568,15.37,15.03,0.34,FALSE,carbohydrate_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.5187367718057797,0.5580529801956531,6,0.2278241751531394,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.08210717606038731,0.5187367718057797,0.022670543497279944,0.2278241751531394,0.11368955036936503,1,0.10477771955766725,0.7465609469589192,0.8212170416548111,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.8,967514 MM WT,MoneyMaker,m_39,0.08210717606038731,0.05069287634678377,5,0.022670543497279944,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.4127225776320232,0.7009182087584007,6,0.28614866048061016,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.08210717606038731,0.4127225776320232,0.022670543497279944,0.28614866048061016,0.30087976054855775,1,0.10477771955766725,0.6988712381126334,0.8212170416548111,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_39,0.10465824038104339,0.10083656288459797,5,0.045095481845478666,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.08210717606038731,0.10465824038104339,0.022670543497279944,0.045095481845478666,0.6709558849945766,1,0.10477771955766725,0.14975372222652206,0.8212170416548111,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.4378328160317237,0.5275319702647244,6,0.2153640250256072,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.3177368198051252,0.4378328160317237,0.20058651571703193,0.2153640250256072,0.691869404815321,1,0.5183233355221571,0.6531968410573309,0.7185165251630641,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.6,967514 MM WT,MoneyMaker,m_39,0.3177368198051252,0.49133461278948637,6,0.20058651571703193,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.20730417047683705,0.34079706354735884,6,0.13912981858831375,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.3177368198051252,0.20730417047683705,0.20058651571703193,0.13912981858831375,0.6618118657905636,1,0.5183233355221571,0.34643398906515077,0.7185165251630641,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_39,0.2755306567559976,0.35468030877002377,6,0.1447976297165573,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.3177368198051252,0.2755306567559976,0.20058651571703193,0.1447976297165573,0.8682669973692505,1,0.5183233355221571,0.4203282864725549,0.7185165251630641,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.185672043301487,0.1677686604929496,6,0.06849126883965892,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.47008026673640607,0.185672043301487,0.20485960744055684,0.06849126883965892,0.2462185187193259,1,0.6749398741769629,0.25416331214114596,0.7974830857761481,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,1,967514 MM WT,MoneyMaker,m_39,0.47008026673640607,0.45808000808100685,5,0.20485960744055684,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.5594391790478432,0.40550186798558613,6,0.16554544438501861,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.47008026673640607,0.5594391790478432,0.20485960744055684,0.16554544438501861,0.7429848469095494,1,0.6749398741769629,0.7249846234328619,0.7974830857761481,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_39,0.36699724901631364,0.5643698523670905,6,0.23040302741820745,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.47008026673640607,0.36699724901631364,0.20485960744055684,0.23040302741820745,0.7457737460451106,1,0.6749398741769629,0.5974002764345211,0.7974830857761481,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.13845131633943208,0.07979128914939244,6,0.03257465738914725,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.7747688198130576,0.13845131633943208,0.26919092084029383,0.03257465738914725,0.07694211566905569,1,1.0439597406533514,0.17102597372857933,1.2291398361096748,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.4,967514 MM WT,MoneyMaker,m_39,0.7747688198130576,0.6019291979246618,5,0.26919092084029383,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.7071402680756742,1.0049266402731847,6,0.4102595829331211,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.7747688198130576,0.7071402680756742,0.26919092084029383,0.4102595829331211,0.8936623296574107,1,1.0439597406533514,1.1173998510087952,1.2291398361096748,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_39,0.5267331592640738,0.3576715921517713,6,0.14601881604344868,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.7747688198130576,0.5267331592640738,0.26919092084029383,0.14601881604344868,0.44763951201041563,1,1.0439597406533514,0.6727519753075225,1.2291398361096748,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.05435475422664885,0.0433839745672598,6,0.017711433450611526,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.057276324271923716,0.05435475422664885,0.0217060012242127,0.017711433450611526,0.9190863142369889,1,0.07898232549613642,0.07206618767726038,0.18476793508916686,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.8,967514 MM WT,MoneyMaker,m_39,0.057276324271923716,0.05316862735554811,6,0.0217060012242127,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.057658425001020884,0.04932466072734784,6,0.0201367084196498,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.057276324271923716,0.057658425001020884,0.0217060012242127,0.0201367084196498,0.9899585936613109,1,0.07898232549613642,0.07779513342067068,0.18476793508916686,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_39,0.12507268568740412,0.10507861366648848,6,0.04289816439365664,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.057276324271923716,0.12507268568740412,0.0217060012242127,0.04289816439365664,0.19909769655423137,1,0.07898232549613642,0.16797085008106077,0.18476793508916686,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.07195122784927872,0.027122955662814783,6,0.011072900281671289,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.05990805682544309,0.07195122784927872,0.018752265716653886,0.011072900281671289,0.5951687622724089,1,0.07866032254209698,0.08302412813095002,0.18845130282983458,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.6,967514 MM WT,MoneyMaker,m_39,0.05990805682544309,0.045933482526888336,6,0.018752265716653886,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.10049672273552224,0.17347933874492807,6,0.07082264347341828,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.05990805682544309,0.10049672273552224,0.018752265716653886,0.07082264347341828,0.6006189671960254,1,0.07866032254209698,0.1713193662089405,0.18845130282983458,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_39,0.07695170297556968,0.12720569376915059,6,0.051931507018525405,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.05990805682544309,0.07695170297556968,0.018752265716653886,0.051931507018525405,0.7675420776391506,1,0.07866032254209698,0.12888320999409508,0.18845130282983458,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.03820063320855501,0.02800901554826967,6,0.011434632715156852,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.06029159292349876,0.03820063320855501,0.019219568762399573,0.011434632715156852,0.35168249352249414,1,0.079511161685898335,0.04963526592371186,0.1783860844096059,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,1,967514 MM WT,MoneyMaker,m_39,0.06029159292349876,0.04707813654421373,6,0.019219568762399573,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.10423630030239517,0.14190596432596486,6,0.05793286734270109,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.06029159292349876,0.10423630030239517,0.019219568762399573,0.05793286734270109,0.49824909898428127,1,0.079511161685898335,0.16216916764509626,0.1783860844096059,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_39,0.04272592418614011,0.050557507989735184,6,0.020640016206922487,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.06029159292349876,0.04272592418614011,0.019219568762399573,0.020640016206922487,0.547403784941801,1,0.079511161685898335,0.06336594039306259,0.1783860844096059,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_39,0.04526141563796885,0.05097326458932903,6,0.020809748127955743,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.11744758851005432,0.04526141563796885,0.03822544200098619,0.020809748127955743,0.13713175207423334,1,0.1556730305110405,0.06607116376592459,0.17124033356214458,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.4,967514 MM WT,MoneyMaker,m_39,0.11744758851005432,0.09363282809476894,6,0.03822544200098619,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_39,0.07470693334553642,0.06973358410073827,6,0.028468616497044418,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.11744758851005432,0.07470693334553642,0.03822544200098619,0.028468616497044418,0.39261339698772124,1,0.1556730305110405,0.10317554984258084,0.17124033356214458,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_39,0.04901429936629276,0.034345747869868694,6,0.01402159285257676,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.11744758851005432,0.04901429936629276,0.03822544200098619,0.01402159285257676,0.14128560491982425,1,0.1556730305110405,0.06303589221886952,0.17124033356214458,0,24,0,9.973242677824269,methyl_alpha-D-glucopyranoside,glucopyranoside_133_204_rt10.03,10.00621951,9.99,0.062428172,10.12,9.7,0.42,FALSE,carbohydrate_derivative +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.5597062965994246,0.5983688219121972,6,0.24428304861253022,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.1812850401655158,0.5597062965994246,0.0708862505937082,0.24428304861253022,0.18882957567115383,1,0.252171290759224,0.8039893452119549,0.8843882797331504,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_38,0.1812850401655158,0.1585064749976164,5,0.0708862505937082,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.2717306898967731,0.22701045239399084,6,0.09267662910727494,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.1812850401655158,0.2717306898967731,0.0708862505937082,0.09267662910727494,0.4585660331531647,1,0.252171290759224,0.36440731900404805,0.8843882797331504,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_38,0.4208117423085404,0.3262310134214409,5,0.14589494447579762,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.1812850401655158,0.4208117423085404,0.0708862505937082,0.14589494447579762,0.1919782532132751,1,0.252171290759224,0.566706686784338,0.8843882797331504,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.428692661063342,0.3381354229686268,6,0.13804320837221715,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.41562243038150243,0.428692661063342,0.16987365883807817,0.13804320837221715,0.9536104299265163,1,0.5854960892195806,0.5667358694355591,0.6440456981415388,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_38,0.41562243038150243,0.41610378489292144,6,0.16987365883807817,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.2235312870223087,0.19947272504787328,6,0.08143439899496246,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.41562243038150243,0.2235312870223087,0.16987365883807817,0.08143439899496246,0.34099148335466406,1,0.5854960892195806,0.30496568601727114,0.6440456981415388,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_38,0.34987163502193175,0.38502394891417824,6,0.157185368931859,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.41562243038150243,0.34987163502193175,0.16987365883807817,0.157185368931859,0.7821675075101968,1,0.5854960892195806,0.5070570039537907,0.6440456981415388,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.4260932814555854,0.3928628948833917,6,0.160385605222829,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.19553434598918623,0.4260932814555854,0.1355094210938971,0.160385605222829,0.30076811972917034,1,0.33104376708308336,0.5864788866784144,0.9420372258418412,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_38,0.19553434598918623,0.30300827715759787,5,0.1355094210938971,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.20542103017057825,0.2653944158903409,6,0.10834681658588717,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.19553434598918623,0.20542103017057825,0.1355094210938971,0.10834681658588717,0.955938377908429,1,0.33104376708308336,0.3137678467564654,0.9420372258418412,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_38,0.613750337024133,0.5943616830292224,6,0.2426471410139045,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.19553434598918623,0.613750337024133,0.1355094210938971,0.2426471410139045,0.17238036285662733,1,0.33104376708308336,0.8563974780380375,0.9420372258418412,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.2731916940453773,0.3531231307753108,6,0.14416191446226778,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.3443978425598105,0.2731916940453773,0.23014584610595623,0.14416191446226778,0.8008157126380696,1,0.5745436886657667,0.4173536085076451,0.6319980575323434,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_38,0.3443978425598105,0.5146217566321234,5,0.23014584610595623,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.21389451627581388,0.24524439738557355,6,0.10012060597850068,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.3443978425598105,0.21389451627581388,0.23014584610595623,0.10012060597850068,0.623333163365816,1,0.5745436886657667,0.31401512225431455,0.6319980575323434,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_38,0.17503923944790592,0.14851325085518421,6,0.060630280772859806,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.3443978425598105,0.17503923944790592,0.23014584610595623,0.060630280772859806,0.5114627323696518,1,0.5745436886657667,0.23566952022076573,0.6319980575323434,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.2772098629834692,0.18718049594384958,6,0.07641611747725464,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.21291635920975596,0.2772098629834692,0.09513036959574658,0.07641611747725464,0.6102727655067135,1,0.30804672880550255,0.35362598046072385,0.43889160453750514,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_38,0.21291635920975596,0.23302086455195395,6,0.09513036959574658,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.2094197504917511,0.118438076518002,6,0.04835214226430252,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.21291635920975596,0.2094197504917511,0.09513036959574658,0.04835214226430252,0.9747247833780057,1,0.30804672880550255,0.2577718927560536,0.43889160453750514,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_38,0.25823002983778376,0.34479590291399975,6,0.1407623379235845,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.21291635920975596,0.25823002983778376,0.09513036959574658,0.1407623379235845,0.7958452287728831,1,0.30804672880550255,0.39899236776136826,0.43889160453750514,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.2994398871467102,0.1362691482041731,6,0.05563164679732046,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.4110583574795691,0.2994398871467102,0.23864810377698692,0.05563164679732046,0.6660476223941709,1,0.649706461256556,0.3550715339440307,0.7146771073822116,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_38,0.4110583574795691,0.5845660823363849,6,0.23864810377698692,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.18102613891108346,0.17338499993391102,6,0.07078412981509619,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.4110583574795691,0.18102613891108346,0.23864810377698692,0.07078412981509619,0.3918184761664521,1,0.649706461256556,0.2518102687261796,0.7146771073822116,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_38,0.12408523172769566,0.10894627055711265,6,0.044477128707354735,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.4110583574795691,0.12408523172769566,0.23864810377698692,0.044477128707354735,0.28703971412545976,1,0.649706461256556,0.1685623604350504,0.7146771073822116,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.1730175308520321,0.14748119577061555,6,0.06020894604892011,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.44290557279658127,0.1730175308520321,0.18733140111920207,0.06020894604892011,0.21909637085494324,1,0.6302369739157834,0.2332264769009522,0.9216810707638364,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_38,0.44290557279658127,0.4588663455426866,6,0.18733140111920207,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.6315115511279644,0.5055265048388053,6,0.20638033138461406,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.44290557279658127,0.6315115511279644,0.18733140111920207,0.20638033138461406,0.5140951588793646,1,0.6302369739157834,0.8378918825125785,0.9216810707638364,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_38,0.5019378379929359,0.32321507133049476,6,0.13195200032283005,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.44290557279658127,0.5019378379929359,0.18733140111920207,0.13195200032283005,0.802500316102702,1,0.6302369739157834,0.633889838315766,0.9216810707638364,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_38,0.3074020464016017,0.33599375199630455,6,0.1371688748590305,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.2772677295136325,0.3074020464016017,0.09205644457702311,0.1371688748590305,0.859415292859454,1,0.3693241740906556,0.4445709212606322,0.8830075169681465,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_38,0.2772677295136325,0.2254913167485062,6,0.09205644457702311,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_38,0.5424659443643322,0.6375241931193943,6,0.2602681619703464,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.2772677295136325,0.5424659443643322,0.09205644457702311,0.2602681619703464,0.3725172451719827,1,0.3693241740906556,0.8027341063346786,0.8830075169681465,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_38,0.41309005329310544,0.31256836158931606,6,0.12760549927192888,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.2772677295136325,0.41309005329310544,0.09205644457702311,0.12760549927192888,0.41020580003799467,1,0.3693241740906556,0.5406955525650343,0.8830075169681465,0,24,0,12.989031578947367,6-phosphogluconic_acid,gluconic_acid_6phosphate_299_387_rt13.13,12.99062112,12.99,0.022574583,13.09,12.92,0.17,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,0.10156503997031822,0.05922034719828028,6,0.024176605504374348,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.11810988595165788,0.10156503997031822,0.08011541074688053,0.024176605504374348,0.8514874921960905,1,0.1982252966985384,0.12574164547469258,0.21804782636839223,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_27,0.11810988595165788,0.17914350447534205,5,0.08011541074688053,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.12358693115059576,0.1540614079039849,6,0.06289530640325772,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.11810988595165788,0.12358693115059576,0.08011541074688053,0.06289530640325772,0.9584320075096429,1,0.1982252966985384,0.18648223755385346,0.21804782636839223,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_27,0.13014624451401824,0.13649930998357535,5,0.061044347201018034,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.11810988595165788,0.13014624451401824,0.08011541074688053,0.061044347201018034,0.9080278088984546,1,0.1982252966985384,0.19119059171503627,0.21804782636839223,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,0.061919560942088316,0.025506296524053514,6,0.01041290195200922,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.11640308912547614,0.061919560942088316,0.04322299477783063,0.01041290195200922,0.26960916845373245,1,0.15962608390330676,0.07233246289409753,0.28595993556273547,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_27,0.11640308912547614,0.10587428236066698,6,0.04322299477783063,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.17405474891998096,0.21043279511767707,6,0.08590882886432401,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.11640308912547614,0.17405474891998096,0.04322299477783063,0.08590882886432401,0.5667978328103092,1,0.15962608390330676,0.25996357778430496,0.28595993556273547,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_27,0.10299908640323747,0.1507133697204388,6,0.06152847553841728,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.11640308912547614,0.10299908640323747,0.04322299477783063,0.06152847553841728,0.8624792932477996,1,0.15962608390330676,0.16452756194165474,0.28595993556273547,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,0.17524195104870846,0.2557212362848745,6,0.10439775754860559,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.13302120760438507,0.17524195104870846,0.06556312126029118,0.10439775754860559,0.7406630219159214,1,0.19858432886467625,0.279639708597314,0.3076036794570454,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_27,0.13302120760438507,0.14660359595507277,5,0.06556312126029118,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.1835308669856246,0.11371688336671583,6,0.04642472323134024,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.13302120760438507,0.1835308669856246,0.06556312126029118,0.04642472323134024,0.5481702577458113,1,0.19858432886467625,0.22995559021696482,0.3076036794570454,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_27,0.13571735717697628,0.1969164304041841,6,0.08039079607675442,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.13302120760438507,0.13571735717697628,0.06556312126029118,0.08039079607675442,0.9798366974070547,1,0.19858432886467625,0.2161081532537307,0.3076036794570454,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,0.12569582059083798,0.10129166779991394,6,0.04135215021754839,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.17225335880055176,0.12569582059083798,0.07008659132385286,0.04135215021754839,0.5861099683940953,1,0.24233995012440462,0.16704797080838638,0.2665739451368451,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_27,0.17225335880055176,0.15671838251138198,5,0.07008659132385286,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.13995835137608348,0.15759692266421266,6,0.06433867426003045,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.17225335880055176,0.13995835137608348,0.07008659132385286,0.06433867426003045,0.742357620590016,1,0.24233995012440462,0.20429702563611393,0.2665739451368451,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_27,0.13224727496431046,0.12771258046246511,6,0.052138442644529936,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.17225335880055176,0.13224727496431046,0.07008659132385286,0.052138442644529936,0.6595279373360834,1,0.24233995012440462,0.1843857176088404,0.2665739451368451,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,0.08234655262808672,0.07629988584529612,6,0.031149297958930046,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.055503212544787406,0.08234655262808672,0.01919259055082546,0.031149297958930046,0.48330890850424235,1,0.07469580309561287,0.11349585058701678,0.1374176408963883,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_27,0.055503212544787406,0.047012053691684305,6,0.01919259055082546,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.0693617854222482,0.06993020109511165,6,0.028548885048873495,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.055503212544787406,0.0693617854222482,0.01919259055082546,0.028548885048873495,0.6967133625793575,1,0.07469580309561287,0.0979106704711217,0.1374176408963883,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_27,0.08593301887867955,0.09551077155679516,6,0.03899210920894618,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.055503212544787406,0.08593301887867955,0.01919259055082546,0.03899210920894618,0.5055412854441494,1,0.07469580309561287,0.12492512808762572,0.1374176408963883,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,0.03784196935519183,0.03202833083860308,6,0.013075511311270731,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.08454901757967777,0.03784196935519183,0.035342712958118264,0.013075511311270731,0.2590679337469352,1,0.11989173053779603,0.05091748066646256,0.19726221471432204,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_27,0.08454901757967777,0.0865716128730408,6,0.035342712958118264,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.1369100284921092,0.10390553641663013,6,0.042419257611819916,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.08454901757967777,0.1369100284921092,0.035342712958118264,0.042419257611819916,0.3660188273482019,1,0.11989173053779603,0.17932928610392912,0.19726221471432204,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_27,0.06349770200553755,0.07399300803132162,6,0.030207519035065942,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.08454901757967777,0.06349770200553755,0.035342712958118264,0.030207519035065942,0.6605989584310584,1,0.11989173053779603,0.09370522104060348,0.19726221471432204,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,0.06779262656994585,0.02872526186916435,6,0.011727039051213138,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.14802638980929453,0.06779262656994585,0.0529717139242555,0.011727039051213138,0.194145368077733,1,0.20099810373355004,0.07951966562115899,0.22109791410690505,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_27,0.14802638980929453,0.1297536699151087,6,0.0529717139242555,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.0632713175720998,0.06604667732488437,6,0.02696344310870243,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.14802638980929453,0.0632713175720998,0.0529717139242555,0.02696344310870243,0.1945369931902594,1,0.20099810373355004,0.09023476068080223,0.22109791410690505,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_27,0.0980389692923469,0.06052575553059373,6,0.024709536224398594,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.14802638980929453,0.0980389692923469,0.0529717139242555,0.024709536224398594,0.420446908931593,1,0.20099810373355004,0.12274850551674549,0.22109791410690505,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_27,0.1209104271119265,0.09894330342127412,6,0.040393434474582456,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.16080898004551072,0.1209104271119265,0.08917795391190375,0.040393434474582456,0.6958360211400323,1,0.24998693395741448,0.16130386158650895,0.3244030910211974,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_27,0.16080898004551072,0.2184404833895992,6,0.08917795391190375,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_27,0.2227596886334843,0.17673610393541545,6,0.07215221229487698,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.16080898004551072,0.2227596886334843,0.08917795391190375,0.07215221229487698,0.6014810601641319,1,0.24998693395741448,0.2949119009283613,0.3244030910211974,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_27,0.06948445623587118,0.07510624819788243,6,0.030661997429940097,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.16080898004551072,0.06948445623587118,0.08917795391190375,0.030661997429940097,0.3692691509896507,1,0.24998693395741448,0.10014645366581128,0.3244030910211974,0,24,0,12.42021052631579,fructose-6-phosphate,fructose-6-phosphate_459_315_rt12.55,12.42434783,12.42,0.006401426,12.45,12.4,0.05,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.051098614286874344,0.06730200882932325,6,0.027475930049355033,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.09082178661311957,0.051098614286874344,0.0297151263694804,0.027475930049355033,0.35288674781370954,1,0.12053691298259997,0.07857454433622937,0.13474447354038532,4,24,16.666666666666664,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_40,0.09082178661311957,0.0664450425221547,5,0.0297151263694804,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.06126632938724511,0.060926540747589276,6,0.024873156104080214,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.09082178661311957,0.06126632938724511,0.0297151263694804,0.024873156104080214,0.46674923443989047,1,0.12053691298259997,0.08613948549132533,0.13474447354038532,4,24,16.666666666666664,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_40,0.08775222698353122,0.07768714840485408,5,0.03474274896227361,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.09082178661311957,0.08775222698353122,0.0297151263694804,0.03474274896227361,0.948154694624207,1,0.12053691298259997,0.12249497594580483,0.13474447354038532,4,24,16.666666666666664,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.0904022651156519,0.08751774574184366,6,0.035728970084358706,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.04970488345710922,0.0904022651156519,0.012473473266923297,0.035728970084358706,0.32224476519897693,1,0.06217835672403251,0.1261312352000106,0.13874435872001167,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_40,0.04970488345710922,0.03055364482420879,6,0.012473473266923297,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.0417348459195482,0.03372242336204848,6,0.01376712168785493,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.04970488345710922,0.0417348459195482,0.012473473266923297,0.01376712168785493,0.6770926315024619,1,0.06217835672403251,0.05550196760740313,0.13874435872001167,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_40,0.05458733844868754,0.0562510638399195,6,0.02296440064942076,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.04970488345710922,0.05458733844868754,0.012473473266923297,0.02296440064942076,0.856614693372965,1,0.06217835672403251,0.0775517390981083,0.13874435872001167,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.07761487348899969,0.08540751643358792,6,0.03486747257677656,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.09275599788030106,0.07761487348899969,0.048115984807762587,0.03486747257677656,0.8056093146626637,1,0.14087198268806364,0.11248234606577626,0.15495918095687003,7,24,29.166666666666668,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_40,0.09275599788030106,0.1075906128345043,5,0.048115984807762587,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.07560941801264653,0.05137822545394808,6,0.020975072708641237,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.09275599788030106,0.07560941801264653,0.048115984807762587,0.020975072708641237,0.7559754435255193,1,0.14087198268806364,0.09658449072128777,0.15495918095687003,7,24,29.166666666666668,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_40,0.10747028110587949,0.03415707127894752,6,0.013944565956882642,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.09275599788030106,0.10747028110587949,0.048115984807762587,0.013944565956882642,0.7815620976934895,1,0.14087198268806364,0.12141484706276212,0.15495918095687003,7,24,29.166666666666668,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.06611912950638914,0.05372868923852528,6,0.0219346455304921,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.16116027733743604,0.06611912950638914,0.06997717368609377,0.0219346455304921,0.25393081885887775,1,0.2311374510235298,0.08805377503688123,0.2750495499289453,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_40,0.16116027733743604,0.1564737172354152,5,0.06997717368609377,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.10209816418569122,0.09291405988741122,6,0.03793200610909262,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.16116027733743604,0.10209816418569122,0.06997717368609377,0.03793200610909262,0.4849629639218006,1,0.2311374510235298,0.14003017029478385,0.2750495499289453,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_40,0.1856407619517192,0.1577576316732475,6,0.06440428343823107,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.16116027733743604,0.1856407619517192,0.06997717368609377,0.06440428343823107,0.8028684696387156,1,0.2311374510235298,0.25004504538995026,0.2750495499289453,1,24,4.166666666666666,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.013520035817984924,0.0033369422090048493,6,0.0013623009522029366,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.014991181659005667,0.013520035817984924,0.004425678105678528,0.0013623009522029366,0.7615849031562245,1,0.019416859764684196,0.014882336770187861,0.026222389432385005,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_40,0.014991181659005667,0.01084065312471964,6,0.004425678105678528,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.014092709997829264,0.010427334867116425,6,0.004256941633594513,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.014991181659005667,0.014092709997829264,0.004425678105678528,0.004256941633594513,0.8865851550757159,1,0.019416859764684196,0.018349651631423776,0.026222389432385005,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_40,0.015503169935477215,0.02041739330414498,6,0.008335365912145513,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.014991181659005667,0.015503169935477215,0.004425678105678528,0.008335365912145513,0.9581320571309724,1,0.019416859764684196,0.02383853584762273,0.026222389432385005,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.017067137383293202,0.011281198902109862,6,0.00460553016616916,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.018078492704062993,0.017067137383293202,0.006546829545105946,0.00460553016616916,0.9022412468784309,1,0.02462532224916894,0.021672667549462364,0.03089119905812755,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_40,0.018078492704062993,0.016036391818486873,6,0.006546829545105946,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.014834099298260739,0.01896196906706505,6,0.007741191455457959,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.018078492704062993,0.014834099298260739,0.006546829545105946,0.007741191455457959,0.755724725309255,1,0.02462532224916894,0.022575290753718696,0.03089119905812755,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_40,0.019195340032445756,0.021770007149613156,6,0.008887568202215647,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.018078492704062993,0.019195340032445756,0.006546829545105946,0.008887568202215647,0.9215827050364549,1,0.02462532224916894,0.028082908234661405,0.03089119905812755,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.007457068329928207,0.004596326628687796,6,0.0018764424885753237,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.011205041868716329,0.007457068329928207,0.004500681858937313,0.0018764424885753237,0.46838347195487273,1,0.015705723727653643,0.00933351081850353,0.040479295512273666,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_40,0.011205041868716329,0.011024374048997273,6,0.004500681858937313,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.030130936610411663,0.01633423360725873,6,0.006668422946200755,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.011205041868716329,0.030130936610411663,0.004500681858937313,0.006668422946200755,0.04382595446294489,1,0.015705723727653643,0.03679935955661242,0.040479295512273666,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_40,0.01266009295272282,0.01313590506974374,6,0.0053627107884184734,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.011205041868716329,0.01266009295272282,0.004500681858937313,0.0053627107884184734,0.839654407536421,1,0.015705723727653643,0.018022803741141295,0.040479295512273666,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_40,0.014360455847593897,0.0175833421945916,6,0.007178369391583132,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.012132654321115988,0.014360455847593897,0.005764889698567512,0.007178369391583132,0.8139122673187572,1,0.0178975440196835,0.02153882523917703,0.03836636478292668,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_40,0.012132654321115988,0.014121038184917526,6,0.005764889698567512,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_40,0.026219710213308007,0.021209649686169847,6,0.00865880322571625,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.012132654321115988,0.026219710213308007,0.005764889698567512,0.00865880322571625,0.20977246562912216,1,0.0178975440196835,0.034878513439024254,0.03836636478292668,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_40,0.009051359841783105,0.007414825098337354,6,0.00302708967048477,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.012132654321115988,0.009051359841783105,0.005764889698567512,0.00302708967048477,0.6494121791579301,1,0.0178975440196835,0.012078449512267875,0.03836636478292668,0,24,0,9.0467,glucose 1-phosphate,glucose-1-phosphate_217_rt9.16,9.040201342,9.04,0.009964111,9.14,9,0.14,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,0.12300891523227027,0.08703661391335625,6,0.03553254883789097,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.1215052977767301,0.12300891523227027,0.06327047805865221,0.03553254883789097,0.9840982938330008,1,0.1847757758353823,0.15854146407016123,0.20325335341892053,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_41,0.1215052977767301,0.14147708990805527,5,0.06327047805865221,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.08667230639332146,0.06995525606570155,6,0.028559113697784442,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.1215052977767301,0.08667230639332146,0.06327047805865221,0.028559113697784442,0.6348924658222385,1,0.1847757758353823,0.1152314200911059,0.20325335341892053,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_41,0.07670676514903371,0.08564016985777044,5,0.03829944828132064,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.1215052977767301,0.07670676514903371,0.06327047805865221,0.03829944828132064,0.5649868801825507,1,0.1847757758353823,0.11500621343035436,0.20325335341892053,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,0.079537313050803915,0.053911799037605526,6,0.022009399792933794,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.09805111127586441,0.079537313050803915,0.05499845295055051,0.022009399792933794,0.7643362076607854,1,0.1530495642264149,0.1015467128437377,0.16835452064905643,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_41,0.09805111127586441,0.13471814637131668,6,0.05499845295055051,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.027005465264438627,0.015218628925397505,6,0.006212979241997429,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.09805111127586441,0.027005465264438627,0.05499845295055051,0.006212979241997429,0.2542240317353529,1,0.1530495642264149,0.03321844450643605,0.16835452064905643,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_41,0.09684524441985509,0.08492390055672408,6,0.034670037221805713,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.09805111127586441,0.09684524441985509,0.05499845295055051,0.034670037221805713,0.9856333096885872,1,0.1530495642264149,0.13151528164166082,0.16835452064905643,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,0.08272723248206397,0.06157872261613706,6,0.025139408236986377,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1458503930272182,0.08272723248206397,0.04922337351131039,0.025139408236986377,0.29673842866208666,1,0.1950737665385286,0.10786664071905035,0.21458114319238147,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_41,0.1458503930272182,0.11006680925315256,5,0.04922337351131039,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.04955272967861809,0.04522049413593043,6,0.01846118942492474,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1458503930272182,0.04955272967861809,0.04922337351131039,0.01846118942492474,0.12507677762446623,1,0.1950737665385286,0.06801391910354283,0.21458114319238147,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_41,0.05178191768774454,0.043942504756036636,6,0.01793945244535213,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1458503930272182,0.05178191768774454,0.04922337351131039,0.01793945244535213,0.13180515255762784,1,0.1950737665385286,0.06972137013309666,0.21458114319238147,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,0.033124405877616336,0.02845462857692154,6,0.011616553472312403,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.09246065074214105,0.033124405877616336,0.03606199540340797,0.011616553472312403,0.18010796812079255,1,0.12852264614554904,0.044740959349928736,0.14735198732731136,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_41,0.09246065074214105,0.08063707312630518,5,0.03606199540340797,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.10098712636706926,0.08075778029886607,6,0.03296922574866831,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.09246065074214105,0.10098712636706926,0.03606199540340797,0.03296922574866831,0.8654866628629574,1,0.12852264614554904,0.1339563521157376,0.14735198732731136,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_41,0.08631913262311348,0.10089074812646479,6,0.04118847544624944,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.09246065074214105,0.08631913262311348,0.03606199540340797,0.04118847544624944,0.9131399721413604,1,0.12852264614554904,0.12750760806936293,0.14735198732731136,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,0.060973189988720033,0.030069143304272416,6,0.012275676349682128,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.05393589170302452,0.060973189988720033,0.011184361689773775,0.012275676349682128,0.6807852978751519,1,0.0651202533927983,0.07324886633840216,0.1229410632183839,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_41,0.05393589170302452,0.02739597923867799,6,0.011184361689773775,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.08516933186868518,0.06514484366094972,6,0.02659527105711835,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.05393589170302452,0.08516933186868518,0.011184361689773775,0.02659527105711835,0.3163368354744939,1,0.0651202533927983,0.11176460292580354,0.1229410632183839,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_41,0.06607852356359774,0.09916745365594007,6,0.0404849434246919,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.05393589170302452,0.06607852356359774,0.011184361689773775,0.0404849434246919,0.7826282958584838,1,0.0651202533927983,0.10656346698828964,0.1229410632183839,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,0.0659854634815018,0.058104831512958276,6,0.023721198132856013,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.13029764454798176,0.0659854634815018,0.03269299091810412,0.023721198132856013,0.14535345736476446,1,0.1629906354660859,0.08970666161435782,0.17928969901269448,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_41,0.13029764454798176,0.08008114591479963,6,0.03269299091810412,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.05425945408329554,0.06713172428932888,6,0.02740641167700991,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.13029764454798176,0.05425945408329554,0.03269299091810412,0.02740641167700991,0.1059374501612568,1,0.1629906354660859,0.08166586576030545,0.17928969901269448,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_41,0.05962814441989561,0.032724388993660855,6,0.0133596758631365,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.13029764454798176,0.05962814441989561,0.03269299091810412,0.0133596758631365,0.08780889524171233,1,0.1629906354660859,0.0729878202830321,0.17928969901269448,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,0.07823252847661262,0.04000583853531065,6,0.01633231519061391,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.0768419330391239,0.07823252847661262,0.03507742824926539,0.01633231519061391,0.972324664045164,1,0.11191936128838928,0.09456484366722653,0.12311129741722822,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_41,0.0768419330391239,0.08592180069978846,6,0.03507742824926539,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.0606665770786489,0.046090963253318906,6,0.018816556954000176,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.0768419330391239,0.0606665770786489,0.03507742824926539,0.018816556954000176,0.695597888361045,1,0.11191936128838928,0.07948313403264907,0.12311129741722822,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_41,0.07662235000845834,0.05356882595854525,6,0.021869381619732307,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.0768419330391239,0.07662235000845834,0.03507742824926539,0.021869381619732307,0.9958859150263144,1,0.11191936128838928,0.09849173162819064,0.12311129741722822,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_41,0.09647399840866437,0.10121508589058602,6,0.04132088578398481,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.08984424186010753,0.09647399840866437,0.029087127725133752,0.04132088578398481,0.8985104368436744,1,0.11893136958524128,0.13779488419264918,0.23514229708191434,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_41,0.08984424186010753,0.07124862100973932,6,0.029087127725133752,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_41,0.16346018079922398,0.12322291359392974,6,0.05030554382069813,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.08984424186010753,0.16346018079922398,0.029087127725133752,0.05030554382069813,0.24081405640286693,1,0.11893136958524128,0.2137657246199221,0.23514229708191434,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_41,0.06528544174924418,0.04580352177265378,6,0.018699209460910235,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.08984424186010753,0.06528544174924418,0.029087127725133752,0.018699209460910235,0.49652445407857826,1,0.11893136958524128,0.08398465121015442,0.23514229708191434,0,24,0,12.52317894736842,glucose-6-phosphate,glucose-6-phosphate_160_387_rt12.65,12.52950311,12.53,0.005454498,12.55,12.48,0.07,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.04237217585784211,0.03036371249661124,6,0.012395933718877773,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.07661005892445352,0.04237217585784211,0.038844005280280494,0.012395933718877773,0.4407534171825246,1,0.11545406420473402,0.05476810957671988,0.19650134655055326,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.8,967514 MM WT,MoneyMaker,m_51,0.07661005892445352,0.08685783632506797,5,0.038844005280280494,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.08617797068920141,0.15982471842595833,6,0.06524816807126577,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.07661005892445352,0.08617797068920141,0.038844005280280494,0.06524816807126577,0.9028682693699903,1,0.11545406420473402,0.15142613876046718,0.19650134655055326,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_51,0.12909466123976948,0.11078135153309623,5,0.04954292653346074,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.07661005892445352,0.12909466123976948,0.038844005280280494,0.04954292653346074,0.4299814480690418,1,0.11545406420473402,0.17863758777323022,0.19650134655055326,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.07526342339543353,0.0702390270739131,6,0.028674962726770014,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.05203093452155786,0.07526342339543353,0.024295973803624044,0.028674962726770014,0.5506597358695215,1,0.07632690832518191,0.10393838612220355,0.1143322247344239,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.6,967514 MM WT,MoneyMaker,m_51,0.05203093452155786,0.05951273862290589,6,0.024295973803624044,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.020611700087251033,0.009412126524996104,6,0.0038424845634592395,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.05203093452155786,0.020611700087251033,0.024295973803624044,0.0038424845634592395,0.2550642949006013,1,0.07632690832518191,0.024454184650710274,0.1143322247344239,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_51,0.05385697339509824,0.09882834649022923,6,0.040346503504006405,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.05203093452155786,0.05385697339509824,0.024295973803624044,0.040346503504006405,0.9699991632024827,1,0.07632690832518191,0.09420347689910465,0.1143322247344239,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.06112461343618569,0.07954781500670807,6,0.0324752594866242,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.07955344307577379,0.06112461343618569,0.04625586178307061,0.0324752594866242,0.7533224442713372,1,0.1258093048588444,0.09359987292280988,0.14752164404917395,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,1,967514 MM WT,MoneyMaker,m_51,0.07955344307577379,0.10343125130478052,5,0.04625586178307061,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.04699862757084065,0.028894961176617124,6,0.011796318503373635,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.07955344307577379,0.04699862757084065,0.04625586178307061,0.011796318503373635,0.5286018729210916,1,0.1258093048588444,0.05879494607421428,0.14752164404917395,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_51,0.08021583281936384,0.132014643879215,6,0.0538947526798852,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.07955344307577379,0.08021583281936384,0.04625586178307061,0.0538947526798852,0.9927624901928582,1,0.1258093048588444,0.13411058549924904,0.14752164404917395,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.04700822756464625,0.05264446166139396,6,0.021492011475654462,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.14607312776150533,0.04700822756464625,0.10494681952573018,0.021492011475654462,0.4036222120538552,1,0.25101994728723553,0.06850023904030071,0.27612194201595913,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.4,967514 MM WT,MoneyMaker,m_51,0.14607312776150533,0.23466822248193492,5,0.10494681952573018,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.05760994627473478,0.046889895177590485,6,0.01914271954628105,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.14607312776150533,0.05760994627473478,0.10494681952573018,0.01914271954628105,0.45084057383215237,1,0.25101994728723553,0.07675266582101584,0.27612194201595913,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_51,0.13052111831713523,0.11424169255694383,6,0.04663897568607055,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.14607312776150533,0.13052111831713523,0.10494681952573018,0.04663897568607055,0.8970467088029364,1,0.25101994728723553,0.17716009400320576,0.27612194201595913,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.037776235559030015,0.015316142071217079,6,0.006252788817076023,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,0.060436691441825584,0.037776235559030015,0.005866675771930517,0.006252788817076023,0.024689694543266687,0.5925526690384004,0.0663033672137561,0.044029024376106035,0.07293370393513171,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.8,967514 MM WT,MoneyMaker,m_51,0.060436691441825584,0.014370362127578383,6,0.005866675771930517,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.03276751207003903,0.021912998802072845,6,0.008945944299882918,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,0.060436691441825584,0.03276751207003903,0.005866675771930517,0.008945944299882918,0.030377787259305598,0.69868910696402875,0.0663033672137561,0.04171345636992195,0.07293370393513171,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_51,0.03667429495272286,0.03780112000623564,6,0.015432242620165031,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.060436691441825584,0.03667429495272286,0.005866675771930517,0.015432242620165031,0.197015875894176,1,0.0663033672137561,0.05210653757288789,0.07293370393513171,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.03933666773240674,0.022907338832674106,6,0.009351881917515669,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.0253784178368673,0.03933666773240674,0.006361209367072591,0.009351881917515669,0.249060803930277,1,0.03173962720393989,0.048688549649922405,0.07338701240212538,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.6,967514 MM WT,MoneyMaker,m_51,0.0253784178368673,0.015581717096340581,6,0.006361209367072591,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.024710110601917263,0.024298610625748642,6,0.00991986624860894,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.0253784178368673,0.024710110601917263,0.006361209367072591,0.00991986624860894,0.9560827189921852,1,0.03173962720393989,0.034629976850526205,0.07338701240212538,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_51,0.04322671224728558,0.057535460947404894,6,0.023488753572828404,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.0253784178368673,0.04322671224728558,0.006361209367072591,0.023488753572828404,0.4921927364522385,1,0.03173962720393989,0.06671546582011398,0.07338701240212538,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.0421815006128187,0.043348020974627054,6,0.017696755457883174,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.045401606178241107,0.0421815006128187,0.021364244229704663,0.017696755457883174,0.9099699378987848,1,0.06676585040794578,0.05987825607070188,0.07344243544874036,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,1,967514 MM WT,MoneyMaker,m_51,0.045401606178241107,0.052331497102976264,6,0.021364244229704663,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.0456686985407165,0.045147276373130825,6,0.018431298398430215,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.045401606178241107,0.0456686985407165,0.021364244229704663,0.018431298398430215,0.9926374714968684,1,0.06676585040794578,0.06409999693914671,0.07344243544874036,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_51,0.03232285355373565,0.020433734117812623,6,0.008342037021390115,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.045401606178241107,0.03232285355373565,0.021364244229704663,0.008342037021390115,0.5876949972861977,1,0.06676585040794578,0.04066489057512577,0.07344243544874036,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_51,0.028876921320153404,0.04408809060647025,6,0.01799888761990738,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.02391517198091068,0.028876921320153404,0.007036145017559501,0.01799888761990738,0.8053160523666678,1,0.03095131699847018,0.046875808940060784,0.09072230243300787,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.4,967514 MM WT,MoneyMaker,m_51,0.02391517198091068,0.017234965049246962,6,0.007036145017559501,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_51,0.05640527558839977,0.06385708259947102,6,0.026069544805243743,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.02391517198091068,0.05640527558839977,0.007036145017559501,0.026069544805243743,0.2762746043337126,1,0.03095131699847018,0.08247482039364351,0.09072230243300787,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_51,0.031010484215714024,0.034372203691612875,6,0.014032393396576638,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.02391517198091068,0.031010484215714024,0.007036145017559501,0.014032393396576638,0.6642827423396584,1,0.03095131699847018,0.045042877612290665,0.09072230243300787,0,24,0,9.286813417190777,glycerophosphoric_acid,glycerol-3-phosphate_357_445_rt9.40,9.295521472,9.29,0.024972908,9.53,9.23,0.3,FALSE,carbohydrate_phosphate +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.2971892197602282,0.42198587818395095,6,0.17227501336848994,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.14036049074143064,0.2971892197602282,0.05557387361624212,0.17227501336848994,0.41950448929463746,1,0.19593436435767275,0.46946423312871816,0.5178757897829104,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_14,0.14036049074143064,0.12426695917889945,5,0.05557387361624212,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.30681989105405355,0.19337909330247477,6,0.07894668425218719,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.14036049074143064,0.30681989105405355,0.05557387361624212,0.07894668425218719,0.12051174874432048,1,0.19593436435767275,0.38576657530624076,0.5178757897829104,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_14,0.37098416551493674,0.2231864326561851,5,0.09981200701498176,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.14036049074143064,0.37098416551493674,0.05557387361624212,0.09981200701498176,0.0880672658930942,1,0.19593436435767275,0.4707961725299185,0.5178757897829104,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.4178423529591117,0.4254354998986588,6,0.17368331553626645,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.3859706383380984,0.4178423529591117,0.09860127063127386,0.17368331553626645,0.8772051839945066,1,0.4845719089693723,0.5915256684953781,0.650678235344916,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_14,0.3859706383380984,0.24152280103669352,6,0.09860127063127386,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.36219909556417507,0.3383983006158426,6,0.13815052772229416,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.3859706383380984,0.36219909556417507,0.09860127063127386,0.13815052772229416,0.8916849585565069,1,0.4845719089693723,0.5003496232864693,0.650678235344916,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_14,0.35988957021160406,0.14492837572910133,6,0.059166761631110044,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.3859706383380984,0.35988957021160406,0.09860127063127386,0.059166761631110044,0.8261323642089418,1,0.4845719089693723,0.4190563318427141,0.650678235344916,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.1932879092877179,0.2521133414810482,6,0.10292484066277005,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.26083660590641117,0.1932879092877179,0.10084631430750725,0.10292484066277005,0.6504667765472792,1,0.3616829202139184,0.29621274995048796,0.3978512122353103,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_14,0.26083660590641117,0.22549921407189585,5,0.10084631430750725,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.23913086832041144,0.2603423814339717,6,0.10628433215570991,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.26083660590641117,0.23913086832041144,0.10084631430750725,0.10628433215570991,0.8855032910628323,1,0.3616829202139184,0.34541520047612134,0.3978512122353103,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_14,0.20706180657962558,0.25103082433048285,6,0.10248290488665394,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.26083660590641117,0.20706180657962558,0.10084631430750725,0.10248290488665394,0.7171356879484426,1,0.3616829202139184,0.30954471146627954,0.3978512122353103,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.23477826497178234,0.1730972377515171,6,0.07066665139607373,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.4593333726917689,0.23477826497178234,0.21329588036217775,0.07066665139607373,0.36456658130095215,1,0.6726292530539466,0.3054449163678561,0.7398921783593413,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_14,0.4593333726917689,0.4769440878104919,5,0.21329588036217775,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.4468618064842374,0.24085123344893872,6,0.09832710431164202,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.4593333726917689,0.4468618064842374,0.21329588036217775,0.09832710431164202,0.9594713884782253,1,0.6726292530539466,0.5451889107958794,0.7398921783593413,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_14,0.48953270967713125,0.3634066969456466,6,0.1483601627711794,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.4593333726917689,0.48953270967713125,0.21329588036217775,0.1483601627711794,0.9105531477967909,1,0.6726292530539466,0.6378928724483106,0.7398921783593413,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.18500362185043637,0.17504997341436862,6,0.07146385239216066,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.2783900626750451,0.18500362185043637,0.16133481393145355,0.07146385239216066,0.6132566717573973,1,0.43972487660649867,0.256467474242597,0.4886145046210157,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_14,0.2783900626750451,0.395187971878928,6,0.16133481393145355,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.2177258374170984,0.2520545408406056,6,0.10290083540183118,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.2783900626750451,0.2177258374170984,0.16133481393145355,0.10290083540183118,0.7588834654736534,1,0.43972487660649867,0.32062667281892954,0.4886145046210157,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_14,0.3572693783533732,0.21292342889858237,6,0.08692562584755015,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.2783900626750451,0.3572693783533732,0.16133481393145355,0.08692562584755015,0.6787183591854868,1,0.43972487660649867,0.44419500420092334,0.4886145046210157,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.26848639405521796,0.37498762369153393,6,0.15308805631717512,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.42139187334646816,0.26848639405521796,0.20497049144599117,0.15308805631717512,0.5643877040556478,1,0.6263623647924593,0.42157445037239305,0.6889986012717053,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_14,0.42139187334646816,0.5020731163701825,6,0.20497049144599117,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.21301389255194414,0.23254284908293277,6,0.0949352205977034,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.42139187334646816,0.21301389255194414,0.20497049144599117,0.0949352205977034,0.38675486505149104,1,0.6263623647924593,0.30794911314964757,0.6889986012717053,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_14,0.08638823238990297,0.07874556082370586,6,0.032147740587896066,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.42139187334646816,0.08638823238990297,0.20497049144599117,0.032147740587896066,0.1645676115811055,1,0.6263623647924593,0.11853597297779903,0.6889986012717053,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.12697432202742373,0.09035480021140412,6,0.03688719272150962,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.22735610280917243,0.12697432202742373,0.08792373539596403,0.03688719272150962,0.3288783201200389,1,0.31527983820513644,0.16386151474893335,0.49436728475931563,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_14,0.22735610280917243,0.21536828799959612,6,0.08792373539596403,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.24558771660993203,0.22727074445448373,6,0.09278289289599247,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.22735610280917243,0.24558771660993203,0.08792373539596403,0.09278289289599247,0.88942379055252,1,0.31527983820513644,0.3383706095059245,0.49436728475931563,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_14,0.29175336227147075,0.386214580043995,6,0.15767144205517977,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.22735610280917243,0.29175336227147075,0.08792373539596403,0.15767144205517977,0.730721496536793,1,0.31527983820513644,0.44942480432665055,0.49436728475931563,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_14,0.31663342785279697,0.3598936526994254,6,0.14692596846333567,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.5429704957271277,0.31663342785279697,0.1638479678878666,0.14692596846333567,0.32824955737277706,1,0.7068184636149943,0.46355939631613263,0.7775003099764939,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_14,0.5429704957271277,0.40134391671719677,6,0.1638479678878666,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_14,0.35656865316434705,0.24943721784033243,6,0.10183231776137791,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.5429704957271277,0.35656865316434705,0.1638479678878666,0.10183231776137791,0.36103706437253597,1,0.7068184636149943,0.45840097092572496,0.7775003099764939,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_14,0.17927577233331315,0.1093894437274295,6,0.04465805339651604,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.5429704957271277,0.17927577233331315,0.1638479678878666,0.04465805339651604,0.07806544180803844,1,0.7068184636149943,0.2239338257298292,0.7775003099764939,0,24,0,8.639412997903564,4-hydroxy-benzoic_acid,benzoic_acid-4-hydroxy_267_223_rt8.76,8.644417178,8.65,0.019022344,8.69,8.58,0.11,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.28673503621813,0.21909958617228878,6,0.08944703149617675,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.19118955198528337,0.28673503621813,0.08956360956390202,0.08944703149617675,0.46988495682037845,1,0.2807531615491854,0.37618206771430673,0.481883241059109,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_20,0.19118955198528337,0.20027031929513522,5,0.08956360956390202,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.2580849302860467,0.19695516861015155,6,0.08040661088311628,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.19118955198528337,0.2580849302860467,0.08956360956390202,0.08040661088311628,0.5925424979429259,1,0.2807531615491854,0.33849154116916297,0.481883241059109,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_20,0.2855417097413745,0.3410763122668505,5,0.1525339639487246,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.19118955198528337,0.2855417097413745,0.08956360956390202,0.1525339639487246,0.6115842554774038,1,0.2807531615491854,0.4380756736900991,0.481883241059109,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.35681544634856294,0.3759724815822235,6,0.153490122867399,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.39299740135009426,0.35681544634856294,0.08820583548527025,0.153490122867399,0.8431715698327902,1,0.4812032368353645,0.5103055692159619,0.5613361261375581,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_20,0.39299740135009426,0.21605928927478993,6,0.08820583548527025,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.28546308262446407,0.24260860856943026,6,0.09904454970028642,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.39299740135009426,0.28546308262446407,0.08820583548527025,0.09904454970028642,0.43659807749219137,1,0.4812032368353645,0.3845076323247505,0.5613361261375581,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_20,0.25865702529822643,0.3172457676725624,6,0.12951504230921948,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.39299740135009426,0.25865702529822643,0.08820583548527025,0.12951504230921948,0.41396411814662193,1,0.4812032368353645,0.38817206760744594,0.5613361261375581,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.3632816150714155,0.3360813690965354,6,0.13720464439041516,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.22556621537006274,0.3632816150714155,0.07758298387073097,0.13720464439041516,0.4086225770776434,1,0.3031491992407937,0.5004862594618307,0.5682950549145092,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_20,0.22556621537006274,0.1734808258322242,5,0.07758298387073097,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.35464499923637566,0.39678517375705247,6,0.16198686886772354,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.22556621537006274,0.35464499923637566,0.07758298387073097,0.16198686886772354,0.49533832346668116,1,0.3031491992407937,0.5166318681040992,0.5682950549145092,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_20,0.14925901366582153,0.21264228631287266,6,0.08681084986755756,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.22556621537006274,0.14925901366582153,0.07758298387073097,0.08681084986755756,0.528600256404115,1,0.3031491992407937,0.2360698635333791,0.5682950549145092,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.38621528964426166,0.20478144764350567,6,0.08360167591917626,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.25893859176971484,0.38621528964426166,0.12540529300485265,0.08360167591917626,0.42554790476157833,1,0.3843438847745675,0.46981696556343794,0.5167986621197818,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_20,0.25893859176971484,0.2804147598971294,5,0.12540529300485265,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.22189897912380874,0.21061542129993444,6,0.08598338569102452,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.25893859176971484,0.22189897912380874,0.12540529300485265,0.08598338569102452,0.8142047839268356,1,0.3843438847745675,0.3078823648148333,0.5167986621197818,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_20,0.17410320710926183,0.19908777289017537,6,0.08127724293467192,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.25893859176971484,0.17410320710926183,0.12540529300485265,0.08127724293467192,0.5878175526960192,1,0.3843438847745675,0.2553804500439337,0.5167986621197818,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.2941482878953325,0.29734396944914016,6,0.12139016720735059,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.47242506320619365,0.2941482878953325,0.1973230899067768,0.12139016720735059,0.462893193374181,1,0.6697481531129704,0.41553845510268306,0.7367229684242675,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_20,0.47242506320619365,0.48334088474093256,6,0.1973230899067768,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.38042586398783207,0.5101888633515341,6,0.20828373127696523,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.47242506320619365,0.38042586398783207,0.1973230899067768,0.20828373127696523,0.7550925874337371,1,0.6697481531129704,0.5887095952647973,0.7367229684242675,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_20,0.15741461483349392,0.15028702651496834,6,0.061354421653633084,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.47242506320619365,0.15741461483349392,0.1973230899067768,0.061354421653633084,0.17858613364070755,1,0.6697481531129704,0.218769036487127,0.7367229684242675,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.2773853841671654,0.32696098487182806,6,0.1334812631223048,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.08342296002108518,0.2773853841671654,0.04713664256526615,0.1334812631223048,0.21796978930091143,1,0.13055960258635133,0.4108666472894702,0.6731348127977029,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_20,0.08342296002108518,0.11546072247285638,6,0.04713664256526615,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.48166667322734485,0.31910498763298367,6,0.13027406567965774,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,0.08342296002108518,0.48166667322734485,0.04713664256526615,0.13027406567965774,0.02681817211668634,0.6168179586837857,0.13055960258635133,0.6119407389070026,0.6731348127977029,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_20,0.2807345105904819,0.2364293923092605,6,0.09652189522566561,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.08342296002108518,0.2807345105904819,0.04713664256526615,0.09652189522566561,0.1073442155587363,1,0.13055960258635133,0.3772564058161475,0.6731348127977029,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.20167490989781792,0.1696088142673808,6,0.06924250847226109,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.0959731849741338,0.20167490989781792,0.03091283065165798,0.06924250847226109,0.2064785788364494,1,0.12688601562579177,0.270917418370079,0.8268270645628084,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_20,0.0959731849741338,0.07572066160162964,6,0.03091283065165798,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.640637369871504,0.27195116429445215,6,0.11102359791286724,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.0959731849741338,0.640637369871504,0.03091283065165798,0.11102359791286724,0.003589251425296111,0.08614203420710667,0.12688601562579177,0.7516609677843712,0.8268270645628084,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_20,0.28575275959219465,0.4359233979416597,6,0.17796498198288085,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.0959731849741338,0.28575275959219465,0.03091283065165798,0.17796498198288085,0.3389322139599364,1,0.12688601562579177,0.4637177415750755,0.8268270645628084,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_20,0.17034121629647106,0.21612748652444796,6,0.08823367689585748,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.2991847081399426,0.17034121629647106,0.06236856003613897,0.08823367689585748,0.2635872371526935,1,0.3615532681760816,0.2585748931923285,0.5371340913344861,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_20,0.2991847081399426,0.15277114808067924,6,0.06236856003613897,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_20,0.20627638173881327,0.13430506617005522,6,0.05482981366456105,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.2991847081399426,0.20627638173881327,0.06236856003613897,0.05482981366456105,0.2897981376941377,1,0.3615532681760816,0.2611061954033743,0.5371340913344861,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_20,0.3555064341208613,0.32528558814842307,6,0.13279728527412596,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.2991847081399426,0.3555064341208613,0.06236856003613897,0.13279728527412596,0.7122938895781952,1,0.3615532681760816,0.4883037193949873,0.5371340913344861,0,24,0,11.071530398322851,4-hydroxy-cinnamic_acid,cinnamic_acid-4hyd-trans_249_293_rt11.20,11.07588957,11.07,0.034439606,11.3,10.97,0.33,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.0674712699237811,0.05741302661676068,6,0.023438769966648815,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.24406925558945872,0.0674712699237811,0.12296054068459072,0.023438769966648815,0.2265056250133196,1,0.3670297962740494,0.09091003989042991,0.4037327759014544,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_83,0.24406925558945872,0.2749481275208734,5,0.12296054068459072,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.14642196605976224,0.10908503050292395,6,0.04453377721801706,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.24406925558945872,0.14642196605976224,0.12296054068459072,0.04453377721801706,0.48855289864833484,1,0.3670297962740494,0.1909557432777793,0.4037327759014544,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_83,0.17626255385693454,0.1334706490022936,5,0.05968988883402859,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.24406925558945872,0.17626255385693454,0.12296054068459072,0.05968988883402859,0.6381089083275686,1,0.3670297962740494,0.23595244269096313,0.4037327759014544,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.04907870920175713,0.03967400327636875,6,0.01619684401343524,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.1263772350332554,0.04907870920175713,0.04174052785453706,0.01619684401343524,0.1313918406250205,1,0.16811776288779245,0.06527555321519238,0.2551209622389962,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_83,0.1263772350332554,0.10224299483804405,6,0.04174052785453706,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.19006636349128772,0.10041578274506345,6,0.04099457164126283,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.1263772350332554,0.19006636349128772,0.04174052785453706,0.04099457164126283,0.3018727028760104,1,0.16811776288779245,0.23106093513255055,0.2551209622389962,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_83,0.15242543206097828,0.19474108596679013,6,0.07950271542901827,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.1263772350332554,0.15242543206097828,0.04174052785453706,0.07950271542901827,0.7795434011394143,1,0.16811776288779245,0.23192814748999654,0.2551209622389962,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.0707773113411454,0.07369449477894624,6,0.030085651510102885,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.17773604797251727,0.0707773113411454,0.057683947919554224,0.030085651510102885,0.15037648150067487,1,0.2354199958920715,0.10086296285124828,0.2589619954812787,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_83,0.17773604797251727,0.12898522875868082,5,0.057683947919554224,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.1121746296625082,0.10562020270130625,6,0.043119267191254966,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.17773604797251727,0.1121746296625082,0.057683947919554224,0.043119267191254966,0.38998809403851975,1,0.2354199958920715,0.15529389685376316,0.2589619954812787,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_83,0.0965934793463578,0.015231453922088484,6,0.006218215024971726,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.17773604797251727,0.0965934793463578,0.057683947919554224,0.006218215024971726,0.232960700241065,1,0.2354199958920715,0.10281169437132953,0.2589619954812787,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.04981432304429786,0.05357595034978454,6,0.021872290140276345,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.12344679193154873,0.04981432304429786,0.04165573859457676,0.021872290140276345,0.16752141671358803,1,0.1651025305261255,0.0716866131845742,0.18161278357873806,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_83,0.12344679193154873,0.09314506315043519,5,0.04165573859457676,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.04807124327054028,0.04986397012131582,6,0.02035688055776833,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.12344679193154873,0.04807124327054028,0.04165573859457676,0.02035688055776833,0.15621604679523454,1,0.1651025305261255,0.06842812382830861,0.18161278357873806,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_83,0.056925452345565564,0.04913405150499994,6,0.020058892530479624,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.12344679193154873,0.056925452345565564,0.04165573859457676,0.020058892530479624,0.20173702348636322,1,0.1651025305261255,0.07698434487604519,0.18161278357873806,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.05978010885843429,0.0516547571442674,6,0.021087966298473183,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.189102072027277,0.05978010885843429,0.05716583785745009,0.021087966298473183,0.07558431784265805,1,0.24626790988472708,0.08086807515690747,0.2708947008731998,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_83,0.189102072027277,0.14002713346943027,6,0.05716583785745009,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.1480086459284128,0.13593522630423444,6,0.05549532375252206,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.189102072027277,0.1480086459284128,0.05716583785745009,0.05549532375252206,0.6172275009640138,1,0.24626790988472708,0.20350396968093487,0.2708947008731998,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_83,0.1280177589576065,0.11199206495574753,6,0.04572056906370183,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.189102072027277,0.1280177589576065,0.05716583785745009,0.04572056906370183,0.4244148073570536,1,0.24626790988472708,0.17373832802130834,0.2708947008731998,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.076713378802337015,0.053795570566033186,6,0.02196194971811116,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.09374040706385152,0.076713378802337015,0.04345269301629808,0.02196194971811116,0.7362931579214325,1,0.1371931000801496,0.09867532852044818,0.15949377143189786,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_83,0.09374040706385152,0.10643692583972839,6,0.04345269301629808,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.1123394978787069,0.07998769510963889,6,0.032654839786654774,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.09374040706385152,0.1123394978787069,0.04345269301629808,0.032654839786654774,0.7398380119184792,1,0.1371931000801496,0.14499433766536168,0.15949377143189786,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_83,0.07695445913068107,0.06515064375033941,6,0.026597638933696228,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.09374040706385152,0.07695445913068107,0.04345269301629808,0.026597638933696228,0.7499680587180824,1,0.1371931000801496,0.10355209806437729,0.15949377143189786,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.10709081045807693,0.06912881269065409,6,0.028221719602756132,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.19510001304728575,0.10709081045807693,0.043454206409766834,0.028221719602756132,0.12527389821347001,1,0.23855421945705257,0.13531253006083307,0.26240964140275785,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_83,0.19510001304728575,0.10644063288150689,6,0.043454206409766834,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.13054956408544874,0.16034323621433183,6,0.06545985207194435,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.19510001304728575,0.13054956408544874,0.043454206409766834,0.06545985207194435,0.4332848978931696,1,0.23855421945705257,0.1960094161573931,0.26240964140275785,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_83,0.1478123878513331,0.0661704813604726,6,0.027013985894583852,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.19510001304728575,0.1478123878513331,0.043454206409766834,0.027013985894583852,0.38128234510884185,1,0.23855421945705257,0.17482637374591695,0.26240964140275785,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_83,0.0664561961724679,0.07907934643634305,6,0.032284007993636635,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.09010884469718412,0.0664561961724679,0.04408463224730141,0.032284007993636635,0.6751185577282064,1,0.13419347694448552,0.09874020416610453,0.14761282463893408,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_83,0.09010884469718412,0.10798485450413331,6,0.04408463224730141,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_83,0.0762627914113146,0.08613313199813796,6,0.035163703890538085,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.09010884469718412,0.0762627914113146,0.04408463224730141,0.035163703890538085,0.8112478997312792,1,0.13419347694448552,0.1114264953018527,0.14761282463893408,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_83,0.04148196955388572,0.031007520518776727,6,0.012658767243313754,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.09010884469718412,0.04148196955388572,0.04408463224730141,0.012658767243313754,0.3310666601771242,1,0.13419347694448552,0.054140736797199475,0.14761282463893408,0,24,0,6.014372384937238,L-pipecolic acid,pipecolic_acid_156_230_rt6.11,6.025670732,6.03,0.030640026,6.04,5.74,0.3,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.20072754299161108,0.13628092062831088,6,0.055636452869349325,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.11346237107188983,0.20072754299161108,0.07019514680978228,0.055636452869349325,0.35825344351665106,1,0.18365751788167212,0.2563639958609604,0.28719786914146384,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_4,0.11346237107188983,0.1569611199572507,5,0.07019514680978228,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.1999162605251393,0.1498419291655571,6,0.06117271142164595,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.11346237107188983,0.1999162605251393,0.07019514680978228,0.06117271142164595,0.3788325571220461,1,0.18365751788167212,0.26108897194678526,0.28719786914146384,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_4,0.1555508785137763,0.14136464059839063,5,0.06322018919856559,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.11346237107188983,0.1555508785137763,0.07019514680978228,0.06322018919856559,0.6678699959147131,1,0.18365751788167212,0.2187710677123419,0.28719786914146384,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.2259826780119085,0.27084281619825046,6,0.11057111669735403,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.20535799810809888,0.2259826780119085,0.07890362323444308,0.11057111669735403,0.8826512406409972,1,0.28426162134254196,0.3365537947092625,0.3702091741801888,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_4,0.20535799810809888,0.19327361578119676,6,0.07890362323444308,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.10835456166451474,0.0671670700081586,6,0.027420841506297353,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.20535799810809888,0.10835456166451474,0.07890362323444308,0.027420841506297353,0.28834678971947825,1,0.28426162134254196,0.1357754031708121,0.3702091741801888,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_4,0.14076208592340667,0.10279544295176246,6,0.041966063852532584,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.20535799810809888,0.14076208592340667,0.07890362323444308,0.041966063852532584,0.49139319288495653,1,0.28426162134254196,0.18272814977593926,0.3702091741801888,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.16110172747280047,0.18985559838110316,6,0.07750822347407914,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.13243592727798897,0.16110172747280047,0.06573235034526784,0.07750822347407914,0.7842892012113318,1,0.1981682776232568,0.2386099509468796,0.6817187575104596,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_4,0.13243592727798897,0.14698200369285067,5,0.06573235034526784,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.2749142756272523,0.24159593667137852,6,0.098631128129106,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.13243592727798897,0.2749142756272523,0.06573235034526784,0.098631128129106,0.2622596824059859,1,0.1981682776232568,0.3735454037563583,0.6817187575104596,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_4,0.44041348432903127,0.4392690548115136,6,0.1793308406804774,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.13243592727798897,0.44041348432903127,0.06573235034526784,0.1793308406804774,0.15569399752421847,1,0.1981682776232568,0.6197443250095087,0.6817187575104596,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.12518025124182255,0.12307674450300192,6,0.05024587053920819,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.3145457567512343,0.12518025124182255,0.12170018482430693,0.05024587053920819,0.2061347630223882,1,0.43624594157554125,0.17542612178103073,0.4798705357330954,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_4,0.3145457567512343,0.2721298861414386,5,0.12170018482430693,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.3061279387969536,0.19914878988215282,6,0.08130215301733595,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.3145457567512343,0.3061279387969536,0.12170018482430693,0.08130215301733595,0.9556952213937178,1,0.43624594157554125,0.38743009181428956,0.4798705357330954,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_4,0.1411087566158351,0.07272543950820905,6,0.02969003635245943,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.3145457567512343,0.1411087566158351,0.12170018482430693,0.02969003635245943,0.23121310721149102,1,0.43624594157554125,0.17079879296829453,0.4798705357330954,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.16060871186621398,0.08915296457840183,6,0.036396545378917886,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,0.06349084011043378,0.16060871186621398,0.017049043941219432,0.036396545378917886,0.04588741572560352,1,0.08053988405165322,0.19700525724513185,0.31109068505654736,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_4,0.06349084011043378,0.041761458258276686,6,0.017049043941219432,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.20132621098776107,0.13499634401048938,6,0.05511202666115385,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.06349084011043378,0.20132621098776107,0.017049043941219432,0.05511202666115385,0.05443853340824004,1,0.08053988405165322,0.25643823764891494,0.31109068505654736,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_4,0.2208605830197609,0.15174376014562388,6,0.061949130668009424,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.06349084011043378,0.2208605830197609,0.017049043941219432,0.061949130668009424,0.051573655872840275,1,0.08053988405165322,0.2828097136877703,0.31109068505654736,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.12729326635838345,0.08125633869554279,6,0.03317276136180799,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.16533517433843112,0.12729326635838345,0.07666103736587702,0.03317276136180799,0.6629696900100055,1,0.24199621170430813,0.16046602772019145,0.26619583287473897,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_4,0.16533517433843112,0.18778042469883371,6,0.07666103736587702,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.129221549533993,0.10304826013800521,6,0.04206927603661607,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.16533517433843112,0.129221549533993,0.07666103736587702,0.04206927603661607,0.6907917729998925,1,0.24199621170430813,0.17129082557060907,0.26619583287473897,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_4,0.08700203191971627,0.11133710476898194,6,0.045453182687132894,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.16533517433843112,0.08700203191971627,0.07666103736587702,0.045453182687132894,0.4046693124688995,1,0.24199621170430813,0.13245521460684917,0.26619583287473897,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.273089440162362,0.25933699489722434,6,0.10587388482082741,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.09074605130189199,0.273089440162362,0.03533754444138896,0.10587388482082741,0.15263204803640157,1,0.12608359574328096,0.3789633249831894,0.4168596574815084,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_4,0.09074605130189199,0.08655895264432696,6,0.03533754444138896,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.12795954078998006,0.11080115571046506,6,0.04523438240021766,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.09074605130189199,0.12795954078998006,0.03533754444138896,0.04523438240021766,0.5322278856114941,1,0.12608359574328096,0.17319392319019772,0.4168596574815084,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_4,0.12177630057249285,0.17535619688141704,6,0.0715888675990831,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.09074605130189199,0.12177630057249285,0.03533754444138896,0.0715888675990831,0.7086033384080365,1,0.12608359574328096,0.19336516817157595,0.4168596574815084,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_4,0.11519325787348489,0.10035255023121287,6,0.0409687570755816,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.17672209274212816,0.11519325787348489,0.059390009558031344,0.0409687570755816,0.4161830945292473,1,0.2361121023001595,0.15616201494906648,0.36080832322314454,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_4,0.17672209274212816,0.14547521923619267,6,0.059390009558031344,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_4,0.11792727773894003,0.17457518140379116,6,0.07127001936551652,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.17672209274212816,0.11792727773894003,0.059390009558031344,0.07127001936551652,0.540915997011687,1,0.2361121023001595,0.18919729710445654,0.36080832322314454,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_4,0.23306184956912493,0.23256855990625247,6,0.09494571699737009,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.17672209274212816,0.23306184956912493,0.059390009558031344,0.09494571699737009,0.6278452753223114,1,0.2361121023001595,0.328007566566495,0.36080832322314454,0,24,0,7.604067085953878,adipic_acid,adipic_acid_275_111_rt7.70,7.609509202,7.61,0.02999596,7.83,7.43,0.4,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,0.05276481644668533,0.019398207063345645,6,0.007919284871674892,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,0.012815651191332388,0.05276481644668533,0.00835591964961938,0.007919284871674892,0.007343921054749677,0.17625410531399224,0.021171570840951767,0.06068410131836022,0.07217506744672904,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_10,0.012815651191332388,0.01868440435107516,5,0.00835591964961938,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,0.04129806561452106,0.059560891330850206,6,0.02431563206432352,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.012815651191332388,0.04129806561452106,0.00835591964961938,0.02431563206432352,0.30943381333096154,1,0.021171570840951767,0.06561369767884458,0.07217506744672904,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_10,0.026113437818576068,0.035863748588894295,5,0.01603875595454596,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.012815651191332388,0.026113437818576068,0.00835591964961938,0.01603875595454596,0.48979082805658036,1,0.021171570840951767,0.04215219377312203,0.07217506744672904,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,0.06818060549877485,0.06095980592618374,6,0.02488673655637338,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.04840423240570187,0.06818060549877485,0.019783447971486495,0.02488673655637338,0.5485194305641856,1,0.06818768037718836,0.09306734205514823,0.10237407626066305,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_10,0.04840423240570187,0.04845935288304083,6,0.019783447971486495,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,0.008788981074370353,0.0056059553298139254,6,0.0022886216798133165,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.04840423240570187,0.008788981074370353,0.019783447971486495,0.0022886216798133165,0.10186994791973368,1,0.06818768037718836,0.01107760275418367,0.10237407626066305,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_10,0.0415588240294689,0.04007107530553436,6,0.01635894799053312,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.04840423240570187,0.0415588240294689,0.019783447971486495,0.01635894799053312,0.7953374417352796,1,0.06818768037718836,0.05791777202000202,0.10237407626066305,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,0.042106594473121074,0.06767957642388092,6,0.027630071374367755,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.03609883824099338,0.042106594473121074,0.017887755111999446,0.027630071374367755,0.8595739741055793,1,0.05398659335299283,0.06973666584748883,0.07671033243223772,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_10,0.03609883824099338,0.039998236395300125,5,0.017887755111999446,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,0.0351433876208734,0.030275423935798036,6,0.012359890064858268,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.03609883824099338,0.0351433876208734,0.017887755111999446,0.012359890064858268,0.9661139877124084,1,0.05398659335299283,0.04750327768573167,0.07671033243223772,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_10,0.042929590025592525,0.043645302407074746,6,0.01781812009446659,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.03609883824099338,0.042929590025592525,0.017887755111999446,0.01781812009446659,0.7929216140064916,1,0.05398659335299283,0.06074771012005911,0.07671033243223772,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,0.04771008713195427,0.030627924933697193,6,0.012503797994637406,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.11622052155787452,0.04771008713195427,0.06708496171885502,0.012503797994637406,0.36874854805936214,1,0.18330548327672952,0.060213885126591676,0.2016360316044025,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_10,0.11622052155787452,0.15000653467133096,5,0.06708496171885502,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,0.09253171238479034,0.1610959577639372,6,0.06576714935776605,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.11622052155787452,0.09253171238479034,0.06708496171885502,0.06576714935776605,0.8066814534958363,1,0.18330548327672952,0.1582988617425564,0.2016360316044025,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_10,0.03811332557598398,0.041514395887293394,6,0.016948181150627555,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.11622052155787452,0.03811332557598398,0.06708496171885502,0.016948181150627555,0.31538273959235025,1,0.18330548327672952,0.05506150672661153,0.2016360316044025,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,0.013223593563483979,0.010705703190344357,6,0.004370585025671609,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.024980272786189344,0.013223593563483979,0.01390400059389428,0.004370585025671609,0.45075768703321295,1,0.03888427338008363,0.017594178589155587,0.04277270071809199,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_10,0.024980272786189344,0.034057706838395256,6,0.01390400059389428,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,0.015184810188587564,0.016692119888715103,6,0.006814529408785789,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.024980272786189344,0.015184810188587564,0.01390400059389428,0.006814529408785789,0.54635955912659,1,0.03888427338008363,0.021999339597373352,0.04277270071809199,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_10,0.015470196554383234,0.011923406615069722,6,0.0048677103671077296,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.024980272786189344,0.015470196554383234,0.01390400059389428,0.0048677103671077296,0.541676346174284,1,0.03888427338008363,0.020337906921490963,0.04277270071809199,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,0.018362623597110012,0.019799273829043153,6,0.00808301969313277,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.020983386863345627,0.018362623597110012,0.008893291331041076,0.00808301969313277,0.8317957699248686,1,0.029876678194386705,0.026445643290242783,0.048699709548577254,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_10,0.020983386863345627,0.02178402589496767,6,0.008893291331041076,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,0.030437349503716238,0.0338889691529222,6,0.013835113722263077,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.020983386863345627,0.030437349503716238,0.008893291331041076,0.013835113722263077,0.5802577196884734,1,0.029876678194386705,0.04427246322597932,0.048699709548577254,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_10,0.019017163489134292,0.007448092468166071,6,0.003040671017345573,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.020983386863345627,0.019017163489134292,0.008893291331041076,0.003040671017345573,0.8410460562482079,1,0.029876678194386705,0.022057834506479863,0.048699709548577254,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,0.00722919863617862,0.008047062411362622,6,0.0032851994726948016,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.015194000832375357,0.00722919863617862,0.006296219502514601,0.0032851994726948016,0.29653131473516886,1,0.021490220334889957,0.010514398108873422,0.04440378148549982,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_10,0.015194000832375357,0.015422525089720918,6,0.006296219502514601,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,0.03252813734880681,0.019201395111816587,6,0.007838936728920299,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.015194000832375357,0.03252813734880681,0.006296219502514601,0.007838936728920299,0.11683366864235513,1,0.021490220334889957,0.040367074077727105,0.04440378148549982,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_10,0.02586617998969487,0.022483796800331145,6,0.009178971606872064,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.015194000832375357,0.02586617998969487,0.006296219502514601,0.009178971606872064,0.363115886047369,1,0.021490220334889957,0.03504515159656693,0.04440378148549982,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_10,0.016035103578560788,0.010662388114697233,6,0.004352901720087357,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.013437896136773228,0.016035103578560788,0.006351250600731087,0.004352901720087357,0.7437462961458426,1,0.019789146737504315,0.020388005298648145,0.04059144287946637,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_10,0.013437896136773228,0.015557323200336296,6,0.006351250600731087,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_10,0.027583114811510805,0.011039107493386989,6,0.004506696762422059,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.013437896136773228,0.027583114811510805,0.006351250600731087,0.004506696762422059,0.10263480314869952,1,0.019789146737504315,0.03208981157393286,0.04059144287946637,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_10,0.02593356868532659,0.026865374037004158,6,0.010967743023279198,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.013437896136773228,0.02593356868532659,0.006351250600731087,0.010967743023279198,0.3529927221517347,1,0.019789146737504315,0.03690131170860579,0.04059144287946637,0,24,0,10.54437238493724,ascorbic_acid,ascorbic_acid_332_449_rt10.66,10.55573171,10.55,0.035447377,10.63,10.31,0.32,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.14740062042427618,0.16217700147460992,6,0.0662084836045649,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.06004960733295839,0.14740062042427618,0.022945019582226934,0.0662084836045649,0.25784073905469373,1,0.08299462691518532,0.2136091040288411,0.310963338819335,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_15,0.06004960733295839,0.05130662353092325,5,0.022945019582226934,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.17382945840362005,0.21335454776273463,6,0.08710162938682703,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.06004960733295839,0.17382945840362005,0.022945019582226934,0.08710162938682703,0.2558604990956422,1,0.08299462691518532,0.26093108779044705,0.310963338819335,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_15,0.22474310182106141,0.12958202331788835,5,0.05795084256015223,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,*,0.06004960733295839,0.22474310182106141,0.022945019582226934,0.05795084256015223,0.043907223236060944,1,0.08299462691518532,0.28269394438121365,0.310963338819335,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.35653441030920757,0.567917673270314,6,0.2318514192368204,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.17780777112660615,0.35653441030920757,0.09326928185089499,0.2318514192368204,0.4990965521018631,1,0.2710770529775011,0.588385829546028,0.6472244125006309,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_15,0.17780777112660615,0.2284621492105205,6,0.09326928185089499,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.13025533025636646,0.19816314237835106,6,0.08089976410890891,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.17780777112660615,0.13025533025636646,0.09326928185089499,0.08089976410890891,0.7083533550943193,1,0.2710770529775011,0.21115509436527535,0.6472244125006309,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_15,0.07971870713462854,0.09594714704949188,6,0.03917025875783994,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.17780777112660615,0.07971870713462854,0.09326928185089499,0.03917025875783994,0.3658677977708462,1,0.2710770529775011,0.11888896589246849,0.6472244125006309,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.07033224541939805,0.12032658535661638,6,0.049123122769192736,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1523406969004828,0.07033224541939805,0.0750911304302389,0.049123122769192736,0.39067679340093786,1,0.2274318273307217,0.11945536818859079,0.2501750100637939,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_15,0.1523406969004828,0.16790887214931724,5,0.0750911304302389,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.10028257670065273,0.1376008155974699,6,0.05617529773410035,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1523406969004828,0.10028257670065273,0.0750911304302389,0.05617529773410035,0.5944076460384939,1,0.2274318273307217,0.15645787443475306,0.2501750100637939,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_15,0.12781656013187292,0.13160569986371629,6,0.05372780198466243,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1523406969004828,0.12781656013187292,0.0750911304302389,0.05372780198466243,0.7976422385460441,1,0.2274318273307217,0.18154436211653535,0.2501750100637939,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.08768509065413803,0.0710432447200532,6,0.029003283205967584,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1251542720244198,0.08768509065413803,0.08473044508051016,0.029003283205967584,0.6932383260882862,1,0.20988471710492995,0.11668837386010561,0.6318302102358168,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_15,0.1251542720244198,0.18946303496383335,5,0.08473044508051016,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.27754918862618333,0.4221829921205616,6,0.17235548479613783,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1251542720244198,0.27754918862618333,0.08473044508051016,0.17235548479613783,0.45289835785853694,1,0.20988471710492995,0.44990467342232116,0.6318302102358168,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_15,0.46616487614009794,0.26509902577010463,6,0.1082262240742808,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,*,0.1251542720244198,0.46616487614009794,0.08473044508051016,0.1082262240742808,0.0353496982170319,0.8483927572087655,0.20988471710492995,0.5743911002143788,0.6318302102358168,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.06130351946038104,0.023279206148907675,6,0.009503696113647406,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.14057948063012482,0.06130351946038104,0.08739831320642004,0.009503696113647406,0.40761943969858555,1,0.22797779383654487,0.07080721557402844,0.2507755732201994,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_15,0.14057948063012482,0.21408127173567743,6,0.08739831320642004,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.06070585120100199,0.05027931033246744,6,0.02052644248893188,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.14057948063012482,0.06070585120100199,0.08739831320642004,0.02052644248893188,0.4105325598804337,1,0.22797779383654487,0.08123229368993387,0.2507755732201994,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_15,0.07102083211341521,0.06895659843297837,6,0.02815141342646652,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.14057948063012482,0.07102083211341521,0.08739831320642004,0.02815141342646652,0.4772850212148507,1,0.22797779383654487,0.09917224553988173,0.2507755732201994,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.06514947368108381,0.04824720448355438,6,0.019696838750071503,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.0699092879397003,0.06514947368108381,0.017425339112330802,0.019696838750071503,0.8600421936835346,1,0.0873346270520311,0.08484631243115531,0.10809845673921392,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_15,0.0699092879397003,0.042683189420172823,6,0.017425339112330802,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.07728162304726387,0.05141405794317802,6,0.020989701261112426,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.0699092879397003,0.07728162304726387,0.017425339112330802,0.020989701261112426,0.7926501733898998,1,0.0873346270520311,0.09827132430837629,0.10809845673921392,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_15,0.05040688000056052,0.07003457613151752,6,0.028591495979053295,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.0699092879397003,0.05040688000056052,0.017425339112330802,0.028591495979053295,0.5758029095291506,1,0.0873346270520311,0.07899837597961382,0.10809845673921392,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.07577018074596838,0.03286190842183902,6,0.013415817934595802,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.11663644816659262,0.07577018074596838,0.07949967269626355,0.013415817934595802,0.6326818456686012,1,0.19613612086285617,0.08918599868056418,0.21574973294914182,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_15,0.11663644816659262,0.19473363282411746,6,0.07949967269626355,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.07645058417535126,0.04873623929895471,6,0.019896486377436,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.11663644816659262,0.07645058417535126,0.07949967269626355,0.019896486377436,0.642417148740253,1,0.19613612086285617,0.09634707055278727,0.21574973294914182,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_15,0.10058719764304296,0.08269517230770695,6,0.03376016272423595,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.11663644816659262,0.10058719764304296,0.07949967269626355,0.03376016272423595,0.8580506308894651,1,0.19613612086285617,0.1343473603672789,0.21574973294914182,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_15,0.08772880228776107,0.06608725667298689,6,0.02698000955819342,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.08151479369115074,0.08772880228776107,0.03432210761929959,0.02698000955819342,0.8897955806528591,1,0.11583690131045032,0.1147088118459545,0.12742059144149537,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_15,0.08151479369115074,0.08407165056417469,6,0.03432210761929959,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_15,0.042005500255870576,0.02725657786480888,6,0.011127451317203397,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.08151479369115074,0.042005500255870576,0.03432210761929959,0.011127451317203397,0.3152424423769445,1,0.11583690131045032,0.053132951573073975,0.12742059144149537,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_15,0.06855165978686532,0.09992843089955773,6,0.04079561108348071,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.08151479369115074,0.06855165978686532,0.03432210761929959,0.04079561108348071,0.8129449847033672,1,0.11583690131045032,0.10934727087034604,0.12742059144149537,0,24,0,5.5830125523012555,benzoic_acid,benzoic_acid_179_105_rt5.69,5.59347561,5.6,0.036597538,5.62,5.36,0.26,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.40192715226700826,0.4509928621214001,6,0.1841170649724663,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.131271561877565,0.40192715226700826,0.05667274328704294,0.1841170649724663,0.21022402666142187,1,0.18794430516460794,0.5860442172394745,0.6446486389634221,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_92,0.131271561877565,0.1267241064612229,5,0.05667274328704294,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.32092034913771555,0.32172453640056553,6,0.13134349198580975,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.131271561877565,0.32092034913771555,0.05667274328704294,0.13134349198580975,0.22806419043979043,1,0.18794430516460794,0.4522638411235253,0.6446486389634221,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_92,0.22776770695611775,0.37482792284214705,5,0.16762814306801738,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.131271561877565,0.22776770695611775,0.05667274328704294,0.16762814306801738,0.609405665562064,1,0.18794430516460794,0.39539585002413513,0.6446486389634221,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.36092498594417355,0.17178165085773744,6,0.0701295652957315,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,0.08116670709265246,0.36092498594417355,0.01728233914900004,0.0701295652957315,0.009397654695945536,0.22554371270269286,0.0984490462416525,0.43105455123990505,0.4741600063638956,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_92,0.08116670709265246,0.04233291247677575,6,0.01728233914900004,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.2500728362277989,0.2612668667042527,6,0.10666175168686115,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.08116670709265246,0.2500728362277989,0.01728233914900004,0.10666175168686115,0.17587991585844504,1,0.0984490462416525,0.35673458791466006,0.4741600063638956,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_92,0.24636117991528697,0.171110109246912,6,0.06985540958113667,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.08116670709265246,0.24636117991528697,0.01728233914900004,0.06985540958113667,0.06447852388674966,1,0.0984490462416525,0.3162165894964236,0.4741600063638956,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.20778490824782192,0.276383426123546,6,0.11283306122748304,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.20561579333129618,0.20778490824782192,0.09726424691113494,0.11283306122748304,0.9887005922438818,1,0.3028800402424311,0.32061796947530496,0.4806788989102941,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_92,0.20561579333129618,0.2174894678736217,5,0.09726424691113494,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.31919633547006465,0.288511879834896,6,0.11778448172111178,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.20561579333129618,0.31919633547006465,0.09726424691113494,0.11778448172111178,0.4762208379778129,1,0.3028800402424311,0.43698081719117643,0.4806788989102941,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_92,0.13683590464998363,0.16999071583150605,6,0.06939841913294069,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.20561579333129618,0.13683590464998363,0.09726424691113494,0.06939841913294069,0.58161466685444,1,0.3028800402424311,0.20623432378292433,0.4806788989102941,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.19959243448915656,0.2211040012000069,6,0.09026533050462274,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1389296776895647,0.19959243448915656,0.05823079855472109,0.09026533050462274,0.5872896152856486,1,0.1971604762442858,0.2898577649937793,0.4815487009157724,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_92,0.1389296776895647,0.13020802395245287,5,0.05823079855472109,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.346729531497955,0.22300648138824122,6,0.09104201478911077,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1389296776895647,0.346729531497955,0.05823079855472109,0.09104201478911077,0.08978886740871007,1,0.1971604762442858,0.43777154628706577,0.4815487009157724,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_92,0.2696186974667127,0.2006629270106392,6,0.08192029691156838,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1389296776895647,0.2696186974667127,0.05823079855472109,0.08192029691156838,0.22730891326725022,1,0.1971604762442858,0.35153899437828107,0.4815487009157724,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.12061051492673099,0.09178319302254094,6,0.0374703316447671,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.0774453139941637,0.12061051492673099,0.04155290177271044,0.0374703316447671,0.4584594273652831,1,0.11899821576687414,0.1580808465714981,0.2576246280822914,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_92,0.0774453139941637,0.10178340667513115,6,0.04155290177271044,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.1434590396495811,0.14040594418382119,6,0.057320486684009575,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.0774453139941637,0.1434590396495811,0.04155290177271044,0.057320486684009575,0.3751450132722297,1,0.11899821576687414,0.20077952633359067,0.2576246280822914,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_92,0.19069001799421756,0.10658756048648249,6,0.043514189353320076,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.0774453139941637,0.19069001799421756,0.04155290177271044,0.043514189353320076,0.08926921047441057,1,0.11899821576687414,0.23420420734753764,0.2576246280822914,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.07190587182768941,0.045134862892466605,6,0.018426230616170342,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,0.2934577338852293,0.07190587182768941,0.07501357029373859,0.018426230616170342,0.030789266062544833,0.7081531194385312,0.3684713041789679,0.09033210244385975,0.40531843459686473,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_92,0.2934577338852293,0.18374497100405757,6,0.07501357029373859,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.09413423951994027,0.10959309802226874,6,0.04474119491422979,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.2934577338852293,0.09413423951994027,0.07501357029373859,0.04474119491422979,0.05128988271685875,1,0.3684713041789679,0.13887543443417005,0.40531843459686473,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_92,0.10379126726222172,0.13289015327609094,6,0.05425217789444486,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.2934577338852293,0.10379126726222172,0.07501357029373859,0.05425217789444486,0.070389739483085,1,0.3684713041789679,0.15804344515666657,0.40531843459686473,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.16397041291971273,0.17342831572148343,6,0.07080181341132272,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.18053257833893857,0.16397041291971273,0.055167974994723284,0.07080181341132272,0.8575095334368609,1,0.23570055333366186,0.23477222633103545,0.25927060866702806,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_92,0.18053257833893857,0.13513338887969353,6,0.055167974994723284,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.14335377390575502,0.11634029293138222,6,0.04749572570130184,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.18053257833893857,0.14335377390575502,0.055167974994723284,0.04749572570130184,0.6208708793796647,1,0.23570055333366186,0.19084949960705686,0.25927060866702806,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_92,0.16020593152983556,0.14962014985399721,6,0.06108217039684137,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.18053257833893857,0.16020593152983556,0.055167974994723284,0.06108217039684137,0.8099861464071142,1,0.23570055333366186,0.22128810192667692,0.25927060866702806,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_92,0.1623063348685577,0.118691736486358,6,0.04845569851274297,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.15096642626337134,0.1623063348685577,0.059535640091139014,0.04845569851274297,0.8856129794900407,1,0.21050206635451035,0.21076203338130067,0.2592373980762655,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_92,0.15096642626337134,0.14583193973327596,6,0.059535640091139014,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_92,0.16838745921896572,0.164808779951288,6,0.06728290266854832,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.15096642626337134,0.16838745921896572,0.059535640091139014,0.06728290266854832,0.8501862625923364,1,0.21050206635451035,0.23567036188751406,0.2592373980762655,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_92,0.15445741540716407,0.06523969089175051,6,0.026633992276948,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.15096642626337134,0.15445741540716407,0.059535640091139014,0.026633992276948,0.9588250898266432,1,0.21050206635451035,0.18109140768411208,0.2592373980762655,0,24,0,16.659684210526315,chlorogenic_acid,quinic_acid_3-caffeoyl-trans_345_255_rt16.8,16.65217391,16.65,0.012077647,16.68,16.52,0.16,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.11236338133283874,0.09055192512390754,6,0.03696766863004698,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.10625916806110883,0.11236338133283874,0.046884266636465353,0.03696766863004698,0.9210725916989293,1,0.1531434346975742,0.1493310499628857,0.41457964749955034,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_69,0.10625916806110883,0.10483640727436196,5,0.046884266636465353,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.2642899767593462,0.2758140438228625,6,0.11260061187660862,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.10625916806110883,0.2642899767593462,0.046884266636465353,0.11260061187660862,0.2383512083609346,1,0.1531434346975742,0.3768905886359548,0.41457964749955034,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_69,0.21125459887771494,0.2600053836872048,5,0.11627794248810097,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.10625916806110883,0.21125459887771494,0.046884266636465353,0.11627794248810097,0.43867295978023585,1,0.1531434346975742,0.3275325413658159,0.41457964749955034,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.23877080185152152,0.10616389149407085,6,0.043341227211445475,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.1925900730094572,0.23877080185152152,0.12302742136407871,0.043341227211445475,0.7349970577468287,1,0.3156174943735359,0.282112029062967,0.34717924381088955,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_69,0.1925900730094572,0.3013544067123748,6,0.12302742136407871,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.15249498477160695,0.1315023241847719,6,0.05368559904045784,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.1925900730094572,0.15249498477160695,0.12302742136407871,0.05368559904045784,0.7740401068042164,1,0.3156174943735359,0.20618058381206478,0.34717924381088955,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_69,0.158498100352908,0.23562706586849042,6,0.09619434682782727,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.1925900730094572,0.158498100352908,0.12302742136407871,0.09619434682782727,0.8318367055170148,1,0.3156174943735359,0.25469244718073525,0.34717924381088955,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.07606711668418194,0.06865482944846615,6,0.02802821675442439,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.12964242255529027,0.07606711668418194,0.06247351327519086,0.02802821675442439,0.4657946850585668,1,0.19211593583048112,0.10409533343860633,0.32584208868394976,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_69,0.12964242255529027,0.1396950224765623,5,0.06247351327519086,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.23571633791665433,0.14820329715617933,6,0.06050374270511811,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.12964242255529027,0.23571633791665433,0.06247351327519086,0.06050374270511811,0.25420870108596333,1,0.19211593583048112,0.29622008062177246,0.32584208868394976,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_69,0.1843884026143837,0.19538405714900997,6,0.07976520731497704,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.12964242255529027,0.1843884026143837,0.06247351327519086,0.07976520731497704,0.6022928887895069,1,0.19211593583048112,0.2641536099293607,0.32584208868394976,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.5095131099755934,0.9133861988345977,6,0.3728883542075106,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.3125481718395814,0.5095131099755934,0.11960069171907711,0.3728883542075106,0.6329006142107874,1,0.4321488635586585,0.882401464183104,1.650728886181655,5,24,20.833333333333336,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_69,0.3125481718395814,0.26743527683985263,5,0.11960069171907711,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,1.1772500750486534,0.7921957208574727,6,0.3234125487528509,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,*,0.3125481718395814,1.1772500750486534,0.11960069171907711,0.3234125487528509,0.04411366746609405,0.9705006842540691,0.4321488635586585,1.5006626238015044,1.650728886181655,5,24,20.833333333333336,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_69,0.5508420923031172,0.9025636397972036,6,0.3684700629820502,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.3125481718395814,0.5508420923031172,0.11960069171907711,0.3684700629820502,0.5609731911996753,1,0.4321488635586585,0.9193121552851674,1.650728886181655,5,24,20.833333333333336,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.2570542362188223,0.11713861270343466,6,0.04782163838348575,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.24083593243319748,0.2570542362188223,0.10639928461342724,0.04782163838348575,0.8933732736695065,1,0.34723521704662474,0.30487587460230803,0.3819587387512873,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_69,0.24083593243319748,0.260623956300058,6,0.10639928461342724,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.15074936758436208,0.09513598767633115,6,0.03883910433045334,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.24083593243319748,0.15074936758436208,0.10639928461342724,0.03883910433045334,0.4552824874746969,1,0.34723521704662474,0.18958847191481543,0.3819587387512873,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_69,0.14667142904776598,0.09962195402055757,6,0.0406704924215622,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.24083593243319748,0.14667142904776598,0.10639928461342724,0.0406704924215622,0.438013261899868,1,0.34723521704662474,0.18734192146932818,0.3819587387512873,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.27692264819359763,0.10194668907951784,6,0.041619561535164135,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,0.11892839863900133,0.27692264819359763,0.02091956908537081,0.041619561535164135,0.010696252669633225,0.2567100640711974,0.13984796772437214,0.3185422097287618,0.350396430701638,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_69,0.11892839863900133,0.05124226989805987,6,0.02091956908537081,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.053313793531047114,0.03510727553410477,6,0.014332485219642076,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,0.11892839863900133,0.053313793531047114,0.02091956908537081,0.014332485219642076,0.029732834775513146,0.6838551998368023,0.13984796772437214,0.0676462787506892,0.350396430701638,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_69,0.1308271078676492,0.1334068373936737,6,0.05446311330215785,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.11892839863900133,0.1308271078676492,0.02091956908537081,0.05446311330215785,0.8446859000323079,1,0.13984796772437214,0.18529022116980703,0.350396430701638,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.19618705731086694,0.1207668050362357,6,0.04930284170082587,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.28118168349697054,0.19618705731086694,0.15086484417778448,0.04930284170082587,0.6113818495518691,1,0.43204652767475504,0.24548989901169282,0.4752511804422306,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_69,0.28118168349697054,0.3695418883600655,6,0.15086484417778448,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.1641517320333051,0.15574112037601714,6,0.06358104614843571,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.28118168349697054,0.1641517320333051,0.15086484417778448,0.06358104614843571,0.4987760585761759,1,0.43204652767475504,0.2277327781817408,0.4752511804422306,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_69,0.14596045413762396,0.1386489519382833,6,0.05660319760341047,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.28118168349697054,0.14596045413762396,0.15086484417778448,0.05660319760341047,0.43167864558805635,1,0.43204652767475504,0.2025636517410344,0.4752511804422306,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_69,0.06596044645321515,0.05861760164074947,6,0.023930535660927708,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.13152915182633618,0.06596044645321515,0.03402132551317283,0.023930535660927708,0.1494895605715049,1,0.165550477339509,0.08989098211414286,0.19253681475667414,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_69,0.13152915182633618,0.08333488788040448,6,0.03402132551317283,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_69,0.11277571565456708,0.11790611552300573,6,0.04813497009750183,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.13152915182633618,0.11277571565456708,0.03402132551317283,0.04813497009750183,0.757627248366038,1,0.165550477339509,0.1609106857520689,0.19253681475667414,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_69,0.13358116861034905,0.10153698207324896,6,0.041452299350263795,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.13152915182633618,0.13358116861034905,0.03402132551317283,0.041452299350263795,0.970257424113963,1,0.165550477339509,0.17503346796061284,0.19253681475667414,0,24,0,6.856885593220339,citramalic_acid,malic_acid_2-methyl_247_259_rt6.95,6.862531646,6.86,0.031581191,7.09,6.67,0.42,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,0.11393394499064269,0.07389763303343619,6,0.03016858235522622,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.26388311186179936,0.11393394499064269,0.11610527449061277,0.03016858235522622,0.2718441598016718,1,0.3799883863524121,0.1441025273458689,0.41798722498765334,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_21,0.26388311186179936,0.2596192863072824,5,0.11610527449061277,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,0.10638703396660909,0.11389446594146081,6,0.04649722101389605,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.26388311186179936,0.10638703396660909,0.11610527449061277,0.04649722101389605,0.2607607959869426,1,0.3799883863524121,0.15288425498050515,0.41798722498765334,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_21,0.2280468154606301,0.2388369916206759,5,0.1068111497610758,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.26388311186179936,0.2280468154606301,0.11610527449061277,0.1068111497610758,0.8260405356117265,1,0.3799883863524121,0.3348579652217059,0.41798722498765334,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,0.12543790374933303,0.1533535353548229,6,0.06260631864519603,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.10864848595624406,0.12543790374933303,0.04950667909963342,0.06260631864519603,0.8378365563945243,1,0.15815516505587748,0.18804422239452906,0.9722446864986501,0,23,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_21,0.10864848595624406,0.12126610265381038,6,0.04950667909963342,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,0.15840471608788573,0.10119371132301054,6,0.04131215965331272,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.10864848595624406,0.15840471608788573,0.04950667909963342,0.04131215965331272,0.4587215240217264,1,0.15815516505587748,0.19971687574119845,0.9722446864986501,0,23,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_21,0.4807985310994504,0.9012701735013582,5,0.4030602748084133,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.10864848595624406,0.4807985310994504,0.04950667909963342,0.4030602748084133,0.40987558288734366,1,0.15815516505587748,0.8838588059078637,0.9722446864986501,0,23,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,0.1182187095308022,0.09133767166300022,6,0.03728844831136947,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.14956351876573262,0.1182187095308022,0.061413201215440555,0.03728844831136947,0.6762365584390615,1,0.21097671998117318,0.15550715784217167,0.23548382217324532,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_21,0.14956351876573262,0.1373240926335978,5,0.061413201215440555,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,0.15785208091879296,0.13772040782583844,6,0.05622412105688457,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.14956351876573262,0.15785208091879296,0.061413201215440555,0.05622412105688457,0.9229722904066069,1,0.21097671998117318,0.21407620197567753,0.23548382217324532,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_21,0.12742232386329633,0.10769034891330806,6,0.043964400843314946,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.14956351876573262,0.12742232386329633,0.061413201215440555,0.043964400843314946,0.777288482473716,1,0.21097671998117318,0.17138672470661126,0.23548382217324532,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,0.15045251478824798,0.11858025845255127,6,0.0484101877960171,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.11177906235402002,0.15045251478824798,0.030704026707327556,0.0484101877960171,0.5185298830077788,1,0.14248308906134757,0.19886270258426508,0.38769496112285323,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_21,0.11177906235402002,0.06865629090055346,5,0.030704026707327556,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,0.16403245619288373,0.16129934040261634,6,0.06585017997231683,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.11177906235402002,0.16403245619288373,0.030704026707327556,0.06585017997231683,0.49533988943938423,1,0.14248308906134757,0.22988263616520055,0.38769496112285323,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_21,0.21586205143729545,0.3345706924201664,6,0.13658791321984387,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.11177906235402002,0.21586205143729545,0.030704026707327556,0.13658791321984387,0.48772292798013206,1,0.14248308906134757,0.3524499646571393,0.38769496112285323,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,0.10071323495884554,0.15810025074853018,6,0.06454415708999553,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.19328475025076886,0.10071323495884554,0.05262288069099389,0.06454415708999553,0.29334308002267145,1,0.24590763094176274,0.16525739204884107,0.27049839403593906,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_21,0.19328475025076886,0.12889920648829248,6,0.05262288069099389,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,0.05552657500630372,0.050961570648641034,6,0.020804974096661082,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,0.19328475025076886,0.05552657500630372,0.05262288069099389,0.020804974096661082,0.047605438531430164,1,0.24590763094176274,0.0763315491029648,0.27049839403593906,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_21,0.14515995924952887,0.17731809567594697,6,0.07238980942801305,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.19328475025076886,0.14515995924952887,0.05262288069099389,0.07238980942801305,0.6036179556438417,1,0.24590763094176274,0.21754976867754194,0.27049839403593906,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,0.07883992707384675,0.11962767767941934,6,0.04883779490478497,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.09404031062141671,0.07883992707384675,0.04124677476511081,0.04883779490478497,0.8169819463192558,1,0.1352870853865275,0.12767772197863173,0.17843506661785943,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_21,0.09404031062141671,0.10103355171002695,6,0.04124677476511081,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,0.11968710777388836,0.10416844392200274,6,0.0425265891514384,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.09404031062141671,0.11968710777388836,0.04124677476511081,0.0425265891514384,0.674280961406938,1,0.1352870853865275,0.16221369692532675,0.17843506661785943,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_21,0.1200341084397351,0.08679393955514376,6,0.0354334774460113,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.09404031062141671,0.1200341084397351,0.04124677476511081,0.0354334774460113,0.6431350368138078,1,0.1352870853865275,0.15546758588574638,0.17843506661785943,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,0.0817044611123497,0.06154852459526617,6,0.02512707994659044,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.17522759039149674,0.0817044611123497,0.08765511425649647,0.02512707994659044,0.3458135956614998,1,0.26288270464799324,0.10683154105894015,0.2891709751127926,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_21,0.17522759039149674,0.2147103032737756,6,0.08765511425649647,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,0.0827181063616571,0.09882147366863912,6,0.04034369768634158,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.17522759039149674,0.0827181063616571,0.08765511425649647,0.04034369768634158,0.3695190844886372,1,0.26288270464799324,0.12306180404799869,0.2891709751127926,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_21,0.09940628858139207,0.02459960764239656,6,0.010042747766090175,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.17522759039149674,0.09940628858139207,0.08765511425649647,0.010042747766090175,0.4284470975666674,1,0.26288270464799324,0.10944903634748224,0.2891709751127926,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_21,0.07655995005389664,0.04697903024457969,6,0.019179108784999777,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.060758520336455867,0.07655995005389664,0.014562000054167072,0.019179108784999777,0.5275627937958633,1,0.07532052039062294,0.09573905883889641,0.12740710383651715,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_21,0.060758520336455867,0.035669469767090324,6,0.014562000054167072,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_21,0.09882584041590133,0.041638384856831565,6,0.01699879943547789,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.060758520336455867,0.09882584041590133,0.014562000054167072,0.01699879943547789,0.12055128720980227,1,0.07532052039062294,0.11582463985137921,0.12740710383651715,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_21,0.07224088004484575,0.06392381523238504,6,0.02609678828854904,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.060758520336455867,0.07224088004484575,0.014562000054167072,0.02609678828854904,0.711026774756949,1,0.07532052039062294,0.09833766833339479,0.12740710383651715,0,24,0,9.605574112734864,citric_acid,citric_acid_273_375_rt9.72,9.631829268,9.64,0.039479063,9.69,9.36,0.33,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.4360898928656411,0.4178758118332142,6,0.1705970858071086,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.28788972775644667,0.4360898928656411,0.16526486715829608,0.1705970858071086,0.5482451361809499,1,0.45315459491474275,0.6066869786727497,0.7345668107442105,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_22,0.28788972775644667,0.36954347725842257,5,0.16526486715829608,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.25309485715649144,0.2035668030471664,6,0.083105799339199593,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.28788972775644667,0.25309485715649144,0.16526486715829608,0.083105799339199593,0.8570281308304487,1,0.45315459491474275,0.33620065649569103,0.7345668107442105,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_22,0.4648348336659779,0.45381709801240866,5,0.20295317610148608,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.28788972775644667,0.4648348336659779,0.16526486715829608,0.20295317610148608,0.5188261040131265,1,0.45315459491474275,0.667788009767464,0.7345668107442105,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.29777813370829603,0.24278536341022472,6,0.09911670956187198,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.2257664635279999,0.29777813370829603,0.09143707782855472,0.09911670956187198,0.6050769465044994,1,0.3172035413565546,0.396894843270168,0.9850657329833763,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_22,0.2257664635279999,0.2239741842511119,6,0.09143707782855472,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.7152801625100689,0.4414816777243679,6,0.18023414020209133,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,*,0.2257664635279999,0.7152801625100689,0.09143707782855472,0.18023414020209133,0.04404692293254511,1,0.3172035413565546,0.8955143027121601,0.9850657329833763,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_22,0.6627126190243962,0.37876769610164646,6,0.15463126441643318,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,0.2257664635279999,0.6627126190243962,0.09143707782855472,0.15463126441643318,0.04063872519034279,0.975329404568227,0.3172035413565546,0.8173438834408293,0.9850657329833763,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.36442317317616385,0.42046465466372984,6,0.17165397646694625,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.5354478801369623,0.36442317317616385,0.3105769262823403,0.17165397646694625,0.6460177689934374,1,0.8460248064193026,0.53607714964311,0.9306272870612329,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_22,0.5354478801369623,0.694471119410254,5,0.3105769262823403,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.26589560902387727,0.21085284240705446,6,0.08608031245212631,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.5354478801369623,0.26589560902387727,0.3105769262823403,0.08608031245212631,0.44406440600948477,1,0.8460248064193026,0.3519759214760036,0.9306272870612329,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_22,0.1995379969397875,0.13791735389719287,6,0.05630452395382859,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.5354478801369623,0.1995379969397875,0.3105769262823403,0.05630452395382859,0.3437489650137691,1,0.8460248064193026,0.2558425208936161,0.9306272870612329,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.4226102026813871,0.2501130970465012,6,0.10210824429185639,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.18781113533032795,0.4226102026813871,0.08639410185861547,0.10210824429185639,0.11316872456211587,1,0.2742052371889434,0.5247184469732435,0.6633691632927137,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_22,0.18781113533032795,0.19318308461090514,5,0.08639410185861547,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.3164948597647259,0.36968926710916206,6,0.15092501130015384,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.18781113533032795,0.3164948597647259,0.08639410185861547,0.15092501130015384,0.4810713720101938,1,0.2742052371889434,0.46741987106487976,0.6633691632927137,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_22,0.49390809100466676,0.26737352553750393,6,0.10915478471598201,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.18781113533032795,0.49390809100466676,0.08639410185861547,0.10915478471598201,0.05585867884414516,1,0.2742052371889434,0.6030628757206488,0.6633691632927137,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.23502464608442583,0.19059536547064931,6,0.07781023212372777,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.40066671746286836,0.23502464608442583,0.06007817688110447,0.07781023212372777,0.12484267883724327,1,0.4607448943439728,0.3128348782081536,0.6220291200985418,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_22,0.40066671746286836,0.14716087803537886,6,0.06007817688110447,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.4574184435067916,0.26469816846465255,6,0.10806257476461002,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.40066671746286836,0.4574184435067916,0.06007817688110447,0.10806257476461002,0.6587155997724676,1,0.4607448943439728,0.5654810182714016,0.6220291200985418,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_22,0.2719033442506329,0.25553065191862046,6,0.10431995180689325,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.40066671746286836,0.2719033442506329,0.06007817688110447,0.10431995180689325,0.316045528404052,1,0.4607448943439728,0.37622329605752614,0.6220291200985418,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.27824126387118037,0.20748614035361818,6,0.08470586209430978,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.19449804492969655,0.27824126387118037,0.10938663199307412,0.08470586209430978,0.5592906431965778,1,0.30388467692277066,0.36294712596549017,0.6743918823212931,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_22,0.19449804492969655,0.26794143306463325,6,0.10938663199307412,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.30496540072314793,0.13169723381141743,6,0.05376517056233083,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.19449804492969655,0.30496540072314793,0.10938663199307412,0.05376517056233083,0.39376449955708204,1,0.30388467692277066,0.35873057128547875,0.6743918823212931,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_22,0.42879003050016506,0.4514250351751118,6,0.18429349888282864,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.19449804492969655,0.42879003050016506,0.10938663199307412,0.18429349888282864,0.30560964734064056,1,0.30388467692277066,0.6130835293829937,0.6743918823212931,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.32169596206342144,0.24373851751320857,6,0.09950583309496375,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.1496778282611895,0.32169596206342144,0.05121336836410358,0.09950583309496375,0.1654511896292187,1,0.2008911966252931,0.4212017951583852,0.46332197467422376,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_22,0.1496778282611895,0.12544662050124822,6,0.05121336836410358,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.20408032029833165,0.15240589513283367,6,0.06221944614459413,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.1496778282611895,0.20408032029833165,0.05121336836410358,0.06221944614459413,0.5154786450738609,1,0.2008911966252931,0.2662997664429258,0.46332197467422376,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_22,0.16752991096220285,0.23336665778990628,6,0.09527153909399459,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.1496778282611895,0.16752991096220285,0.05121336836410358,0.09527153909399459,0.8731758720932316,1,0.2008911966252931,0.2628014500561974,0.46332197467422376,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_22,0.3006440081436716,0.29680485861603906,6,0.12117007613136652,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.1578322201096589,0.3006440081436716,0.05965954168230668,0.12117007613136652,0.3241114038933057,1,0.21749176179196555,0.4218140842750381,0.6921533937682349,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_22,0.1578322201096589,0.14613543540995566,6,0.05965954168230668,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_22,0.3974417101868918,0.5677639152410562,6,0.23178864778423083,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.1578322201096589,0.3974417101868918,0.05965954168230668,0.23178864778423083,0.35763429797891494,1,0.21749176179196555,0.6292303579711226,0.6921533937682349,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_22,0.2712872812466646,0.3034472823814076,6,0.12388183427811476,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.1578322201096589,0.2712872812466646,0.05965954168230668,0.12388183427811476,0.4357746758165326,1,0.21749176179196555,0.3951691155247794,0.6921533937682349,0,24,0,6.946247379454927,decanoic_acid,decanoic_acid_229_117_rt7.04,6.950368098,6.95,0.033991458,7.19,6.74,0.45,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.07046435727355971,0.07856512555512926,6,0.03207407819796028,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.016780261306849332,0.07046435727355971,0.007085198305739134,0.03207407819796028,0.1579419841559096,1,0.023865459612588465,0.10253843547151999,0.11279227901867199,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_25,0.016780261306849332,0.015842985045699042,5,0.007085198305739134,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.06460234019262971,0.06617284553780516,6,0.027014951065938222,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.016780261306849332,0.06460234019262971,0.007085198305739134,0.027014951065938222,0.14048599357106617,1,0.023865459612588465,0.09161729125856793,0.11279227901867199,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_25,0.06781443197618393,0.05778528818251029,5,0.025842366495101656,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.016780261306849332,0.06781443197618393,0.007085198305739134,0.025842366495101656,0.12023985347315055,1,0.023865459612588465,0.0936567984712856,0.11279227901867199,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.03897454196346454,0.0393821777938304,6,0.01607770675907517,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.03728072199769069,0.03897454196346454,0.014937763469273693,0.01607770675907517,0.9400099990502038,1,0.05221848546696438,0.05505224872253971,0.10177486396691807,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_25,0.03728072199769069,0.03658989839810717,6,0.014937763469273693,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.0354755792925994,0.0224800509845652,6,0.009177442383989225,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.03728072199769069,0.0354755792925994,0.014937763469273693,0.009177442383989225,0.9204347161417051,1,0.05221848546696438,0.044653021676588626,0.10177486396691807,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_25,0.06025469867524454,0.07903990214969649,6,0.0322679049310446,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.03728072199769069,0.06025469867524454,0.014937763469273693,0.0322679049310446,0.5386706057080434,1,0.05221848546696438,0.09252260360628914,0.10177486396691807,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.04882284175227051,0.03723364758840091,6,0.01520057297569861,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.04979135240743471,0.04882284175227051,0.018663007704607583,0.01520057297569861,0.9688681406710159,1,0.06845436011204228,0.06402341472796912,0.18061786648231914,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_25,0.04979135240743471,0.04173175389210487,5,0.018663007704607583,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.0547819129592888,0.057057759333718656,6,0.023293732705689168,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.04979135240743471,0.0547819129592888,0.018663007704607583,0.023293732705689168,0.8709520374559416,1,0.06845436011204228,0.07807564566497797,0.18061786648231914,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_25,0.10897009643529394,0.13528033134058307,6,0.05522796400317799,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.04979135240743471,0.10897009643529394,0.018663007704607583,0.05522796400317799,0.34855267106471044,1,0.06845436011204228,0.16419806043847193,0.18061786648231914,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.025953118102858164,0.02535879062765622,6,0.010352682921971685,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1335540363194013,0.025953118102858164,0.07522305795907616,0.010352682921971685,0.22693751362856532,1,0.20877709427847746,0.036305801024829845,0.2296548037063252,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_25,0.1335540363194013,0.1682038710719009,5,0.07522305795907616,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.06077715592030649,0.04476279563722936,6,0.018274334795282152,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1335540363194013,0.06077715592030649,0.07522305795907616,0.018274334795282152,0.39508533331946166,1,0.20877709427847746,0.07905149071558865,0.2296548037063252,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_25,0.07522231128793493,0.07738360510457054,6,0.03159172449387159,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1335540363194013,0.07522231128793493,0.07522305795907616,0.03159172449387159,0.5043464085955388,1,0.20877709427847746,0.10681403578180651,0.2296548037063252,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.04819973036674304,0.03261792831129377,6,0.013316213471558522,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.07757083340874556,0.04819973036674304,0.02009671613606108,0.013316213471558522,0.2551801924385266,1,0.09766754954480664,0.061515943838301564,0.11769307783779229,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_25,0.07757083340874556,0.04922670003890679,6,0.02009671613606108,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.03801876585645755,0.03182547936885004,6,0.01299269754552597,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.07757083340874556,0.03801876585645755,0.02009671613606108,0.01299269754552597,0.13451233316130964,1,0.09766754954480664,0.051011463401983516,0.11769307783779229,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_25,0.07172428762724563,0.08639208129431719,6,0.03526941949802007,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.07757083340874556,0.07172428762724563,0.02009671613606108,0.03526941949802007,0.8890683395699571,1,0.09766754954480664,0.10699370712526571,0.11769307783779229,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.04856963317692838,0.044610560838018634,6,0.018212185198755265,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.06397152225292031,0.04856963317692838,0.02205801932954179,0.018212185198755265,0.6024686004704565,1,0.08602954158246211,0.06678181837568364,0.09463249574070833,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_25,0.06397152225292031,0.05403089209382569,6,0.02205801932954179,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.047939433569167855,0.03682610440111921,6,0.015034194166200662,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.06397152225292031,0.047939433569167855,0.02205801932954179,0.015034194166200662,0.5632289978611018,1,0.08602954158246211,0.06297362773536852,0.09463249574070833,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_25,0.034774644478974194,0.03747346838741113,6,0.015298479406912207,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.06397152225292031,0.034774644478974194,0.02205801932954179,0.015298479406912207,0.3053055016610921,1,0.08602954158246211,0.0500731238858864,0.09463249574070833,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.02975089319365794,0.020880449495315836,6,0.008524407810579723,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.05045561157405457,0.02975089319365794,0.017695160825701543,0.008524407810579723,0.3258950179448453,1,0.06815077239975612,0.038275301004237663,0.1098739678225917,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_25,0.05045561157405457,0.043344114939454635,6,0.017695160825701543,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.06335158091905346,0.05788387470629809,6,0.02363099289427064,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.05045561157405457,0.06335158091905346,0.017695160825701543,0.02363099289427064,0.6722396761062219,1,0.06815077239975612,0.08698257381332411,0.1098739678225917,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_25,0.08666535485227334,0.032382426944080604,6,0.013220070440991844,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.05045561157405457,0.08666535485227334,0.017695160825701543,0.013220070440991844,0.13463392006596134,1,0.06815077239975612,0.09988542529326518,0.1098739678225917,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_25,0.03898339638104013,0.03791675291801293,6,0.01547944955871947,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.05448569087831068,0.03898339638104013,0.02162506505844762,0.01547944955871947,0.5741713590776,1,0.0761107559367583,0.0544628459397596,0.08372183153043414,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_25,0.05448569087831068,0.05297037504768635,6,0.02162506505844762,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_25,0.026228877898586116,0.02067287768925897,6,0.008439666975608509,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.05448569087831068,0.026228877898586116,0.02162506505844762,0.008439666975608509,0.26591916400270693,1,0.0761107559367583,0.03466854487419463,0.08372183153043414,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_25,0.03874740403272692,0.027810007403775004,6,0.01135338798037852,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.05448569087831068,0.03874740403272692,0.02162506505844762,0.01135338798037852,0.5383842813201294,1,0.0761107559367583,0.05010079201310544,0.08372183153043414,0,24,0,7.14,erythronic_acid,erythronic_acid_292_rt7.24,7.140731707,7.14,0.034580057,7.39,6.93,0.46,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.19464560551144852,0.20904318977038414,6,0.08534152485687223,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.09202313544478677,0.19464560551144852,0.032996978862271424,0.08534152485687223,0.3021905285486365,1,0.1250201143070582,0.27998713036832074,0.4751619922269197,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_32,0.09202313544478677,0.07378348778816257,5,0.032996978862271424,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,0.12474086124263262,0.11050691976572098,6,0.04511426107878287,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.09202313544478677,0.12474086124263262,0.032996978862271424,0.04511426107878287,0.5732139765790756,1,0.1250201143070582,0.16985512232141547,0.4751619922269197,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_32,0.2736432582284342,0.35401917751089157,5,0.15832218925058367,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.09202313544478677,0.2736432582284342,0.032996978862271424,0.15832218925058367,0.31959524050899074,1,0.1250201143070582,0.4319654474790179,0.4751619922269197,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.25807248670891053,0.12912662264791708,6,0.05271572294938449,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.13198219853501836,0.25807248670891053,0.03885543154197939,0.05271572294938449,0.08562089502362168,1,0.17083763007699776,0.310788209658295,0.34186703062412455,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_32,0.13198219853501836,0.09517598101349246,6,0.03885543154197939,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,0.09617033102432208,0.11381218432468758,6,0.04646362968451177,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.13198219853501836,0.09617033102432208,0.03885543154197939,0.04646362968451177,0.5678748724011244,1,0.17083763007699776,0.14263396070883386,0.34186703062412455,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_32,0.09020189879723887,0.03140964897293689,6,0.012822935497271516,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.13198219853501836,0.09020189879723887,0.03885543154197939,0.012822935497271516,0.3461243988077627,1,0.17083763007699776,0.1030248342945104,0.34186703062412455,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.1078984819409942,0.07684320865194628,6,0.031371108565915004,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.15856157205621652,0.1078984819409942,0.05661990360046649,0.031371108565915004,0.4619789414012708,1,0.215181475656683,0.1392695905069092,0.2366996232223513,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_32,0.15856157205621652,0.12660595333012817,5,0.05661990360046649,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,0.09579310165560202,0.1119956779189346,6,0.04572204404974647,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.15856157205621652,0.09579310165560202,0.05661990360046649,0.04572204404974647,0.41308610641915,1,0.215181475656683,0.14151514570534848,0.2366996232223513,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_32,0.08723293299052919,0.07508697806318393,6,0.030654130430392425,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.15856157205621652,0.08723293299052919,0.05661990360046649,0.030654130430392425,0.30868301024913447,1,0.215181475656683,0.11788706342092162,0.2366996232223513,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.02647395141813184,0.046384654513695195,6,0.01893645590897297,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1340384675578256,0.02647395141813184,0.049157034585852695,0.01893645590897297,0.0946288481051499,1,0.1831955021436783,0.045410407327104815,0.20151505235804615,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_32,0.1340384675578256,0.10991847090627485,5,0.049157034585852695,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,0.08815409750406167,0.08184636608641759,6,0.03341363903545948,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1340384675578256,0.08815409750406167,0.049157034585852695,0.03341363903545948,0.4643764959047114,1,0.1831955021436783,0.12156773653952115,0.20151505235804615,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_32,0.12073043414434659,0.13765218668415727,6,0.056196269892419735,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1340384675578256,0.12073043414434659,0.049157034585852695,0.056196269892419735,0.8624812770945329,1,0.1831955021436783,0.17692670403676633,0.20151505235804615,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.030400493164011538,0.018496031840281472,6,0.00755097337916009,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.06425509605310409,0.030400493164011538,0.02967254411637347,0.00755097337916009,0.3137396991466784,1,0.09392764016947755,0.03795146654317163,0.15588461920835595,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_32,0.06425509605310409,0.07268259245533815,6,0.02967254411637347,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,0.04231406040042788,0.046942688261728295,6,0.019164272232628628,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.06425509605310409,0.04231406040042788,0.02967254411637347,0.019164272232628628,0.5506926923150584,1,0.09392764016947755,0.06147833263305651,0.15588461920835595,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_32,0.09382657663129534,0.11729801367620897,6,0.04788671355811914,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.06425509605310409,0.09382657663129534,0.02967254411637347,0.04788671355811914,0.6132903243976663,1,0.09392764016947755,0.14171329018941448,0.15588461920835595,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.03374731876906371,0.02702595109098191,6,0.01103329833105334,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,0.10163678929171738,0.03374731876906371,0.025214006687667986,0.01103329833105334,0.04378743562169045,1,0.12685079597938537,0.04478061710011705,0.13953587557732391,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_32,0.10163678929171738,0.061761450755909185,6,0.025214006687667986,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,0.09319846017894677,0.05813162965796785,6,0.023732138429743775,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.10163678929171738,0.09319846017894677,0.025214006687667986,0.023732138429743775,0.8124082344428353,1,0.12685079597938537,0.11693059860869054,0.13953587557732391,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_32,0.04186961015240972,0.0339355502374887,6,0.013854130370405303,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.10163678929171738,0.04186961015240972,0.025214006687667986,0.013854130370405303,0.07244107049429663,1,0.12685079597938537,0.05572374052281502,0.13953587557732391,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.039408210682708576,0.04652877782421896,6,0.01899529400411029,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.06276397796384277,0.039408210682708576,0.016033934315745617,0.01899529400411029,0.3701829536341086,1,0.07879791227958838,0.05840350468681887,0.13452342199036066,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_32,0.06276397796384277,0.0392749576428781,6,0.016033934315745617,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,0.0785393492476502,0.10717661718527097,6,0.04375467074358676,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.06276397796384277,0.0785393492476502,0.016033934315745617,0.04375467074358676,0.7459324879592566,1,0.07879791227958838,0.12229401999123696,0.13452342199036066,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_32,0.036144605720073164,0.024624419047137885,6,0.01005287697965983,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.06276397796384277,0.036144605720073164,0.016033934315745617,0.01005287697965983,0.1954308727359458,1,0.07879791227958838,0.04619748269973299,0.13452342199036066,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_32,0.03332714566933448,0.03453720528927379,6,0.014099755016745512,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.08001429700552702,0.03332714566933448,0.03387113931623028,0.014099755016745512,0.24567233475695596,1,0.1138854363217573,0.04742690068607999,0.12527397995393302,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_32,0.08001429700552702,0.0829670083314861,6,0.03387113931623028,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_32,0.06237438121246974,0.053418622595151,6,0.02180806135340468,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.08001429700552702,0.06237438121246974,0.03387113931623028,0.02180806135340468,0.6723394186611964,1,0.1138854363217573,0.08418244256587443,0.12527397995393302,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_32,0.04871761192309765,0.032801776281849354,6,0.013391269091243089,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.08001429700552702,0.04871761192309765,0.03387113931623028,0.013391269091243089,0.4206290783331398,1,0.1138854363217573,0.062108881014340735,0.12527397995393302,0,24,0,5.9579035639413,fumaric_acid,fumaric_acid_245_115_rt6.09,5.969325153,5.97,0.024523328,6,5.74,0.26,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.019184795534783583,0.024227119117462247,6,0.009890679962568337,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.014062669723944321,0.019184795534783583,0.00707397717034898,0.009890679962568337,0.6839121350760955,1,0.0211366468942933,0.02907547549735192,0.10552499132745832,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_49,0.014062669723944321,0.01581789382418193,5,0.00707397717034898,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.02886400635248998,0.0444559733245224,6,0.018149075110643367,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.014062669723944321,0.02886400635248998,0.00707397717034898,0.018149075110643367,0.4741928340321947,1,0.0211366468942933,0.04701308146313335,0.10552499132745832,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_49,0.07299042526808952,0.05129849642418129,5,0.022941385029599852,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.014062669723944321,0.07299042526808952,0.00707397717034898,0.022941385029599852,0.06017317182014116,1,0.0211366468942933,0.09593181029768938,0.10552499132745832,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.019333738847446713,0.019256785049055977,6,0.00786154957610718,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.017047473999013518,0.019333738847446713,0.006523807742310107,0.00786154957610718,0.8275730326064367,1,0.023571281741323627,0.02719528842355389,0.05075190598390139,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_49,0.017047473999013518,0.01598000014867809,6,0.006523807742310107,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.009103551544398977,0.006139414984909913,6,0.0025064056720376956,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.017047473999013518,0.009103551544398977,0.006523807742310107,0.0025064056720376956,0.2961654012821233,1,0.023571281741323627,0.011609957216436673,0.05075190598390139,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_49,0.029719388130148922,0.04021745737182867,6,0.01641870821885234,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.017047473999013518,0.029719388130148922,0.006523807742310107,0.01641870821885234,0.4980256806529947,1,0.023571281741323627,0.04613809634900126,0.05075190598390139,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.020127765293166882,0.024880398089615383,6,0.010157379986145845,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.02966672179286949,0.020127765293166882,0.014229612162483384,0.010157379986145845,0.6010793141428996,1,0.043896333955352876,0.030285145279312725,0.05524463175420511,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_49,0.02966672179286949,0.03181838008877063,5,0.014229612162483384,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.013574589549538016,0.017681520896590842,6,0.007218450678834283,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.02966672179286949,0.013574589549538016,0.014229612162483384,0.007218450678834283,0.35208745089165244,1,0.043896333955352876,0.0207930402283723,0.05524463175420511,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_49,0.031597756618734284,0.04562085456359587,6,0.018624635885088538,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.02966672179286949,0.031597756618734284,0.014229612162483384,0.018624635885088538,0.9361829742894185,1,0.043896333955352876,0.05022239250382282,0.05524463175420511,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.059636047685525995,0.05022452591597993,6,0.020504076844556792,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.04079424306685109,0.059636047685525995,0.0215657950817677,0.020504076844556792,0.5427745513070562,1,0.06236003814861879,0.08014012453008279,0.08815413698309107,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_49,0.04079424306685109,0.048222583791663214,5,0.0215657950817677,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.030574916253052604,0.01554170929112043,6,0.006344876248986253,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.04079424306685109,0.030574916253052604,0.0215657950817677,0.006344876248986253,0.6696401683364822,1,0.06236003814861879,0.036919792502038855,0.08815413698309107,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_49,0.052574176029444884,0.03746898021555612,6,0.015296647118425093,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.04079424306685109,0.052574176029444884,0.0215657950817677,0.015296647118425093,0.6684859272327168,1,0.06236003814861879,0.06787082314786998,0.08815413698309107,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.021665846424006707,0.02276011311623108,6,0.009291777270465484,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.012647067233054568,0.021665846424006707,0.005268801945191248,0.009291777270465484,0.4232741464442348,1,0.017915869178245815,0.03095762369447219,0.034053386063919416,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_49,0.012647067233054568,0.012905876321502018,6,0.005268801945191248,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.011773708130923414,0.010844460704595861,6,0.0044272325436538,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.012647067233054568,0.011773708130923414,0.005268801945191248,0.0044272325436538,0.901603359906415,1,0.017915869178245815,0.016200940674577214,0.034053386063919416,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_49,0.012110284376787184,0.007224144801913894,6,0.00294924476544475,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.012647067233054568,0.012110284376787184,0.005268801945191248,0.00294924476544475,0.9313868635818223,1,0.017915869178245815,0.015059529142231933,0.034053386063919416,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.020733624130784906,0.014848955840240078,6,0.006062060836951407,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.013457504383126725,0.020733624130784906,0.005291316517082652,0.006062060836951407,0.3875040989530666,1,0.01874882090020938,0.026795684967736315,0.039008959227797034,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_49,0.013457504383126725,0.012961025534413166,6,0.005291316517082652,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.020811924227034633,0.018707015333223297,6,0.007637107029469684,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.013457504383126725,0.020811924227034633,0.005291316517082652,0.007637107029469684,0.44919475879353454,1,0.01874882090020938,0.028449031256504317,0.039008959227797034,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_49,0.02554034455696519,0.02430468389432563,6,0.009922345650123024,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.013457504383126725,0.02554034455696519,0.005291316517082652,0.009922345650123024,0.3153938959489889,1,0.01874882090020938,0.03546269020708821,0.039008959227797034,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.01302681835168625,0.010747329246016806,6,0.0043875787917386395,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.01138322506524588,0.01302681835168625,0.0014855524749258428,0.0043875787917386395,0.7346136841836477,1,0.012868777540171723,0.017414397143424888,0.03335808405665822,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_49,0.01138322506524588,0.003638845549697016,6,0.0014855524749258428,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.025354083792603954,0.012177508844790828,6,0.004971447167994427,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.01138322506524588,0.025354083792603954,0.0014855524749258428,0.004971447167994427,0.03661682978202092,0.8788039147685021,0.012868777540171723,0.030325530960598382,0.03335808405665822,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_49,0.015152286040909976,0.02439049517613021,6,0.009957377959222257,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.01138322506524588,0.015152286040909976,0.0014855524749258428,0.009957377959222257,0.7228469200875125,1,0.012868777540171723,0.02510966400013223,0.03335808405665822,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_49,0.006838763760372994,0.003961541256642817,6,0.0016172924456264938,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.012525525808872673,0.006838763760372994,0.003331185895849963,0.0016172924456264938,0.16711995094551765,1,0.015856711704722637,0.008456056205999488,0.02607083224692602,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_49,0.012525525808872673,0.008159705683188476,6,0.003331185895849963,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_49,0.01918695333903146,0.011056514759570434,6,0.0045138032490831,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.012525525808872673,0.01918695333903146,0.003331185895849963,0.0045138032490831,0.264807018012881,1,0.015856711704722637,0.02370075658811456,0.02607083224692602,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_49,0.007439755805644932,0.004388981937739173,6,0.0017917943729587904,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.012525525808872673,0.007439755805644932,0.003331185895849963,0.0017917943729587904,0.2171764620285057,1,0.015856711704722637,0.009231550178603722,0.02607083224692602,0,24,0,6.716771488469602,glutaric_acid,glutaric_acid_261_158_rt6.80,6.722515337,6.72,0.03127622,6.9,6.5,0.4,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,0.15211352712502438,0.09517301117720713,6,0.03885421911139294,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.1779351621519063,0.15211352712502438,0.06477694018175888,0.03885421911139294,0.7429350322459607,1,0.2427121023336652,0.19096774623641732,0.6139930578213879,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_50,0.1779351621519063,0.14484564162085042,5,0.06477694018175888,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,0.33869481115390504,0.5376157134842315,6,0.21948069595644754,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.1779351621519063,0.33869481115390504,0.06477694018175888,0.21948069595644754,0.5093258470409747,1,0.2427121023336652,0.5581755071103526,0.6139930578213879,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_50,0.10971756550043969,0.11029891790935671,5,0.049327175657998115,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.1779351621519063,0.10971756550043969,0.06477694018175888,0.049327175657998115,0.42810182036921274,1,0.2427121023336652,0.1590447411584378,0.6139930578213879,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,0.06018127907054005,0.04759406196781541,6,0.019430194434591805,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.09701351803447729,0.06018127907054005,0.03976204083838637,0.019430194434591805,0.4317853397093505,1,0.13677555887286366,0.07961147350513186,0.15045311476015005,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_50,0.09701351803447729,0.09739671118575324,6,0.03976204083838637,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,0.06406751537596407,0.06199433665734662,6,0.025309081958802954,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.09701351803447729,0.06406751537596407,0.03976204083838637,0.025309081958802954,0.5032740410147885,1,0.13677555887286366,0.08937659733476702,0.15045311476015005,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_50,0.05649024237118675,0.05933170356252083,6,0.02422206654970782,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.09701351803447729,0.05649024237118675,0.03976204083838637,0.02422206654970782,0.4086762325404676,1,0.13677555887286366,0.08071230892089457,0.15045311476015005,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,0.07645151262843257,0.10087857980889886,6,0.041183507751405335,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.0837038705666159,0.07645151262843257,0.036636538489173046,0.041183507751405335,0.898217421209745,1,0.12034040905578895,0.1176350203798379,0.1470618481202957,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_50,0.0837038705666159,0.08192179052207837,5,0.036636538489173046,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,0.07013282262277191,0.07030324328815925,6,0.028701178886456066,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.0837038705666159,0.07013282262277191,0.036636538489173046,0.028701178886456066,0.7780079648470911,1,0.12034040905578895,0.09883400150922798,0.1470618481202957,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_50,0.10498540419704454,0.07031795520957695,6,0.028707185003224285,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.0837038705666159,0.10498540419704454,0.036636538489173046,0.028707185003224285,0.6596545018927946,1,0.12034040905578895,0.13369258920026883,0.1470618481202957,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,0.14656814895252124,0.09024172134132229,6,0.036841028466111134,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.23414097728566752,0.14656814895252124,0.09742112936570049,0.036841028466111134,0.4378027495846785,1,0.331562106651368,0.18340917741863239,0.36471831731650484,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_50,0.23414097728566752,0.21784026770650727,5,0.09742112936570049,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,0.19945170095438414,0.11697380275976078,6,0.04775435500572944,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.23414097728566752,0.19945170095438414,0.09742112936570049,0.04775435500572944,0.7602254265330367,1,0.331562106651368,0.24720605596011358,0.36471831731650484,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_50,0.04972035505368614,0.03712487316652761,6,0.015156166003922637,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.23414097728566752,0.04972035505368614,0.09742112936570049,0.015156166003922637,0.13143696035813324,1,0.331562106651368,0.06487652105760877,0.36471831731650484,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,0.10550863447307705,0.12433194977707492,6,0.05075830594652971,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.06565932240961092,0.10550863447307705,0.026076060478993864,0.05075830594652971,0.5061368520817805,1,0.09173538288860478,0.15626694041960676,0.2670529156069944,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_50,0.06565932240961092,0.06387304267548927,6,0.026076060478993864,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,0.07016526114862032,0.027466777263517508,6,0.011213264862382725,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.06565932240961092,0.07016526114862032,0.026076060478993864,0.011213264862382725,0.8784893498802796,1,0.09173538288860478,0.08137852601100304,0.2670529156069944,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_50,0.17950065093669032,0.15499079448919562,6,0.06327472688785003,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.06565932240961092,0.17950065093669032,0.026076060478993864,0.06327472688785003,0.14242133088727837,1,0.09173538288860478,0.24277537782454034,0.2670529156069944,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,0.07301889546228672,0.08815630165653622,6,0.03598965944489753,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.09447559574865916,0.07301889546228672,0.03840203678784758,0.03598965944489753,0.6921310626171406,1,0.13287763253650675,0.10900855490718425,0.17692732488670848,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_50,0.09447559574865916,0.0940653952138149,6,0.03840203678784758,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,0.07019043230668649,0.08220832081336904,6,0.03356140643396272,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.09447559574865916,0.07019043230668649,0.03840203678784758,0.03356140643396272,0.6443646984106937,1,0.13287763253650675,0.10375183874064922,0.17692732488670848,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_50,0.12465319415105054,0.08864661363825922,6,0.03618982847322989,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.09447559574865916,0.12465319415105054,0.03840203678784758,0.03618982847322989,0.5800631203998188,1,0.13287763253650675,0.16084302262428044,0.17692732488670848,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,0.09972905493902921,0.10662759292422108,6,0.043530532527589955,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.05529743042008425,0.09972905493902921,0.02330134240533558,0.043530532527589955,0.3956309159165209,1,0.07859877282541983,0.14325958746661915,0.163506222897034,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_50,0.05529743042008425,0.057076399214948205,6,0.02330134240533558,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,0.09571400545878535,0.12964663072210744,6,0.05292801535670011,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.05529743042008425,0.09571400545878535,0.02330134240533558,0.05292801535670011,0.5075928669102918,1,0.07859877282541983,0.14864202081548544,0.163506222897034,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_50,0.10768276793838871,0.08612294843880958,6,0.035159546469851435,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.05529743042008425,0.10768276793838871,0.02330134240533558,0.035159546469851435,0.2467565605739483,1,0.07859877282541983,0.14284231440824013,0.163506222897034,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_50,0.0664072086678326,0.07503362468600294,6,0.030632349005367814,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.061588462136655885,0.0664072086678326,0.026984896581259032,0.030632349005367814,0.9084101151376129,1,0.08857335871791491,0.09703955767320041,0.11669194247072606,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_50,0.061588462136655885,0.06609922738585884,6,0.026984896581259032,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_50,0.06955235443661197,0.08948287226426997,6,0.036531229627684444,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.061588462136655885,0.06955235443661197,0.026984896581259032,0.036531229627684444,0.8646015147391943,1,0.08857335871791491,0.10608358406429641,0.11669194247072606,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_50,0.03507507272245817,0.04840821711383779,6,0.019762571881127795,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.061588462136655885,0.03507507272245817,0.026984896581259032,0.019762571881127795,0.44799417793813234,1,0.08857335871791491,0.054837644603585964,0.11669194247072606,0,24,0,5.532767295597484,glyceric_acid,glyceric_acid_292_189_rt5.63,5.543006135,5.55,0.024873382,5.57,5.35,0.22,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.4371865279219318,0.5462187723494748,6,0.22299288003094309,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.4138743754430867,0.4371865279219318,0.2581837507970658,0.22299288003094309,0.9471118564731558,1,0.6720581262401525,0.6601794079528749,0.7392639388641677,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_55,0.4138743754430867,0.5773164174681047,5,0.2581837507970658,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.3014976357665583,0.29677806867216155,6,0.12115913918257691,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.4138743754430867,0.3014976357665583,0.2581837507970658,0.12115913918257691,0.7077949400139808,1,0.6720581262401525,0.42265677494913523,0.7392639388641677,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_55,0.26693956418639997,0.2966029685525493,5,0.13264488000234653,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.4138743754430867,0.26693956418639997,0.2581837507970658,0.13264488000234653,0.6308423250330442,1,0.6720581262401525,0.3995844441887465,0.7392639388641677,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.3652549639016214,0.2922160014425359,6,0.11929668303510102,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.3406984094924497,0.3652549639016214,0.16829808367166457,0.11929668303510102,0.9078562273441465,1,0.5089964931641143,0.48455164693672237,0.5598961424805258,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_55,0.3406984094924497,0.4122444296838074,6,0.16829808367166457,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.2611251443253631,0.39156816027652025,6,0.15985703203296933,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.3406984094924497,0.2611251443253631,0.16829808367166457,0.15985703203296933,0.7388533695679151,1,0.5089964931641143,0.42098217635833246,0.5598961424805258,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_55,0.18275059120629597,0.16778559549099228,6,0.06849818252365884,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.3406984094924497,0.18275059120629597,0.16829808367166457,0.06849818252365884,0.4151400788715883,1,0.5089964931641143,0.2512487737299548,0.5598961424805258,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.08301635181894995,0.07904474336785347,6,0.03226988135008096,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1217159368824563,0.08301635181894995,0.0739190542222244,0.03226988135008096,0.6498091743630312,1,0.1956349911046807,0.11528623316903092,0.41141070192276474,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_55,0.1217159368824563,0.1652880300733866,5,0.0739190542222244,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.18399959542370162,0.14452936587591433,6,0.059003866540668214,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1217159368824563,0.18399959542370162,0.0739190542222244,0.059003866540668214,0.52848703447009715,1,0.1956349911046807,0.24300346196436984,0.41141070192276474,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_55,0.2809006601652619,0.22806970912147648,6,0.09310906885543328,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1217159368824563,0.2809006601652619,0.0739190542222244,0.09310906885543328,0.21383728254246223,1,0.1956349911046807,0.3740097290206952,0.41141070192276474,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.22224968340202536,0.16873790446131634,6,0.06888696103278705,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.230182407484722,0.22224968340202536,0.09067952671175628,0.06888696103278705,0.9462048638886542,1,0.32086193419647824,0.2911366444348124,0.5388578851799829,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_55,0.230182407484722,0.20276558589499502,5,0.09067952671175628,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.23703873564411757,0.15722721923970542,6,0.06418774346899674,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.230182407484722,0.23703873564411757,0.09067952671175628,0.06418774346899674,0.952402142453644,1,0.32086193419647824,0.3012264791131143,0.5388578851799829,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_55,0.3307603264312144,0.3897394845109459,6,0.1591104782778609,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.230182407484722,0.3307603264312144,0.09067952671175628,0.1591104782778609,0.5983268070968741,1,0.32086193419647824,0.4898708047090753,0.5388578851799829,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.28687063999934853,0.10608395459366002,6,0.04330859310850777,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.29058059907067063,0.28687063999934853,0.17689694928825683,0.04330859310850777,0.9844541338443558,1,0.46747754835892746,0.3301792331078563,0.5142253031948203,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_55,0.29058059907067063,0.4333072628112211,6,0.17689694928825683,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.22455962161638796,0.17159034220855654,6,0.07005146386675246,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.29058059907067063,0.22455962161638796,0.17689694928825683,0.07005146386675246,0.7395026867911515,1,0.46747754835892746,0.2946110854831404,0.5142253031948203,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_55,0.15168213852717483,0.17704733123268263,6,0.07227927030693199,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.29058059907067063,0.15168213852717483,0.17689694928825683,0.07227927030693199,0.49219099202829564,1,0.46747754835892746,0.2239614088341068,0.5142253031948203,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.12521301506468116,0.11541842634223409,6,0.04711937524224637,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.17071084592208477,0.12521301506468116,0.0562658146607054,0.04711937524224637,0.5495765544504378,1,0.22697666058279017,0.17233239030692754,0.4561242879652307,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_55,0.17071084592208477,0.13782253588073723,6,0.0562658146607054,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.298248467545875,0.28514504231386223,6,0.11640997605888015,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.17071084592208477,0.298248467545875,0.0562658146607054,0.11640997605888015,0.35584807351967757,1,0.22697666058279017,0.4146584436047551,0.4561242879652307,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_55,0.13117752543880265,0.13378360317757143,6,0.054616927289339375,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.17071084592208477,0.13117752543880265,0.0562658146607054,0.054616927289339375,0.6250816078874708,1,0.22697666058279017,0.18579445272814202,0.4561242879652307,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.1755302265689079,0.23333119552138368,6,0.09525706168349427,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.2600180505743243,0.1755302265689079,0.09259462607629906,0.09525706168349427,0.5390763965638941,1,0.35261267665062335,0.27078728825240217,0.5509755486516476,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_55,0.2600180505743243,0.22680958681073835,6,0.09259462607629906,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.4306373846785499,0.17207537514050436,6,0.07024947773203882,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.2600180505743243,0.4306373846785499,0.09259462607629906,0.07024947773203882,0.17501793978602578,1,0.35261267665062335,0.5008868624105887,0.5509755486516476,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_55,0.19602012012284112,0.19684504833868274,6,0.08036165447054372,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.2600180505743243,0.19602012012284112,0.09259462607629906,0.08036165447054372,0.6132647094194665,1,0.35261267665062335,0.27638177459338487,0.5509755486516476,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_55,0.1619611046782965,0.17707847598823542,6,0.07229198510014333,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.22512476031314774,0.1619611046782965,0.07331625099339453,0.07229198510014333,0.5532724006706613,1,0.29844101130654227,0.23425308977843984,0.5097394466596793,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_55,0.22512476031314774,0.17958740478763688,6,0.07331625099339453,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_55,0.21828387992224427,0.18904160557151914,6,0.07717591230111658,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.22512476031314774,0.21828387992224427,0.07331625099339453,0.07717591230111658,0.9500294929531024,1,0.29844101130654227,0.29545979222336083,0.5097394466596793,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_55,0.360529785195334,0.25197830381880443,6,0.1028697117680108,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.22512476031314774,0.360529785195334,0.07331625099339453,0.1028697117680108,0.3115536174292627,1,0.29844101130654227,0.4633994969633448,0.5097394466596793,0,24,0,3.243605870020964,glycolic_acid,glycolic_acid_177_205_rt3.35,3.279141104,3.27,0.031158669,3.48,3.23,0.25,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,0.2341255817630119,0.24521247562315437,6,0.10010757397356447,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.24647162421932575,0.2341255817630119,0.07812598122565961,0.10010757397356447,0.9247157321360465,1,0.3245976054449854,0.33423315573657636,0.5255883655396253,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_63,0.24647162421932575,0.17469500482944725,5,0.07812598122565961,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,0.12578343322024121,0.03958074577799643,6,0.01615877179915181,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.24647162421932575,0.12578343322024121,0.07812598122565961,0.01615877179915181,0.19934844413735503,1,0.3245976054449854,0.14194220501939303,0.5255883655396253,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_63,0.3439790350835693,0.2992497797452721,5,0.13382856995245362,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.24647162421932575,0.3439790350835693,0.07812598122565961,0.13382856995245362,0.5508480491505506,1,0.3245976054449854,0.47780760503602293,0.5255883655396253,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,0.2987646271921173,0.2772182637265825,6,0.11317388225173763,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.056540517344536946,0.2987646271921173,0.021802283157910524,0.11317388225173763,0.08572618939808649,1,0.07834280050244746,0.41193850944385496,0.4531323603882405,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_63,0.056540517344536946,0.05340446896455626,6,0.021802283157910524,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,0.21436366861723566,0.2028660231281426,6,0.08281970713526672,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.056540517344536946,0.21436366861723566,0.021802283157910524,0.08281970713526672,0.11759795531880385,1,0.07834280050244746,0.29718337575250237,0.4531323603882405,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_63,0.17550312509608426,0.17857946693326665,6,0.07290476208745407,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.056540517344536946,0.17550312509608426,0.021802283157910524,0.07290476208745407,0.1699420923756093,1,0.07834280050244746,0.24840788718353835,0.4531323603882405,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,0.3019830315943394,0.34812919060351477,6,0.14212314692445324,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.24300359498969798,0.3019830315943394,0.10341987069850292,0.14212314692445324,0.7451935197393171,1,0.3464234656882009,0.44410617851879264,0.6450054013600502,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_63,0.24300359498969798,0.2312538611060912,5,0.10341987069850292,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,0.29204605970749414,0.15552159716039762,6,0.0634914261709419,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.24300359498969798,0.29204605970749414,0.10341987069850292,0.0634914261709419,0.6985097846954487,1,0.3464234656882009,0.35553748587843603,0.6450054013600502,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_63,0.46734051457441644,0.29155794377312705,6,0.11902803211653823,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.24300359498969798,0.46734051457441644,0.10341987069850292,0.11902803211653823,0.1885654181463578,1,0.3464234656882009,0.5863685466909547,0.6450054013600502,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,0.23978199037053397,0.28724764979760026,6,0.11726836196963272,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1309726307648062,0.23978199037053397,0.06065027631461617,0.11726836196963272,0.43569319537900175,1,0.19162290707942237,0.3570503523401667,0.3927553875741834,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_63,0.1309726307648062,0.13561814069362718,5,0.06065027631461617,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,0.05807236996428015,0.07320465850538244,6,0.02988567668881327,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1309726307648062,0.05807236996428015,0.06065027631461617,0.02988567668881327,0.32304495396037025,1,0.19162290707942237,0.08795804665309342,0.3927553875741834,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_63,0.12944309323305103,0.08371414708082821,6,0.034176157433388504,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1309726307648062,0.12944309323305103,0.06065027631461617,0.034176157433388504,0.9831377441637505,1,0.19162290707942237,0.16361925066643954,0.3927553875741834,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,0.04501624489183912,0.02778796863037366,6,0.0113443906888135,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.11157482268826313,0.04501624489183912,0.04997898963829022,0.0113443906888135,0.24570999423722292,1,0.16155381232655336,0.05636063558065262,0.17770919355920872,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_63,0.11157482268826313,0.12242302247365863,6,0.04997898963829022,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,0.054304763701011304,0.026255599122970524,6,0.01071880345705722,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.11157482268826313,0.054304763701011304,0.04997898963829022,0.01071880345705722,0.30939713004692504,1,0.16155381232655336,0.06502356715806852,0.17770919355920872,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_63,0.08858001389375292,0.08259665901644479,6,0.033719944841490206,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.11157482268826313,0.08858001389375292,0.04997898963829022,0.033719944841490206,0.7119808740795863,1,0.16155381232655336,0.12229995873524313,0.17770919355920872,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,0.07033932871714417,0.07032075063261498,6,0.02870832622990068,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.0857889180677253,0.07033932871714417,0.04272765635021035,0.02870832622990068,0.771086027078872,1,0.12851657441793565,0.09904765494704484,0.142807650476993,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_63,0.0857889180677253,0.10466095596300477,6,0.04272765635021035,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,0.07121113970950683,0.049958569820901556,6,0.020395500723402602,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.0857889180677253,0.07121113970950683,0.04272765635021035,0.020395500723402602,0.7669155725455179,1,0.12851657441793565,0.09160664043290943,0.142807650476993,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_63,0.08712704283712973,0.10458854319174708,6,0.04269809396013665,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.0857889180677253,0.08712704283712973,0.04272765635021035,0.04269809396013665,0.9827621027340734,1,0.12851657441793565,0.12982513679726637,0.142807650476993,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,0.03966414017645281,0.02942936083853004,6,0.012014486251774047,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.153291996055018,0.03966414017645281,0.05495250624425041,0.012014486251774047,0.09442157739699174,1,0.2082445022992684,0.05167862642822686,0.22906895252919526,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_63,0.153291996055018,0.1346056003855199,6,0.05495250624425041,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,0.06415508727180315,0.06854748437593494,6,0.027984393312073804,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.153291996055018,0.06415508727180315,0.05495250624425041,0.027984393312073804,0.1891579024219665,1,0.2082445022992684,0.09213948058387696,0.22906895252919526,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_63,0.06130020351207081,0.07047862557318947,6,0.028772778404497303,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.153291996055018,0.06130020351207081,0.05495250624425041,0.028772778404497303,0.1785616083210202,1,0.2082445022992684,0.09007298191656811,0.22906895252919526,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_63,0.08485491741731173,0.027918802243833068,6,0.011397803287843514,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.1303436448899705,0.08485491741731173,0.0425330368231596,0.011397803287843514,0.3433081134884048,1,0.1728766817131301,0.09625272070515524,0.2507281160108307,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_63,0.1303436448899705,0.10418423742774864,6,0.0425330368231596,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_63,0.14867799861624217,0.19413835686278377,6,0.07925665230269485,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.1303436448899705,0.14867799861624217,0.0425330368231596,0.07925665230269485,0.8437954765366169,1,0.1728766817131301,0.22793465091893703,0.2507281160108307,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_63,0.061545697807498044,0.07102030091525137,6,0.0289939164368805,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.1303436448899705,0.061545697807498044,0.0425330368231596,0.0289939164368805,0.21482349475650353,1,0.1728766817131301,0.09053961424437854,0.2507281160108307,0,24,0,9.6876617954071,isocitric_acid,isocitric_acid_245_rt9.80,9.705182927,9.71,0.033825111,9.8,9.51,0.29,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.08215429565123689,0.048871350501514386,6,0.019951645294903505,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.10863383382382272,0.08215429565123689,0.04398682966473003,0.019951645294903505,0.6045908904696378,1,0.15262066348855274,0.1021059409461404,0.4098544438497183,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_65,0.10863383382382272,0.09835754124504065,5,0.04398682966473003,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.23757542437225912,0.09584871221442523,6,0.03913007290470189,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.10863383382382272,0.23757542437225912,0.04398682966473003,0.03913007290470189,0.057770638130370304,1,0.15262066348855274,0.27670549727696103,0.4098544438497183,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_65,0.259291637011606,0.2533539075797037,5,0.11330331194268334,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.10863383382382272,0.259291637011606,0.04398682966473003,0.11330331194268334,0.2683516823666969,1,0.15262066348855274,0.37259494895428935,0.4098544438497183,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.22607552824793056,0.2023128539306552,6,0.08259387675605523,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.1128140194177959,0.22607552824793056,0.023674882709137608,0.08259387675605523,0.23696241398732149,1,0.13648890212693351,0.30866940500398576,0.3395363455043844,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_65,0.1128140194177959,0.05799138235762738,6,0.023674882709137608,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.17822048830398177,0.07425315809370811,6,0.030313724853299293,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.1128140194177959,0.17822048830398177,0.023674882709137608,0.030313724853299293,0.12166064007868357,1,0.13648890212693351,0.20853421315728105,0.3395363455043844,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_65,0.14567681841954672,0.05892376981646523,6,0.024055528295258102,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.1128140194177959,0.14567681841954672,0.023674882709137608,0.024055528295258102,0.35319092166153276,1,0.13648890212693351,0.1697323467148048,0.3395363455043844,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.08993332323640886,0.08425430610016192,6,0.03439667642961013,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1318506222631617,0.08993332323640886,0.046000006723284845,0.03439667642961013,0.48691609997777474,1,0.17785062898644655,0.12432999966601899,0.19563569188509122,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_65,0.1318506222631617,0.10285914199871228,5,0.046000006723284845,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.07280380281852043,0.032030626741026726,6,0.013076448609510257,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1318506222631617,0.07280380281852043,0.046000006723284845,0.013076448609510257,0.27568672868776395,1,0.17785062898644655,0.08588025142803069,0.19563569188509122,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_65,0.11382235262989437,0.08991848072295046,6,0.03670906603625235,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1318506222631617,0.11382235262989437,0.046000006723284845,0.03670906603625235,0.7670857137814833,1,0.17785062898644655,0.15053141866614672,0.19563569188509122,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.12971872035106316,0.09871916450673349,6,0.04030193014589481,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.06160733148044093,0.12971872035106316,0.03075204941982649,0.04030193014589481,0.21273496960934987,1,0.09235938090026742,0.17002065049695797,0.21212921864796855,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_65,0.06160733148044093,0.068763672950165,5,0.03075204941982649,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.14614874455626178,0.11438137221862428,6,0.046695999669164164,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.06160733148044093,0.14614874455626178,0.03075204941982649,0.046695999669164164,0.16753527579362934,1,0.09235938090026742,0.19284474422542594,0.21212921864796855,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_65,0.13980209719064815,0.10802238972270105,6,0.04409995593611387,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.06160733148044093,0.13980209719064815,0.03075204941982649,0.04409995593611387,0.18163372723368756,1,0.09235938090026742,0.18390205312676203,0.21212921864796855,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.12811385703334807,0.09189666876002843,6,0.037516657920605496,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.05424864425966103,0.12811385703334807,0.019325700292935333,0.037516657920605496,0.12079821493611832,1,0.07357434455259636,0.16563051495395356,0.24689239743937716,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_65,0.05424864425966103,0.04733810463964695,6,0.019325700292935333,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.18154261351662285,0.10509540767561983,6,0.042905020519174546,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,0.05424864425966103,0.18154261351662285,0.019325700292935333,0.042905020519174546,0.030626612035368424,0.7350386888488422,0.07357434455259636,0.2244476340357974,0.24689239743937716,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_65,0.12948055121522803,0.14057411904172748,6,0.057389143782248825,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.05424864425966103,0.12948055121522803,0.019325700292935333,0.057389143782248825,0.2595941638979204,1,0.07357434455259636,0.18686969499747685,0.24689239743937716,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.11716618455243226,0.21545200532769676,6,0.08795791285204331,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.10610334767038469,0.11716618455243226,0.03426186395960818,0.08795791285204331,0.9102512759756263,1,0.14036521162999288,0.20512409740447557,0.33710961939689676,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_65,0.10610334767038469,0.08392408433769288,6,0.03426186395960818,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.25484148929949596,0.12644707220369533,6,0.05162180106131928,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,0.10610334767038469,0.25484148929949596,0.03426186395960818,0.05162180106131928,0.04078685540296488,0.9380976742681922,0.14036521162999288,0.3064632903608152,0.33710961939689676,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_65,0.0671582577780608,0.06706072683034897,6,0.02737742708575408,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.10610334767038469,0.0671582577780608,0.03426186395960818,0.02737742708575408,0.39638110960851736,1,0.14036521162999288,0.09453568486381488,0.33710961939689676,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.13358693574534128,0.16708611068766346,6,0.0682126190484944,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.0394867626976508,0.13358693574534128,0.012875678023193724,0.0682126190484944,0.22959796361447818,1,0.052362440720844526,0.20179955479383568,0.22197951027321927,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_65,0.0394867626976508,0.03153884124919181,6,0.012875678023193724,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.07844306814440986,0.09408029464111478,6,0.03840811945357164,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.0394867626976508,0.07844306814440986,0.012875678023193724,0.03840811945357164,0.37271267228838206,1,0.052362440720844526,0.1168511875979815,0.22197951027321927,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_65,0.10958903099975655,0.16981194408888953,6,0.06932543587463424,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.0394867626976508,0.10958903099975655,0.012875678023193724,0.06932543587463424,0.3629803784183695,1,0.052362440720844526,0.17891446687439078,0.22197951027321927,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_65,0.06822715691240466,0.09357935527978628,6,0.03820361181568323,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.15032553383490233,0.06822715691240466,0.04846437560774548,0.03820361181568323,0.21450569608416467,1,0.1987899094426478,0.10643076872808789,0.21866890038691258,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_65,0.15032553383490233,0.1187129909415638,6,0.04846437560774548,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_65,0.10144343412602937,0.11466677177814358,6,0.046812513551437056,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.15032553383490233,0.10144343412602937,0.04846437560774548,0.046812513551437056,0.4848217257453217,1,0.1987899094426478,0.14825594767746642,0.21866890038691258,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_65,0.09923801101268692,0.13483188030387475,6,0.05504488463408507,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.15032553383490233,0.09923801101268692,0.04846437560774548,0.05504488463408507,0.5021813510187766,1,0.1987899094426478,0.154282895646772,0.21866890038691258,0,24,0,6.200649895178197,itaconic_acid,itaconic_acid_147_259_rt6.32,6.218404908,6.23,0.057552192,6.41,6.07,0.34,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.12606542875002305,0.18746310952115755,6,0.0765314939870525,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.11052116966050667,0.12606542875002305,0.05310758235296524,0.0765314939870525,0.8713718314016927,1,0.1636287520134719,0.20259692273707555,0.32256573094517127,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_70,0.11052116966050667,0.11875216426189851,5,0.05310758235296524,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.2257027725177907,0.16543560045772432,6,0.06753880106872863,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.11052116966050667,0.2257027725177907,0.05310758235296524,0.06753880106872863,0.2134066446437785,1,0.1636287520134719,0.2932415735865193,0.32256573094517127,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_70,0.1532371656172052,0.1302068764591756,5,0.058230285380126756,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.11052116966050667,0.1532371656172052,0.05310758235296524,0.058230285380126756,0.6027017095329676,1,0.1636287520134719,0.21146745099733197,0.32256573094517127,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.3524051922059988,0.5963119281127701,6,0.2434433252352484,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.08184226218823872,0.3524051922059988,0.03393085126140124,0.2434433252352484,0.31937844776193874,1,0.11577311344963995,0.5958485174412472,0.655433369185372,0,23,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_70,0.08184226218823872,0.08311327212870398,6,0.03393085126140124,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.17927870797795106,0.2498360733891812,6,0.10199514985733746,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.08184226218823872,0.17927870797795106,0.03393085126140124,0.10199514985733746,0.3991171988687056,1,0.11577311344963995,0.2812738578352885,0.655433369185372,0,23,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_70,0.20528055789612426,0.1789198690320383,5,0.08001539793619943,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.08184226218823872,0.20528055789612426,0.03393085126140124,0.08001539793619943,0.21033933779928837,1,0.11577311344963995,0.2852959558323237,0.655433369185372,0,23,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.1596488362485152,0.12057264393028283,6,0.04922357576124604,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.09816891442591658,0.1596488362485152,0.04510619479850019,0.04922357576124604,0.38116573051027336,1,0.14327510922441677,0.20887241200976123,0.4588845599867868,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_70,0.09816891442591658,0.10086051777579386,5,0.04510619479850019,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.281333378541579,0.3327249775136889,6,0.13583440326459076,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.09816891442591658,0.281333378541579,0.04510619479850019,0.13583440326459076,0.24736633248967183,1,0.14327510922441677,0.41716778180616976,0.4588845599867868,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_70,0.17639197179305496,0.16513377867914175,6,0.06741558284359754,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.09816891442591658,0.17639197179305496,0.04510619479850019,0.06741558284359754,0.36186646508822107,1,0.14327510922441677,0.2438075546366525,0.4588845599867868,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.29019434699678887,0.1692380856307586,6,0.06909115914013406,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.13266611430716918,0.29019434699678887,0.051072241907351455,0.06909115914013406,0.10105804737729283,1,0.18373835621452064,0.3592855061369229,0.3952140567506152,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_70,0.13266611430716918,0.11420100466815138,5,0.051072241907351455,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.21746908047645394,0.21574804432052025,6,0.08807877026477415,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.13266611430716918,0.21746908047645394,0.051072241907351455,0.08807877026477415,0.4295888725152318,1,0.18373835621452064,0.3055478507412281,0.3952140567506152,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_70,0.11331227658829124,0.07295511440874952,6,0.029783800737967537,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.13266611430716918,0.11331227658829124,0.051072241907351455,0.029783800737967537,0.7535754541361984,1,0.18373835621452064,0.14309607732625879,0.3952140567506152,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.06419726142070663,0.04308030611838544,6,0.017587461325490755,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.14965848807393023,0.06419726142070663,0.054818107345408415,0.017587461325490755,0.1880710077661389,1,0.20447659541933866,0.08178472274619739,0.22492425496127255,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_70,0.14965848807393023,0.1342763916613651,6,0.054818107345408415,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.05899466258014222,0.024227992363518188,6,0.00989103646377783,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.14965848807393023,0.05899466258014222,0.054818107345408415,0.00989103646377783,0.16095985515189437,1,0.20447659541933866,0.06888569904392006,0.22492425496127255,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_70,0.10909128914776571,0.11207034851577477,6,0.045752528193254385,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.14965848807393023,0.10909128914776571,0.054818107345408415,0.045752528193254385,0.58285903073206,1,0.20447659541933866,0.1548438173410201,0.22492425496127255,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.04603844920478487,0.051551713158544746,6,0.021045898767459326,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.07350782973503629,0.04603844920478487,0.030826337365432995,0.021045898767459326,0.48085972236078567,1,0.10433416710046929,0.06708434797224419,0.11476758381051623,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_70,0.07350782973503629,0.07550879718420193,6,0.030826337365432995,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.061574924196871716,0.04726563770595403,6,0.019296115791140038,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.07350782973503629,0.061574924196871716,0.030826337365432995,0.019296115791140038,0.7508547510436459,1,0.10433416710046929,0.08087103998801176,0.11476758381051623,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_70,0.06685884584442296,0.04369244486678716,6,0.017837365923052448,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.07350782973503629,0.06685884584442296,0.030826337365432995,0.017837365923052448,0.8565449910705601,1,0.10433416710046929,0.08469621176747541,0.11476758381051623,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.054571400013243565,0.06686977692752377,6,0.027299472114361453,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.09655300612046809,0.054571400013243565,0.048423954443440734,0.027299472114361453,0.47206940288658905,1,0.14497696056390882,0.08187087212760502,0.15947465662029972,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_70,0.09655300612046809,0.11861397971420796,6,0.048423954443440734,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.0958729638629922,0.09564045593118212,6,0.03904505263308953,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.09655300612046809,0.0958729638629922,0.048423954443440734,0.03904505263308953,0.9915019391875672,1,0.14497696056390882,0.13491801649608173,0.15947465662029972,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_70,0.07997416616527205,0.05820296939775052,6,0.023761262756552187,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.09655300612046809,0.07997416616527205,0.048423954443440734,0.023761262756552187,0.7671814961595862,1,0.14497696056390882,0.10373542892182423,0.15947465662029972,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_70,0.041857509207654665,0.015184249786423729,6,0.006198944017283765,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,0.07162451626449728,0.041857509207654665,0.010499743777588381,0.006198944017283765,0.04009595104437899,0.9222068740207168,0.08212426004208567,0.04805645322493843,0.09033668604629425,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_70,0.07162451626449728,0.025719014685054237,6,0.010499743777588381,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_70,0.04935661387796797,0.048267216211650255,6,0.019705008503855873,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.07162451626449728,0.04935661387796797,0.010499743777588381,0.019705008503855873,0.3491934720511426,1,0.08212426004208567,0.06906162238182384,0.09033668604629425,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_70,0.03438325235776718,0.02004412521778871,6,0.008182979854005847,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,0.07162451626449728,0.03438325235776718,0.010499743777588381,0.008182979854005847,0.019896062674077813,0.4775055041778675,0.08212426004208567,0.042566232211773025,0.09033668604629425,0,24,0,7.1203549060542795,malic_acid,malic_acid_233_245_rt7.22,7.124634146,7.12,0.027321989,7.33,6.89,0.44,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.0333792620833695,0.030290617066314644,6,0.012366092634418468,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.020229960038663463,0.0333792620833695,0.011160457312119402,0.012366092634418468,0.4501823717437259,1,0.031390417350782865,0.04574535471778797,0.1420776032126287,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_105,0.020229960038663463,0.02495554120988357,5,0.011160457312119402,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.08935228079593054,0.09751216992204238,6,0.03980917667009553,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.020229960038663463,0.08935228079593054,0.011160457312119402,0.03980917667009553,0.14752983615002194,1,0.031390417350782865,0.12916145746602606,0.1420776032126287,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_105,0.06993353808605848,0.06912672094465092,5,0.030914409418779584,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.020229960038663463,0.06993353808605848,0.011160457312119402,0.030914409418779584,0.1905876701407692,1,0.031390417350782865,0.10084794750483807,0.1420776032126287,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.042483874018666455,0.06147310572228216,6,0.02509629032062601,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.022233312541402667,0.042483874018666455,0.010968933995966882,0.02509629032062601,0.4842630640336053,1,0.03320224653736955,0.06758016433929247,0.11365406014257572,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_105,0.022233312541402667,0.026868291312386574,6,0.010968933995966882,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.055026603015977726,0.05570925592739669,6,0.02274320849537353,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.022233312541402667,0.055026603015977726,0.010968933995966882,0.02274320849537353,0.23404439906187358,1,0.03320224653736955,0.07776981151135126,0.11365406014257572,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_105,0.06907620187477932,0.08388441980540028,6,0.03424567098210768,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.022233312541402667,0.06907620187477932,0.010968933995966882,0.03424567098210768,0.2403376130272451,1,0.03320224653736955,0.103321872856887,0.11365406014257572,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.08318413205256377,0.08893940878389657,6,0.03630936159089246,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.09838082604580638,0.08318413205256377,0.04348554355339218,0.03630936159089246,0.7950569741333925,1,0.14186636959919857,0.11949349364345623,0.15605300655911844,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_105,0.09838082604580638,0.09723663142391267,5,0.04348554355339218,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.0565328451404861,0.05157132201291888,6,0.02105390404873552,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.09838082604580638,0.0565328451404861,0.04348554355339218,0.02105390404873552,0.42056427751331493,1,0.14186636959919857,0.07758674918922162,0.15605300655911844,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_105,0.0636422436952883,0.07553726238487675,6,0.0308379582349462,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.09838082604580638,0.0636422436952883,0.04348554355339218,0.0308379582349462,0.5340553043267144,1,0.14186636959919857,0.0944802019302345,0.15605300655911844,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.04489645225977105,0.04104388207207626,6,0.01675609468992553,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.0927820121528073,0.04489645225977105,0.08098834133006362,0.01675609468992553,0.5912986277529855,1,0.17377035348287093,0.061652546949696574,0.19114738883115803,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_105,0.0927820121528073,0.181095436598978,5,0.08098834133006362,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.038252407794893216,0.04108897694275693,6,0.016774504593789603,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.0927820121528073,0.038252407794893216,0.08098834133006362,0.016774504593789603,0.543019990879775,1,0.17377035348287093,0.05502691238868282,0.19114738883115803,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_105,0.08719324177506782,0.03974192322543943,6,0.01622457221653174,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.0927820121528073,0.08719324177506782,0.08098834133006362,0.01622457221653174,0.9490702330137342,1,0.17377035348287093,0.10341781399159956,0.19114738883115803,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.11960851550203395,0.08011736428412167,6,0.03270777700546323,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.10347853583134399,0.11960851550203395,0.062181661646854035,0.03270777700546323,0.824500444180217,1,0.16566019747819802,0.15231629250749718,0.31442994612536507,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_105,0.10347853583134399,0.1523133423931831,6,0.062181661646854035,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.18928010427063915,0.11879741774338191,6,0.04849884270525706,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.10347853583134399,0.18928010427063915,0.062181661646854035,0.04849884270525706,0.3035739480538917,1,0.16566019747819802,0.23777894697589622,0.31442994612536507,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_105,0.2164819781488502,0.16990500398875108,6,0.06936342741966346,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.10347853583134399,0.2164819781488502,0.062181661646854035,0.06936342741966346,0.2533006544713981,1,0.16566019747819802,0.2858454055685137,0.31442994612536507,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.14620316926989044,0.16625110567402124,6,0.06787172967914622,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.1223820141469435,0.14620316926989044,0.04887953006547445,0.06787172967914622,0.7821792148686126,1,0.17126154421241796,0.21407489894903664,0.2879193277683681,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_105,0.1223820141469435,0.11972990752744161,6,0.04887953006547445,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.1845837239251733,0.18900537075842555,6,0.07716111950061584,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.1223820141469435,0.1845837239251733,0.04887953006547445,0.07716111950061584,0.5140910307482927,1,0.17126154421241796,0.26174484342578913,0.2879193277683681,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_105,0.10397885895981447,0.11098678142429873,6,0.045310163780556384,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.1223820141469435,0.10397885895981447,0.04887953006547445,0.045310163780556384,0.7881126119411183,1,0.17126154421241796,0.14928902274037087,0.2879193277683681,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.1670085930800853,0.1252586593322497,6,0.051136633538186343,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.18225020158112293,0.1670085930800853,0.043771267055776594,0.051136633538186343,0.825532867752658,1,0.22602146863689954,0.21814522661827165,0.2486236155005895,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_105,0.18225020158112293,0.107217269681748,6,0.043771267055776594,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.07233285998184606,0.06746495155471484,6,0.027542451138439672,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.18225020158112293,0.07233285998184606,0.043771267055776594,0.027542451138439672,0.06455431975431503,1,0.22602146863689954,0.09987531112028573,0.2486236155005895,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_105,0.1757813866999788,0.06998815120930177,6,0.028572543083923797,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.18225020158112293,0.1757813866999788,0.043771267055776594,0.028572543083923797,0.9043518591584631,1,0.22602146863689954,0.2043539297839026,0.2486236155005895,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_105,0.1965773538303528,0.07421607722824103,6,0.030298586653363435,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.18165385826052902,0.1965773538303528,0.07412857409641883,0.030298586653363435,0.8577441307214724,1,0.25578243235694786,0.22687594048371623,0.28756080353064983,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_105,0.18165385826052902,0.18157718189632072,6,0.07412857409641883,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_105,0.18079174421908648,0.19749542120529986,6,0.08062716808150423,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.18165385826052902,0.18079174421908648,0.07412857409641883,0.08062716808150423,0.9938755078791246,1,0.25578243235694786,0.2614189123005907,0.28756080353064983,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_105,0.08995928973914658,0.10956408325802959,6,0.04472934968633094,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.18165385826052902,0.08995928973914658,0.07412857409641883,0.04472934968633094,0.3197010806845845,1,0.25578243235694786,0.1346886394254775,0.28756080353064983,0,24,0,10.0025786163522,myristic_acid,tetradecanoic_acid_285_300_rt10.09,10.00214724,10,0.019930197,10.06,9.82,0.24,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,0.049731866552879055,0.045156571486983356,6,0.018435093112770178,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.03209526316197318,0.049731866552879055,0.010830173454577128,0.018435093112770178,0.4337177397479828,1,0.04292543661655031,0.06816695966564923,0.09886406979379601,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_75,0.03209526316197318,0.024217004052548192,5,0.010830173454577128,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,0.06499138500766939,0.060955655317808256,6,0.024885042077599704,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.03209526316197318,0.06499138500766939,0.010830173454577128,0.024885042077599704,0.26607116852700335,1,0.04292543661655031,0.08987642708526909,0.09886406979379601,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_75,0.04609521115868596,0.0542035124888741,5,0.02424054770887626,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.03209526316197318,0.04609521115868596,0.010830173454577128,0.02424054770887626,0.6184296721051972,1,0.04292543661655031,0.07033575886756221,0.09886406979379601,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,0.05732029800753299,0.10006721639790445,6,0.040852270025921934,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.058155979090647035,0.05732029800753299,0.03367564463130526,0.040852270025921934,0.9877278768717598,1,0.0918316237219523,0.09817256803345492,0.10798982483680042,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_75,0.058155979090647035,0.08248814610599363,6,0.03367564463130526,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,0.0132269818909266,0.016392419701390094,6,0.006692177319658654,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.058155979090647035,0.0132269818909266,0.03367564463130526,0.006692177319658654,0.24365644723855023,1,0.0918316237219523,0.019919159210585256,0.10798982483680042,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_75,0.04250457505255693,0.043339937106106445,6,0.0176934552323793,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.058155979090647035,0.04250457505255693,0.03367564463130526,0.0176934552323793,0.6921604541104527,1,0.0918316237219523,0.06019803028493623,0.10798982483680042,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,0.05810503090573297,0.07266101277432671,6,0.029663734248491794,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.014506362363759883,0.05810503090573297,0.007695622799920415,0.029663734248491794,0.20749914466237646,1,0.0222019851636803,0.08776876515422477,0.09654564166964726,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_75,0.014506362363759883,0.01720793570981931,5,0.007695622799920415,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,0.05329483061055466,0.05982729508005791,6,0.024424390939510727,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.014506362363759883,0.05329483061055466,0.007695622799920415,0.024424390939510727,0.18088154419865696,1,0.0222019851636803,0.07771922155006539,0.09654564166964726,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_75,0.029488838170038223,0.030630075477921025,6,0.012504675950640351,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.014506362363759883,0.029488838170038223,0.007695622799920415,0.012504675950640351,0.33718928902880063,1,0.0222019851636803,0.041993514120678574,0.09654564166964726,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,0.021273777805051502,0.016736308652659147,6,0.006832569396123656,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.03324928077098388,0.021273777805051502,0.015572650893260868,0.006832569396123656,0.5098789886080781,1,0.04882193166424475,0.028106347201175157,0.07782122431589689,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_75,0.03324928077098388,0.03482150598720413,5,0.015572650893260868,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,0.06300907713738331,0.01895290342485304,6,0.007737490422522948,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.03324928077098388,0.06300907713738331,0.015572650893260868,0.007737490422522948,0.13843628327146115,1,0.04882193166424475,0.07074656755990626,0.07782122431589689,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_75,0.02997827197929463,0.01840571183162165,6,0.007514100390030037,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.03324928077098388,0.02997827197929463,0.015572650893260868,0.007514100390030037,0.8563709095051184,1,0.04882193166424475,0.037492372369324664,0.07782122431589689,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,0.05590109562434812,0.04133786268769193,6,0.01687611177368014,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.025695816331535875,0.05590109562434812,0.012504832515921148,0.01687611177368014,0.18348332991900343,1,0.038200648847457025,0.07277720739802826,0.08005492813783109,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_75,0.025695816331535875,0.030630458982970413,6,0.012504832515921148,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,0.03937468234313949,0.030578077962839616,6,0.012483448053999997,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.025695816331535875,0.03937468234313949,0.012504832515921148,0.012483448053999997,0.4567510224923911,1,0.038200648847457025,0.05185813039713949,0.08005492813783109,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_75,0.04805378014091155,0.03078662249244879,6,0.012568586001698533,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.025695816331535875,0.04805378014091155,0.012504832515921148,0.012568586001698533,0.2359170028473166,1,0.038200648847457025,0.06062236614261009,0.08005492813783109,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,0.051267276711297015,0.09251556994667799,6,0.03776932327202124,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.025800669838152695,0.051267276711297015,0.006448192647796742,0.03776932327202124,0.534145184027965,1,0.03224886248594944,0.08903659998331825,0.09794025998165008,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_75,0.025800669838152695,0.01579478175026802,6,0.006448192647796742,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,0.03939420784437453,0.05080139321391221,6,0.020739581932762152,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.025800669838152695,0.03939420784437453,0.006448192647796742,0.020739581932762152,0.5545938610389252,1,0.03224886248594944,0.06013378977713668,0.09794025998165008,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_75,0.03618733177394954,0.04266764886159489,6,0.017418994705858507,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.025800669838152695,0.03618733177394954,0.006448192647796742,0.017418994705858507,0.5951999820468414,1,0.03224886248594944,0.05360632647980805,0.09794025998165008,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,0.03897504084639055,0.019842269866083156,6,0.008100572751751073,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.02726023766493202,0.03897504084639055,0.012735977417317919,0.008100572751751073,0.4587785599286571,1,0.03999621508224994,0.04707561359814162,0.11438790543536084,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_75,0.02726023766493202,0.031196646048038432,6,0.012735977417317919,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,0.0824856711332705,0.052672195598256984,6,0.021503333807966627,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.02726023766493202,0.0824856711332705,0.012735977417317919,0.021503333807966627,0.05760611411134659,1,0.03999621508224994,0.10398900494123713,0.11438790543536084,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_75,0.01841581227887712,0.018219608608318425,6,0.00743812406726668,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.02726023766493202,0.01841581227887712,0.012735977417317919,0.00743812406726668,0.565210896696868,1,0.03999621508224994,0.0258539363461438,0.11438790543536084,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_75,0.020441289293746,0.016949986730326105,6,0.006919803106040796,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.040602977454809265,0.020441289293746,0.010126727346222556,0.006919803106040796,0.13526290080585338,1,0.050729704801031825,0.027361092399786797,0.07234936467582333,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_75,0.040602977454809265,0.024805314762534062,6,0.010126727346222556,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_75,0.049818132430174154,0.039079201671591485,6,0.015954017275119765,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.040602977454809265,0.049818132430174154,0.010126727346222556,0.015954017275119765,0.6381671499671955,1,0.050729704801031825,0.06577214970529392,0.07234936467582333,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_75,0.04515504374935627,0.028849058082971793,6,0.011777578643865924,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.040602977454809265,0.04515504374935627,0.010126727346222556,0.011777578643865924,0.7755960675834244,1,0.050729704801031825,0.05693262239322219,0.07234936467582333,0,24,0,6.215723270440251,nicotinic_acid,nicotinic_acid_180_136_rt6.32,6.220797546,6.22,0.022743378,6.41,6.03,0.38,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,0.05331574483709985,0.024443853643135345,6,0.009979161462158876,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.02883128750841557,0.05331574483709985,0.0136869484778368,0.009979161462158876,0.18799632511149755,1,0.04251823598625237,0.06329490629925873,0.08840747957532558,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_77,0.02883128750841557,0.03060494720098036,5,0.0136869484778368,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,0.056617284970020165,0.040024887321532115,6,0.016340091825024234,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.02883128750841557,0.056617284970020165,0.0136869484778368,0.016340091825024234,0.22486272160203075,1,0.04251823598625237,0.0729573767950444,0.08840747957532558,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_77,0.05765559181619073,0.05079193564315534,5,0.022714844161377964,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.02883128750841557,0.05765559181619073,0.0136869484778368,0.022714844161377964,0.31536106190146995,1,0.04251823598625237,0.0803704359775687,0.08840747957532558,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,0.01956187260816226,0.00988434076061006,6,0.004035265217881337,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.03915671983925143,0.01956187260816226,0.015055375948102483,0.004035265217881337,0.25763575720872345,1,0.05421209578735391,0.0235971378260436,0.05963330536608931,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_77,0.03915671983925143,0.03687798895862159,6,0.015055375948102483,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,0.037567179089160296,0.03650598418753462,6,0.014903505636261824,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.03915671983925143,0.037567179089160296,0.015055375948102483,0.014903505636261824,0.9416679887852955,1,0.05421209578735391,0.05247068472542212,0.05963330536608931,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_77,0.04212965621782083,0.023676149450599263,6,0.009665747537974079,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.03915671983925143,0.04212965621782083,0.015055375948102483,0.009665747537974079,0.8718989247279073,1,0.05421209578735391,0.05179540375579491,0.05963330536608931,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,0.028855220776190293,0.024076410883223424,6,0.00982915358358151,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.0519304053073034,0.028855220776190293,0.016243136695670467,0.00982915358358151,0.2650484543983627,1,0.06817354200297386,0.0386843743597718,0.10412393929332922,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_77,0.0519304053073034,0.03632075781934048,5,0.016243136695670467,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,0.05845037432758304,0.0886905178747374,6,0.03620775230271624,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.0519304053073034,0.05845037432758304,0.016243136695670467,0.03620775230271624,0.8742289935506924,1,0.06817354200297386,0.09465812663029928,0.10412393929332922,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_77,0.04873955337067234,0.04488015606910103,6,0.01832224699096186,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.0519304053073034,0.04873955337067234,0.016243136695670467,0.01832224699096186,0.8991832730946328,1,0.06817354200297386,0.0670618003616342,0.10412393929332922,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,0.048389343621540126,0.05368751583103023,6,0.021917836557269674,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.043422179926086636,0.048389343621540126,0.020642451037720905,0.021917836557269674,0.8726174970663094,1,0.06406463096380755,0.0703071801788098,0.10722224602986676,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_77,0.043422179926086636,0.04615792374255502,5,0.020642451037720905,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,0.07223439532404934,0.0618260367124441,6,0.02524037379401134,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.043422179926086636,0.07223439532404934,0.020642451037720905,0.02524037379401134,0.4000553862514701,1,0.06406463096380755,0.09747476911806068,0.10722224602986676,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_77,0.012911258819221061,0.016971888530565145,6,0.006928744478546465,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.043422179926086636,0.012911258819221061,0.020642451037720905,0.006928744478546465,0.22116315157639957,1,0.06406463096380755,0.019840003297767528,0.10722224602986676,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,0.05188568015340674,0.052628749359810004,6,0.021485596955393562,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.011881105393994229,0.05188568015340674,0.003502615550089463,0.021485596955393562,0.12257717432019039,1,0.015383720944083691,0.0733712771088003,0.13663882496479415,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_77,0.011881105393994229,0.008579620862856997,6,0.003502615550089463,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,0.10424468255761576,0.04892226498744018,6,0.019972431046742557,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,0.011881105393994229,0.10424468255761576,0.003502615550089463,0.019972431046742557,0.005255004195179201,0.12612010068430082,0.015383720944083691,0.12421711360435832,0.13663882496479415,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_77,0.061281175862744064,0.061806546090553346,6,0.025232416780944362,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.011881105393994229,0.061281175862744064,0.003502615550089463,0.025232416780944362,0.10804450572406053,1,0.015383720944083691,0.08651359264368842,0.13663882496479415,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,0.029629947943309382,0.06288966302252569,6,0.025674597416794533,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.07315016682358773,0.029629947943309382,0.008522893000756765,0.025674597416794533,0.15807713889477618,1,0.08167305982434449,0.055304545360103916,0.11812384427803467,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_77,0.07315016682358773,0.020876738984192234,6,0.008522893000756765,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,0.07998438486039294,0.06711829237179383,6,0.02740092811963857,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.07315016682358773,0.07998438486039294,0.008522893000756765,0.02740092811963857,0.8197350131221598,1,0.08167305982434449,0.10738531298003151,0.11812384427803467,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_77,0.03579970165434402,0.02401669347706607,6,0.009804774054606833,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,0.07315016682358773,0.03579970165434402,0.008522893000756765,0.009804774054606833,0.01683433539094586,0.38718971399175484,0.08167305982434449,0.045604475708950855,0.11812384427803467,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,0.0692866868592071,0.06039195560778324,6,0.024654912634647013,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.03709575079862123,0.0692866868592071,0.013928334017556736,0.024654912634647013,0.2889411900477877,1,0.05102408481617796,0.09394159949385411,0.11279723186924129,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_77,0.03709575079862123,0.034117311310063236,6,0.013928334017556736,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,0.0787769700977455,0.05821449475807376,6,0.02376596796520113,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.03709575079862123,0.0787769700977455,0.013928334017556736,0.02376596796520113,0.16837319985270202,1,0.05102408481617796,0.10254293806294662,0.11279723186924129,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_77,0.020903871291711635,0.019139464248929105,6,0.007813653560019531,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.03709575079862123,0.020903871291711635,0.013928334017556736,0.007813653560019531,0.34082003517635984,1,0.05102408481617796,0.028717524851731166,0.11279723186924129,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_77,0.04120179700644311,0.040885123664898756,6,0.01669128184159855,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.04147828362657421,0.04120179700644311,0.014472127235453845,0.01669128184159855,0.9902654254035911,1,0.05595041086202805,0.05789307884804166,0.10449167400330232,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_77,0.04147828362657421,0.03544932721949726,6,0.014472127235453845,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_77,0.0748913223401549,0.049237459265533426,6,0.020101108571938114,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.04147828362657421,0.0748913223401549,0.014472127235453845,0.020101108571938114,0.20999562185228893,1,0.05595041086202805,0.09499243091209301,0.10449167400330232,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_77,0.033135101461974514,0.042114205480103195,6,0.017193052391495982,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.04147828362657421,0.033135101461974514,0.014472127235453845,0.017193052391495982,0.7184167983705392,1,0.05595041086202805,0.050328153853470496,0.10449167400330232,0,24,0,6.113661087866109,nonanoic_acid,nonanoic_acid_117_215_rt6.19,6.125304878,6.13,0.029896012,6.13,5.9,0.23,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.16653090395431536,0.15594057697838548,6,0.0636624739653743,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.14043589357999395,0.16653090395431536,0.07676550089939994,0.0636624739653743,0.7999862135282181,1,0.2172013944793939,0.23019337791968966,0.42595212274969624,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_48,0.14043589357999395,0.17165287833787954,5,0.07676550089939994,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.2021407209834489,0.2593905914408993,6,0.10589576551815749,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.14043589357999395,0.2021407209834489,0.07676550089939994,0.10589576551815749,0.6487609042348172,1,0.2172013944793939,0.3080364865016064,0.42595212274969624,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_48,0.20728820715368082,0.4023602975327254,5,0.17994099534604296,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.14043589357999395,0.20728820715368082,0.07676550089939994,0.17994099534604296,0.7454369116730005,1,0.2172013944793939,0.3872292024997238,0.42595212274969624,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.17215463712844095,0.09003963185944158,6,0.0367585257806126,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.40337607263751674,0.17215463712844095,0.2162515535940259,0.0367585257806126,0.33759174159494826,1,0.6196276262315427,0.20891316290905354,0.681590388854697,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_48,0.40337607263751674,0.5297059623894931,6,0.2162515535940259,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.10867803792312491,0.047556305948441714,6,0.01941478060422777,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.40337607263751674,0.10867803792312491,0.2162515535940259,0.01941478060422777,0.2318681760884266,1,0.6196276262315427,0.1280928185273527,0.681590388854697,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_48,0.1510715014083269,0.0756429478928289,6,0.030881104162894468,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.40337607263751674,0.1510715014083269,0.2162515535940259,0.030881104162894468,0.2983554468985359,1,0.6196276262315427,0.18195260557122137,0.681590388854697,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.10934526540059823,0.08873451289057303,6,0.03622571319272006,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.08781808638090353,0.10934526540059823,0.037932812204153156,0.03622571319272006,0.6913332568315749,1,0.1257508985850567,0.1455709785933183,0.3398998773384741,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_48,0.08781808638090353,0.08482034666622008,5,0.037932812204153156,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.21576836138848174,0.2283696693380096,6,0.0932315271010401,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.08781808638090353,0.21576836138848174,0.037932812204153156,0.0932315271010401,0.2468241727444908,1,0.1257508985850567,0.30899988848952187,0.3398998773384741,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_48,0.14838215122367937,0.10712321724695462,6,0.04373287031005823,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.08781808638090353,0.14838215122367937,0.037932812204153156,0.04373287031005823,0.3227943355055003,1,0.1257508985850567,0.1921150215337376,0.3398998773384741,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.18717760740616607,0.12393331692048967,6,0.05059556476430606,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.18620021907815146,0.18717760740616607,0.06437945662850342,0.05059556476430606,0.9907678211687376,1,0.25057967570665485,0.2377731721704721,0.4879726779449273,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_48,0.18620021907815146,0.14395684137583306,5,0.06437945662850342,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.31721962447594443,0.3095956648953139,6,0.12639190092853492,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.18620021907815146,0.31721962447594443,0.06437945662850342,0.12639190092853492,0.3851022627738184,1,0.25057967570665485,0.44361152540447935,0.4879726779449273,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_48,0.08614138120656101,0.10745571905501045,6,0.04386861360477317,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.18620021907815146,0.08614138120656101,0.06437945662850342,0.04386861360477317,0.23818899505024868,1,0.25057967570665485,0.13000999481133418,0.4879726779449273,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.09919536663899249,0.07406213318916884,6,0.03023573926258511,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.16641021477327209,0.09919536663899249,0.031031259556838872,0.03023573926258511,0.15187855499645603,1,0.19744147433011094,0.1294311059015776,0.21718562176312206,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_48,0.16641021477327209,0.07601075199011928,6,0.031031259556838872,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.08601004254301207,0.07328666627652741,6,0.02991915622118796,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.16641021477327209,0.08601004254301207,0.031031259556838872,0.02991915622118796,0.09176948924641044,1,0.19744147433011094,0.11592919876420003,0.21718562176312206,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_48,0.10809238096849454,0.05657745686088004,6,0.023097650042247234,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.16641021477327209,0.10809238096849454,0.031031259556838872,0.023097650042247234,0.16507572175171245,1,0.19744147433011094,0.13119003101074178,0.21718562176312206,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.06276795123630723,0.0498035113612211,6,0.020332198372316097,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.048988588485709604,0.06276795123630723,0.027963329287602954,0.020332198372316097,0.6993835015675305,1,0.07695191777331256,0.08310014960862333,0.12104047467834551,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_48,0.048988588485709604,0.06849588826405187,6,0.027963329287602954,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.07179669637577583,0.09366872974019555,6,0.03824009878635644,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.048988588485709604,0.07179669637577583,0.027963329287602954,0.03824009878635644,0.6414903997967816,1,0.07695191777331256,0.11003679516213227,0.12104047467834551,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_48,0.04561031771836636,0.03530822382538741,6,0.01441452201602985,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.048988588485709604,0.04561031771836636,0.027963329287602954,0.01441452201602985,0.9173081056171527,1,0.07695191777331256,0.06002483973439621,0.12104047467834551,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.052138151735070526,0.054865341555915284,6,0.02239868189591836,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.13214477646301814,0.052138151735070526,0.04391616699949491,0.02239868189591836,0.14612151446611304,1,0.17606094346251305,0.07453683363098888,0.283939511832893,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_48,0.13214477646301814,0.10757220060761587,6,0.04391616699949491,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.2101247091499064,0.11758070005521852,6,0.04800211978908721,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.13214477646301814,0.2101247091499064,0.04391616699949491,0.04800211978908721,0.2585351407525703,1,0.17606094346251305,0.25812682893899364,0.283939511832893,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_48,0.06160001084512386,0.05151719364003676,6,0.021031806233040806,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.13214477646301814,0.06160001084512386,0.04391616699949491,0.021031806233040806,0.18963034999726933,1,0.17606094346251305,0.08263181707816467,0.283939511832893,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_48,0.0902271874411517,0.04781662652698882,6,0.01952105603539219,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.14994247261485927,0.0902271874411517,0.031487173885944075,0.01952105603539219,0.14407889942672547,1,0.18142964650080334,0.10974824347654388,0.1995726111508837,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_48,0.14994247261485927,0.07712750946285035,6,0.031487173885944075,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_48,0.05340218852803239,0.04302723261235426,6,0.017565794157384605,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,*,0.14994247261485927,0.05340218852803239,0.031487173885944075,0.017565794157384605,0.02855026844374136,0.6566561742060513,0.18142964650080334,0.070967982685417,0.1995726111508837,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_48,0.040098081520377006,0.038418995445189195,6,0.01568448921183743,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,0.14994247261485927,0.040098081520377006,0.031487173885944075,0.01568448921183743,0.015802846931347467,0.3792683263523392,0.18142964650080334,0.05578257073221443,0.1995726111508837,0,24,0,8.467190775681342,oxoglutaric_acid,glutaric_acid_2-oxo_198_288_rt8.57,8.470122699,8.47,0.016062675,8.59,8.42,0.17,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.24937637369915444,0.2813728371600577,6,0.11486997975356046,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.10070783692744581,0.24937637369915444,0.056407951496266054,0.11486997975356046,0.2825059355860194,1,0.15711578842371188,0.3642463534527149,0.6830483694416317,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_90,0.10070783692744581,0.12613201401716187,5,0.056407951496266054,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,0.20290456600898008,0.16923689713429052,6,0.06909067393848276,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.10070783692744581,0.20290456600898008,0.056407951496266054,0.06909067393848276,0.2816613939279059,1,0.15711578842371188,0.27199523994746283,0.6830483694416317,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_90,0.3502396816795171,0.6053335233393291,5,0.27071338144923907,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.10070783692744581,0.3502396816795171,0.056407951496266054,0.27071338144923907,0.41406401861102987,1,0.15711578842371188,0.6209530631287561,0.6830483694416317,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.13301872281277102,0.10304077579514266,6,0.04206622056643719,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.17997506663541804,0.13301872281277102,0.08368566313286253,0.04206622056643719,0.6307554959275932,1,0.2636607297682806,0.1750849433792082,0.37348662252849846,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_90,0.17997506663541804,0.20498717346195514,6,0.08368566313286253,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,0.12341278920018017,0.11662623232304119,6,0.047612459969122896,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.17997506663541804,0.12341278920018017,0.08368566313286253,0.047612459969122896,0.5732345880994414,1,0.2636607297682806,0.17102524916930306,0.37348662252849846,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_90,0.22137509177840212,0.2894273024268371,6,0.11815820142932373,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.17997506663541804,0.22137509177840212,0.08368566313286253,0.11815820142932373,0.7813997975434881,1,0.2636607297682806,0.33953329320772585,0.37348662252849846,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.30354068193583195,0.5110477034616029,6,0.2086343512836826,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.12775544244401088,0.30354068193583195,0.05249754070076061,0.2086343512836826,0.4470967686607396,1,0.1802529831447715,0.5121750332195145,0.563392536541466,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_90,0.12775544244401088,0.11738806965846267,5,0.05249754070076061,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,0.1467527103223659,0.1284045604508887,6,0.052420942291839065,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.12775544244401088,0.1467527103223659,0.05249754070076061,0.052420942291839065,0.8037282369149628,1,0.1802529831447715,0.19917365261420494,0.563392536541466,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_90,0.10623562070386094,0.07752543379099451,6,0.03164962581264291,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.12775544244401088,0.10623562070386094,0.05249754070076061,0.03164962581264291,0.7362842713346069,1,0.1802529831447715,0.13788524651650386,0.563392536541466,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.08624954022812403,0.10041307428835138,6,0.04099346591844033,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.25446285013445025,0.08624954022812403,0.09962244746225435,0.04099346591844033,0.1754009193601319,1,0.3540852975967046,0.12724300614656436,0.41989841299371505,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_90,0.25446285013445025,0.22276256461050215,5,0.09962244746225435,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,0.2949907253696999,0.21245674911715048,6,0.08673510462458653,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.25446285013445025,0.2949907253696999,0.09962244746225435,0.08673510462458653,0.7663880310905333,1,0.3540852975967046,0.3817258299942864,0.41989841299371505,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_90,0.2584666786583481,0.2273423285572481,6,0.0928121169835704,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.25446285013445025,0.2584666786583481,0.09962244746225435,0.0928121169835704,0.9772036455692173,1,0.3540852975967046,0.3512787956419185,0.41989841299371505,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.05255235376921311,0.08377131885159986,6,0.034199497711068824,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.07094219599152647,0.05255235376921311,0.023515745040701357,0.034199497711068824,0.6683207102811746,1,0.09445794103222782,0.08675185148028194,0.12203649794511313,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_90,0.07094219599152647,0.05760157627110236,6,0.023515745040701357,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,0.07135248027786949,0.047223886519527206,6,0.01927907094065645,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.07094219599152647,0.07135248027786949,0.023515745040701357,0.01927907094065645,0.9895103361684775,1,0.09445794103222782,0.09063155121852594,0.12203649794511313,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_90,0.08886622913910809,0.05407503775460334,6,0.022076041720085666,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.07094219599152647,0.08886622913910809,0.023515745040701357,0.022076041720085666,0.5906724796518339,1,0.09445794103222782,0.11094227085919375,0.12203649794511313,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.051084932189474706,0.05130814499457085,6,0.02094646248090556,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.05128202101245435,0.051084932189474706,0.015487817861778858,0.02094646248090556,0.994124904274859,1,0.06676983887423321,0.07203139467038026,0.24234270804441296,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_90,0.05128202101245435,0.0379372509905214,6,0.015487817861778858,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,0.1474863872277837,0.17838449600638487,6,0.07282516553986443,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.05128202101245435,0.1474863872277837,0.015487817861778858,0.07282516553986443,0.24837573129507448,1,0.06676983887423321,0.22031155276764813,0.24234270804441296,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_90,0.12253452855372182,0.19975252997539814,6,0.08154862887828784,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.05128202101245435,0.12253452855372182,0.015487817861778858,0.08154862887828784,0.4273812333200092,1,0.06676983887423321,0.20408315743200967,0.24234270804441296,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.0740692352010821,0.026453108767132687,6,0.010799436431636547,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.09776753082180534,0.0740692352010821,0.02890663580902195,0.010799436431636547,0.47000837769044257,1,0.12667416663082728,0.08486867163271865,0.16192002914941372,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_90,0.09776753082180534,0.07080650791256818,6,0.02890663580902195,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,0.09355097409853001,0.13141280356613239,6,0.053649052400936995,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.09776753082180534,0.09355097409853001,0.02890663580902195,0.053649052400936995,0.9466058260782392,1,0.12667416663082728,0.147200026499467,0.16192002914941372,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_90,0.0765703059852864,0.06355098382268314,6,0.025944580502907006,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.09776753082180534,0.0765703059852864,0.02890663580902195,0.025944580502907006,0.5973520817178868,1,0.12667416663082728,0.1025148864881934,0.16192002914941372,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_90,0.038905534639093554,0.03804808249995149,6,0.01553306463603322,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.058059886589412635,0.038905534639093554,0.027061135625082573,0.01553306463603322,0.5564038684408683,1,0.0851210222144952,0.05443859927512677,0.11173038431201596,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_90,0.058059886589412635,0.0662859741417042,6,0.027061135625082573,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_90,0.07398277767477339,0.05150700243555166,6,0.021027645691231996,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.058059886589412635,0.07398277767477339,0.027061135625082573,0.021027645691231996,0.6527480300627317,1,0.0851210222144952,0.09501042336600539,0.11173038431201596,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_90,0.0658847762399053,0.08741812578524673,6,0.035688300407381926,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.058059886589412635,0.0658847762399053,0.027061135625082573,0.035688300407381926,0.8650438734685697,1,0.0851210222144952,0.10157307664728722,0.11173038431201596,0,24,0,3.501194968553459,pyruvic_acid,pyruvic_acid_174_189_rt3.61,3.538282209,3.53,0.030542322,3.75,3.46,0.29,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.08788416762316542,0.06440288403943985,6,0.026292367310043727,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.03253869191548899,0.08788416762316542,0.0164317801297169,0.026292367310043727,0.11152591605611986,1,0.048970472045205896,0.11417653493320915,0.15963652584733257,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_91,0.03253869191548899,0.0367425773613773,5,0.0164317801297169,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,0.09139759190140088,0.0786653792361838,6,0.032115006591863504,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.03253869191548899,0.09139759190140088,0.0164317801297169,0.032115006591863504,0.14484180465658436,1,0.048970472045205896,0.12351259849326439,0.15963652584733257,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_91,0.1066571508068325,0.08601474549723759,5,0.03846696359983344,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.03253869191548899,0.1066571508068325,0.0164317801297169,0.03846696359983344,0.13213101402492414,1,0.048970472045205896,0.14512411440666595,0.15963652584733257,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.10976973543402117,0.09934629520759207,6,0.04055795518241773,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.08966200139818303,0.10976973543402117,0.037312424733349225,0.04055795518241773,0.7228640047354895,1,0.12697442613153226,0.1503276906164389,0.16536045967808283,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_91,0.08966200139818303,0.09139640166270828,6,0.037312424733349225,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,0.10028212143163806,0.06802762168571873,6,0.027772160257517088,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.08966200139818303,0.10028212143163806,0.037312424733349225,0.027772160257517088,0.8243685653026536,1,0.12697442613153226,0.12805428168915514,0.16536045967808283,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_91,0.06396707534275148,0.05586380724301212,6,0.022806303805762467,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.08966200139818303,0.06396707534275148,0.037312424733349225,0.022806303805762467,0.5724914999919148,1,0.12697442613153226,0.08677337914851395,0.16536045967808283,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.07610073873466867,0.08314173394102957,6,0.033942470747626664,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.6813334552218595,0.07610073873466867,0.6474799642714837,0.033942470747626664,0.4031527681658068,1,1.3288134194933432,0.11004320948229535,1.4616947614426776,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_91,0.6813334552218595,1.4478092141801726,5,0.6474799642714837,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,0.033374509367960124,0.0309482719978067,6,0.012634579135915229,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.6813334552218595,0.033374509367960124,0.6474799642714837,0.012634579135915229,0.37362514056165125,1,1.3288134194933432,0.046009088503875355,1.4616947614426776,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_91,0.07214112743362507,0.057784862560229994,6,0.02359057135490318,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.6813334552218595,0.07214112743362507,0.6474799642714837,0.02359057135490318,0.4001970915425716,1,1.3288134194933432,0.09573169878852825,1.4616947614426776,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.5992224084900971,1.231362865907479,6,0.5027017849474112,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.08779878725879317,0.5992224084900971,0.03342709137265021,0.5027017849474112,0.35624403574029806,1,0.12122587863144338,1.1019241934375084,2.1033041119597917,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_91,0.08779878725879317,0.07474524859934263,5,0.03342709137265021,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,1.1861235537809711,1.7782587469756073,6,0.7259710934552028,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.08779878725879317,1.1861235537809711,0.03342709137265021,0.7259710934552028,0.1908664026327999,1,0.12122587863144338,1.912094647236174,2.1033041119597917,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_91,0.6587465316381159,1.3734144879700505,6,0.5606941168120749,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.08779878725879317,0.6587465316381159,0.03342709137265021,0.5606941168120749,0.3557244070697951,1,0.12122587863144338,1.219440648450191,2.1033041119597917,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.07236711149483721,0.05363912976773653,6,0.021898083029647745,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.04631089421523157,0.07236711149483721,0.012930622095859103,0.021898083029647745,0.33514739601182403,1,0.05924151631109067,0.09426519452448495,0.13502775367670933,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_91,0.04631089421523157,0.03167342619161239,6,0.012930622095859103,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,0.04912862447032499,0.03959477690769341,6,0.016164499983863878,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.04631089421523157,0.04912862447032499,0.012930622095859103,0.016164499983863878,0.8945542928930208,1,0.05924151631109067,0.06529312445418886,0.13502775367670933,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_91,0.09841069404545581,0.05962501219380333,6,0.0243418092970072,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.04631089421523157,0.09841069404545581,0.012930622095859103,0.0243418092970072,0.0972619841210778,1,0.05924151631109067,0.12275250334246302,0.13502775367670933,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.04835111331731697,0.04559609868265599,6,0.018614529339015907,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,0.14475283812564532,0.04835111331731697,0.022528902845652968,0.018614529339015907,0.008412314588458807,0.20189555012301136,0.16728174097129828,0.06696564265633288,0.18400991506842812,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_91,0.14475283812564532,0.055184316436585695,6,0.022528902845652968,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,0.08038050376539434,0.08368617766584087,6,0.03416473896753465,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.14475283812564532,0.08038050376539434,0.022528902845652968,0.03416473896753465,0.15150939116275017,1,0.16728174097129828,0.11454524273292899,0.18400991506842812,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_91,0.09175176345885323,0.03795003170323967,6,0.015493035565897,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.14475283812564532,0.09175176345885323,0.022528902845652968,0.015493035565897,0.08501205157900935,1,0.16728174097129828,0.10724479902475023,0.18400991506842812,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.07873709089616081,0.07917065683036985,6,0.03232128530589965,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.09925991970036045,0.07873709089616081,0.031014166564449837,0.03232128530589965,0.6566516725654442,1,0.1302740862648103,0.11105837620206047,0.15527766397035664,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_91,0.09925991970036045,0.07596888288058887,6,0.031014166564449837,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,0.10657236804312609,0.08472575504945033,6,0.03458914465719811,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.09925991970036045,0.10657236804312609,0.031014166564449837,0.03458914465719811,0.878097807723888,1,0.1302740862648103,0.1411615127003242,0.15527766397035664,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_91,0.033095754410551535,0.03699227086745431,6,0.015102031342014387,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.09925991970036045,0.033095754410551535,0.031014166564449837,0.015102031342014387,0.09519759431275884,1,0.1302740862648103,0.04819778575256592,0.15527766397035664,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_91,0.16348182736500405,0.12919431335765474,6,0.052743357565915173,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.18492206214960275,0.16348182736500405,0.0528066981833006,0.052743357565915173,0.7797724537732728,1,0.23772876033290335,0.21622518493091922,0.35986305287110154,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_91,0.18492206214960275,0.1293494655502419,6,0.0528066981833006,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_91,0.2559036098024787,0.17451296611527936,6,0.07124462008034085,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.18492206214960275,0.2559036098024787,0.0528066981833006,0.07124462008034085,0.4436058680415963,1,0.23772876033290335,0.32714822988281955,0.35986305287110154,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_91,0.10972517180128467,0.04963493869264463,6,0.02026337886855082,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.18492206214960275,0.10972517180128467,0.0528066981833006,0.02026337886855082,0.2288367561665156,1,0.23772876033290335,0.1299885506698355,0.35986305287110154,0,24,0,9.370855949895615,quinic_acid,quinic_acid_255_345_rt9.45,9.394634146,9.4,0.028075058,9.46,9.29,0.17,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.17515685839810277,0.2188429335118033,6,0.08934225348629055,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.1469981039653585,0.17515685839810277,0.06182647753249616,0.08934225348629055,0.8016697901102131,1,0.20882458149785466,0.26449911188439335,0.3159849829333213,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_99,0.1469981039653585,0.13824820657202488,5,0.06182647753249616,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.16432351166893758,0.10749533810961108,6,0.04388478801608367,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.1469981039653585,0.16432351166893758,0.06182647753249616,0.04388478801608367,0.8253391012004181,1,0.20882458149785466,0.20820829968502125,0.3159849829333213,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_99,0.1538555000585146,0.29829946289149967,5,0.13340357533541383,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.1469981039653585,0.1538555000585146,0.06182647753249616,0.13340357533541383,0.964408097308252,1,0.20882458149785466,0.2872590753939284,0.3159849829333213,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.24022183788853643,0.22792680900613954,6,0.0930507301276399,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.16935162483484625,0.24022183788853643,0.028936026008519678,0.0930507301276399,0.49462968428800214,1,0.19828765084336594,0.33327256801617633,0.9972198374986327,0,23,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_99,0.16935162483484625,0.07087849890477621,6,0.028936026008519678,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.2105555345367872,0.10223257684766232,6,0.04173627472777365,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.16935162483484625,0.2105555345367872,0.028936026008519678,0.04173627472777365,0.4383264764578081,1,0.19828765084336594,0.25229180926456085,0.9972198374986327,0,23,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_99,0.4929391494366838,0.9248921395961354,5,0.4136243391984367,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.16935162483484625,0.4929391494366838,0.028936026008519678,0.4136243391984367,0.4783513994905679,1,0.19828765084336594,0.9065634886351206,0.9972198374986327,0,23,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.06978816841954065,0.0658232132493619,6,0.026872214281890294,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.10966322197514575,0.06978816841954065,0.046086671640456024,0.026872214281890294,0.48067015438111504,1,0.15574989361560176,0.09666038270143094,0.18784937560311807,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_99,0.10966322197514575,0.10305293064477142,5,0.046086671640456024,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.10744510138297632,0.15511897963924828,6,0.0633270582562219,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.10966322197514575,0.10744510138297632,0.046086671640456024,0.0633270582562219,0.9780481767886566,1,0.15574989361560176,0.17077215963919823,0.18784937560311807,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_99,0.09365862494014136,0.07210561520640427,6,0.02943699414085967,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.10966322197514575,0.09365862494014136,0.046086671640456024,0.02943699414085967,0.7782653614296946,1,0.15574989361560176,0.12309561908100103,0.18784937560311807,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.12876027254133712,0.10047378364385465,6,0.041018250409039704,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.156903527667835,0.12876027254133712,0.11566522580107291,0.041018250409039704,0.8276925168117207,1,0.2725687534689079,0.16977852295037682,0.2998256288157987,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_99,0.156903527667835,0.2586353075240616,5,0.11566522580107291,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.0795144797340807,0.052817828191993196,6,0.021562788065395255,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.156903527667835,0.0795144797340807,0.11566522580107291,0.021562788065395255,0.5444141523564507,1,0.2725687534689079,0.10107726779947596,0.2998256288157987,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_99,0.1483666662486418,0.14982416653856082,6,0.06116545985954057,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.156903527667835,0.1483666662486418,0.11566522580107291,0.06116545985954057,0.9500432046668434,1,0.2725687534689079,0.2095321261081824,0.2998256288157987,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.028087744564372425,0.021448291090311773,6,0.008756228170991087,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.0726965205430045,0.028087744564372425,0.030424534698359415,0.008756228170991087,0.20993115765315268,1,0.10312105524136392,0.03684397273536351,0.11343316076550032,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_99,0.0726965205430045,0.07452458567258227,6,0.030424534698359415,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.032337790140640976,0.020754357688923235,6,0.008472931046178443,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.0726965205430045,0.032337790140640976,0.030424534698359415,0.008472931046178443,0.25028009798435963,1,0.10312105524136392,0.040810721186819415,0.11343316076550032,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_99,0.06569724577456926,0.0331626179756469,6,0.013538582095864022,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.0726965205430045,0.06569724577456926,0.030424534698359415,0.013538582095864022,0.8395915281786241,1,0.10312105524136392,0.07923582787043328,0.11343316076550032,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.04172252479828783,0.04337701957774532,6,0.017708594088032045,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.025552255384904132,0.04172252479828783,0.012784649106587996,0.017708594088032045,0.47775446221303175,1,0.03833690449149213,0.05943111888631987,0.10563195356089325,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_99,0.025552255384904132,0.03131586685166941,6,0.012784649106587996,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.06292694003127715,0.08108327562825175,6,0.03310210866044399,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.025552255384904132,0.06292694003127715,0.012784649106587996,0.03310210866044399,0.3300243380919754,1,0.03833690449149213,0.09602904869172113,0.10563195356089325,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_99,0.021921490973326296,0.018649496346482147,6,0.007613625001463396,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.025552255384904132,0.021921490973326296,0.012784649106587996,0.007613625001463396,0.8132587683902195,1,0.03833690449149213,0.029535115974789694,0.10563195356089325,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.06399732085162979,0.05432813019149696,6,0.02217936627477682,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.15109880118250793,0.06399732085162979,0.03276497847637769,0.02217936627477682,0.05591766088346512,1,0.18386377965888562,0.08617668712640661,0.2022501576247742,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_99,0.15109880118250793,0.08025747870039875,6,0.03276497847637769,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.050814558843685166,0.04235487966175784,6,0.01729130721471528,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.15109880118250793,0.050814558843685166,0.03276497847637769,0.01729130721471528,0.02813178867011813,0.6751629280828351,0.18386377965888562,0.06810586605840044,0.2022501576247742,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_99,0.046927191139574255,0.06837237201340683,6,0.027912903989432615,leaf_1_log2-1,1,967514 MM WT,leaf,*,0.15109880118250793,0.046927191139574255,0.03276497847637769,0.027912903989432615,0.03662549170405189,0.8423863091931935,0.18386377965888562,0.07484009512900687,0.2022501576247742,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_99,0.045306282209510794,0.03150828914787685,6,0.012863205180061814,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.035894886787556736,0.045306282209510794,0.01240276972023455,0.012863205180061814,0.609902343023135,1,0.04829765650779129,0.05816948738957261,0.12750319209175198,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_99,0.035894886787556736,0.030380457211816314,6,0.01240276972023455,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_99,0.08235801181736117,0.08219013227268505,6,0.033553980993322456,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.035894886787556736,0.08235801181736117,0.01240276972023455,0.033553980993322456,0.23922849396393003,1,0.04829765650779129,0.11591199281068362,0.12750319209175198,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_99,0.06466295987092681,0.02919615740127137,6,0.011919281347182899,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.035894886787556736,0.06466295987092681,0.01240276972023455,0.011919281347182899,0.1254417675473672,1,0.04829765650779129,0.0765822412181097,0.12750319209175198,0,24,0,9.461022964509397,shikimic_acid,shikimic_acid_204_462_rt9.57,9.44902439,9.45,0.038021943,9.55,9.24,0.31,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.183323420587061,0.32577208058345153,6,0.13299589497904993,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.034325932163303374,0.183323420587061,0.013157221483607852,0.13299589497904993,0.31468580548324754,1,0.047483153646911226,0.3163193155661109,0.3479512471227221,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_102,0.034325932163303374,0.029420441632367792,5,0.013157221483607852,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.050356597497758525,0.033744255841249626,6,0.013776034760165385,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.034325932163303374,0.050356597497758525,0.013157221483607852,0.013776034760165385,0.42194542795894163,1,0.047483153646911226,0.06413263225792391,0.3479512471227221,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_102,0.05176437181597278,0.05715821459874573,5,0.025561930663063264,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.034325932163303374,0.05176437181597278,0.013157221483607852,0.025561930663063264,0.5664349823804793,1,0.047483153646911226,0.07732630247903605,0.3479512471227221,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.0762404955129385,0.0686590559575017,6,0.02802994221951278,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.03981802132007791,0.0762404955129385,0.008553912148746142,0.02802994221951278,0.26086686675978227,1,0.048371933468824055,0.10427043773245129,0.11469748150569642,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_102,0.03981802132007791,0.020952720069022088,6,0.008553912148746142,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.046442973357345485,0.02328241165031484,6,0.009505004754116963,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.03981802132007791,0.046442973357345485,0.008553912148746142,0.009505004754116963,0.615786107022467,1,0.048371933468824055,0.055947978111462446,0.11469748150569642,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_102,0.02067824050030494,0.011376939947335992,6,0.0046446162842099506,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.03981802132007791,0.02067824050030494,0.008553912148746142,0.0046446162842099506,0.08616255032396843,1,0.048371933468824055,0.025322856784514892,0.11469748150569642,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.09133720344580036,0.1071068201984362,6,0.04372617624303194,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.07091788952180193,0.09133720344580036,0.030063741306683073,0.04372617624303194,0.7098583656105155,1,0.100981630828485,0.1350633796888323,0.15201755671616146,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_102,0.07091788952180193,0.0672245692197117,5,0.030063741306683073,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.055497785971505266,0.057970628695913184,6,0.02366641006222192,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.07091788952180193,0.055497785971505266,0.030063741306683073,0.02366641006222192,0.6974534782978246,1,0.100981630828485,0.07916419603372718,0.15201755671616146,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_102,0.08301650423814688,0.13516596611348616,6,0.05518127459472717,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.07091788952180193,0.08301650423814688,0.030063741306683073,0.05518127459472717,0.8523867007699012,1,0.100981630828485,0.13819777883287404,0.15201755671616146,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.041864340689219105,0.055829537757781024,6,0.022792313347001797,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.07569522798396985,0.041864340689219105,0.030208600487955553,0.022792313347001797,0.39799567684567017,1,0.10590382847192541,0.0646566540362209,0.14270928693068466,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_102,0.07569522798396985,0.06754848419620194,5,0.030208600487955553,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.10269546932550007,0.0662348053810772,6,0.027040246066031448,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.07569522798396985,0.10269546932550007,0.030208600487955553,0.027040246066031448,0.5229437436022961,1,0.10590382847192541,0.1297357153915315,0.14270928693068466,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_102,0.0679820236634157,0.03699683752888098,6,0.01510389567373495,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.07569522798396985,0.0679820236634157,0.030208600487955553,0.01510389567373495,0.8269968780294494,1,0.10590382847192541,0.08308591933715065,0.14270928693068466,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.0383920625334185,0.011416805959756476,6,0.0046608915156282245,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.03608729440224109,0.0383920625334185,0.018178764513782766,0.0046608915156282245,0.9065043954531826,1,0.05426605891602385,0.04305295404904673,0.062431354446000495,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_102,0.03608729440224109,0.04452869721298171,6,0.018178764513782766,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.039804168973492704,0.04152278941900224,6,0.016951607795598646,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.03608729440224109,0.039804168973492704,0.018178764513782766,0.016951607795598646,0.8841179262790033,1,0.05426605891602385,0.056755776769091354,0.062431354446000495,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_102,0.03363145023840416,0.020119784835083584,6,0.00821386776342363,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.03608729440224109,0.03363145023840416,0.018178764513782766,0.00821386776342363,0.9054993354604102,1,0.05426605891602385,0.04184531800182779,0.062431354446000495,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.015800062547582188,0.011208704866726836,6,0.004575934600155213,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.01672647410709449,0.015800062547582188,0.008583032527888116,0.004575934600155213,0.9265741565821792,1,0.025309506634982607,0.020375997147737402,0.05215795802799711,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_102,0.01672647410709449,0.02102405013903631,6,0.008583032527888116,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.010619192190616022,0.010792562501703962,6,0.004406045191045036,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.01672647410709449,0.010619192190616022,0.008583032527888116,0.004406045191045036,0.5456215766377004,1,0.025309506634982607,0.015025237381661057,0.05215795802799711,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_102,0.03111676314604443,0.03992561074887276,6,0.016299562333952942,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.01672647410709449,0.03111676314604443,0.008583032527888116,0.016299562333952942,0.45841418068735507,1,0.025309506634982607,0.04741632547999737,0.05215795802799711,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.026844682008767034,0.03036611853350063,6,0.012396915979324661,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.034652900132128295,0.026844682008767034,0.014025522395762447,0.012396915979324661,0.6855279912073993,1,0.048678422527890744,0.039241597988091695,0.05354626478067982,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_102,0.034652900132128295,0.03435537324559586,6,0.014025522395762447,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.03397154873492081,0.011710255112467417,6,0.004780691630560535,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.034652900132128295,0.03397154873492081,0.014025522395762447,0.004780691630560535,0.96478258650921,1,0.048678422527890744,0.03875224036548135,0.05354626478067982,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_102,0.023383770272069764,0.01264267320500941,6,0.00516134972283838,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.034652900132128295,0.023383770272069764,0.014025522395762447,0.00516134972283838,0.47793094386283486,1,0.048678422527890744,0.028545119994908143,0.05354626478067982,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_102,0.017759327115066448,0.010732115878971592,6,0.004381367960650232,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.009801931803075833,0.017759327115066448,0.0026872633231655296,0.004381367960650232,0.15883009302634682,1,0.012489195126241363,0.022140695075716678,0.04731668486182934,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_102,0.009801931803075833,0.006582423946251401,6,0.0026872633231655296,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_102,0.03336161901077942,0.023646269368232834,6,0.009653549045429066,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.009801931803075833,0.03336161901077942,0.0026872633231655296,0.009653549045429066,0.058650451202220844,1,0.012489195126241363,0.04301516805620849,0.04731668486182934,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_102,0.019385101500151086,0.02345485799576215,6,0.009575405679842566,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.009801931803075833,0.019385101500151086,0.0026872633231655296,0.009575405679842566,0.3737998093905249,1,0.012489195126241363,0.028960507179993652,0.04731668486182934,0,24,0,5.866289308176101,succinic_acid,succinic_acid_247_172_5.97,5.876196319,5.88,0.029983711,5.91,5.65,0.26,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,0.024069250488549354,0.040636833685126564,6,0.016589917881817243,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.07328125174519062,0.024069250488549354,0.02484567678780502,0.016589917881817243,0.14222362583625905,1,0.09812692853299565,0.040659168370366594,0.14794122577808116,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.8,967514 MM WT,MoneyMaker,m_106,0.07328125174519062,0.05555662224452065,5,0.02484567678780502,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,0.03273210716438676,0.04024422137785675,6,0.01642963457855927,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.07328125174519062,0.03273210716438676,0.02484567678780502,0.01642963457855927,0.21466245634617961,1,0.09812692853299565,0.049161741742946026,0.14794122577808116,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_106,0.08856480375365346,0.10269638522420567,5,0.04592721968096577,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.07328125174519062,0.08856480375365346,0.02484567678780502,0.04592721968096577,0.7793718125005717,1,0.09812692853299565,0.13449202343461922,0.14794122577808116,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,0.009201989574365651,0.007123309090578476,6,0.002908078758674358,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,0.04787369932752594,0.009201989574365651,0.01310911254170455,0.002908078758674358,0.03103771439930212,0.7449051455832509,0.06098281186923049,0.012110068333040009,0.06708109305615355,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.6,967514 MM WT,MoneyMaker,m_106,0.04787369932752594,0.03211063670789561,6,0.01310911254170455,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,0.03564605733433616,0.012700773880242608,6,0.00518506922417713,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.04787369932752594,0.03564605733433616,0.01310911254170455,0.00518506922417713,0.4164816800253718,1,0.06098281186923049,0.04083112655851329,0.06708109305615355,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_106,0.03976383115790642,0.040220184286790285,6,0.01641982147722366,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.04787369932752594,0.03976383115790642,0.01310911254170455,0.01641982147722366,0.7079830270222934,1,0.06098281186923049,0.056183652635130074,0.06708109305615355,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,0.049514154492828734,0.07679237476446528,6,0.031350355718253245,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.023129487737413346,0.049514154492828734,0.011400631836192972,0.031350355718253245,0.45783770721625194,1,0.03453011957360632,0.08086451021108199,0.08895096123219019,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,1,967514 MM WT,MoneyMaker,m_106,0.023129487737413346,0.025492587772175734,5,0.011400631836192972,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,0.035181909724158654,0.023333861523460325,6,0.009526009076873189,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.023129487737413346,0.035181909724158654,0.011400631836192972,0.009526009076873189,0.43986757624460604,1,0.03453011957360632,0.044707918801031844,0.08895096123219019,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_106,0.03464870954848472,0.03066624528518432,6,0.012519442212621999,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.023129487737413346,0.03464870954848472,0.011400631836192972,0.012519442212621999,0.5134373691094776,1,0.03453011957360632,0.047168151761106725,0.08895096123219019,1,24,4.166666666666666,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,0.03024924652350336,0.0205602383161087,6,0.008393682144080991,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.09699711901170271,0.03024924652350336,0.05509429774258491,0.008393682144080991,0.2944206015336947,1,0.1520914167542876,0.03864292866758435,0.1673005584297164,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.4,967514 MM WT,MoneyMaker,m_106,0.09699711901170271,0.12319459492503307,5,0.05509429774258491,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,0.032029453059609546,0.011054488881399777,6,0.0045129761877832405,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.09699711901170271,0.032029453059609546,0.05509429774258491,0.0045129761877832405,0.3042664120644776,1,0.1520914167542876,0.03654242924739279,0.1673005584297164,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_106,0.06153205895470889,0.04884565422680561,6,0.019941154834682357,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.09699711901170271,0.06153205895470889,0.05509429774258491,0.019941154834682357,0.5711699796898498,1,0.1520914167542876,0.08147321378939125,0.1673005584297164,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,0.02566885709396464,0.01298566105423842,6,0.0053013739259360005,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.028430348997868487,0.02566885709396464,0.0066124241753244654,0.0053013739259360005,0.7515787312574668,1,0.03504277317319295,0.03097023101990064,0.05249741189136208,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.8,967514 MM WT,MoneyMaker,m_106,0.028430348997868487,0.016197065192388792,6,0.0066124241753244654,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,0.01559219207762482,0.007809840879913711,6,0.0031883541880195643,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.028430348997868487,0.01559219207762482,0.0066124241753244654,0.0031883541880195643,0.1225810912473315,1,0.03504277317319295,0.018780546265644384,0.05249741189136208,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_106,0.04079779417229212,0.016967923420023,6,0.006927125728946134,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.028430348997868487,0.04079779417229212,0.0066124241753244654,0.006927125728946134,0.22566457285679672,1,0.03504277317319295,0.047724919901238255,0.05249741189136208,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,0.016996381408120726,0.017695954882310103,6,0.007224343328828751,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.03600890357504379,0.016996381408120726,0.006244361657579881,0.007224343328828751,0.07508844008576913,1,0.042253265232623675,0.024220724736949476,0.04647859175588605,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.6,967514 MM WT,MoneyMaker,m_106,0.03600890357504379,0.01529549983047048,6,0.006244361657579881,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,0.022229523896857433,0.0177414168767477,6,0.007242903110338978,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.03600890357504379,0.022229523896857433,0.006244361657579881,0.007242903110338978,0.18082768271822786,1,0.042253265232623675,0.029472427007196413,0.04647859175588605,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_106,0.029558741115227456,0.02068557311805473,6,0.008444849862711086,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.03600890357504379,0.029558741115227456,0.006244361657579881,0.008444849862711086,0.5539890359215007,1,0.042253265232623675,0.03800359097793854,0.04647859175588605,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,0.014358640163956013,0.009018431882913156,6,0.0036817593988640934,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.02832649448041713,0.014358640163956013,0.006545553803077798,0.0036817593988640934,0.10052752447610694,1,0.034872048283494925,0.018040399562820105,0.076389280727022,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,1,967514 MM WT,MoneyMaker,m_106,0.02832649448041713,0.016033266901474486,6,0.006545553803077798,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,0.04628127275416016,0.056738824014302386,6,0.023163527906768927,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.02832649448041713,0.04628127275416016,0.006545553803077798,0.023163527906768927,0.48486742767532987,1,0.034872048283494925,0.06944480066092909,0.076389280727022,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_106,0.03523106126967379,0.034766421204904786,6,0.014193332022448976,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.02832649448041713,0.03523106126967379,0.006545553803077798,0.014193332022448976,0.6719287526485014,1,0.034872048283494925,0.04942439329212277,0.076389280727022,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_106,0.015807357711653314,0.014707741647517585,6,0.006004410384183215,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.034805798976429436,0.015807357711653314,0.007061670337414379,0.006004410384183215,0.06827446217079006,1,0.041867469313843816,0.02181176809583653,0.07090208019588436,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.4,967514 MM WT,MoneyMaker,m_106,0.034805798976429436,0.017297489058412746,6,0.007061670337414379,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_106,0.04498097836175171,0.04770493504781801,6,0.019475458179961328,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.034805798976429436,0.04498097836175171,0.007061670337414379,0.019475458179961328,0.6399677524091889,1,0.041867469313843816,0.06445643654171304,0.07090208019588436,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_106,0.012434010470703841,0.019156501561125378,6,0.00782060901359776,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.034805798976429436,0.012434010470703841,0.007061670337414379,0.00782060901359776,0.059984960436819314,1,0.041867469313843816,0.0202546194843016,0.07090208019588436,0,24,0,7.392852852852853,threonic_acid,threonic_acid_292_220_rt7.49,7.395220126,7.39,0.019154154,7.59,7.38,0.21,FALSE,carboxylic_acid +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,0.07820758264891685,0.09501542813959489,6,0.03878988610568164,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.3532755208372961,0.07820758264891685,0.18349838288151457,0.03878988610568164,0.21067271394233109,1,0.5367739037188106,0.11699746875459849,0.5904512940906917,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.8,967514 MM WT,MoneyMaker,m_18,0.3532755208372961,0.41031485788435035,5,0.18349838288151457,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,0.30655555698741616,0.2771535392769866,6,0.1131474586058389,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.3532755208372961,0.30655555698741616,0.18349838288151457,0.1131474586058389,0.8347577788709307,1,0.5367739037188106,0.41970301559325507,0.5904512940906917,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_18,0.14372820957653382,0.11512757094869035,5,0.05148661494514031,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.3532755208372961,0.14372820957653382,0.18349838288151457,0.05148661494514031,0.32545053257497236,1,0.5367739037188106,0.19521482452167413,0.5904512940906917,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,0.33784871135430233,0.5032842124782002,6,0.20546491936167685,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.23043451928137984,0.33784871135430233,0.11384809698332544,0.20546491936167685,0.6599276781512345,1,0.3442826162647053,0.5433136307159792,0.5976449937875771,1,24,4.166666666666666,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.6,967514 MM WT,MoneyMaker,m_18,0.23043451928137984,0.2788697457960401,6,0.11384809698332544,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,0.23481164434681992,0.2892149129425615,6,0.11807149378545573,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.23043451928137984,0.23481164434681992,0.11384809698332544,0.11807149378545573,0.9792353759290952,1,0.3442826162647053,0.3528831381322757,0.5976449937875771,1,24,4.166666666666666,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_18,0.133322585476949,0.07568645476166096,6,0.030898865767718595,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.23043451928137984,0.133322585476949,0.11384809698332544,0.030898865767718595,0.4432745524467313,1,0.3442826162647053,0.16422145124466758,0.5976449937875771,1,24,4.166666666666666,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,0.4566131837711166,0.4116811182362202,6,0.16806811273618838,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.10065747502836846,0.4566131837711166,0.05288812996531544,0.16806811273618838,0.09013716589212177,1,0.1535456049936839,0.624681296507305,0.6871494261580355,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,1,967514 MM WT,MoneyMaker,m_18,0.10065747502836846,0.11826145380528892,5,0.05288812996531544,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,0.26033621771937515,0.19547236453543987,6,0.07980125865452238,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.10065747502836846,0.26033621771937515,0.05288812996531544,0.07980125865452238,0.13232819767571533,1,0.1535456049936839,0.3401374763738975,0.6871494261580355,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_18,0.2263403538352111,0.12220200438237666,6,0.049888759380362774,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.10065747502836846,0.2263403538352111,0.05288812996531544,0.049888759380362774,0.11890946979983849,1,0.1535456049936839,0.27622911321557386,0.6871494261580355,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,0.25208664012025134,0.42028822093847934,6,0.17158194770023255,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1570373964086697,0.25208664012025134,0.09263777969811618,0.17158194770023255,0.6397952307427635,1,0.24967517610678588,0.4236685878204839,0.5489857997383517,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.4,967514 MM WT,MoneyMaker,m_18,0.1570373964086697,0.20714437268963773,5,0.09263777969811618,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,0.3618736723748486,0.33608059260063017,6,0.1372043273872893,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1570373964086697,0.3618736723748486,0.09263777969811618,0.1372043273872893,0.24939475907938155,1,0.24967517610678588,0.49907799976213785,0.5489857997383517,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_18,0.2514098059173329,0.23890168855886745,6,0.09753120594308787,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1570373964086697,0.2514098059173329,0.09263777969811618,0.09753120594308787,0.5007419121963614,1,0.24967517610678588,0.3489410118604208,0.5489857997383517,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,0.13831824225928813,0.07507000294574583,6,0.030647200367717897,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.17374757342445526,0.13831824225928813,0.09076004543322676,0.030647200367717897,0.7239476580345989,1,0.26450761885768204,0.16896544262700602,0.3437805954091301,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.8,967514 MM WT,MoneyMaker,m_18,0.17374757342445526,0.22231580034322415,6,0.09076004543322676,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,0.22050882232932234,0.2253995762589065,6,0.09201899167897772,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.17374757342445526,0.22050882232932234,0.09076004543322676,0.09201899167897772,0.7250334594149358,1,0.26450761885768204,0.31252781400830004,0.3437805954091301,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_18,0.19570481117567753,0.12467351658363654,6,0.050897750011387695,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.17374757342445526,0.19570481117567753,0.09076004543322676,0.050897750011387695,0.8382455949794848,1,0.26450761885768204,0.24660256118706522,0.3437805954091301,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,0.32147811118773345,0.098582512015551,6,0.04024614199998194,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,0.14129554428594218,0.32147811118773345,0.06557060206196824,0.04024614199998194,0.046165786609586805,1,0.20686614634791042,0.3617242531877154,0.39789667850648697,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.6,967514 MM WT,MoneyMaker,m_18,0.14129554428594218,0.1606145171789087,6,0.06557060206196824,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,0.13164420462161944,0.19226213847080845,6,0.07849068935163407,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.14129554428594218,0.13164420462161944,0.06557060206196824,0.07849068935163407,0.926740516482532,1,0.20686614634791042,0.21013489397325352,0.39789667850648697,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_18,0.12760931137324594,0.057858193646260776,6,0.023620508645413107,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.14129554428594218,0.12760931137324594,0.06557060206196824,0.023620508645413107,0.8505238326589182,1,0.20686614634791042,0.15122982001865903,0.39789667850648697,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,0.4064191517360401,0.18479334233811304,6,0.07544156609863806,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.260342103292428,0.4064191517360401,0.10676875238040741,0.07544156609863806,0.29278499277012426,1,0.3671108556728354,0.48186071783467815,0.6941364393051449,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,1,967514 MM WT,MoneyMaker,m_18,0.260342103292428,0.26152896380556495,6,0.10676875238040741,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,0.49922820591884015,0.3228548013573801,6,0.1318049207222005,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.260342103292428,0.49922820591884015,0.10676875238040741,0.1318049207222005,0.19062672730797434,1,0.3671108556728354,0.6310331266410407,0.6941364393051449,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_18,0.2051361896996291,0.18739412278543438,6,0.07650333027012883,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.260342103292428,0.2051361896996291,0.10676875238040741,0.07650333027012883,0.6840543621119635,1,0.3671108556728354,0.28163951996975795,0.6941364393051449,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_18,0.2196849722531838,0.15082842615171677,6,0.06157544712979338,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.2706540678601748,0.2196849722531838,0.061443988587856796,0.06157544712979338,0.5709075027103532,1,0.3320980564480316,0.2812604193829772,0.5033489631077449,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.4,967514 MM WT,MoneyMaker,m_18,0.2706540678601748,0.15050641980164187,6,0.061443988587856796,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_18,0.3505329535158945,0.26223505510347783,6,0.10705701294569175,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.2706540678601748,0.3505329535158945,0.061443988587856796,0.10705701294569175,0.5357365031016844,1,0.3320980564480316,0.45758996646158623,0.5033489631077449,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_18,0.15665256213031262,0.11473860594960875,6,0.046841839729134596,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.2706540678601748,0.15665256213031262,0.061443988587856796,0.046841839729134596,0.17295799720353833,1,0.3320980564480316,0.20349440185944723,0.5033489631077449,0,24,0,8.93968487394958,calystegine_a_3,calystegine_a3_167_216_rt9.05,8.947098765,8.95,0.018739207,9.01,8.82,0.19,FALSE,no_chebi +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,0.04495427641807981,0.057881825454098756,6,0.02363015629056353,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.16111854615271032,0.04495427641807981,0.07195599317784669,0.02363015629056353,0.18727077743984255,1,0.233074539330557,0.06858443270864334,0.2563819932636127,4,24,16.666666666666664,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.8,967514 MM WT,MoneyMaker,m_19,0.16111854615271032,0.1608984921341763,5,0.07195599317784669,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,0.10754179736429482,0.057571238343026236,6,0.023503359633428065,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.16111854615271032,0.10754179736429482,0.07195599317784669,0.023503359633428065,0.5116022372009462,1,0.233074539330557,0.1310451569977229,0.2563819932636127,4,24,16.666666666666664,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_19,0.013096166903330842,0.012714320141273655,5,0.005686016824716525,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.16111854615271032,0.013096166903330842,0.07195599317784669,0.005686016824716525,0.10873635509604657,1,0.233074539330557,0.018782183728047366,0.2563819932636127,4,24,16.666666666666664,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,0.13926445843433888,0.14039516993337375,6,0.05731608811468338,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.07342027637216282,0.13926445843433888,0.026612888107116022,0.05731608811468338,0.331794270618084,1,0.10003316447927885,0.19658054654902227,0.21623860120392452,6,24,25,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.6,967514 MM WT,MoneyMaker,m_19,0.07342027637216282,0.06518799644421712,6,0.026612888107116022,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,0.09857621791301721,0.11031063270303355,6,0.04503412722100055,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.07342027637216282,0.09857621791301721,0.026612888107116022,0.04503412722100055,0.6432876667984975,1,0.10003316447927885,0.14361034513401777,0.21623860120392452,6,24,25,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_19,0.06636102615329001,0.10673597784269538,6,0.04357478048526915,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.07342027637216282,0.06636102615329001,0.026612888107116022,0.04357478048526915,0.8933428783996311,1,0.10003316447927885,0.10993580663855916,0.21623860120392452,6,24,25,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,0.07264730511500955,0.0761213520476106,6,0.03107641184123491,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.04110808127703193,0.07264730511500955,0.019239737233206072,0.03107641184123491,0.4130593721224751,1,0.060347818510238,0.10372371695624447,0.11831275487223526,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,1,967514 MM WT,MoneyMaker,m_19,0.04110808127703193,0.0430213603226825,5,0.019239737233206072,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,0.08935103888147117,0.04459543720732518,6,0.018206011002379056,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.04110808127703193,0.08935103888147117,0.019239737233206072,0.018206011002379056,0.10282314756147626,1,0.060347818510238,0.10755704988385023,0.11831275487223526,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_19,0.0334446142467916,0.020316517470386684,6,0.008294183525464571,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.04110808127703193,0.0334446142467916,0.019239737233206072,0.008294183525464571,0.728249364808439,1,0.060347818510238,0.04173879777225617,0.11831275487223526,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,0.09106873031407049,0.13042169942495294,6,0.053244435829628824,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.0696840118995431,0.09106873031407049,0.0341676148819545,0.053244435829628824,0.7438159849426044,1,0.10385162678149759,0.14431316614369932,0.23612636100146964,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.4,967514 MM WT,MoneyMaker,m_19,0.0696840118995431,0.07640110950508372,5,0.0341676148819545,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,0.16163776865825186,0.12987821569235877,6,0.05302255952490234,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.0696840118995431,0.16163776865825186,0.0341676148819545,0.05302255952490234,0.18193805231000734,1,0.10385162678149759,0.2146603281831542,0.23612636100146964,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_19,0.10863463845683398,0.11915530179024056,6,0.04864494825557139,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.0696840118995431,0.10863463845683398,0.0341676148819545,0.04864494825557139,0.5295506145526905,1,0.10385162678149759,0.15727958671240538,0.23612636100146964,7,24,29.166666666666668,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,0.053341792003267274,0.05177339952477625,6,0.02113640184749248,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.06556665737869889,0.053341792003267274,0.032345237685093155,0.02113640184749248,0.7592421979418866,1,0.09791189506379205,0.07447819385075975,0.1847712125913156,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.8,967514 MM WT,MoneyMaker,m_19,0.06556665737869889,0.07922932793751958,6,0.032345237685093155,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,0.11925544843174236,0.11631778132772141,6,0.04748653537759172,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.06556665737869889,0.11925544843174236,0.032345237685093155,0.04748653537759172,0.37496077805739714,1,0.09791189506379205,0.16674198380933408,0.1847712125913156,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_19,0.14444087166411332,0.05764373915103621,6,0.023532957964355384,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.06556665737869889,0.14444087166411332,0.032345237685093155,0.023532957964355384,0.07963197334117868,1,0.09791189506379205,0.1679738296284687,0.1847712125913156,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,0.1245354152446864,0.04658902297196602,6,0.019019888982686774,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.05945684825474551,0.1245354152446864,0.02348301263931716,0.019019888982686774,0.057874662303185345,1,0.08293986089406266,0.14355530422737317,0.1579108346501105,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.6,967514 MM WT,MoneyMaker,m_19,0.05945684825474551,0.057521398589655104,6,0.02348301263931716,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,0.06578130582456783,0.0959392089187105,6,0.03916701802951896,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.05945684825474551,0.06578130582456783,0.02348301263931716,0.03916701802951896,0.8932008500270952,1,0.08293986089406266,0.10494832385408678,0.1579108346501105,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_19,0.06681521794970739,0.044450301937495086,6,0.01814675977658491,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.05945684825474551,0.06681521794970739,0.02348301263931716,0.01814675977658491,0.809508421296641,1,0.08293986089406266,0.0849619777262923,0.1579108346501105,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,0.12180230209014582,0.07341563044035519,6,0.02997180562060175,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.13243488541257994,0.12180230209014582,0.05964664679266465,0.02997180562060175,0.8777229249280131,1,0.1920815322052446,0.15177410771074756,0.2713168618629424,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,1,967514 MM WT,MoneyMaker,m_19,0.13243488541257994,0.14610384951004318,6,0.05964664679266465,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,0.18587469839147386,0.14887262391752948,6,0.06077699421120102,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.13243488541257994,0.18587469839147386,0.05964664679266465,0.06077699421120102,0.5443655995214585,1,0.1920815322052446,0.2466516926026749,0.2713168618629424,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_19,0.17577541436145946,0.08683269150655151,6,0.03544929786392566,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.13243488541257994,0.17577541436145946,0.05964664679266465,0.03544929786392566,0.5493156486734527,1,0.1920815322052446,0.21122471222538514,0.2713168618629424,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_19,0.11256858498841556,0.08937127391611342,6,0.03648566979283094,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.10651967863961335,0.11256858498841556,0.009411725044311144,0.03648566979283094,0.8780335651082936,1,0.1159314036839245,0.1490542547812465,0.26455095021568853,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.4,967514 MM WT,MoneyMaker,m_19,0.10651967863961335,0.023053923957935697,6,0.009411725044311144,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_19,0.17859007878758212,0.15164983293504367,6,0.06191078504486201,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.10651967863961335,0.17859007878758212,0.009411725044311144,0.06191078504486201,0.29965823669108743,1,0.1159314036839245,0.24050086383244412,0.26455095021568853,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_19,0.07874210094969485,0.08475908210525596,6,0.03460275037075695,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.10651967863961335,0.07874210094969485,0.009411725044311144,0.03460275037075695,0.4692837719980547,1,0.1159314036839245,0.1133448513204518,0.26455095021568853,0,24,0,9.105491525423728,calystegine_b_2,calystegine_b2_167_288_rt9.2,9.112389381,9.11,0.018673622,9.26,9.09,0.17,FALSE,no_chebi +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.36021046157854253,0.3910111607176722,6,0.15962963791528048,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.03395168674726654,0.36021046157854253,0.014320607083185768,0.15962963791528048,0.09650940715290893,1,0.04827229383045231,0.519840099493823,0.5718241094432054,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.8,967514 MM WT,MoneyMaker,m_35,0.03395168674726654,0.03202185091706836,5,0.014320607083185768,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.24852142304870506,0.30636287187277356,6,0.1250721187036593,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.03395168674726654,0.24852142304870506,0.014320607083185768,0.1250721187036593,0.1475267449918641,1,0.04827229383045231,0.37359354175236437,0.5718241094432054,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_35,0.1911315700813776,0.1676722972164189,5,0.07498533090389228,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.03395168674726654,0.1911315700813776,0.014320607083185768,0.07498533090389228,0.10383438230051562,1,0.04827229383045231,0.26611690098526986,0.5718241094432054,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.4607608582728469,0.39944407882142446,6,0.1630723623147591,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.2963948317515479,0.4607608582728469,0.061942982265268696,0.1630723623147591,0.3801920202147248,1,0.3583378140168166,0.623833220587606,0.6862165426463667,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.6,967514 MM WT,MoneyMaker,m_35,0.2963948317515479,0.15172869969617597,6,0.061942982265268696,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.36923259697458644,0.33503862775054666,6,0.13677894701851925,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.2963948317515479,0.36923259697458644,0.061942982265268696,0.13677894701851925,0.6424868847294284,1,0.3583378140168166,0.5060115439931057,0.6862165426463667,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_35,0.2626835565024962,0.3007554541657294,6,0.12278290001084174,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.2963948317515479,0.2626835565024962,0.061942982265268696,0.12278290001084174,0.813022772987568,1,0.3583378140168166,0.38546645651333794,0.6862165426463667,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.2247257881844459,0.2350576412256365,6,0.09596188019083415,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.35055398399271603,0.2247257881844459,0.17674003151148188,0.09596188019083415,0.5536131520227949,1,0.5272940155041979,0.32068766837528007,0.664033811031603,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,1,967514 MM WT,MoneyMaker,m_35,0.35055398399271603,0.3952027248051284,5,0.17674003151148188,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.4367052369329124,0.40897137331598316,6,0.16696186400490845,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.35055398399271603,0.4367052369329124,0.17674003151148188,0.16696186400490845,0.7314737032368879,1,0.5272940155041979,0.6036671009378208,0.664033811031603,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_35,0.36729792584358,0.38718585487962337,6,0.1580679633463956,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.35055398399271603,0.36729792584358,0.17674003151148188,0.1580679633463956,0.9453235007320281,1,0.5272940155041979,0.5253658891899756,0.664033811031603,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.346624799388655,0.24175396449627032,6,0.0986956427184638,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.37521236318114404,0.346624799388655,0.10961256955429524,0.0986956427184638,0.8508224012163169,1,0.48482493273543925,0.4453204421071188,0.5333074260089832,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.4,967514 MM WT,MoneyMaker,m_35,0.37521236318114404,0.245101156711828,5,0.10961256955429524,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.23748308926666942,0.06486026352694227,6,0.02647909170390983,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.37521236318114404,0.23748308926666942,0.10961256955429524,0.02647909170390983,0.2824415170033232,1,0.48482493273543925,0.2639621809705792,0.5333074260089832,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_35,0.24077574110338873,0.1887579298800752,6,0.07706010218503843,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.37521236318114404,0.24077574110338873,0.10961256955429524,0.07706010218503843,0.3470822476479686,1,0.48482493273543925,0.3178358432884272,0.5333074260089832,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.13314615834643329,0.11283134866084844,6,0.04606320520152346,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.1471311449044003,0.13314615834643329,0.0493909748209646,0.04606320520152346,0.8401303122261768,1,0.1965221197253649,0.17920936354795675,0.2161743316979014,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.8,967514 MM WT,MoneyMaker,m_35,0.1471311449044003,0.12098268621001498,6,0.0493909748209646,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.11394601562634284,0.15214148983041229,6,0.062111503131891024,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.1471311449044003,0.11394601562634284,0.0493909748209646,0.062111503131891024,0.685092174236428,1,0.1965221197253649,0.17605751875823386,0.2161743316979014,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_35,0.11203516357368248,0.05130039407157965,6,0.020943298179844888,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.1471311449044003,0.11203516357368248,0.0493909748209646,0.020943298179844888,0.5346582260556085,1,0.1965221197253649,0.13297846175352737,0.2161743316979014,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.09281248630847472,0.1043821791272902,6,0.04261384618360895,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.1900352870588161,0.09281248630847472,0.09114296498684601,0.04261384618360895,0.36570460393245496,1,0.2811782520456621,0.13542633249208366,0.33872071831747486,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.6,967514 MM WT,MoneyMaker,m_35,0.1900352870588161,0.22325375786212562,6,0.09114296498684601,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.21606331056552408,0.22502143260234037,6,0.09186461517763483,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.1900352870588161,0.21606331056552408,0.09114296498684601,0.09186461517763483,0.8446268324004588,1,0.2811782520456621,0.3079279257431589,0.33872071831747486,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_35,0.08083149148360717,0.07268180026841316,6,0.029672220707415615,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.1900352870588161,0.08083149148360717,0.09114296498684601,0.029672220707415615,0.29768027085539345,1,0.2811782520456621,0.11050371219102278,0.33872071831747486,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.15363900663246324,0.11172191832731228,6,0.045610282164468566,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.24124670352884073,0.15363900663246324,0.0884779301268241,0.045610282164468566,0.4061810113541635,1,0.32972463365566484,0.19924928879693182,0.3626970970212314,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,1,967514 MM WT,MoneyMaker,m_35,0.24124670352884073,0.21672578230834236,6,0.0884779301268241,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.1937008615113772,0.12431599949959907,6,0.05075179427301777,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.24124670352884073,0.1937008615113772,0.0884779301268241,0.05075179427301777,0.6535960420630834,1,0.32972463365566484,0.24445265578439496,0.3626970970212314,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_35,0.16218635413169027,0.19273444379586904,6,0.07868350719316704,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.24124670352884073,0.16218635413169027,0.0884779301268241,0.07868350719316704,0.51962700670631,1,0.32972463365566484,0.24086986132485733,0.3626970970212314,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_35,0.24599072131350988,0.19143813031509022,6,0.07815428943073381,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.22613208608320137,0.24599072131350988,0.05055851662280259,0.07815428943073381,0.8360509251704792,1,0.276690602706004,0.3241450107442437,0.5252959440327046,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.4,967514 MM WT,MoneyMaker,m_35,0.22613208608320137,0.12384256787788775,6,0.05055851662280259,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_35,0.329325945829032,0.36305313441734127,6,0.14821582147342666,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.22613208608320137,0.329325945829032,0.05055851662280259,0.14821582147342666,0.5338116017572141,1,0.276690602706004,0.4775417673024587,0.5252959440327046,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_35,0.2014656670638606,0.15049185260734363,6,0.06143804155568769,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.22613208608320137,0.2014656670638606,0.05055851662280259,0.06143804155568769,0.7631485698882952,1,0.276690602706004,0.26290370861954826,0.5252959440327046,0,24,0,10.02077922077922,galactonolactone,galactonic_acid_1-4-lacton_217_451_rt10.11,10.03823171,10.03,0.039240269,10.13,9.84,0.29,FALSE,no_chebi +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.17591136925875564,0.17663809931261454,6,0.07211220207516095,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.13471541991143016,0.17591136925875564,0.0634766000906644,0.07211220207516095,0.6781436726681433,1,0.19819202000209457,0.2480235713339166,0.27282592846730824,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.8,967514 MM WT,MoneyMaker,m_56,0.13471541991143016,0.14193799278329491,5,0.0634766000906644,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.09372382888479829,0.10905307219936206,6,0.044520730295221786,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.13471541991143016,0.09372382888479829,0.0634766000906644,0.044520730295221786,0.6123775822206504,1,0.19819202000209457,0.13824455918002007,0.27282592846730824,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_56,0.10920382905204926,0.0707564262295641,5,0.03164323577885089,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.13471541991143016,0.10920382905204926,0.0634766000906644,0.03164323577885089,0.7316590199590975,1,0.19819202000209457,0.14084706483090015,0.27282592846730824,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.09681230856442842,0.07010268024245403,6,0.028619299365916687,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.16341895268578444,0.09681230856442842,0.02668863121139856,0.028619299365916687,0.11971681106015163,1,0.190107583897183,0.1254316079303451,0.30099676789896646,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.6,967514 MM WT,MoneyMaker,m_56,0.16341895268578444,0.06537352840124375,6,0.02668863121139856,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.15204291470970133,0.1051554232975478,6,0.042929521794227765,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.16341895268578444,0.15204291470970133,0.02668863121139856,0.042929521794227765,0.8273438223618873,1,0.190107583897183,0.1949724365039291,0.30099676789896646,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_56,0.21775416232405817,0.13687568164742836,6,0.055879263038638584,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.16341895268578444,0.21775416232405817,0.02668863121139856,0.055879263038638584,0.4086969581390272,1,0.190107583897183,0.27363342536269675,0.30099676789896646,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.1638671554078943,0.1432029398119443,6,0.05846235536762573,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.11336641610464956,0.1638671554078943,0.0514930805222428,0.05846235536762573,0.5330307011737874,1,0.16485949662689237,0.22232951077552002,0.41686826090530404,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,1,967514 MM WT,MoneyMaker,m_56,0.11336641610464956,0.11514202841860528,5,0.0514930805222428,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.15365038531223543,0.14596660462806807,6,0.05959061680422339,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.11336641610464956,0.15365038531223543,0.0514930805222428,0.05959061680422339,0.6213270793603722,1,0.16485949662689237,0.21324100211645883,0.41686826090530404,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_56,0.2542639589390388,0.30546897623702113,6,0.12470718733851029,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.11336641610464956,0.2542639589390388,0.0514930805222428,0.12470718733851029,0.3330236147987832,1,0.16485949662689237,0.3789711462775491,0.41686826090530404,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.08976233480411426,0.08096165030298398,6,0.03305245532932631,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1693908461807459,0.08976233480411426,0.11021489617062817,0.03305245532932631,0.5214616992706841,1,0.2796057423513741,0.12281479013344057,0.3075663165865115,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.4,967514 MM WT,MoneyMaker,m_56,0.1693908461807459,0.24644799997060587,5,0.11021489617062817,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.04340649210937205,0.04398535987410121,6,0.017956947974039617,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1693908461807459,0.04340649210937205,0.11021489617062817,0.017956947974039617,0.3193549175909794,1,0.2796057423513741,0.06136344008341167,0.3075663165865115,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_56,0.17561290523883033,0.14675564296294752,6,0.05991274035554838,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1693908461807459,0.17561290523883033,0.11021489617062817,0.05991274035554838,0.9619830568143344,1,0.2796057423513741,0.23552564559437872,0.3075663165865115,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.21301828314091606,0.1810485879328345,6,0.07391277651447606,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.13647314975220523,0.21301828314091606,0.09109909308968409,0.07391277651447606,0.5294090782282417,1,0.22757224284188932,0.2869310596553921,0.37538732268954805,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.8,967514 MM WT,MoneyMaker,m_56,0.13647314975220523,0.22314629410003103,6,0.09109909308968409,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.2574946448362438,0.20518532365101136,6,0.08376655760879984,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.13647314975220523,0.2574946448362438,0.09109909308968409,0.08376655760879984,0.3513482826197619,1,0.22757224284188932,0.34126120244504365,0.37538732268954805,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_56,0.25425160078195025,0.19013735987205127,6,0.07762325212107725,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.13647314975220523,0.25425160078195025,0.09109909308968409,0.07762325212107725,0.34885853311084225,1,0.22757224284188932,0.3318748529030275,0.37538732268954805,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.3389353749123298,0.18121326471639684,6,0.07398000552984449,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.2593149522429566,0.3389353749123298,0.09962591639843765,0.07398000552984449,0.5367203860224887,1,0.35894086864139424,0.41291538044217424,0.4542069184863917,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.6,967514 MM WT,MoneyMaker,m_56,0.2593149522429566,0.24403266033334742,6,0.09962591639843765,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.20632130262754358,0.08660934683269492,6,0.03535811778263949,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.2593149522429566,0.20632130262754358,0.09962591639843765,0.03535811778263949,0.6333585919360696,1,0.35894086864139424,0.2416794204101831,0.4542069184863917,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_56,0.2655627247012991,0.25266290511240724,6,0.1031491990757735,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.2593149522429566,0.2655627247012991,0.09962591639843765,0.1031491990757735,0.9661080601273335,1,0.35894086864139424,0.3687119237770726,0.4542069184863917,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.270401097096479,0.3330329350879481,6,0.1359601264178175,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.2568063739764694,0.270401097096479,0.08105913382326545,0.1359601264178175,0.9336290137812632,1,0.33786550779973484,0.4063612235142965,0.44699734586572615,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,1,967514 MM WT,MoneyMaker,m_56,0.2568063739764694,0.19855351685897768,6,0.08105913382326545,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.13715628896909537,0.18638934579609875,6,0.07609313178193514,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.2568063739764694,0.13715628896909537,0.08105913382326545,0.07609313178193514,0.30721663220489426,1,0.33786550779973484,0.2132494207510305,0.44699734586572615,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_56,0.19243399954672671,0.14845250160755596,6,0.0606054799963686,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.2568063739764694,0.19243399954672671,0.08105913382326545,0.0606054799963686,0.5401623516134488,1,0.33786550779973484,0.2530394795430953,0.44699734586572615,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_56,0.19521532418777196,0.175623070896761,6,0.0716978184596165,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.0564852883677985,0.19521532418777196,0.01961615649043646,0.0716978184596165,0.11341692368004903,1,0.07610144485823496,0.26691314264738847,0.29360445691212733,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.4,967514 MM WT,MoneyMaker,m_56,0.0564852883677985,0.04804957411615377,6,0.01961615649043646,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_56,0.18344213975720072,0.17790114175129423,6,0.07262783699153524,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.0564852883677985,0.18344213975720072,0.01961615649043646,0.07262783699153524,0.14483118258218217,1,0.07610144485823496,0.256069976748736,0.29360445691212733,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_56,0.18873294439692398,0.18087331996372696,6,0.07384122366571484,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.0564852883677985,0.18873294439692398,0.01961615649043646,0.07384122366571484,0.1367621958914437,1,0.07610144485823496,0.26257416806263884,0.29360445691212733,0,24,0,4.242217573221757,guanidine,guanidine_146_171_rt4.33,4.263170732,4.26,0.02667128,4.44,4.1,0.34,FALSE,one_carbon_compound +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.1714031752817086,0.2686362698880284,6,0.10967029793837653,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.037422844129498145,0.1714031752817086,0.019864893985421482,0.10967029793837653,0.2800274306146322,1,0.05728773811491963,0.28107347322008513,0.3121904371030778,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.8,967514 MM WT,MoneyMaker,m_121,0.037422844129498145,0.04441925331722915,5,0.019864893985421482,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.19374716303451053,0.20832480320163865,6,0.08504824476828969,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.037422844129498145,0.19374716303451053,0.019864893985421482,0.08504824476828969,0.12776089912439204,1,0.05728773811491963,0.2787954078028002,0.3121904371030778,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_121,0.21182171850910114,0.1609695467463285,5,0.07198776976642411,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.037422844129498145,0.21182171850910114,0.019864893985421482,0.07198776976642411,0.07120535855339236,1,0.05728773811491963,0.28380948827552527,0.3121904371030778,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.36332330516789163,0.16969806019475536,6,0.06927894296954261,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.23551029414235103,0.36332330516789163,0.09692915318571448,0.06927894296954261,0.31113839496697737,1,0.3324394473280655,0.43260224813743425,0.47586247295117773,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.6,967514 MM WT,MoneyMaker,m_121,0.23551029414235103,0.237426966505067,6,0.09692915318571448,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.1287604539197913,0.15885387560959136,6,0.06485182315117483,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.23551029414235103,0.1287604539197913,0.09692915318571448,0.06485182315117483,0.3846024647339884,1,0.3324394473280655,0.19361227707096612,0.47586247295117773,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_121,0.11367038036306935,0.13021365321881315,6,0.053159501321634765,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.23551029414235103,0.11367038036306935,0.09692915318571448,0.053159501321634765,0.3034173867165632,1,0.3324394473280655,0.1668298816847041,0.47586247295117773,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.1652883103277701,0.07972915599714715,6,0.03254929163596198,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1062300435770911,0.1652883103277701,0.05666400135726169,0.03254929163596198,0.3983381367747867,1,0.16289404493435278,0.1978376019637321,0.30120394089439717,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,1,967514 MM WT,MoneyMaker,m_121,0.1062300435770911,0.1267045589119775,5,0.05666400135726169,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.1903035972163932,0.20457689397342751,6,0.08351816723305876,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1062300435770911,0.1903035972163932,0.05666400135726169,0.08351816723305876,0.427802764855018,1,0.16289404493435278,0.27382176444945194,0.30120394089439717,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_121,0.06951733625048913,0.09171395224116796,6,0.0374420642141412,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1062300435770911,0.06951733625048913,0.05666400135726169,0.0374420642141412,0.6052090492941411,1,0.16289404493435278,0.10695940046463033,0.30120394089439717,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.1707689178956152,0.21043213611807457,6,0.08590855982886288,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.23354236217279184,0.1707689178956152,0.08068538077039485,0.08590855982886288,0.6072235986232536,1,0.31422774294318667,0.2566774777244781,0.3456505172375054,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.4,967514 MM WT,MoneyMaker,m_121,0.23354236217279184,0.18041799619305723,5,0.08068538077039485,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.14240481136309688,0.2718624958694249,6,0.11098739917993175,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.23354236217279184,0.14240481136309688,0.08068538077039485,0.11098739917993175,0.5238603995554092,1,0.31422774294318667,0.25339221054302863,0.3456505172375054,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_121,0.14360890486341446,0.20940005456145308,6,0.08548721429775287,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.23354236217279184,0.14360890486341446,0.08068538077039485,0.08548721429775287,0.4638790405554316,1,0.31422774294318667,0.22909611916116734,0.3456505172375054,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.17902435547877762,0.20416803539803116,6,0.0833512514186117,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.18646177297489733,0.17902435547877762,0.07675434215991157,0.0833512514186117,0.9489675201839979,1,0.2632161151348089,0.2623756068973893,0.33760378665993673,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.8,967514 MM WT,MoneyMaker,m_121,0.18646177297489733,0.18800897383477383,6,0.07675434215991157,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.12576978800969277,0.11568287846486239,6,0.04722733736921891,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.18646177297489733,0.12576978800969277,0.07675434215991157,0.04722733736921891,0.5189427231890098,1,0.2632161151348089,0.17299712537891168,0.33760378665993673,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_121,0.2049434610370411,0.24977219665589775,6,0.10196907229017407,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.18646177297489733,0.2049434610370411,0.07675434215991157,0.10196907229017407,0.8879551411650657,1,0.2632161151348089,0.3069125333272152,0.33760378665993673,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.18724922118856147,0.13266174695281893,6,0.05415893140343792,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.2383556375431933,0.18724922118856147,0.11761717389758834,0.05415893140343792,0.704779215382657,1,0.35597281144078163,0.24140815259199938,0.3915700925848598,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.6,967514 MM WT,MoneyMaker,m_121,0.2383556375431933,0.28810206103728797,6,0.11761717389758834,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.16606878150535112,0.16497505918873528,6,0.0673507858829758,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.2383556375431933,0.16606878150535112,0.11761717389758834,0.0673507858829758,0.6083611017449759,1,0.35597281144078163,0.23341956738832692,0.3915700925848598,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_121,0.14056011461683804,0.17337752308029408,6,0.07078107740238902,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.2383556375431933,0.14056011461683804,0.11761717389758834,0.07078107740238902,0.49597037724976023,1,0.35597281144078163,0.21134119201922708,0.3915700925848598,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.22051867786854337,0.14574009909715294,6,0.05949814630844668,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.13183928877299725,0.22051867786854337,0.040300404550483525,0.05949814630844668,0.2491683831139477,1,0.17213969332348078,0.28001682417699003,0.30801850659468905,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,1,967514 MM WT,MoneyMaker,m_121,0.13183928877299725,0.0987154275764219,6,0.040300404550483525,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.08560403585455763,0.08917204233086833,6,0.03640433383874822,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.13183928877299725,0.08560403585455763,0.040300404550483525,0.03640433383874822,0.41469801555068053,1,0.17213969332348078,0.12200836969330585,0.30801850659468905,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_121,0.14763111300529352,0.1676875041750466,6,0.06845813691161468,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.13183928877299725,0.14763111300529352,0.040300404550483525,0.06845813691161468,0.8473293996428997,1,0.17213969332348078,0.2160892499169082,0.30801850659468905,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_121,0.104346117904118,0.09845099280448297,6,0.040192449506900256,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.21483340036375234,0.104346117904118,0.10597478052435268,0.040192449506900256,0.36499132206270035,1,0.32080818088810503,0.14453856741101825,0.35288899897691556,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.4,967514 MM WT,MoneyMaker,m_121,0.21483340036375234,0.25958413788810036,6,0.10597478052435268,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_121,0.11613203081427985,0.07873674725111045,6,0.03214414246195111,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.21483340036375234,0.11613203081427985,0.10597478052435268,0.03214414246195111,0.4075899161681997,1,0.32080818088810503,0.14827617327623097,0.35288899897691556,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_121,0.1581858670339468,0.09721509329564022,6,0.03968789564523008,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.21483340036375234,0.1581858670339468,0.10597478052435268,0.03968789564523008,0.6334740919952984,1,0.32080818088810503,0.1978737626791769,0.35288899897691556,0,24,0,5.4569874476987446,urea,urea_189_204_rt5.56,5.465914634,5.47,0.028774862,5.48,5.25,0.23,FALSE,one_carbon_compound +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.06293508284850084,0.06016370939946211,6,0.024561731510295056,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.06389606119755013,0.06293508284850084,0.026146083643376946,0.024561731510295056,0.9792308291198825,1,0.09004214484092708,0.0874968143587959,0.19474362870610162,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.8,967514 MM WT,MoneyMaker,m_23,0.06389606119755013,0.05846442037198622,5,0.026146083643376946,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.12486748737196374,0.12779520773705913,6,0.05217217508812864,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.06389606119755013,0.12486748737196374,0.026146083643376946,0.05217217508812864,0.32967408068680576,1,0.09004214484092708,0.17703966246009237,0.19474362870610162,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_23,0.0861126742119577,0.08231661379071889,5,0.03681310882272881,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.06389606119755013,0.0861126742119577,0.026146083643376946,0.03681310882272881,0.6373139764822525,1,0.09004214484092708,0.12292578303468651,0.19474362870610162,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.10035496688786227,0.06684023554376738,6,0.027287411894944966,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.08607849260970468,0.10035496688786227,0.02273995018910307,0.027287411894944966,0.696467522013218,1,0.10881844279880776,0.12764237878280724,0.18153780190513003,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.6,967514 MM WT,MoneyMaker,m_23,0.08607849260970468,0.055701274739608356,6,0.02273995018910307,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.10333704071198808,0.15112696390279973,6,0.061697324656311926,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.08607849260970468,0.10333704071198808,0.02273995018910307,0.061697324656311926,0.8012893769402392,1,0.10881844279880776,0.16503436536830002,0.18153780190513003,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_23,0.06811096247701036,0.08528205966728276,6,0.03481625506640535,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.08607849260970468,0.06811096247701036,0.02273995018910307,0.03481625506640535,0.6763081830498976,1,0.10881844279880776,0.10292721754341572,0.18153780190513003,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.09943412622977917,0.12394585738359735,6,0.0506006843869314,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.14649837701328722,0.09943412622977917,0.06136274629145689,0.0506006843869314,0.5698962950028255,1,0.2078611233047441,0.15003481061671056,0.22864723563521852,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,1,967514 MM WT,MoneyMaker,m_23,0.14649837701328722,0.13721127199377073,5,0.06136274629145689,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.08777154122333375,0.08022218392489144,6,0.032750569444614526,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.14649837701328722,0.08777154122333375,0.06136274629145689,0.032750569444614526,0.42985803937092454,1,0.2078611233047441,0.12052211066794827,0.22864723563521852,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_23,0.10794458613545466,0.06457138583569415,6,0.026361157880304638,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.14649837701328722,0.10794458613545466,0.06136274629145689,0.026361157880304638,0.5867281092106388,1,0.2078611233047441,0.1343057440157593,0.22864723563521852,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.12519793852996228,0.10450570352031568,6,0.042664274805892195,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.15251861975030395,0.12519793852996228,0.06977053260795602,0.042664274805892195,0.7484049671198076,1,0.22228915235825997,0.16786221333585447,0.24451806759408598,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.4,967514 MM WT,MoneyMaker,m_23,0.15251861975030395,0.15601165373775536,5,0.06977053260795602,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.03206379074060509,0.03725729729947195,6,0.015210227929813325,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.15251861975030395,0.03206379074060509,0.06977053260795602,0.015210227929813325,0.16065995089544105,1,0.22228915235825997,0.047274018670418416,0.24451806759408598,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_23,0.08229968653378328,0.07035840371997076,6,0.028723698038444368,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.15251861975030395,0.08229968653378328,0.06977053260795602,0.028723698038444368,0.3921124106258767,1,0.22228915235825997,0.11102338457222764,0.24451806759408598,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.08220568727960309,0.06364473550187805,6,0.025982854465666446,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.09134527722497543,0.08220568727960309,0.039585880520223195,0.025982854465666446,0.8514099361992118,1,0.13093115774519862,0.10818854174526954,0.1440242735197185,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.8,967514 MM WT,MoneyMaker,m_23,0.09134527722497543,0.09696520829332712,6,0.039585880520223195,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.0634688339961557,0.06380425789122808,6,0.026047979208409306,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.09134527722497543,0.0634688339961557,0.039585880520223195,0.026047979208409306,0.5713944743758529,1,0.13093115774519862,0.089516813204565,0.1440242735197185,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_23,0.0760250987844091,0.079676938590455,6,0.03252797396894745,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.09134527722497543,0.0760250987844091,0.039585880520223195,0.03252797396894745,0.7712781484667668,1,0.13093115774519862,0.10855307275335656,0.1440242735197185,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.07087035192112563,0.07256370336722137,6,0.02962400784939499,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.06455730510869555,0.07087035192112563,0.033230621477884706,0.02962400784939499,0.8900836042019242,1,0.09778792658658025,0.10049435977052062,0.14792792869293847,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.6,967514 MM WT,MoneyMaker,m_23,0.06455730510869555,0.08139806645638896,6,0.033230621477884706,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.10025919713608882,0.08382334681775945,6,0.03422073803930979,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.06455730510869555,0.10025919713608882,0.033230621477884706,0.03422073803930979,0.47143386921620656,1,0.09778792658658025,0.1344799351753986,0.14792792869293847,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_23,0.06268121220470164,0.03544837047500742,6,0.014471736646151458,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.06455730510869555,0.06268121220470164,0.033230621477884706,0.014471736646151458,0.9601999492674413,1,0.09778792658658025,0.07715294885085311,0.14792792869293847,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.11239076646841777,0.1008828737982859,6,0.04118526076523186,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.08209387858990051,0.11239076646841777,0.030947025390913097,0.04118526076523186,0.5704957059986272,1,0.11304090398081361,0.15357602723364963,0.1689336299570146,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,1,967514 MM WT,MoneyMaker,m_23,0.08209387858990051,0.0758044212646922,6,0.030947025390913097,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.09091945696640262,0.07609183467617608,6,0.03106436142480778,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.08209387858990051,0.09091945696640262,0.030947025390913097,0.03106436142480778,0.844520075349477,1,0.11304090398081361,0.1219838183912104,0.1689336299570146,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_23,0.09937290398819654,0.08238470522659469,6,0.033633415069126565,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.08209387858990051,0.09937290398819654,0.030947025390913097,0.033633415069126565,0.7133427135248214,1,0.11304090398081361,0.1330063190573231,0.1689336299570146,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_23,0.045589334535670524,0.04394113366096716,6,0.01793889269813395,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.04144774834023757,0.045589334535670524,0.017238179270771852,0.01793889269813395,0.8711101138289763,1,0.05868592761100942,0.06352822723380447,0.12832251132794548,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.4,967514 MM WT,MoneyMaker,m_23,0.04144774834023757,0.042224743308013256,6,0.017238179270771852,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_23,0.08714871343335402,0.07227982513550388,6,0.029508115046596416,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.04144774834023757,0.08714871343335402,0.017238179270771852,0.029508115046596416,0.2176510498077558,1,0.05868592761100942,0.11665682847995043,0.12832251132794548,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_23,0.04586418621766045,0.03852593427843943,6,0.015728146807696037,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.04144774834023757,0.04586418621766045,0.017238179270771852,0.015728146807696037,0.8537054527848473,1,0.05868592761100942,0.061592333025356494,0.12832251132794548,0,24,0,10.120960334029228,dehydroascorbic_acid,dehydroascorbic_acid_316_173_rt10.24,10.14109756,10.14,0.025597455,10.29,9.89,0.4,FALSE,organic_heterocyclic_compound +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.07004535677515318,0.05622163780774015,6,0.022952387522088405,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.22520750187675914,0.07004535677515318,0.06736629817467595,0.022952387522088405,0.0818729950260522,1,0.2925738000514351,0.09299774429724159,0.3218311800565786,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.8,967514 MM WT,MoneyMaker,m_82,0.22520750187675914,0.1506356221110954,5,0.06736629817467595,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.09471877643801034,0.08752109051892003,6,0.03573033558388211,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.22520750187675914,0.09471877643801034,0.06736629817467595,0.03573033558388211,0.13647576985420748,1,0.2925738000514351,0.13044911202189247,0.3218311800565786,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_82,0.10515330501564621,0.08702821290263082,5,0.03892020000212136,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.22520750187675914,0.10515330501564621,0.06736629817467595,0.03892020000212136,0.1706661056082049,1,0.2925738000514351,0.14407350501776756,0.3218311800565786,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.08648720967494457,0.0788037615731853,6,0.032171500944374765,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.05065096542065454,0.08648720967494457,0.01953060541445772,0.032171500944374765,0.36807972035722825,1,0.07018157083511226,0.11865871061931933,0.13052458168125128,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.6,967514 MM WT,MoneyMaker,m_82,0.05065096542065454,0.047840017633059784,6,0.01953060541445772,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.04308491160124187,0.03541442286636917,6,0.014457877592959556,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.05065096542065454,0.04308491160124187,0.01953060541445772,0.014457877592959556,0.7624532030223572,1,0.07018157083511226,0.05754278919420143,0.13052458168125128,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_82,0.051847445404152724,0.05339344239546898,6,0.02179778157993096,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.05065096542065454,0.051847445404152724,0.01953060541445772,0.02179778157993096,0.9682050886923235,1,0.07018157083511226,0.07364522698408368,0.13052458168125128,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.040341678673743386,0.021800734712269513,6,0.008900112677140226,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.07072073096059181,0.040341678673743386,0.023956670237415954,0.008900112677140226,0.28691890465062225,1,0.09467740119800777,0.049241791350883614,0.10414514131780855,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,1,967514 MM WT,MoneyMaker,m_82,0.07072073096059181,0.0535687431654081,5,0.023956670237415954,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.06189239058691361,0.040466387484097935,6,0.016520333511631246,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.07072073096059181,0.06189239058691361,0.023956670237415954,0.016520333511631246,0.7699859606462257,1,0.09467740119800777,0.07841272409854486,0.10414514131780855,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_82,0.06321312339194278,0.06907979609580386,6,0.02820170866170417,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.07072073096059181,0.06321312339194278,0.023956670237415954,0.02820170866170417,0.8437458024740706,1,0.09467740119800777,0.09141483205364695,0.10414514131780855,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.1510125419338971,0.08772112993675481,6,0.03581200133423855,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.12935869719404192,0.1510125419338971,0.049509489946335104,0.03581200133423855,0.7326701524372491,1,0.17886818714037703,0.18682454326813563,0.20550699759494923,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.4,967514 MM WT,MoneyMaker,m_82,0.12935869719404192,0.11070658505134771,5,0.049509489946335104,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.10422542313250431,0.10805307792664369,6,0.04411248434291086,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.12935869719404192,0.10422542313250431,0.049509489946335104,0.04411248434291086,0.7139032143173235,1,0.17886818714037703,0.14833790747541517,0.20550699759494923,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_82,0.0666257106230268,0.06782373136235599,6,0.027688922381562127,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.12935869719404192,0.0666257106230268,0.049509489946335104,0.027688922381562127,0.30864375618425305,1,0.17886818714037703,0.09431463300458892,0.20550699759494923,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.11836338984540055,0.07115955981210742,6,0.029050768643453868,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.19396426580695833,0.11836338984540055,0.08500495450444426,0.029050768643453868,0.43151325850504196,1,0.2789692203114026,0.14741415848885442,0.4061002662711949,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.8,967514 MM WT,MoneyMaker,m_82,0.19396426580695833,0.2082187641443869,6,0.08500495450444426,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.13752568903056783,0.10754693964775866,6,0.04390585425581773,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.19396426580695833,0.13752568903056783,0.08500495450444426,0.04390585425581773,0.5726141476863023,1,0.2789692203114026,0.18143154328638555,0.4061002662711949,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_82,0.27028383565436026,0.24225018671801327,6,0.09889822459218053,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.19396426580695833,0.27028383565436026,0.08500495450444426,0.09889822459218053,0.5716494750365929,1,0.2789692203114026,0.36918206024654077,0.4061002662711949,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.16357948753604554,0.11914830946417893,6,0.04864209365041036,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.13836553816848784,0.16357948753604554,0.024568304420365485,0.04864209365041036,0.6568959483593926,1,0.16293384258885332,0.2122215811864559,0.2334437393051015,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.6,967514 MM WT,MoneyMaker,m_82,0.13836553816848784,0.06017980967525986,6,0.024568304420365485,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.07513473041002738,0.05983251015965697,6,0.024426519986841675,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.13836553816848784,0.07513473041002738,0.024568304420365485,0.024426519986841675,0.09795493101495306,1,0.16293384258885332,0.09956125039686906,0.2334437393051015,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_82,0.11251426483748661,0.0886007645808294,6,0.03617111067391479,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.13836553816848784,0.11251426483748661,0.024568304420365485,0.03617111067391479,0.5692440699765824,1,0.16293384258885332,0.1486853755114014,0.2334437393051015,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.087935978385552,0.0667520029776185,6,0.027251391100651452,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.13903543379077835,0.087935978385552,0.06549428836237549,0.027251391100651452,0.4957359657909336,1,0.20452972215315385,0.11518736948620345,0.25548780584977143,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,1,967514 MM WT,MoneyMaker,m_82,0.13903543379077835,0.1604275875545224,6,0.06549428836237549,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.1830059754401748,0.12065124923234807,6,0.04925566624143557,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.13903543379077835,0.1830059754401748,0.06549428836237549,0.04925566624143557,0.6041873892340182,1,0.20452972215315385,0.23226164168161037,0.25548780584977143,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_82,0.1314917443427035,0.14487835620859346,6,0.05914634124737288,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.13903543379077835,0.1314917443427035,0.06549428836237549,0.05914634124737288,0.9335823044535777,1,0.20452972215315385,0.1906380855900764,0.25548780584977143,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_82,0.10810041823482797,0.07990559574672935,6,0.03262132286209878,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.14314838529615667,0.10810041823482797,0.04021776020408765,0.03262132286209878,0.5145187219717133,1,0.18336614550024433,0.14072174109692676,0.29211481515869125,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.4,967514 MM WT,MoneyMaker,m_82,0.14314838529615667,0.09851299109762618,6,0.04021776020408765,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_82,0.19393293517856058,0.17544712217066114,6,0.07162598769297693,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.14314838529615667,0.19393293517856058,0.04021776020408765,0.07162598769297693,0.5538926429270081,1,0.18336614550024433,0.2655589228715375,0.29211481515869125,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_82,0.08546546643525439,0.052808459920002694,6,0.02155896348437053,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.14314838529615667,0.08546546643525439,0.04021776020408765,0.02155896348437053,0.2433290443041666,1,0.18336614550024433,0.10702442991962492,0.29211481515869125,0,24,0,5.346075156576201,phosphate,phosphoric_acid_314_299_rt.5.43,5.355853659,5.36,0.025714393,5.37,5.15,0.22,FALSE,phosphoric_acids +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.08295828343571277,0.10591660032785295,6,0.043240271015590206,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.12456847288138366,0.08295828343571277,0.07288883336016728,0.043240271015590206,0.6392229131225748,1,0.19745730624155095,0.12619855445130296,0.21720303686570605,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.8,967514 MM WT,MoneyMaker,m_86,0.12456847288138366,0.16298438619398847,5,0.07288883336016728,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.0631457839110418,0.03768591048976621,6,0.01538520853202122,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.12456847288138366,0.0631457839110418,0.07288883336016728,0.01538520853202122,0.45239363353996037,1,0.19745730624155095,0.07853099244306301,0.21720303686570605,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_86,0.052627811073572686,0.04867183112317018,5,0.021766704596159692,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.12456847288138366,0.052627811073572686,0.07288883336016728,0.021766704596159692,0.3902568049269961,1,0.19745730624155095,0.07439451566973238,0.21720303686570605,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.08542132981880697,0.038227202519280495,6,0.015606190077712141,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.07372605469077802,0.08542132981880697,0.018160407409061632,0.015606190077712141,0.6360147931659985,1,0.09188646209983965,0.10102751989651912,0.1473656513166248,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.6,967514 MM WT,MoneyMaker,m_86,0.07372605469077802,0.04448373167326009,6,0.018160407409061632,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.09723211808155141,0.08998606167073403,6,0.03673665584265292,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.07372605469077802,0.09723211808155141,0.018160407409061632,0.03673665584265292,0.5834605918531084,1,0.09188646209983965,0.13396877392420434,0.1473656513166248,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_86,0.08932660903357707,0.08683481039140602,6,0.0354501628950452,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.07372605469077802,0.08932660903357707,0.018160407409061632,0.0354501628950452,0.7062593765464875,1,0.09188646209983965,0.12477677192862227,0.1473656513166248,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.07225385753765612,0.05207525989326716,6,0.02125963582688769,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.10283015716026486,0.07225385753765612,0.06870099650832272,0.02125963582688769,0.6892144782696139,1,0.17153115366858757,0.09351349336454381,0.18868426903544633,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,1,967514 MM WT,MoneyMaker,m_86,0.10283015716026486,0.15362009831458528,5,0.06870099650832272,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.07730779609285054,0.0664968998333392,6,0.02714724567810747,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.10283015716026486,0.07730779609285054,0.06870099650832272,0.02714724567810747,0.7431460610560783,1,0.17153115366858757,0.10445504177095802,0.18868426903544633,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_86,0.0654871351764208,0.08841461211441884,6,0.03609511424773705,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.10283015716026486,0.0654871351764208,0.06870099650832272,0.03609511424773705,0.6470548069835609,1,0.17153115366858757,0.10158224942415785,0.18868426903544633,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.046985819536129535,0.03893540858930971,6,0.0158953139950977,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.08051450134771088,0.046985819536129535,0.025428976339583017,0.0158953139950977,0.3009793831111797,1,0.1059434776872939,0.06288113353122723,0.2179841509000128,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.4,967514 MM WT,MoneyMaker,m_86,0.08051450134771088,0.05686091969354141,5,0.025428976339583017,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.12710141617515794,0.17407542271199083,6,0.07106599373394458,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.08051450134771088,0.12710141617515794,0.025428976339583017,0.07106599373394458,0.5589433523054478,1,0.1059434776872939,0.19816740990910253,0.2179841509000128,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_86,0.1266942311244069,0.09009200337318224,6,0.03677990636156623,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.08051450134771088,0.1266942311244069,0.025428976339583017,0.03677990636156623,0.33021432065928713,1,0.1059434776872939,0.16347413748597311,0.2179841509000128,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.060061587587083874,0.058081489487433476,6,0.02371166879083955,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.09608617515799549,0.060061587587083874,0.029065967346509482,0.02371166879083955,0.36040088565251915,1,0.12515214250450496,0.08377325637792342,0.21794126265080316,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.8,967514 MM WT,MoneyMaker,m_86,0.09608617515799549,0.07119678887934576,6,0.029065967346509482,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.0640449259845064,0.04650140485263721,6,0.018984119035257124,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.09608617515799549,0.0640449259845064,0.029065967346509482,0.018984119035257124,0.38117570530130807,1,0.12515214250450496,0.08302904501976352,0.21794126265080316,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_86,0.15085856957007585,0.11578701522020836,6,0.04726985102156336,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.09608617515799549,0.15085856957007585,0.029065967346509482,0.04726985102156336,0.3514904520823139,1,0.12515214250450496,0.1981284205916392,0.21794126265080316,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.10778227086011934,0.08588479501722791,6,0.035062320742622596,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.08332033991327314,0.10778227086011934,0.021852076269839652,0.035062320742622596,0.5694250010394852,1,0.1051724161831128,0.14284459160274193,0.15712905076301614,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.6,967514 MM WT,MoneyMaker,m_86,0.08332033991327314,0.05352643668148792,6,0.021852076269839652,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.06575631513414064,0.09783438380041813,6,0.03994071993510616,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.08332033991327314,0.06575631513414064,0.021852076269839652,0.03994071993510616,0.7100313049827672,1,0.1051724161831128,0.1056970350692468,0.15712905076301614,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_86,0.07573188442200769,0.08297136373751852,6,0.033872917403297294,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.08332033991327314,0.07573188442200769,0.021852076269839652,0.033872917403297294,0.8550715965924931,1,0.1051724161831128,0.10960480182530499,0.15712905076301614,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.07950515765344957,0.08050338841996979,6,0.032865370699001015,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.10162968130868173,0.07950515765344957,0.025753741656861822,0.032865370699001015,0.6084070088316729,1,0.12738342296554356,0.11237052835245058,0.14012176526209794,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,1,967514 MM WT,MoneyMaker,m_86,0.10162968130868173,0.06308352602677088,6,0.025753741656861822,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.053395430225142405,0.04073231993948056,6,0.016628899981920058,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.10162968130868173,0.053395430225142405,0.025753741656861822,0.016628899981920058,0.15183583919697793,1,0.12738342296554356,0.07002433020706246,0.14012176526209794,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_86,0.03139458679222932,0.040145427505283174,6,0.0163893021489728,leaf_1_log2-1,1,967514 MM WT,leaf,*,0.10162968130868173,0.03139458679222932,0.025753741656861822,0.0163893021489728,0.048638016516151406,1,0.12738342296554356,0.04778388894120212,0.14012176526209794,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_86,0.06849446214457518,0.06104279999592251,6,0.024920618743462873,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.070785097842,0.06849446214457518,0.015980630835117464,0.024920618743462873,0.9401122357599638,1,0.08676572867711746,0.09341508088803804,0.18453565857453572,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.4,967514 MM WT,MoneyMaker,m_86,0.070785097842,0.0391443913138248,6,0.015980630835117464,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_86,0.12065176332516699,0.11539038224635786,6,0.04710792628804729,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.070785097842,0.12065176332516699,0.015980630835117464,0.04710792628804729,0.35400680454038663,1,0.08676572867711746,0.16775968961321427,0.18453565857453572,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_86,0.07082342174265206,0.0817466603580974,6,0.03337293434232331,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.070785097842,0.07082342174265206,0.015980630835117464,0.03337293434232331,0.9992018037452111,1,0.08676572867711746,0.10419635608497538,0.18453565857453572,0,24,0,8.362887029288702,1_4-diaminobutane,putrescine_174_361_rt8.47,8.367560976,8.37,0.013297998,8.49,8.3,0.19,FALSE,polyamine +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,0.22939934044353172,0.20503000701408927,6,0.0837031498572958,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.33771647239836894,0.22939934044353172,0.17608745196746262,0.0837031498572958,0.5993512308168523,1,0.5138039243658316,0.3131024903008275,0.5651843168024148,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.8,967514 MM WT,MoneyMaker,m_100,0.33771647239836894,0.3937435125839755,5,0.17608745196746262,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,0.18295539315825257,0.24818047045121935,6,0.10131925278822758,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.33771647239836894,0.18295539315825257,0.17608745196746262,0.10131925278822758,0.47285423637115565,1,0.5138039243658316,0.28427464594648016,0.5651843168024148,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_100,0.3797071052905042,0.2974304141028508,5,0.1330149249019773,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.33771647239836894,0.3797071052905042,0.17608745196746262,0.1330149249019773,0.8541771155506432,1,0.5138039243658316,0.5127220301924815,0.5651843168024148,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,0.33680932305555555,0.26124654638931066,6,0.10665345595302438,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.3567548865641564,0.33680932305555555,0.07083184807403156,0.10665345595302438,0.8797592191887402,1,0.42758673463818797,0.44346277900857994,0.487809056909438,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.6,967514 MM WT,MoneyMaker,m_100,0.3567548865641564,0.1735018853197167,6,0.07083184807403156,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,0.26097866746765835,0.1786922190863619,6,0.07295079296120133,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.3567548865641564,0.26097866746765835,0.07083184807403156,0.07295079296120133,0.3684447984407274,1,0.42758673463818797,0.3339294604288597,0.487809056909438,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_100,0.14428670782764763,0.1401412117660006,6,0.05721241012700396,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,0.3567548865641564,0.14428670782764763,0.07083184807403156,0.05721241012700396,0.042868641776900036,0.9859787608687008,0.42758673463818797,0.20149911795465159,0.487809056909438,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,0.2584172135970379,0.251053159875395,6,0.10249202333468091,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.35264067283927014,0.2584172135970379,0.19441781606091174,0.10249202333468091,0.6827340719152176,1,0.5470584889001819,0.36090923693171884,0.6017643377902002,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,1,967514 MM WT,MoneyMaker,m_100,0.35264067283927014,0.43473145274924907,5,0.19441781606091174,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,0.26799128111069526,0.2905490497018676,6,0.11861615283668743,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.35264067283927014,0.26799128111069526,0.19441781606091174,0.11861615283668743,0.7214702584761589,1,0.5470584889001819,0.3866074339473827,0.6017643377902002,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_100,0.3201011280505691,0.13630271638856645,6,0.05564535095121302,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.35264067283927014,0.3201011280505691,0.19441781606091174,0.05564535095121302,0.8789102560396389,1,0.5470584889001819,0.37574647900178215,0.6017643377902002,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,0.15255070822557434,0.10451831567632548,6,0.04266942369702226,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.37565866437965517,0.15255070822557434,0.15139736074926108,0.04266942369702226,0.21963793413847257,1,0.5270560251289163,0.1952201319225966,0.640976108657904,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.4,967514 MM WT,MoneyMaker,m_100,0.37565866437965517,0.3385347902494063,5,0.15139736074926108,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,0.2575655226824517,0.26541498581050094,6,0.10835521422062748,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.37565866437965517,0.2575655226824517,0.15139736074926108,0.10835521422062748,0.5445914369107401,1,0.5270560251289163,0.3659207369030792,0.640976108657904,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_100,0.4939614554372788,0.21737775750941876,6,0.08874409788808837,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.37565866437965517,0.4939614554372788,0.15139736074926108,0.08874409788808837,0.5231361461764369,1,0.5270560251289163,0.5827055533253672,0.640976108657904,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,0.03471497782869045,0.032847520364112356,6,0.013409944034625799,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,0.0974723210092913,0.03471497782869045,0.022008431363498733,0.013409944034625799,0.03995128932585026,0.9588309438204061,0.11948075237279004,0.04812492186331625,0.16536840506872716,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.8,967514 MM WT,MoneyMaker,m_100,0.0974723210092913,0.053909426879637734,6,0.022008431363498733,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,0.09477193349175457,0.0595452522800251,6,0.024309247448559692,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.0974723210092913,0.09477193349175457,0.022008431363498733,0.024309247448559692,0.9360097850404667,1,0.11948075237279004,0.11908118094031427,0.16536840506872716,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_100,0.11105453668614307,0.09621688058526427,6,0.03928037701269979,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.0974723210092913,0.11105453668614307,0.022008431363498733,0.03928037701269979,0.7707445193544038,1,0.11948075237279004,0.15033491369884286,0.16536840506872716,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,0.10656139077003395,0.09066460562411176,6,0.03701367025162397,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.10207513495333553,0.10656139077003395,0.04126526473127859,0.03701367025162397,0.9371121645978512,1,0.14334039968461412,0.1435750610216579,0.1579325671238237,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.6,967514 MM WT,MoneyMaker,m_100,0.10207513495333553,0.10107884269249934,6,0.04126526473127859,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,0.08646542914937212,0.07963116264850895,6,0.0325092860189036,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.10207513495333553,0.08646542914937212,0.04126526473127859,0.0325092860189036,0.7727653564843098,1,0.14334039968461412,0.11897471516827572,0.1579325671238237,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_100,0.10770930569968591,0.08352197389058617,6,0.03409770305699921,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.10207513495333553,0.10770930569968591,0.04126526473127859,0.03409770305699921,0.9183296320851222,1,0.14334039968461412,0.14180700875668512,0.1579325671238237,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,0.08591983689037959,0.0766626418776228,6,0.03129739248898286,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.04706548833270093,0.08591983689037959,0.0185364042955055,0.03129739248898286,0.31615671302215714,1,0.06560189262820643,0.11721722937936245,0.1289389523172987,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,1,967514 MM WT,MoneyMaker,m_100,0.04706548833270093,0.04540473218992277,6,0.0185364042955055,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,0.06773863779934601,0.06630268542091197,6,0.027067957976250608,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.04706548833270093,0.06773863779934601,0.0185364042955055,0.027067957976250608,0.5445299172102709,1,0.06560189262820643,0.09480659577559662,0.1289389523172987,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_100,0.05131908294646892,0.0461272282234352,6,0.018831362066053875,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.04706548833270093,0.05131908294646892,0.0185364042955055,0.018831362066053875,0.8753189191573512,1,0.06560189262820643,0.0701504450125228,0.1289389523172987,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_100,0.05572396581540873,0.030742926407689164,6,0.012550747149795451,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.04818423880724013,0.05572396581540873,0.014057446095895364,0.012550747149795451,0.6976070209369395,1,0.062241684903135495,0.06827471296520418,0.0751021842617246,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.4,967514 MM WT,MoneyMaker,m_100,0.04818423880724013,0.034433570021623124,6,0.014057446095895364,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_100,0.03225175507542125,0.026270979859363785,6,0.010725082616395843,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.04818423880724013,0.03225175507542125,0.014057446095895364,0.010725082616395843,0.39017253204635216,1,0.062241684903135495,0.042976837691817094,0.0751021842617246,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_100,0.042778550346330345,0.05087167919919182,6,0.02076827606609612,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.04818423880724013,0.042778550346330345,0.014057446095895364,0.02076827606609612,0.8342583955951206,1,0.062241684903135495,0.06354682641242647,0.0751021842617246,0,24,0,11.712526315789471,spermidine,spermidine_174_144_11.85,11.71925466,11.72,0.039171941,11.89,11.49,0.4,FALSE,polyamine +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,0.0555823928959854,0.09509143884393452,6,0.03882091734578525,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.04069751288558945,0.0555823928959854,0.01776137435415608,0.03882091734578525,0.7376896862443436,1,0.05845888723974553,0.09440331024177065,0.17228610697127722,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.8,967514 MM WT,MoneyMaker,m_24,0.04069751288558945,0.03971564042971442,5,0.01776137435415608,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.08134027358997116,0.06627271380862637,6,0.027055722116772568,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.04069751288558945,0.08134027358997116,0.01776137435415608,0.027055722116772568,0.24335913871787615,1,0.05845888723974553,0.10839599570674373,0.17228610697127722,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_24,0.09907887424317438,0.12867421730045112,5,0.05754485936707763,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.04069751288558945,0.09907887424317438,0.01776137435415608,0.05754485936707763,0.37902355771871526,1,0.05845888723974553,0.156623733610252,0.17228610697127722,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,0.06730356440368894,0.0685280149693858,6,0.02797644496013377,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.053971229924288155,0.06730356440368894,0.02491981851305631,0.02797644496013377,0.7294385554064301,1,0.07889104843734446,0.095280009363822707,0.11359849024577054,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.6,967514 MM WT,MoneyMaker,m_24,0.053971229924288155,0.06104083983974977,6,0.02491981851305631,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.07674964453855526,0.06496465717025374,6,0.026521710230327032,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.053971229924288155,0.07674964453855526,0.02491981851305631,0.026521710230327032,0.5454450835175952,1,0.07889104843734446,0.1032713547688823,0.11359849024577054,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_24,0.06273145025151912,0.08491372359298581,6,0.034665882493757454,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.053971229924288155,0.06273145025151912,0.02491981851305631,0.034665882493757454,0.8419511315962296,1,0.07889104843734446,0.09739733274527657,0.11359849024577054,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,0.03881455544420328,0.02351921172066532,6,0.009601677978019267,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.08483350534651364,0.03881455544420328,0.023757020612005224,0.009601677978019267,0.12912722558582246,1,0.10859052595851887,0.048416233422222545,0.21478739366814567,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,1,967514 MM WT,MoneyMaker,m_24,0.08483350534651364,0.05312231303130734,5,0.023757020612005224,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.14784992422704235,0.11613359774300364,6,0.04741134274399918,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.08483350534651364,0.14784992422704235,0.023757020612005224,0.04741134274399918,0.27215575297397104,1,0.10859052595851887,0.19526126697104151,0.21478739366814567,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_24,0.09110221655264177,0.09224058875842776,6,0.03765706267200836,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.08483350534651364,0.09110221655264177,0.023757020612005224,0.03765706267200836,0.8914494006195435,1,0.10859052595851887,0.12875927922465014,0.21478739366814567,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,0.08605331976561725,0.07487505351222765,6,0.030567612594757203,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.15943872587362584,0.08605331976561725,0.07941348004757443,0.030567612594757203,0.4265618638964183,1,0.23885220592120027,0.11662093236037446,0.49404090427491765,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.4,967514 MM WT,MoneyMaker,m_24,0.15943872587362584,0.17757393971619964,5,0.07941348004757443,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.13036783272983601,0.18688160928908498,6,0.076294097511404535,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.15943872587362584,0.13036783272983601,0.07941348004757443,0.076294097511404535,0.7978729446157238,1,0.23885220592120027,0.20666193024124055,0.49404090427491765,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_24,0.3237902213222802,0.3070138354546128,6,0.12533787347309944,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.15943872587362584,0.3237902213222802,0.07941348004757443,0.12533787347309944,0.2995399414414878,1,0.23885220592120027,0.44912809479537963,0.49404090427491765,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,0.19785440600408047,0.19790551857267996,6,0.0807945896306609,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.116820757130997,0.19785440600408047,0.03719351776635958,0.0807945896306609,0.39243977023840126,1,0.15401427489735658,0.2786489956347414,0.8362703425341149,1,24,4.166666666666666,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.8,967514 MM WT,MoneyMaker,m_24,0.116820757130997,0.09110514026672169,6,0.03719351776635958,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.16034517445290963,0.13960485459135558,6,0.056993443227377094,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.116820757130997,0.16034517445290963,0.03719351776635958,0.056993443227377094,0.5391228246259117,1,0.15401427489735658,0.21733861768028673,0.8362703425341149,1,24,4.166666666666666,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_24,0.4666880330773734,0.7190666555619438,6,0.293557732862731,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.116820757130997,0.4666880330773734,0.03719351776635958,0.293557732862731,0.2886589690661993,1,0.15401427489735658,0.7602457659401044,0.8362703425341149,1,24,4.166666666666666,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,0.18623616936351564,0.15506090463691752,6,0.06330334923580168,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.08850332461484323,0.18623616936351564,0.024586679508651524,0.06330334923580168,0.19664404620870168,1,0.11309000412349475,0.24953951859931733,0.3016618888314537,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.6,967514 MM WT,MoneyMaker,m_24,0.08850332461484323,0.06022481926553925,6,0.024586679508651524,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.20505523888582614,0.1694626615372556,6,0.06918284187004083,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.08850332461484323,0.20505523888582614,0.024586679508651524,0.06918284187004083,0.16159259388917316,1,0.11309000412349475,0.274238080755867,0.3016618888314537,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_24,0.1518916455876537,0.2965514533515023,6,0.12106662386532484,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.08850332461484323,0.1518916455876537,0.024586679508651524,0.12106662386532484,0.6281341480954667,1,0.11309000412349475,0.2729582694529785,0.3016618888314537,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,0.21921307342327181,0.16076617015085007,6,0.06563251412850707,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.16667015379648722,0.21921307342327181,0.08210000315624005,0.06563251412850707,0.6284849857074009,1,0.24877015695272728,0.2848455875517789,0.3133301463069568,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,1,967514 MM WT,MoneyMaker,m_24,0.16667015379648722,0.20110311561367655,6,0.08210000315624005,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.1283128648829557,0.05680674236464648,6,0.02319125545718803,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.16667015379648722,0.1283128648829557,0.08210000315624005,0.02319125545718803,0.6693243239663915,1,0.24877015695272728,0.15150412034014374,0.3133301463069568,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_24,0.08954653126450092,0.04304440052684573,6,0.017572802929126576,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.16667015379648722,0.08954653126450092,0.08210000315624005,0.017572802929126576,0.39709856276697153,1,0.24877015695272728,0.1071193341936275,0.3133301463069568,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_24,0.06518348334799413,0.05556842070020995,6,0.022685712754637453,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.19582880549979131,0.06518348334799413,0.07596352428929848,0.022685712754637453,0.15143253427015643,1,0.2717923297890898,0.08786919610263158,0.38022235152857403,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.4,967514 MM WT,MoneyMaker,m_24,0.19582880549979131,0.18607187357229743,6,0.07596352428929848,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_24,0.17617086833381937,0.10822866721840547,6,0.04418416837109637,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.19582880549979131,0.17617086833381937,0.07596352428929848,0.04418416837109637,0.8285780488779869,1,0.2717923297890898,0.22035503670491574,0.38022235152857403,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_24,0.24842956648546696,0.23815682513172415,6,0.09722711672232756,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.19582880549979131,0.24842956648546696,0.07596352428929848,0.09722711672232756,0.6794260300501473,1,0.2717923297890898,0.3456566832077945,0.38022235152857403,0,24,0,6.587272727272727,erythritol,erythritol_217_293_rt6.68,6.59196319,6.59,0.02486653,6.75,6.37,0.38,FALSE,polyol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.12830247201438705,0.09966482196554516,6,0.04068799318681908,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.09050120101976482,0.12830247201438705,0.05442892676515512,0.04068799318681908,0.5936716565749057,1,0.14493012778491993,0.16899046520120614,0.44984223454390243,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.8,967514 MM WT,MoneyMaker,m_62,0.09050120101976482,0.12170678018924459,5,0.05442892676515512,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.1609745676486151,0.1686580349536681,6,0.06885435444282946,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.09050120101976482,0.1609745676486151,0.05442892676515512,0.06885435444282946,0.44298924828011466,1,0.14493012778491993,0.22982892209144457,0.44984223454390243,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_62,0.2660860699562978,0.3194478375215626,5,0.14286141599270435,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.09050120101976482,0.2660860699562978,0.05442892676515512,0.14286141599270435,0.30140322406423875,1,0.14493012778491993,0.40894748594900215,0.44984223454390243,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.13330522163243166,0.14554356992175818,6,0.0594179136085655,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.1322942470910272,0.13330522163243166,0.03512314360126192,0.0594179136085655,0.9886675549638088,1,0.16741739069228911,0.19272313524099716,0.41494043593955504,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.6,967514 MM WT,MoneyMaker,m_62,0.1322942470910272,0.08603377998559168,6,0.03512314360126192,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.27349101643757695,0.25407959840182825,6,0.10372756168929126,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.1322942470910272,0.27349101643757695,0.03512314360126192,0.10372756168929126,0.24378553384811297,1,0.16741739069228911,0.3772185781268682,0.41494043593955504,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_62,0.10795188680964711,0.09958809910824272,6,0.040656671211485855,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.1322942470910272,0.10795188680964711,0.03512314360126192,0.040656671211485855,0.6603674956786276,1,0.16741739069228911,0.14860855802113296,0.41494043593955504,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.07818942096715535,0.08941437608574018,6,0.03650326617989635,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.18257434236662587,0.07818942096715535,0.059661956784794024,0.03650326617989635,0.18049762545976042,1,0.2422362991514199,0.11469268714705169,0.2664599290665619,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,1,967514 MM WT,MoneyMaker,m_62,0.18257434236662587,0.13340819104145424,5,0.059661956784794024,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.12686409876801283,0.1383653667440702,6,0.056487424432672115,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.18257434236662587,0.12686409876801283,0.059661956784794024,0.056487424432672115,0.5152467209234128,1,0.2422362991514199,0.18335152320068493,0.2664599290665619,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_62,0.110890585554506,0.10987340671143594,6,0.044855630457384464,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.18257434236662587,0.110890585554506,0.059661956784794024,0.044855630457384464,0.3656783236240981,1,0.2422362991514199,0.15574621601189045,0.2664599290665619,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.09700832479074568,0.12403684660048299,6,0.050637830579175605,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.038988188802436506,0.09700832479074568,0.01507855939666418,0.050637830579175605,0.3151464470016691,1,0.054066748199100685,0.1476461553699213,0.22257664389860735,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.4,967514 MM WT,MoneyMaker,m_62,0.038988188802436506,0.033716683813709326,5,0.01507855939666418,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.07538809980783216,0.06828691929614693,6,0.027878018063695765,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.038988188802436506,0.07538809980783216,0.01507855939666418,0.027878018063695765,0.2858788664550594,1,0.054066748199100685,0.10326611787152792,0.22257664389860735,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_62,0.13243869616426532,0.1712284142096385,6,0.06990370737992316,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.038988188802436506,0.13243869616426532,0.01507855939666418,0.06990370737992316,0.24360628776294913,1,0.054066748199100685,0.20234240354418848,0.22257664389860735,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.0739273942480813,0.048540257360348504,6,0.019816477086038224,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,0.021620002569258112,0.0739273942480813,0.008152200995041232,0.019816477086038224,0.046501798461763305,1,0.029772203564299344,0.09374387133411952,0.10311825846753148,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.8,967514 MM WT,MoneyMaker,m_62,0.021620002569258112,0.01996873271846031,6,0.008152200995041232,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.05742124156613319,0.048551714867489486,6,0.019821154593741504,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.021620002569258112,0.05742124156613319,0.008152200995041232,0.019821154593741504,0.14104731412164973,1,0.029772203564299344,0.07724239615987469,0.10311825846753148,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_62,0.053763805808942244,0.04848728552689753,6,0.019794851425589125,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.021620002569258112,0.053763805808942244,0.008152200995041232,0.019794851425589125,0.1791446727073108,1,0.029772203564299344,0.07355865723453137,0.10311825846753148,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.0747622364250562,0.055121497753293995,6,0.02250325722558994,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.0547810011639099,0.0747622364250562,0.019966462613433662,0.02250325722558994,0.5218038165300396,1,0.07474746377734356,0.09726549365064613,0.16361038773891032,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.6,967514 MM WT,MoneyMaker,m_62,0.0547810011639099,0.04890764537126956,6,0.019966462613433662,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.10397804397430684,0.1096359083368584,6,0.04475867215197524,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.0547810011639099,0.10397804397430684,0.019966462613433662,0.04475867215197524,0.3492978710990676,1,0.07474746377734356,0.1487367161262821,0.16361038773891032,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_62,0.07648060483063723,0.04913665660729748,6,0.020059956059039076,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.0547810011639099,0.07648060483063723,0.019966462613433662,0.020059956059039076,0.4609835083358763,1,0.07474746377734356,0.0965405608896763,0.16361038773891032,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.06261727151092789,0.04705735407332351,6,0.019211084354187027,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.0336647677649089,0.06261727151092789,0.008680452659386818,0.019211084354187027,0.21223841788157533,1,0.04234522042429571,0.08182835586511492,0.10004536011095416,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,1,967514 MM WT,MoneyMaker,m_62,0.0336647677649089,0.02126267975188297,6,0.008680452659386818,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.07106018001515742,0.048720711936938,6,0.019890147358437263,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.0336647677649089,0.07106018001515742,0.008680452659386818,0.019890147358437263,0.12954086011574487,1,0.04234522042429571,0.09095032737359468,0.10004536011095416,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_62,0.036521633011213396,0.03720636496990226,6,0.015189434893337158,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.0336647677649089,0.036521633011213396,0.008680452659386818,0.015189434893337158,0.8743582933833415,1,0.04234522042429571,0.05171106790455055,0.10004536011095416,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_62,0.04042708575746697,0.039681657932041745,6,0.016199969013527833,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,0.11103868259688143,0.04042708575746697,0.022728313020769466,0.016199969013527833,0.03214006835103662,0.7713616404248789,0.1337669956176509,0.056627054770994806,0.147143695179416,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.4,967514 MM WT,MoneyMaker,m_62,0.11103868259688143,0.05567276961514015,6,0.022728313020769466,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_62,0.08229312019019093,0.06469444504187952,6,0.026411396590855653,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.11103868259688143,0.08229312019019093,0.022728313020769466,0.026411396590855653,0.4290474059887297,1,0.1337669956176509,0.10870451678104659,0.147143695179416,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_62,0.04597666640929695,0.0443292241550474,6,0.018097329978887484,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.11103868259688143,0.04597666640929695,0.022728313020769466,0.018097329978887484,0.050332612193836626,1,0.1337669956176509,0.06407399638818444,0.147143695179416,0,24,0,10.59623430962343,myo-inositol,inositol_myo_305_265_rt10.71,10.60006098,10.6,0.023062916,10.69,10.36,0.33,FALSE,polyol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,0.06273771035038611,0.07034181499792377,6,0.028716925721027704,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.09494789642131045,0.06273771035038611,0.04544390927205522,0.028716925721027704,0.5680708306613552,1,0.14039180569336568,0.09145463607141381,0.2626549812050197,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.8,967514 MM WT,MoneyMaker,m_61,0.09494789642131045,0.10161567029564847,5,0.04544390927205522,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,0.14849372392029347,0.14149731147236908,6,0.05776603551382743,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.09494789642131045,0.14849372392029347,0.04544390927205522,0.05776603551382743,0.4850972122564442,1,0.14039180569336568,0.2062597594341209,0.2626549812050197,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_61,0.16065607033618806,0.17468428082425383,5,0.07812118530473891,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.09494789642131045,0.16065607033618806,0.04544390927205522,0.07812118530473891,0.4928158033763451,1,0.14039180569336568,0.23877725564092697,0.2626549812050197,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,0.07545837964828395,0.07560236321082907,6,0.03086453553584902,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.16633731378862826,0.07545837964828395,0.0928833017267976,0.03086453553584902,0.38846281992032206,1,0.25922061551542586,0.10632291518413296,0.28514267706696844,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.6,967514 MM WT,MoneyMaker,m_61,0.16633731378862826,0.22751669485562576,6,0.0928833017267976,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,0.06187009651409906,0.07436165622529203,6,0.030358019030036952,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.16633731378862826,0.06187009651409906,0.0928833017267976,0.030358019030036952,0.3257890464064249,1,0.25922061551542586,0.09222811554413601,0.28514267706696844,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_61,0.06967100439203437,0.02295061450442708,6,0.009369549136527495,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.16633731378862826,0.06967100439203437,0.0928833017267976,0.009369549136527495,0.3470125673715869,1,0.25922061551542586,0.07904055352856187,0.28514267706696844,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,0.12192449799138012,0.1611600604406864,6,0.06579331916596307,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.05328263921033751,0.12192449799138012,0.03149482853743019,0.06579331916596307,0.37764131502441467,1,0.0847774677477677,0.1877178171573432,0.2462703599381609,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,1,967514 MM WT,MoneyMaker,m_61,0.05328263921033751,0.0704245775493942,5,0.03149482853743019,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,0.1138751943691008,0.066484364990023,6,0.027142128349752395,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.05328263921033751,0.1138751943691008,0.03149482853743019,0.027142128349752395,0.1812398445142682,1,0.0847774677477677,0.1410173227188532,0.2462703599381609,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_61,0.16337449417441238,0.1482128710328835,6,0.060507651223915694,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.05328263921033751,0.16337449417441238,0.03149482853743019,0.060507651223915694,0.1482740120062455,1,0.0847774677477677,0.22388214539832807,0.2462703599381609,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,0.04581434821103447,0.06161181378855322,6,0.025152917651554717,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.12855907749570158,0.04581434821103447,0.0557072810790004,0.025152917651554717,0.22779965644578554,1,0.18426635857470197,0.0709672658625892,0.20269299443217217,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.4,967514 MM WT,MoneyMaker,m_61,0.12855907749570158,0.12456526733433274,5,0.0557072810790004,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,0.09726091776405162,0.09958404962134614,6,0.04065501801538307,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.12855907749570158,0.09726091776405162,0.0557072810790004,0.04065501801538307,0.6625366912768934,1,0.18426635857470197,0.13791593577943467,0.20269299443217217,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_61,0.14734001310531172,0.08383737141151455,6,0.03422646355573476,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.12855907749570158,0.14734001310531172,0.0557072810790004,0.03422646355573476,0.7824595095207496,1,0.18426635857470197,0.18156647666104647,0.20269299443217217,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,0.059619765489401365,0.06569210286192909,6,0.026818688690358795,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.13719529000194175,0.059619765489401365,0.041559341017030786,0.026818688690358795,0.15300411119114007,1,0.17875463101897254,0.08643845417976016,0.20455133621864316,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.8,967514 MM WT,MoneyMaker,m_61,0.13719529000194175,0.10179917953804511,6,0.041559341017030786,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,0.13986136203529828,0.11290775550117918,6,0.04609439816346823,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.13719529000194175,0.13986136203529828,0.041559341017030786,0.04609439816346823,0.9665901582843899,1,0.17875463101897254,0.1859557601987665,0.20455133621864316,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_61,0.10025181984861176,0.10284054825724609,6,0.041984478016387126,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.13719529000194175,0.10025181984861176,0.041559341017030786,0.041984478016387126,0.5457395189477028,1,0.17875463101897254,0.1422362978649989,0.20455133621864316,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,0.06452870838830942,0.04802264815929833,6,0.019605164014581122,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.13091124768012277,0.06452870838830942,0.02769037522795701,0.019605164014581122,0.08207476475794848,1,0.15860162290807978,0.08413387240289054,0.17446178519888778,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.6,967514 MM WT,MoneyMaker,m_61,0.13091124768012277,0.0678272900946981,6,0.02769037522795701,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,0.04609351624900045,0.025211967583953752,6,0.01029274266537945,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,0.13091124768012277,0.04609351624900045,0.02769037522795701,0.01029274266537945,0.026620260392877435,0.6388862494290585,0.15860162290807978,0.0563862589143799,0.17446178519888778,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_61,0.05224460721242238,0.04864651215055669,6,0.01985985542249431,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,0.13091124768012277,0.05224460721242238,0.02769037522795701,0.01985985542249431,0.04614026492464717,1,0.15860162290807978,0.07210446263491668,0.17446178519888778,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,0.07954413216496103,0.06407773579093214,6,0.026159626093443137,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.11158789135766822,0.07954413216496103,0.03686554982808248,0.026159626093443137,0.4963220566740727,1,0.1484534411857507,0.10570375825840417,0.1632987853043258,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,1,967514 MM WT,MoneyMaker,m_61,0.11158789135766822,0.09030178616595018,6,0.03686554982808248,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,0.10865102648146648,0.05293538318868858,6,0.02161077969183163,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.11158789135766822,0.10865102648146648,0.03686554982808248,0.02161077969183163,0.9468792869865643,1,0.1484534411857507,0.1302618061732981,0.1632987853043258,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_61,0.08914561836085351,0.06947866200306536,6,0.028364544986467993,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.11158789135766822,0.08914561836085351,0.03686554982808248,0.028364544986467993,0.6405231951712012,1,0.1484534411857507,0.1175101633473215,0.1632987853043258,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_61,0.08904858005390559,0.10818583037880869,6,0.04416668030456211,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.07166103611180559,0.08904858005390559,0.02544919769392097,0.04416668030456211,0.7418201083356954,1,0.09711023380572656,0.1332152603584677,0.19741067973520876,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.4,967514 MM WT,MoneyMaker,m_61,0.07166103611180559,0.06233754871332072,6,0.02544919769392097,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_61,0.12185771188117316,0.14110663478371932,6,0.057606542423562085,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.07166103611180559,0.12185771188117316,0.02544919769392097,0.057606542423562085,0.4520427590775764,1,0.09711023380572656,0.17946425430473523,0.19741067973520876,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_61,0.08452488703879002,0.04093641907978225,6,0.01671222310703337,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.07166103611180559,0.08452488703879002,0.02544919769392097,0.01671222310703337,0.6829746322032848,1,0.09711023380572656,0.10123711014582339,0.19741067973520876,0,24,0,12.793263157894735,myo-inositol_1-phosphate,inositol-1-phosphate-myo_299_318_rt12.92,12.79944099,12.8,0.004220256,12.82,12.77,0.05,FALSE,polyol +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.1318379761659072,0.16136097118082815,6,0.06587534063216177,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.12442058101485345,0.1318379761659072,0.05340290973137087,0.06587534063216177,0.9322330610905099,1,0.17782349074622433,0.19771331679806897,0.21748464847787588,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.8,967514 MM WT,MoneyMaker,m_111,0.12442058101485345,0.1194125363556303,5,0.05340290973137087,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.11868488703943185,0.10698204651054845,6,0.04367523759825689,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.12442058101485345,0.11868488703943185,0.05340290973137087,0.04367523759825689,0.9357330911391399,1,0.17782349074622433,0.16236012463768873,0.21748464847787588,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_111,0.11677600826531317,0.11096040010515722,5,0.04962299948914127,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.12442058101485345,0.11677600826531317,0.05340290973137087,0.04962299948914127,0.9190782021365077,1,0.17782349074622433,0.16639900775445443,0.21748464847787588,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.19534959630818516,0.18714318827417784,6,0.07640088668488997,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.11520738576908025,0.19534959630818516,0.05324507977454878,0.07640088668488997,0.41197114165714876,1,0.16845246554362903,0.27175048299307514,0.44557100126820526,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.6,967514 MM WT,MoneyMaker,m_111,0.11520738576908025,0.13042327676142929,6,0.05324507977454878,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.24492049984982103,0.26486180000549364,6,0.10812937706142438,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.11520738576908025,0.24492049984982103,0.05324507977454878,0.10812937706142438,0.31615570923373665,1,0.16845246554362903,0.3530498769112454,0.44557100126820526,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_111,0.33378191568448695,0.17460607328441966,6,0.07128263092297231,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,0.11520738576908025,0.33378191568448695,0.05324507977454878,0.07128263092297231,0.035669696152289924,0.8204030115026683,0.16845246554362903,0.4050645466074593,0.44557100126820526,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.09803400772488365,0.1281384683729742,6,0.0523123106559245,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.06325153025398782,0.09803400772488365,0.03307332133563065,0.0523123106559245,0.5892057720173525,1,0.09632485158961847,0.15034631838080814,0.18686148394501667,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,1,967514 MM WT,MoneyMaker,m_111,0.06325153025398782,0.07395419474816428,5,0.03307332133563065,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.10711052095977484,0.1537386850599251,6,0.06276355535387666,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.06325153025398782,0.10711052095977484,0.03307332133563065,0.06276355535387666,0.5548682898765276,1,0.09632485158961847,0.1698740763136515,0.18686148394501667,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_111,0.05758245615577051,0.0616518716562383,6,0.025169271207556777,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.06325153025398782,0.05758245615577051,0.03307332133563065,0.025169271207556777,0.8949297131701772,1,0.09632485158961847,0.08275172736332728,0.18686148394501667,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.11346673836649634,0.08080930883104388,6,0.03299026218384002,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.2551198285217036,0.11346673836649634,0.18403945881816675,0.03299026218384002,0.4884577813223989,1,0.43915928733987036,0.14645700055033636,0.48307521607385745,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.4,967514 MM WT,MoneyMaker,m_111,0.2551198285217036,0.41152474045969395,5,0.18403945881816675,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.1896980344611797,0.3069649834838896,6,0.1253179297395659,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.2551198285217036,0.1896980344611797,0.18403945881816675,0.1253179297395659,0.7770569526389888,1,0.43915928733987036,0.3150159642007456,0.48307521607385745,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_111,0.28089048330448413,0.18767915356411613,6,0.07661969359825524,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.2551198285217036,0.28089048330448413,0.18403945881816675,0.07661969359825524,0.9018396850769506,1,0.43915928733987036,0.35751017690273934,0.48307521607385745,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.04734982307482779,0.08634804534526108,6,0.035251441897098966,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.0503412407335276,0.04734982307482779,0.013396684856634321,0.035251441897098966,0.9391918718775623,1,0.06373792559016192,0.08260126497192675,0.14740236835504827,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.8,967514 MM WT,MoneyMaker,m_111,0.0503412407335276,0.0328150421436245,6,0.013396684856634321,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.0956939495188703,0.09383555161406,6,0.03830820353117358,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.0503412407335276,0.0956939495188703,0.013396684856634321,0.03830820353117358,0.3051621019446136,1,0.06373792559016192,0.13400215305004387,0.14740236835504827,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_111,0.10691208120130218,0.03821168165898624,6,0.015599853713030482,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,*,0.0503412407335276,0.10691208120130218,0.013396684856634321,0.015599853713030482,0.020843608486697664,0.5002466036807439,0.06373792559016192,0.12251193491433265,0.14740236835504827,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.05133186533798432,0.05142920157444188,6,0.02099588362268731,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.09179724586156442,0.05133186533798432,0.03723499913271374,0.02099588362268731,0.37191891797038457,1,0.12903224499427815,0.07232774896067162,0.14193546949370597,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.6,967514 MM WT,MoneyMaker,m_111,0.09179724586156442,0.09120674844812283,6,0.03723499913271374,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.08981456635382612,0.0913170548049469,6,0.037280031514314464,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.09179724586156442,0.08981456635382612,0.03723499913271374,0.037280031514314464,0.9707240229389367,1,0.12903224499427815,0.1270945978681406,0.14193546949370597,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_111,0.05839145927098214,0.06598178293833369,6,0.026936950086332415,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.09179724586156442,0.05839145927098214,0.03723499913271374,0.026936950086332415,0.4855534159701759,1,0.12903224499427815,0.08532840935731456,0.14193546949370597,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.05277830039680905,0.08225703146004786,6,0.03358129247219674,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.11785827882770923,0.05277830039680905,0.032777659885487295,0.03358129247219674,0.1956374742216002,1,0.15063593871319653,0.0863595928690058,0.1656995325845162,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,1,967514 MM WT,MoneyMaker,m_111,0.11785827882770923,0.08028854168193676,6,0.032777659885487295,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.10105058640502455,0.09038776122854399,6,0.036900649000408924,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.11785827882770923,0.10105058640502455,0.032777659885487295,0.036900649000408924,0.7405928812505216,1,0.15063593871319653,0.13795123540543347,0.1656995325845162,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_111,0.08642908011469445,0.10506603594799713,6,0.04289302956158461,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.11785827882770923,0.08642908011469445,0.032777659885487295,0.04289302956158461,0.5741919990900385,1,0.15063593871319653,0.12932210967627905,0.1656995325845162,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_111,0.07999939554321826,0.09908422094532966,6,0.040450963812874524,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.04575301774260717,0.07999939554321826,0.017167342187788703,0.040450963812874524,0.46224682217972046,1,0.06292035993039588,0.12045035935609279,0.14438049807408423,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.4,967514 MM WT,MoneyMaker,m_111,0.04575301774260717,0.04205122859983735,6,0.017167342187788703,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_111,0.10006412715527284,0.07640171881296723,6,0.031190871093894637,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.04575301774260717,0.10006412715527284,0.017167342187788703,0.031190871093894637,0.16673928296127274,1,0.06292035993039588,0.13125499824916748,0.14438049807408423,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_111,0.04692648202675439,0.04245449326809149,6,0.017331974299207933,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.04575301774260717,0.04692648202675439,0.017167342187788703,0.017331974299207933,0.9625816314040669,1,0.06292035993039588,0.06425845632596232,0.14438049807408423,0,24,0,10.336673640167364,tyramine,tyramine_174_338_rt10.45,10.35585366,10.36,0.023780758,10.41,10.08,0.33,FALSE,primary_amino_compound +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.21902295444880485,0.2978538735915436,6,0.12159833470178723,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.08528235556982051,0.21902295444880485,0.053193952845316646,0.12159833470178723,0.34818921357074323,1,0.13847630841513717,0.3406212891505921,0.3746834180656513,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.8,967514 MM WT,MoneyMaker,m_1,0.08528235556982051,0.11894529455404639,5,0.053193952845316646,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.10901408068763563,0.15592177011834002,6,0.06365479609691176,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.08528235556982051,0.10901408068763563,0.053193952845316646,0.06365479609691176,0.7813213753966849,1,0.13847630841513717,0.1726688767845474,0.3746834180656513,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_1,0.08646277766852366,0.11682864343144804,5,0.05224735768636042,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.08528235556982051,0.08646277766852366,0.053193952845316646,0.05224735768636042,0.9877565911894329,1,0.13847630841513717,0.13871013535488408,0.3746834180656513,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.32075429851888193,0.1456625062674766,6,0.059466469168379055,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,*,0.13386795123818096,0.32075429851888193,0.026986282472377887,0.059466469168379055,0.024365349830255317,0.5847683959261276,0.16085423371055885,0.380220767687261,0.41824284445598714,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.6,967514 MM WT,MoneyMaker,m_1,0.13386795123818096,0.0661026221119391,6,0.026986282472377887,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.09617426791405947,0.07963898721810782,6,0.03251248038606596,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.13386795123818096,0.09617426791405947,0.026986282472377887,0.03251248038606596,0.3939955591080908,1,0.16085423371055885,0.12868674830012544,0.41824284445598714,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_1,0.04900399835753655,0.053655166275257155,6,0.021904629906428053,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,*,0.13386795123818096,0.04900399835753655,0.026986282472377887,0.021904629906428053,0.03570459135997437,0.8212056012794106,0.16085423371055885,0.0709086282639646,0.41824284445598714,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.3827352214369719,0.5143063965044616,6,0.20996470714757617,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.07729543085669661,0.3827352214369719,0.034105650060358185,0.20996470714757617,0.20769837243222783,1,0.1114010809170548,0.5926999285845481,0.651969921443003,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,1,967514 MM WT,MoneyMaker,m_1,0.07729543085669661,0.07626255195178071,5,0.034105650060358185,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.13435649578794662,0.08673583347710774,6,0.03540975573898754,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.07729543085669661,0.13435649578794662,0.034105650060358185,0.03540975573898754,0.2758066601852978,1,0.1114010809170548,0.16976625152693414,0.651969921443003,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_1,0.19356467307422268,0.12141644928843658,6,0.04956805785619656,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.07729543085669661,0.19356467307422268,0.034105650060358185,0.04956805785619656,0.08732952747968145,1,0.1114010809170548,0.24313273093041923,0.651969921443003,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.4305063121201095,0.5302643931799368,6,0.2164795320095669,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.2290544112253427,0.4305063121201095,0.11085477640733198,0.2164795320095669,0.4336215569795707,1,0.3399091876326747,0.6469858441296764,0.7116844285426441,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.4,967514 MM WT,MoneyMaker,m_1,0.2290544112253427,0.24787881567733422,5,0.11085477640733198,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.0981336404471193,0.16609705440726427,6,0.06780883851284888,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.2290544112253427,0.0981336404471193,0.11085477640733198,0.06780883851284888,0.34823879783127787,1,0.3399091876326747,0.16594247895996816,0.7116844285426441,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_1,0.25051815688388296,0.18142839001968494,6,0.07406783006714737,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.2290544112253427,0.25051815688388296,0.11085477640733198,0.07406783006714737,0.876513901626161,1,0.3399091876326747,0.32458598695103036,0.7116844285426441,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.5918048106122107,0.8016342417014504,6,0.3272658087519123,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.6177248288403355,0.5918048106122107,0.27770052025139447,0.3272658087519123,0.9530657637368163,1,0.89542534909173,0.9190706193641229,1.0109776813005353,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.8,967514 MM WT,MoneyMaker,m_1,0.6177248288403355,0.6802245759213429,6,0.27770052025139447,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.6017347671602691,0.47381404915476577,6,0.1934337755651939,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.6177248288403355,0.6017347671602691,0.27770052025139447,0.1934337755651939,0.9633557257360896,1,0.89542534909173,0.795168542725463,1.0109776813005353,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_1,0.3786066095674548,0.46010920928801446,6,0.18783879811851167,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.6177248288403355,0.3786066095674548,0.27770052025139447,0.18783879811851167,0.49421783376391737,1,0.89542534909173,0.5664454076859664,1.0109776813005353,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.5474945380105819,0.3082963424304122,6,0.12586145475347751,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.6091234888948323,0.5474945380105819,0.26959532635741457,0.12586145475347751,0.8417341799020336,1,0.8787188152522468,0.6733559927640594,0.9665906967774716,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.6,967514 MM WT,MoneyMaker,m_1,0.6091234888948323,0.6603709866147703,6,0.26959532635741457,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.29769520877828065,0.2738826266396671,6,0.11181211411339657,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.6091234888948323,0.29769520877828065,0.26959532635741457,0.11181211411339657,0.32304221304517255,1,0.8787188152522468,0.40950732289167724,0.9665906967774716,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_1,0.6647948735830382,0.46116539377896376,6,0.1882699836313562,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.6091234888948323,0.6647948735830382,0.26959532635741457,0.1882699836313562,0.8693273080717017,1,0.8787188152522468,0.8530648572143944,0.9665906967774716,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.49838199692136775,0.5733659825203709,6,0.2340756821740746,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.33350241418019294,0.49838199692136775,0.1751899090523738,0.2340756821740746,0.5861914989267023,1,0.5086923232325667,0.7324576790954423,1.0558079386727115,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,1,967514 MM WT,MoneyMaker,m_1,0.33350241418019294,0.42912588526290746,6,0.1751899090523738,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.7414899616439693,0.5348104137835482,6,0.2183354371494048,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.33350241418019294,0.7414899616439693,0.1751899090523738,0.2183354371494048,0.1770697813642229,1,0.5086923232325667,0.959825398793374,1.0558079386727115,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_1,0.4250509172000538,0.4574568065708625,6,0.18675595924361268,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.33350241418019294,0.4250509172000538,0.1751899090523738,0.18675595924361268,0.7281623828164144,1,0.5086923232325667,0.6118068764436665,1.0558079386727115,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_1,0.5559327081575206,0.5370376221413607,6,0.21924469115398856,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.9634217844929773,0.5559327081575206,0.42663630392733626,0.21924469115398856,0.42198907161636867,1,1.3900580884203135,0.7751773993115092,1.529063897262345,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.4,967514 MM WT,MoneyMaker,m_1,0.9634217844929773,1.0450412503689366,6,0.42663630392733626,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_1,0.5935809065531372,0.38620121544666974,6,0.157665985981169,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.9634217844929773,0.5935809065531372,0.42663630392733626,0.157665985981169,0.4455968078777234,1,1.3900580884203135,0.7512468925343062,1.529063897262345,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_1,0.3478518927597188,0.5411411830041646,6,0.22091996286104265,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.9634217844929773,0.3478518927597188,0.42663630392733626,0.22091996286104265,0.23828704167171916,1,1.3900580884203135,0.5687718556207615,1.529063897262345,0,24,0,10.96712788259958,adenine,adenine_264_279_rt11.12,10.9697546,10.97,0.019593112,11.14,10.94,0.2,FALSE,purines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.42357646201689136,0.5120540572411013,6,0.20904519349376469,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.1607841388702667,0.42357646201689136,0.08591667594363253,0.20904519349376469,0.2852685359483802,1,0.24670081481389924,0.6326216555106561,1.1496198249186835,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.8,967514 MM WT,MoneyMaker,m_2,0.1607841388702667,0.19211552781078323,5,0.08591667594363253,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.77349807285934,0.665308012867135,6,0.2716108588849177,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.1607841388702667,0.77349807285934,0.08591667594363253,0.2716108588849177,0.07520613154757716,1,0.24670081481389924,1.0451089317442577,1.1496198249186835,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_2,0.3586399037773872,0.39103715945768636,5,0.17487713405516228,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.1607841388702667,0.3586399037773872,0.08591667594363253,0.17487713405516228,0.3501935100610495,1,0.24670081481389924,0.5335170378325494,1.1496198249186835,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.5965508103808851,0.47048593605408007,6,0.1920750790813686,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.5194900431331457,0.5965508103808851,0.1849187485163972,0.1920750790813686,0.7784734312086494,1,0.704408791649543,0.7886258894622536,2.4668388755578685,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.6,967514 MM WT,MoneyMaker,m_2,0.5194900431331457,0.45295657773921694,6,0.1849187485163972,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.902808152405915,0.5858989785121097,6,0.23919225636209243,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.5194900431331457,0.902808152405915,0.1849187485163972,0.23919225636209243,0.23534322164739127,1,0.704408791649543,1.1420004087680076,2.4668388755578685,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_2,1.491702530964676,1.839268608189035,6,0.7508782649970223,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.5194900431331457,1.491702530964676,0.1849187485163972,0.7508782649970223,0.2585305938156722,1,0.704408791649543,2.2425807959616986,2.4668388755578685,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,1.1378590041399408,1.0172323525345792,6,0.41528336892677564,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.29348781478381475,1.1378590041399408,0.20468670438960954,0.41528336892677564,0.10981460272625655,1,0.49817451917342426,1.5531423730667164,1.7084566103733883,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,1,967514 MM WT,MoneyMaker,m_2,0.29348781478381475,0.45769338510557156,5,0.20468670438960954,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.5052342107252712,0.3593455208265728,6,0.14670219456329484,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.29348781478381475,0.5052342107252712,0.20468670438960954,0.14670219456329484,0.4262098710151917,1,0.49817451917342426,0.651936405288566,1.7084566103733883,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_2,0.5059116158352889,0.460128362496594,6,0.18784661738317118,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.29348781478381475,0.5059116158352889,0.20468670438960954,0.18784661738317118,0.46482393023791835,1,0.49817451917342426,0.6937582332184601,1.7084566103733883,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.43956107898694247,0.4943052552397372,6,0.2017992754189262,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.7810640846901244,0.43956107898694247,0.35227189265155645,0.2017992754189262,0.4301147182800219,1,1.133335977341681,0.6413603544058687,1.535922370016726,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.4,967514 MM WT,MoneyMaker,m_2,0.7810640846901244,0.7877038985313889,5,0.35227189265155645,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.7129759062426002,0.5233461687827088,6,0.2136551787263532,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.7810640846901244,0.7129759062426002,0.35227189265155645,0.2136551787263532,0.8735753017099741,1,1.133335977341681,0.9266310849689534,1.535922370016726,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_2,1.060065349085094,0.8235863380700105,6,0.33622771456647493,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.7810640846901244,1.060065349085094,0.35227189265155645,0.33622771456647493,0.5810689877663504,1,1.133335977341681,1.396293063651569,1.535922370016726,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.06500309369687234,0.06195957221068877,6,0.025294889432885968,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,0.41645666129574455,0.06500309369687234,0.04517981734312816,0.025294889432885968,1.5196953327611213e-4,0.003495299265350579,0.4616364786388727,0.0902979831297583,0.50780012650276,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.8,967514 MM WT,MoneyMaker,m_2,0.41645666129574455,0.11066749916280996,6,0.04517981734312816,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.05449169556654162,0.07163170529095174,6,0.029243521228042302,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,*,0.41645666129574455,0.05449169556654162,0.04517981734312816,0.029243521228042302,1.0855001650402321e-4,0.0026052003960965573,0.4616364786388727,0.08373521679458393,0.50780012650276,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_2,0.22295571380281368,0.2504331162053862,6,0.10223889156638688,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.41645666129574455,0.22295571380281368,0.04517981734312816,0.10223889156638688,0.12777849436182828,1,0.4616364786388727,0.32519460536920053,0.50780012650276,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.06552943020070738,0.036799392597889446,6,0.015023289118196902,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,*,0.58856914340598665,0.06552943020070738,0.15048770510266637,0.015023289118196902,0.017508416520412743,0.31520420285856576,0.739056848508653,0.08055271931890429,0.8129625333595184,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.6,967514 MM WT,MoneyMaker,m_2,0.58856914340598665,0.368618090063961,6,0.15048770510266637,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.06359722546995439,0.07834017116654245,6,0.03198224095338737,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,*,0.58856914340598665,0.06359722546995439,0.15048770510266637,0.03198224095338737,0.016589694887292936,0.31520420285856576,0.739056848508653,0.09557946642334175,0.8129625333595184,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_2,0.07190916875988355,0.10109641161192608,6,0.041272437212599856,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,*,0.58856914340598665,0.07190916875988355,0.15048770510266637,0.041272437212599856,0.017244129038066904,0.31520420285856576,0.739056848508653,0.11318160597248342,0.8129625333595184,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.11903631230584133,0.12496527083599807,6,0.05101685818614985,leaf_1_panK4-1,1,967514 MM WT,leaf,*,0.36980553585962045,0.11903631230584133,0.05839222828981127,0.05101685818614985,0.009163601069004169,0.19243562244908755,0.4281977641494317,0.17005317049199117,0.47101754056437495,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,1,967514 MM WT,MoneyMaker,m_2,0.36980553585962045,0.14303116425414641,6,0.05839222828981127,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.10821694925606044,0.10005772134205021,6,0.040848393685601586,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.36980553585962045,0.10821694925606044,0.05839222828981127,0.040848393685601586,0.00519917687646674,0.11438189128226828,0.4281977641494317,0.14906534294166202,0.47101754056437495,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_2,0.14077638465609552,0.08653338299328264,6,0.03532710567506236,leaf_1_log2-1,1,967514 MM WT,leaf,*,0.36980553585962045,0.14077638465609552,0.05839222828981127,0.03532710567506236,0.009595767652804173,0.19243562244908755,0.4281977641494317,0.17610349033115788,0.47101754056437495,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_2,0.13132735194815334,0.08242863295705619,6,0.03365134848999143,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.2404523329747442,0.13132735194815334,0.08558842821443975,0.03365134848999143,0.27688678821814716,1,0.32604076118918396,0.16497870043814478,0.35864483730810237,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.4,967514 MM WT,MoneyMaker,m_2,0.2404523329747442,0.2096479770122045,6,0.08558842821443975,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_2,0.1658686167355378,0.1931061344773342,6,0.07883524927845653,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.2404523329747442,0.1658686167355378,0.08558842821443975,0.07883524927845653,0.5360576178730417,1,0.32604076118918396,0.24470386601399433,0.35864483730810237,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_2,0.0593115229865356,0.055824092999863725,6,0.02279009053389007,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.2404523329747442,0.0593115229865356,0.08558842821443975,0.02279009053389007,0.08925260861747,1,0.32604076118918396,0.08210161352042566,0.35864483730810237,0,24,0,17.09682105263158,adenosine-5-monophosphate,adenosine-5-monophosphate_169_315_rt17.,17.09919255,17.09,0.029474038,17.14,16.96,0.18,FALSE,purines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.05377356051249205,0.07263562047004155,6,0.029653367883676437,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.08662806906697532,0.05377356051249205,0.0399670742665705,0.029653367883676437,0.528294536023769,1,0.12659514333354582,0.08342692839616848,0.13925465766690043,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.8,967514 MM WT,MoneyMaker,m_87,0.08662806906697532,0.08936909492183419,5,0.0399670742665705,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.05100197224280678,0.02786813527649928,6,0.011377118585046506,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.08662806906697532,0.05100197224280678,0.0399670742665705,0.011377118585046506,0.4332152059654589,1,0.12659514333354582,0.062379090827853284,0.13925465766690043,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_87,0.0482173752606168,0.03653308813219763,5,0.016338093698316944,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.08662806906697532,0.0482173752606168,0.0399670742665705,0.016338093698316944,0.4122315054993114,1,0.12659514333354582,0.06455546895893374,0.13925465766690043,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.09575234042705039,0.07376289146279974,6,0.03011357433935947,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.05894356195597431,0.09575234042705039,0.01822745245739623,0.03011357433935947,0.32544068243106233,1,0.07717101441337054,0.12586591476640985,0.13845250624305083,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.6,967514 MM WT,MoneyMaker,m_87,0.05894356195597431,0.0446479578314601,6,0.01822745245739623,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.055244508132264857,0.04980938011253439,6,0.020334594280006904,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.05894356195597431,0.055244508132264857,0.01822745245739623,0.020334594280006904,0.8949706233621606,1,0.07717101441337054,0.07557910241227175,0.13845250624305083,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_87,0.045393599297465746,0.03511026399263412,6,0.014333705252727808,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.05894356195597431,0.045393599297465746,0.01822745245739623,0.014333705252727808,0.5726388343011612,1,0.07717101441337054,0.05972730455019355,0.13845250624305083,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.19072536399278342,0.33557636097177546,6,0.13699847568681153,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.07931388080016291,0.19072536399278342,0.027494103849534192,0.13699847568681153,0.45886921612204373,1,0.1068079846496971,0.32772383967959495,0.36049622364755446,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,1,967514 MM WT,MoneyMaker,m_87,0.07931388080016291,0.06147868518799711,5,0.027494103849534192,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.08475094676979437,0.08283495757177292,6,0.033817229819322926,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.07931388080016291,0.08475094676979437,0.027494103849534192,0.033817229819322926,0.9034868146936337,1,0.1068079846496971,0.11856817658911731,0.36049622364755446,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_87,0.048452676115486724,0.03261881997188363,6,0.013316577490470004,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.07931388080016291,0.048452676115486724,0.027494103849534192,0.013316577490470004,0.3524035953372241,1,0.1068079846496971,0.061769253605956725,0.36049622364755446,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.07960171831205669,0.08234382755681652,6,0.03361672683032148,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.1027861075458519,0.07960171831205669,0.032198304598947465,0.03361672683032148,0.6304372437911333,1,0.13498441214479937,0.11321844514237817,0.14848285335927933,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.4,967514 MM WT,MoneyMaker,m_87,0.1027861075458519,0.07199759784349063,5,0.032198304598947465,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.058568121702715414,0.05736489808726845,6,0.02341912157676107,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.1027861075458519,0.058568121702715414,0.032198304598947465,0.02341912157676107,0.30046239034339667,1,0.13498441214479937,0.08198724327947648,0.14848285335927933,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_87,0.08634685037338352,0.07493813747810943,6,0.03059336651598412,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.1027861075458519,0.08634685037338352,0.032198304598947465,0.03059336651598412,0.7200700560156457,1,0.13498441214479937,0.11694021688936765,0.14848285335927933,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.04894702115579186,0.013967534273685262,6,0.0057022219892274234,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.09295354006869087,0.04894702115579186,0.04472178476081878,0.0057022219892274234,0.37250547261117595,1,0.13767532482950964,0.05464924314501928,0.15144285731246063,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.8,967514 MM WT,MoneyMaker,m_87,0.09295354006869087,0.10954555305058263,6,0.04472178476081878,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.03182541514151035,0.017799788961024434,6,0.007266733413955766,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.09295354006869087,0.03182541514151035,0.04472178476081878,0.007266733413955766,0.23241612880219334,1,0.13767532482950964,0.03909214855546611,0.15144285731246063,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_87,0.08317455345242471,0.057572230104033235,6,0.02350376451816372,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.09295354006869087,0.08317455345242471,0.04472178476081878,0.02350376451816372,0.8516155891228137,1,0.13767532482950964,0.10667831797058842,0.15144285731246063,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.039706501634538593,0.03727737356632279,6,0.015218424031434077,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.046800154659205916,0.039706501634538593,0.010246899615309876,0.015218424031434077,0.7082418138953034,1,0.05704705427451579,0.05492492566597267,0.28224450772051823,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.6,967514 MM WT,MoneyMaker,m_87,0.046800154659205916,0.02509967550303043,6,0.010246899615309876,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.16239717562323763,0.2307143537069182,6,0.09418874048632438,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.046800154659205916,0.16239717562323763,0.010246899615309876,0.09418874048632438,0.2756455397378318,1,0.05704705427451579,0.256585916109562,0.28224450772051823,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_87,0.1434693996137799,0.18358787307031865,6,0.07494943533085427,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.046800154659205916,0.1434693996137799,0.010246899615309876,0.07494943533085427,0.2554860979986448,1,0.05704705427451579,0.21841883494463418,0.28224450772051823,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.08513830761621873,0.09300951512284336,6,0.03797097554577362,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.10487663831312781,0.08513830761621873,0.042676571212793085,0.03797097554577362,0.7369434200832901,1,0.14755320952592088,0.12310928316199235,0.18535655441583856,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,1,967514 MM WT,MoneyMaker,m_87,0.10487663831312781,0.10453582344289251,6,0.042676571212793085,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.13127517058473762,0.09119643326078099,6,0.03723078797511562,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.10487663831312781,0.13127517058473762,0.042676571212793085,0.03723078797511562,0.6512948043136179,1,0.14755320952592088,0.16850595855985323,0.18535655441583856,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_87,0.06038752559077768,0.06571544585544753,6,0.026828218427557008,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.10487663831312781,0.06038752559077768,0.042676571212793085,0.026828218427557008,0.40196911918710676,1,0.14755320952592088,0.08721574401833469,0.18535655441583856,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_87,0.0416870193878518,0.033196743143832655,6,0.013552513637437648,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.04793150781049812,0.0416870193878518,0.018931537126611657,0.013552513637437648,0.7945486775698906,1,0.06686304493710978,0.055239533025289445,0.10425637737887812,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.4,967514 MM WT,MoneyMaker,m_87,0.04793150781049812,0.04637260600675417,6,0.018931537126611657,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_87,0.0743809895095738,0.049963553692139534,6,0.0203975353803154,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.04793150781049812,0.0743809895095738,0.018931537126611657,0.0203975353803154,0.36442307070890645,1,0.06686304493710978,0.09477852488988919,0.10425637737887812,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_87,0.06522118867150557,0.02543415504450456,6,0.010383450316311825,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.04793150781049812,0.06522118867150557,0.018931537126611657,0.010383450316311825,0.44710605927660796,1,0.06686304493710978,0.0756046389878174,0.10425637737887812,0,24,0,3.206548117154812,2-hydroxypyridine,pyridine-2-hydroxy_152_167_rt3.31,3.239878049,3.24,0.026095337,3.44,3.23,0.21,FALSE,pyridines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.1422174329125312,0.10351049838516826,6,0.0422579840108074,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.09355289056299228,0.1422174329125312,0.03400761909471115,0.0422579840108074,0.393239738115837,1,0.12756050965770344,0.1844754169233386,0.20292295861567247,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.8,967514 MM WT,MoneyMaker,m_88,0.09355289056299228,0.076043348048694,5,0.03400761909471115,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.12301972559801506,0.08260113529909824,6,0.03372177227623111,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.09355289056299228,0.12301972559801506,0.03400761909471115,0.03372177227623111,0.5538276402318971,1,0.12756050965770344,0.15674149787424618,0.20292295861567247,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_88,0.05739771900786832,0.0731505310667792,5,0.0327139120111057,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.09355289056299228,0.05739771900786832,0.03400761909471115,0.0327139120111057,0.4655983896540715,1,0.12756050965770344,0.09011163101897401,0.20292295861567247,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.10280368478241038,0.0910183830379664,6,0.037158099276034855,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.06986181208360935,0.10280368478241038,0.03307033383279943,0.037158099276034855,0.5229826227741359,1,0.10293214591640878,0.13996178405844523,0.19240063829595017,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.6,967514 MM WT,MoneyMaker,m_88,0.06986181208360935,0.08100544351385769,6,0.03307033383279943,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.12029517635203062,0.0718536063418185,6,0.02933411195271079,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.06986181208360935,0.12029517635203062,0.03307033383279943,0.02933411195271079,0.28087278042727576,1,0.10293214591640878,0.1496292883047414,0.19240063829595017,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_88,0.12515338537025875,0.12187751172538477,6,0.049756285807877755,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.06986181208360935,0.12515338537025875,0.03307033383279943,0.049756285807877755,0.3796842500952312,1,0.10293214591640878,0.1749096711781365,0.19240063829595017,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.14688156942721706,0.16026065694863617,6,0.06542613922789633,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.03807724145237405,0.14688156942721706,0.015024282896187438,0.06542613922789633,0.16044298514415287,1,0.05310152434856149,0.2123077086551134,0.23353847952062476,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,1,967514 MM WT,MoneyMaker,m_88,0.03807724145237405,0.03359531786906253,5,0.015024282896187438,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.13522061068785166,0.14528346101956566,6,0.059311724593910965,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.03807724145237405,0.13522061068785166,0.015024282896187438,0.059311724593910965,0.16665008595080597,1,0.05310152434856149,0.19453233528176261,0.23353847952062476,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_88,0.07606892519436292,0.09246359854433919,6,0.03774810603586341,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.03807724145237405,0.07606892519436292,0.015024282896187438,0.03774810603586341,0.3831320950313911,1,0.05310152434856149,0.11381703123022634,0.23353847952062476,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.09025332889930475,0.08108556577458616,6,0.03310304360876992,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.12679451235415135,0.09025332889930475,0.05558117897278004,0.03310304360876992,0.5906594682377415,1,0.18237569132693138,0.12335637250807467,0.30713481814615984,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.4,967514 MM WT,MoneyMaker,m_88,0.12679451235415135,0.1242832944527181,5,0.05558117897278004,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.1258084274468838,0.16553083718375391,6,0.0675776812993196,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.12679451235415135,0.1258084274468838,0.05558117897278004,0.0675776812993196,0.9912557563856861,1,0.18237569132693138,0.1933861087462034,0.30713481814615984,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_88,0.19998510237608236,0.19406907638451992,6,0.07922836866588112,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.12679451235415135,0.19998510237608236,0.05558117897278004,0.07922836866588112,0.46982930266336487,1,0.18237569132693138,0.2792134710419635,0.30713481814615984,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.06960282396456845,0.07431383344016518,6,0.030338495459763692,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.07370913984583531,0.06960282396456845,0.02920464303085896,0.030338495459763692,0.924249518940116,1,0.10291378287669427,0.09994131942433214,0.18344431777775108,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.8,967514 MM WT,MoneyMaker,m_88,0.07370913984583531,0.07153647354573324,6,0.02920464303085896,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.04098420376349776,0.044544645584771565,6,0.018185275409301656,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.07370913984583531,0.04098420376349776,0.02920464303085896,0.018185275409301656,0.36815530848393774,1,0.10291378287669427,0.05916947917279942,0.18344431777775108,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_88,0.11926030584434229,0.1163685357207889,6,0.04750725577179505,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.07370913984583531,0.11926030584434229,0.02920464303085896,0.04750725577179505,0.4368253222965105,1,0.10291378287669427,0.16676756161613734,0.18344431777775108,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.03804921671539526,0.031021832851289413,6,0.01266461022859461,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.04659926196621315,0.03804921671539526,0.015573564765353232,0.01266461022859461,0.6795377648790827,1,0.06217282673156638,0.05071382694398987,0.09243930671699845,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.6,967514 MM WT,MoneyMaker,m_88,0.04659926196621315,0.03814728715130225,6,0.015573564765353232,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.07584136726555646,0.020072015743709183,6,0.00819436611353302,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.04659926196621315,0.07584136726555646,0.015573564765353232,0.00819436611353302,0.1372868265496549,1,0.06217282673156638,0.08403573337908948,0.09243930671699845,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_88,0.046640625617752285,0.04554912551324092,6,0.018595352622904533,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.04659926196621315,0.046640625617752285,0.015573564765353232,0.018595352622904533,0.9986738930086596,1,0.06217282673156638,0.06523597824065681,0.09243930671699845,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.07824191328348891,0.08454042620805284,6,0.03451348447452394,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.10864082218948605,0.07824191328348891,0.0500906823951497,0.03451348447452394,0.6294151919954258,1,0.15873150458463575,0.11275539775801285,0.17460465504309935,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,1,967514 MM WT,MoneyMaker,m_88,0.10864082218948605,0.1226966127359291,6,0.0500906823951497,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.10540288548521937,0.07351095939608517,6,0.03001072350381022,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.10864082218948605,0.10540288548521937,0.0500906823951497,0.03001072350381022,0.9571097547859284,1,0.15873150458463575,0.1354136089890296,0.17460465504309935,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_88,0.08582933608283756,0.05597756091588813,6,0.022852743548248088,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.10864082218948605,0.08582933608283756,0.0500906823951497,0.022852743548248088,0.6910487153596605,1,0.15873150458463575,0.10868207963108564,0.17460465504309935,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_88,0.0213479433380539,0.01411640675531981,6,0.00576299892535184,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,*,0.05352404484358061,0.0213479433380539,0.01149455564502103,0.00576299892535184,0.03923939826536772,0.9417455583688253,0.06501860048860164,0.02711094226340574,0.11099194823357933,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.4,967514 MM WT,MoneyMaker,m_88,0.05352404484358061,0.028155796150329485,6,0.01149455564502103,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_88,0.07643692475015795,0.05992639024521122,6,0.024464846371277802,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.05352404484358061,0.07643692475015795,0.01149455564502103,0.024464846371277802,0.4242569309904939,1,0.06501860048860164,0.10090177112143575,0.11099194823357933,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_88,0.04521349000339766,0.016841681710596974,6,0.006875587766887723,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.05352404484358061,0.04521349000339766,0.01149455564502103,0.006875587766887723,0.5518558734323515,1,0.06501860048860164,0.05208907777028538,0.11099194823357933,0,24,0,4.69475890985325,4-hydroxypyridine,pyridine_4-hydroxy_152_167_rt4.79,4.718711656,4.72,0.022937038,4.89,4.69,0.2,FALSE,pyridines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.2988391534442403,0.14364518678252278,6,0.05864290193732722,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.19697061469198598,0.2988391534442403,0.09747763514551074,0.05864290193732722,0.4014836737916743,1,0.29444824983749673,0.3574820553815675,0.6090616043791411,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.8,967514 MM WT,MoneyMaker,m_76,0.19697061469198598,0.21796661847128462,5,0.09747763514551074,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.21000769567009359,0.15843024651762608,6,0.06467887729858923,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.19697061469198598,0.21000769567009359,0.09747763514551074,0.06467887729858923,0.9143149596049843,1,0.29444824983749673,0.2746865729686828,0.6090616043791411,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_76,0.38377455292408047,0.3799477842424774,5,0.16991781469332057,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.19697061469198598,0.38377455292408047,0.09747763514551074,0.16991781469332057,0.37502764384431764,1,0.29444824983749673,0.553692367617401,0.6090616043791411,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.3756705330398472,0.37188432200948235,6,0.15182113871068392,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.24237004038575363,0.3756705330398472,0.0844817933758002,0.15182113871068392,0.46546253100870805,1,0.3268518337615538,0.5274916717505311,0.5802408389255843,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.6,967514 MM WT,MoneyMaker,m_76,0.24237004038575363,0.2069372863259504,6,0.0844817933758002,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.24318143222146305,0.20408366096105984,6,0.0833168056989593,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.24237004038575363,0.24318143222146305,0.0844817933758002,0.0833168056989593,0.9946784075435493,1,0.3268518337615538,0.3264982379204223,0.5802408389255843,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_76,0.24423046444651308,0.17303526034436942,6,0.07064134922555829,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.24237004038575363,0.24423046444651308,0.0844817933758002,0.07064134922555829,0.9868638590616622,1,0.3268518337615538,0.3148718136720714,0.5802408389255843,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.22422851640028466,0.27677463686337944,6,0.11299277234323114,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.3404703191557905,0.22422851640028466,0.22356896256434175,0.11299277234323114,0.6590008001360732,1,0.5640392817201323,0.3372212887435158,0.6204432098921455,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,1,967514 MM WT,MoneyMaker,m_76,0.3404703191557905,0.49991539795297385,5,0.22356896256434175,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.2469313746573931,0.12571305244455303,6,0.05132213874948273,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.3404703191557905,0.2469313746573931,0.22356896256434175,0.05132213874948273,0.7024102907942621,1,0.5640392817201323,0.29825351340687584,0.6204432098921455,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_76,0.2487344221337621,0.22131322333290163,6,0.09035074508270421,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.3404703191557905,0.2487344221337621,0.22356896256434175,0.09035074508270421,0.7183970752507961,1,0.5640392817201323,0.3390851672164663,0.6204432098921455,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.18579887774662576,0.1555189705258089,6,0.06349035385186139,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.16681581723838015,0.18579887774662576,0.09135991426463541,0.06349035385186139,0.869081429613789,1,0.25817573150301554,0.24928923159848715,0.37572102131501584,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.4,967514 MM WT,MoneyMaker,m_76,0.16681581723838015,0.2042869787142775,5,0.09135991426463541,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.14982152363534254,0.15891483181871036,6,0.06487670841934082,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.16681581723838015,0.14982152363534254,0.09135991426463541,0.06487670841934082,0.8834401723182264,1,0.25817573150301554,0.21469823205468336,0.37572102131501584,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_76,0.21950274769473435,0.298989169062798,6,0.12206181713709821,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.16681581723838015,0.21950274769473435,0.09135991426463541,0.12206181713709821,0.7378383596790377,1,0.25817573150301554,0.34156456483183256,0.37572102131501584,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.10168784538395877,0.10697632389479932,6,0.043672901350160324,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.19157309931770003,0.10168784538395877,0.12756356790992465,0.043672901350160324,0.5291783284200788,1,0.3191366672276247,0.14536074673411908,0.3510503339503872,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.8,967514 MM WT,MoneyMaker,m_76,0.19157309931770003,0.3124656511481858,6,0.12756356790992465,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.12470506390912368,0.11775676575404963,6,0.04807399830964433,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.19157309931770003,0.12470506390912368,0.12756356790992465,0.04807399830964433,0.6401529308758993,1,0.3191366672276247,0.17277906221876801,0.3510503339503872,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_76,0.158895571186537,0.16725616835764004,6,0.06828204480154261,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.19157309931770003,0.158895571186537,0.12756356790992465,0.06828204480154261,0.8272387377033019,1,0.3191366672276247,0.22717761598807962,0.3510503339503872,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.08958367193392203,0.1093954666423605,6,0.04466051224124023,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.13072548643465887,0.08958367193392203,0.039871823920033404,0.04466051224124023,0.5077784304469574,1,0.17059731035469228,0.13424418417516226,0.29892995700292563,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.6,967514 MM WT,MoneyMaker,m_76,0.13072548643465887,0.09766562371817879,6,0.039871823920033404,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.1982263958095082,0.18010635261507918,6,0.07352811055678779,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.13072548643465887,0.1982263958095082,0.039871823920033404,0.07352811055678779,0.4438499615704967,1,0.17059731035469228,0.271754506366296,0.29892995700292563,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_76,0.14895973364802004,0.13057714530232933,6,0.053307896343327395,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.13072548643465887,0.14895973364802004,0.039871823920033404,0.053307896343327395,0.7901631382803751,1,0.17059731035469228,0.20226762999134743,0.29892995700292563,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.311352861503072,0.29382242929758445,6,0.11995250446067812,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.15695207718029924,0.311352861503072,0.050799208933724874,0.11995250446067812,0.27602406557751125,1,0.2077512861140241,0.43130536596375013,0.4744359025601252,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,1,967514 MM WT,MoneyMaker,m_76,0.15695207718029924,0.12443214122465865,6,0.050799208933724874,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.08793223934630016,0.09953956641064218,6,0.04063685782065884,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.15695207718029924,0.08793223934630016,0.050799208933724874,0.04063685782065884,0.31482154691348324,1,0.2077512861140241,0.128569097166959,0.4744359025601252,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_76,0.16551334830168998,0.11356005828655222,6,0.046360699660461586,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.15695207718029924,0.16551334830168998,0.050799208933724874,0.046360699660461586,0.9034190528404134,1,0.2077512861140241,0.21187404796215156,0.4744359025601252,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_76,0.09326727553808907,0.07243467442425973,6,0.029571332004010537,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.31116439514593425,0.09326727553808907,0.13294037009959886,0.029571332004010537,0.16525387436577457,1,0.4441047652455331,0.1228386075420996,0.649102000931895,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.4,967514 MM WT,MoneyMaker,m_76,0.31116439514593425,0.32563607296076685,6,0.13294037009959886,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_76,0.3762107416746784,0.523901731963672,6,0.21388198644522607,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.31116439514593425,0.3762107416746784,0.13294037009959886,0.21388198644522607,0.802424466672255,1,0.4441047652455331,0.5900927281199044,0.649102000931895,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_76,0.22589321900682943,0.1775535170487279,6,0.07248591980098953,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.31116439514593425,0.22589321900682943,0.13294037009959886,0.07248591980098953,0.5892848949697409,1,0.4441047652455331,0.29837913880781897,0.649102000931895,0,24,0,8.119329140461216,6-hydroxy-nicotinic_acid,nicotinic_acid_6-hydroxy_268_282_rt8.22,8.120920245,8.12,0.017701566,8.22,8.05,0.17,FALSE,pyridines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.17765788850420128,0.23319864403527119,6,0.0952029477658904,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.019462886155536686,0.17765788850420128,0.012613856413318511,0.0952029477658904,0.15843975466594895,1,0.0320767425688552,0.27286083627009167,0.4519437840647055,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.8,967514 MM WT,MoneyMaker,m_120,0.019462886155536686,0.028205440398601875,5,0.012613856413318511,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.30601580800089606,0.2568098384278547,6,0.10484217751247257,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,*,0.019462886155536686,0.30601580800089606,0.012613856413318511,0.10484217751247257,0.04086685446995466,0.8990707983390025,0.0320767425688552,0.4108579855133686,0.4519437840647055,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_120,0.2303498491125477,0.276771360148273,5,0.12377591510332295,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.019462886155536686,0.2303498491125477,0.012613856413318511,0.12377591510332295,0.16386408350659834,1,0.0320767425688552,0.3541257642158706,0.4519437840647055,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.14836021236210414,0.28662020174241726,6,0.11701220737374939,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.14458848610305977,0.14836021236210414,0.08633735035444684,0.11701220737374939,0.9798612278486875,1,0.2309258364575066,0.2653724197358535,0.2919096617094389,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.6,967514 MM WT,MoneyMaker,m_120,0.14458848610305977,0.2114824541122951,6,0.08633735035444684,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.12291978251203217,0.13783821943065064,6,0.05627221744314596,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.14458848610305977,0.12291978251203217,0.08633735035444684,0.05627221744314596,0.8383622991920969,1,0.2309258364575066,0.17919199995517812,0.2919096617094389,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_120,0.17604594483706873,0.12324194109167431,6,0.05031331176412415,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.14458848610305977,0.17604594483706873,0.08633735035444684,0.05031331176412415,0.7609221371323431,1,0.2309258364575066,0.22635925660119288,0.2919096617094389,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.11313307438611353,0.09990074342208127,6,0.04078430771813369,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.13714922760228446,0.11313307438611353,0.07946174884008193,0.04078430771813369,0.7969526280844503,1,0.21661097644236638,0.1539173821042472,0.23827207408660303,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,1,967514 MM WT,MoneyMaker,m_120,0.13714922760228446,0.17768187201743826,5,0.07946174884008193,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.1609442091989223,0.1342393333856425,6,0.05480297836769713,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.13714922760228446,0.1609442091989223,0.07946174884008193,0.05480297836769713,0.8120085748402527,1,0.21661097644236638,0.21574718756661942,0.23827207408660303,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_120,0.0900476035191254,0.07812510360807699,6,0.03189443999030961,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.13714922760228446,0.0900476035191254,0.07946174884008193,0.03189443999030961,0.60470323474114,1,0.21661097644236638,0.12194204350943501,0.23827207408660303,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.17158507609272625,0.2169869458629054,6,0.08858454970150594,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.25846092115160085,0.17158507609272625,0.10414831897054723,0.08858454970150594,0.5421368765027096,1,0.36260924012214807,0.2601696257942322,0.3988701641343629,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.4,967514 MM WT,MoneyMaker,m_120,0.25846092115160085,0.23288272096047455,5,0.10414831897054723,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.13791887860418964,0.11215899141441732,6,0.045788716505086965,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.25846092115160085,0.13791887860418964,0.10414831897054723,0.045788716505086965,0.33342334668957746,1,0.36260924012214807,0.1837075951092766,0.3988701641343629,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_120,0.2319511237417288,0.2699234796775091,6,0.11019579913440038,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.25846092115160085,0.2319511237417288,0.10414831897054723,0.11019579913440038,0.8650880796775333,1,0.36260924012214807,0.3421469228761292,0.3988701641343629,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.16810453406645368,0.2083283058988336,6,0.08504967473843154,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.10159240078165614,0.16810453406645368,0.03762113609212294,0.08504967473843154,0.49801976170788087,1,0.13921353687377908,0.2531542088048852,0.27846962968537375,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.8,967514 MM WT,MoneyMaker,m_120,0.10159240078165614,0.09215258696950515,6,0.03762113609212294,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.10680536530118571,0.11303991973782504,6,0.046148353987139366,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.10159240078165614,0.10680536530118571,0.03762113609212294,0.046148353987139366,0.9320287448538315,1,0.13921353687377908,0.15295371928832507,0.27846962968537375,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_120,0.16445519760823082,0.07480849221464632,6,0.030540439058808568,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.10159240078165614,0.16445519760823082,0.03762113609212294,0.030540439058808568,0.2248545834017082,1,0.13921353687377908,0.1949956366670394,0.27846962968537375,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.10067170740210007,0.15866450421337705,6,0.06477451260240757,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.18878413453901258,0.10067170740210007,0.053207490993832075,0.06477451260240757,0.31884038938297216,1,0.24199162553284465,0.16544622000450765,0.2661907880861291,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.6,967514 MM WT,MoneyMaker,m_120,0.18878413453901258,0.13033120342861998,6,0.053207490993832075,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.09693362001859429,0.09403594315928951,6,0.03839001303693694,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.18878413453901258,0.09693362001859429,0.053207490993832075,0.03839001303693694,0.19470857389523114,1,0.24199162553284465,0.13532363305553124,0.2661907880861291,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_120,0.16616283996443437,0.12237173870256143,6,0.04995805312641125,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.18878413453901258,0.16616283996443437,0.053207490993832075,0.04995805312641125,0.7629914102786649,1,0.24199162553284465,0.21612089309084562,0.2661907880861291,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.15452979106760414,0.09688698038335852,6,0.039553944109711955,leaf_1_panK4-1,1,967514 MM WT,leaf,*,0.04233948125386918,0.15452979106760414,0.019306072152701383,0.039553944109711955,0.0370479102162121,0.8521019349728783,0.06164555340657056,0.19408373517731609,0.24576059901027467,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,1,967514 MM WT,MoneyMaker,m_120,0.04233948125386918,0.04729002571147398,6,0.019306072152701383,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.15688359573401267,0.07579295150389308,6,0.030942342880674826,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.04233948125386918,0.15688359573401267,0.019306072152701383,0.030942342880674826,0.013010761344433488,0.3122582722664037,0.06164555340657056,0.1878259386146875,0.24576059901027467,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_120,0.1557791859237548,0.16568236053693747,6,0.06763954044922213,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.04233948125386918,0.1557791859237548,0.019306072152701383,0.06763954044922213,0.15955127672621675,1,0.06164555340657056,0.22341872637297694,0.24576059901027467,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_120,0.10895238988916589,0.11812387121192129,6,0.04822386848524039,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.11753552370366009,0.10895238988916589,0.04810296184985696,0.04822386848524039,0.9022196585364881,1,0.16563848555351707,0.1571762583744063,0.1822023341088688,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.4,967514 MM WT,MoneyMaker,m_120,0.11753552370366009,0.11782771164871515,6,0.04810296184985696,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_120,0.1184694962310553,0.07449095296785328,6,0.030410804204150127,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.11753552370366009,0.1184694962310553,0.04810296184985696,0.030410804204150127,0.9872872024576551,1,0.16563848555351707,0.14888030043520542,0.1822023341088688,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_120,0.07385652592485203,0.045111037242476205,6,0.01841650383529257,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.11753552370366009,0.07385652592485203,0.04810296184985696,0.01841650383529257,0.426846903637015,1,0.16563848555351707,0.0922730297601446,0.1822023341088688,0,24,0,6.316205450733753,uracil,uracil_241_255_rt6.41,6.321717791,6.32,0.022266486,6.52,6.2,0.32,FALSE,pyrimidines +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,0.06209327884864605,0.06673691371856871,6,0.027245230936440008,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.11590407850864093,0.06209327884864605,0.04486296575855532,0.027245230936440008,0.34055158413929437,1,0.16076704426719624,0.08933850978508606,0.17684374869391586,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.8,967514 MM WT,MoneyMaker,m_36,0.11590407850864093,0.10031664110837513,5,0.04486296575855532,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,0.10089235230905376,0.14510479439173726,6,0.05923878424853708,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.11590407850864093,0.10089235230905376,0.04486296575855532,0.05923878424853708,0.8445109437291186,1,0.16076704426719624,0.16013113655759084,0.17684374869391586,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_36,0.10562496125012792,0.07115157982671907,5,0.03181995383980931,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.11590407850864093,0.10562496125012792,0.04486296575855532,0.03181995383980931,0.8568984543846566,1,0.16076704426719624,0.13744491508993723,0.17684374869391586,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,0.12632824733358242,0.08493914464495277,6,0.03467626059476475,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.07880244782661909,0.12632824733358242,0.03479056249198401,0.03467626059476475,0.35609430643475526,1,0.11359301031860311,0.16100450792834717,0.1771049587211819,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.6,967514 MM WT,MoneyMaker,m_36,0.07880244782661909,0.08521912596977199,6,0.03479056249198401,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,0.09101767144803234,0.08736959922834994,6,0.03566848952348671,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.07880244782661909,0.09101767144803234,0.03479056249198401,0.03566848952348671,0.8112948819830229,1,0.11359301031860311,0.12668616097151905,0.1771049587211819,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_36,0.0706013625768845,0.10215267955029719,6,0.04170365679271165,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.07880244782661909,0.0706013625768845,0.03479056249198401,0.04170365679271165,0.8830693927510934,1,0.11359301031860311,0.11230501936959615,0.1771049587211819,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,0.06685365383809083,0.08551547305296166,6,0.034911545682080145,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.044860267518614896,0.06685365383809083,0.02471424219583145,0.034911545682080145,0.6201147215172177,1,0.06957450971444634,0.10176519952017098,0.1153439942099573,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,1,967514 MM WT,MoneyMaker,m_36,0.044860267518614896,0.05526272556227279,5,0.02471424219583145,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,0.08066977559233002,0.059249240051178376,6,0.02418840096217662,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.044860267518614896,0.08066977559233002,0.02471424219583145,0.02418840096217662,0.32791643941012383,1,0.06957450971444634,0.10485817655450663,0.1153439942099573,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_36,0.05888070923604275,0.043349859616257515,6,0.017697506080185586,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.044860267518614896,0.05888070923604275,0.02471424219583145,0.017697506080185586,0.6576000202369248,1,0.06957450971444634,0.07657821531622834,0.1153439942099573,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,0.12026354862622608,0.12777426743748294,6,0.05216362624662485,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.17729973585257514,0.12026354862622608,0.05092640284951128,0.05216362624662485,0.45423356934573156,1,0.2282261387020864,0.17242717487285092,0.2510487525722951,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.4,967514 MM WT,MoneyMaker,m_36,0.17729973585257514,0.11387489862104623,5,0.05092640284951128,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,0.12088018814194908,0.10045863701745164,6,0.04101206682470438,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.17729973585257514,0.12088018814194908,0.05092640284951128,0.04101206682470438,0.412935290631373,1,0.2282261387020864,0.16189225496665346,0.2510487525722951,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_36,0.10035483667275558,0.08780835343327617,6,0.035847610177581674,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.17729973585257514,0.10035483667275558,0.05092640284951128,0.035847610177581674,0.25404790413943906,1,0.2282261387020864,0.13620244685033725,0.2510487525722951,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,0.09351667771395733,0.09451863739879832,6,0.038587072135033165,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.1797851154518543,0.09351667771395733,0.07140063176986697,0.038587072135033165,0.32004193044714885,1,0.25118574722172127,0.13210374984899048,0.2763043219438934,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.8,967514 MM WT,MoneyMaker,m_36,0.1797851154518543,0.17489511514852785,6,0.07140063176986697,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,0.18515673397471347,0.09621225667093691,6,0.0392784893075804,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.1797851154518543,0.18515673397471347,0.07140063176986697,0.0392784893075804,0.9491082705014848,1,0.25118574722172127,0.22443522328229387,0.2763043219438934,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_36,0.07049959051832884,0.04618962429029832,6,0.018856835153682413,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.1797851154518543,0.07049959051832884,0.07140063176986697,0.018856835153682413,0.19199480069602837,1,0.25118574722172127,0.08935642567201126,0.2763043219438934,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,0.08537697816705887,0.0793956740732959,6,0.032413148210649105,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.20585855407721687,0.08537697816705887,0.09186589072874689,0.032413148210649105,0.26078453599304113,1,0.2977244448059638,0.11779012637770797,0.3274968892865602,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.6,967514 MM WT,MoneyMaker,m_36,0.20585855407721687,0.22502455705170574,6,0.09186589072874689,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,0.17262090799340793,0.17363032697390432,6,0.070884284159778,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.20585855407721687,0.17262090799340793,0.09186589072874689,0.070884284159778,0.7807520467900595,1,0.2977244448059638,0.24350519215318595,0.3274968892865602,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_36,0.07838716635954752,0.05676245547918603,6,0.02317317541190883,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.20585855407721687,0.07838716635954752,0.09186589072874689,0.02317317541190883,0.2301037939776849,1,0.2977244448059638,0.10156034177145636,0.3274968892865602,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,0.0921270006224512,0.10055283291192528,6,0.04105052213759196,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.21873454023665242,0.0921270006224512,0.06481289647906155,0.04105052213759196,0.13545718900901887,1,0.283547436715714,0.13317752276004316,0.3119021803872854,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,1,967514 MM WT,MoneyMaker,m_36,0.21873454023665242,0.1587585251255292,6,0.06481289647906155,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,0.161607500405513,0.0957775185577063,6,0.039101008216054514,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.21873454023665242,0.161607500405513,0.06481289647906155,0.039101008216054514,0.4715059943511202,1,0.283547436715714,0.20070850862156753,0.3119021803872854,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_36,0.13437777804638476,0.1443836572806992,6,0.058944381255765746,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.21873454023665242,0.13437777804638476,0.06481289647906155,0.058944381255765746,0.35850676116050595,1,0.283547436715714,0.19332215930215052,0.3119021803872854,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_36,0.18388214834948044,0.11665388236006877,6,0.047623748049470664,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.1700566637906559,0.18388214834948044,0.057150171790327955,0.047623748049470664,0.8563997000456995,1,0.22720683558098387,0.2315058963989511,0.4716110213856921,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.4,967514 MM WT,MoneyMaker,m_36,0.1700566637906559,0.13998875959870485,6,0.057150171790327955,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_36,0.3022710897276805,0.30977766568828996,6,0.12646620244113047,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.1700566637906559,0.3022710897276805,0.057150171790327955,0.12646620244113047,0.37264980073865656,1,0.22720683558098387,0.42873729216881096,0.4716110213856921,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_36,0.14963979306236927,0.12299348882581637,6,0.05021188155132578,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.1700566637906559,0.14963979306236927,0.057150171790327955,0.05021188155132578,0.7939516389561487,1,0.22720683558098387,0.19985167461369505,0.4716110213856921,0,24,0,10.11144050104384,galactonic_glucoronic_acid,galactonic_o_gluconic_acid_333_157_10.24,10.11810976,10.12,0.023250308,10.22,9.88,0.34,FALSE,unannotated +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,0.23462549637236987,0.25689867584278364,6,0.10487844523524653,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.07284220586870997,0.23462549637236987,0.02743671512818299,0.10487844523524653,0.18898220834816815,1,0.10027892099689296,0.33950394160761643,0.4199983299913424,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.8,967514 MM WT,MoneyMaker,m_58,0.07284220586870997,0.06135036010591402,5,0.02743671512818299,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,0.27963759530244864,0.25028657979178726,6,0.1021790683260444,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.07284220586870997,0.27963759530244864,0.02743671512818299,0.1021790683260444,0.10087145186308076,1,0.10027892099689296,0.38181666362849304,0.4199983299913424,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_58,0.1391018961593181,0.13456418764116995,5,0.060178934180538615,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.07284220586870997,0.1391018961593181,0.02743671512818299,0.060178934180538615,0.3577693704135526,1,0.10027892099689296,0.19928083033985672,0.4199983299913424,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,0.2703949602943034,0.27692364144531356,6,0.11305360320907704,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.18615698843639938,0.2703949602943034,0.05765187890313684,0.11305360320907704,0.5268655893928276,1,0.24380886733953622,0.3834485635033804,0.48827276733331826,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.6,967514 MM WT,MoneyMaker,m_58,0.18615698843639938,0.14121768602541157,6,0.05765187890313684,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,0.3213943589990517,0.3000379372101032,6,0.12248997494032851,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.18615698843639938,0.3213943589990517,0.05765187890313684,0.12248997494032851,0.35058731662411435,1,0.24380886733953622,0.4438843339393802,0.48827276733331826,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_58,0.2913153776906638,0.1471668882852246,6,0.06008063055532925,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.18615698843639938,0.2913153776906638,0.05765187890313684,0.06008063055532925,0.23532378875715199,1,0.24380886733953622,0.35139600824599304,0.48827276733331826,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,0.3413954722884996,0.2659783840816536,6,0.10858522060167584,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.28763944163525945,0.3413954722884996,0.08494425229601375,0.10858522060167584,0.7058119571838062,1,0.3725836939312732,0.44998069289017545,0.494978762179193,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,1,967514 MM WT,MoneyMaker,m_58,0.28763944163525945,0.18994112243177935,5,0.08494425229601375,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,0.32120764077978964,0.22404628250272965,6,0.09146651181652309,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.28763944163525945,0.32120764077978964,0.08494425229601375,0.09146651181652309,0.7940635635559588,1,0.3725836939312732,0.41267415259631274,0.494978762179193,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_58,0.13163170416210437,0.19291254968292937,6,0.07875621861708096,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.28763944163525945,0.13163170416210437,0.08494425229601375,0.07875621861708096,0.21210235873040323,1,0.3725836939312732,0.21038792277918533,0.494978762179193,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,0.2174173224494139,0.16176597879852267,6,0.0660406842997104,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.14885489578595834,0.2174173224494139,0.06824436019717613,0.0660406842997104,0.4890242459785379,1,0.21709925598313445,0.2834580067491243,0.31180380742403674,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.4,967514 MM WT,MoneyMaker,m_58,0.14885489578595834,0.15259902848186677,5,0.06824436019717613,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,0.028960400732130243,0.019417591374750066,6,0.007927198483667566,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.14885489578595834,0.028960400732130243,0.06824436019717613,0.007927198483667566,0.15401684954655137,1,0.21709925598313445,0.03688759921579781,0.31180380742403674,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_58,0.22338788595869566,0.1395403855558754,6,0.056967123853854454,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.14885489578595834,0.22338788595869566,0.06824436019717613,0.056967123853854454,0.4252913630002304,1,0.21709925598313445,0.2803550098125501,0.31180380742403674,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,0.11049378614438465,0.13046180490505677,6,0.05326080882331945,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.16942582747591262,0.11049378614438465,0.06989464162929564,0.05326080882331945,0.5186857018523896,1,0.23932046910520827,0.16375459496770411,0.26325251601572913,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.8,967514 MM WT,MoneyMaker,m_58,0.16942582747591262,0.17120620774646578,6,0.06989464162929564,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,0.13509382438743125,0.11342918874959679,6,0.04630727239572573,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.16942582747591262,0.13509382438743125,0.06989464162929564,0.04630727239572573,0.692106662921969,1,0.23932046910520827,0.181401096783157,0.26325251601572913,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_58,0.11649423334567836,0.07738185944610215,6,0.031591011831786135,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.16942582747591262,0.11649423334567836,0.06989464162929564,0.031591011831786135,0.5124804485480077,1,0.23932046910520827,0.1480852451774645,0.26325251601572913,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,0.09344202877123357,0.06139592701101292,6,0.025064782243690138,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.07529198101003853,0.09344202877123357,0.024512674145699874,0.025064782243690138,0.6159286835392753,1,0.09980465515573841,0.11850681101492372,0.16319018191847476,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.6,967514 MM WT,MoneyMaker,m_58,0.07529198101003853,0.06004354388807824,6,0.024512674145699874,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,0.09192354269544707,0.13822756753105148,6,0.05643116813952995,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.07529198101003853,0.09192354269544707,0.024512674145699874,0.05643116813952995,0.7949079126803649,1,0.09980465515573841,0.14835471083497703,0.16319018191847476,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_58,0.05688372020881438,0.0319363047553315,6,0.013037941820097024,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.07529198101003853,0.05688372020881438,0.024512674145699874,0.013037941820097024,0.5268630840719849,1,0.09980465515573841,0.06992166202891141,0.16319018191847476,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,0.11610168635188689,0.23023999741723775,6,0.09399508534199155,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.1951145739817647,0.11610168635188689,0.09084354220617369,0.09399508534199155,0.5590266061009701,1,0.2859581161879384,0.21009677169387844,0.3145539278067323,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,1,967514 MM WT,MoneyMaker,m_58,0.1951145739817647,0.22252032483211315,6,0.09084354220617369,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,0.07480282814347221,0.0667450482147339,6,0.02724855183059323,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.1951145739817647,0.07480282814347221,0.09084354220617369,0.02724855183059323,0.2524114780394164,1,0.2859581161879384,0.10205137997406544,0.3145539278067323,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_58,0.08844170756014025,0.06866099073572929,6,0.02803073208941662,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.1951145739817647,0.08844170756014025,0.09084354220617369,0.02803073208941662,0.30511563871129,1,0.2859581161879384,0.11647243964955686,0.3145539278067323,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_58,0.09331009014412898,0.08927170979297078,6,0.03644502290976642,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.06770359585792478,0.09331009014412898,0.02103700957012283,0.03644502290976642,0.5597296978974791,1,0.08874060542804761,0.12975511305389542,0.14273062435928496,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.4,967514 MM WT,MoneyMaker,m_58,0.06770359585792478,0.05152993916084742,6,0.02103700957012283,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_58,0.06038947241884444,0.07007705520556426,6,0.028608837988413363,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.06770359585792478,0.06038947241884444,0.02103700957012283,0.028608837988413363,0.841309010715525,1,0.08874060542804761,0.08899831040725781,0.14273062435928496,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_58,0.057586804381700794,0.04635881683228509,6,0.018925907719707747,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.06770359585792478,0.057586804381700794,0.02103700957012283,0.018925907719707747,0.7282169871635586,1,0.08874060542804761,0.07651271210140854,0.14273062435928496,0,24,0,9.473131524008352,hexose,hexose_307_217_rt9.58,9.483231707,9.48,0.03352384,9.55,9.23,0.32,FALSE,unannotated +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,0.17508783003344108,0.1962771080912536,6,0.08012979383544515,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.14880337596925006,0.17508783003344108,0.07658039341310502,0.08012979383544515,0.8178806778955736,1,0.22538376938235508,0.25521762386888625,0.3672837558691635,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_45,0.14880337596925006,0.17123896541537997,5,0.07658039341310502,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,0.1787601211502854,0.12073939118429658,6,0.0492916500426367,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.14880337596925006,0.1787601211502854,0.07658039341310502,0.0492916500426367,0.7517822698854316,1,0.22538376938235508,0.22805177119292208,0.3672837558691635,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_45,0.1942792899298736,0.3121887057826731,5,0.13961503358754773,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.14880337596925006,0.1942792899298736,0.07658039341310502,0.13961503358754773,0.7844886776067147,1,0.22538376938235508,0.3338943235174213,0.3672837558691635,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,0.20641683276923053,0.23315449566519963,6,0.09518492426928192,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.17668433724141627,0.20641683276923053,0.03719806463448082,0.09518492426928192,0.7801713017357952,1,0.21388240187589708,0.30160175703851244,0.3886086903557368,0,23,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_45,0.17668433724141627,0.09111627777354644,6,0.03719806463448082,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,0.21600305471878403,0.10559577277828303,6,0.04310929371694457,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.17668433724141627,0.21600305471878403,0.03719806463448082,0.04310929371694457,0.5058986645673382,1,0.21388240187589708,0.2591123484357286,0.3886086903557368,0,23,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_45,0.21374340851959558,0.3120147072463987,5,0.13953721907652872,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.17668433724141627,0.21374340851959558,0.03719806463448082,0.13953721907652872,0.808615991274709,1,0.21388240187589708,0.35328062759612433,0.3886086903557368,0,23,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,0.07230852308713587,0.07676153331921151,6,0.031337764750952964,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.10675222507941626,0.07230852308713587,0.06942522472728922,0.031337764750952964,0.6680852021425596,1,0.17617744980670547,0.10364628783808882,0.22761218283169665,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_45,0.10675222507941626,0.15523952184341802,5,0.06942522472728922,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,0.14610025626791204,0.14897774556169238,6,0.060819909942721274,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.10675222507941626,0.14610025626791204,0.06942522472728922,0.060819909942721274,0.68047820236937,1,0.17617744980670547,0.2069201662106333,0.22761218283169665,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_45,0.08243794523556398,0.07428160247595143,6,0.03032533722372343,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.10675222507941626,0.08243794523556398,0.06942522472728922,0.03032533722372343,0.7600723631236762,1,0.17617744980670547,0.1127632824592874,0.22761218283169665,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,0.16106349926936936,0.06181690358384077,6,0.02523664520987244,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.15986125165718884,0.16106349926936936,0.10574374002497908,0.02523664520987244,0.9916540973306853,1,0.2656049916821679,0.1863001444792418,0.2921654908503847,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_45,0.15986125165718884,0.23645019089091854,5,0.10574374002497908,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,0.07407932865845297,0.05168192233798682,6,0.021099056442369254,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.15986125165718884,0.07407932865845297,0.10574374002497908,0.021099056442369254,0.4677366739893454,1,0.2656049916821679,0.09517838510082223,0.2921654908503847,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_45,0.12301329057779853,0.17187064795092966,6,0.07016589820688347,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.15986125165718884,0.12301329057779853,0.10574374002497908,0.07016589820688347,0.7797461465229937,1,0.2656049916821679,0.193179188784682,0.2921654908503847,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,0.16690840993597877,0.12472970440962734,6,0.05092068859529332,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.1904850724017663,0.16690840993597877,0.10162787839699951,0.05092068859529332,0.8413103390219412,1,0.2921129507987658,0.21782909853127208,0.32132424587864244,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_45,0.1904850724017663,0.2489364457142664,6,0.10162787839699951,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,0.11036719659274279,0.1465883758972194,6,0.05984445386191397,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.1904850724017663,0.11036719659274279,0.10162787839699951,0.05984445386191397,0.5158864694480528,1,0.2921129507987658,0.17021165045465675,0.32132424587864244,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_45,0.14669245742077486,0.11696473881053938,6,0.04775065466395496,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.1904850724017663,0.14669245742077486,0.10162787839699951,0.04775065466395496,0.7079599540122119,1,0.2921129507987658,0.1944431120847298,0.32132424587864244,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,0.15245622572394066,0.1926032748817415,6,0.07862995770821246,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.19012491596995926,0.15245622572394066,0.03411973376675788,0.07862995770821246,0.6739104199542534,1,0.22424464973671715,0.23108618343215312,0.25774871872406807,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_45,0.19012491596995926,0.08357593788816627,6,0.03411973376675788,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,0.12989517502284778,0.25578023089915525,6,0.10442184199903229,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.19012491596995926,0.12989517502284778,0.03411973376675788,0.10442184199903229,0.6031182684744731,1,0.22424464973671715,0.23431701702188007,0.25774871872406807,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_45,0.12291772021887226,0.056893438930416144,6,0.023226649181952583,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.19012491596995926,0.12291772021887226,0.03411973376675788,0.023226649181952583,0.13861676383278493,1,0.22424464973671715,0.14614436940082484,0.25774871872406807,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,0.11422263001634825,0.12538356040261053,6,0.05118762418663826,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.1998811100617862,0.11422263001634825,0.061702076884850444,0.05118762418663826,0.3112616575452748,1,0.2615831869466366,0.1654102542029865,0.2877415056413003,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_45,0.1998811100617862,0.15113860443786017,6,0.061702076884850444,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,0.08640939910175509,0.07771734817789736,6,0.03172797453301142,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.1998811100617862,0.08640939910175509,0.061702076884850444,0.03172797453301142,0.14325668352803622,1,0.2615831869466366,0.11813737363476651,0.2877415056413003,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_45,0.12901265618198524,0.1261380595132982,6,0.05149564715873301,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.1998811100617862,0.12901265618198524,0.061702076884850444,0.05149564715873301,0.39922814776328575,1,0.2615831869466366,0.18050830334071824,0.2877415056413003,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_45,0.1236755917607617,0.13923766295401463,6,0.05684353786916003,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.12630208239510207,0.1236755917607617,0.03409483726284535,0.05684353786916003,0.9693419924396073,1,0.16039691965794742,0.18051912962992173,0.19857104259291392,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_45,0.12630208239510207,0.08351495415720137,6,0.03409483726284535,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_45,0.10761149021645637,0.17316970650652458,6,0.07069623664141757,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.12630208239510207,0.10761149021645637,0.03409483726284535,0.07069623664141757,0.8184082448105537,1,0.16039691965794742,0.17830772685787394,0.19857104259291392,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_45,0.12106618984226018,0.1042173710697198,6,0.04254656357585117,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.12630208239510207,0.12106618984226018,0.03409483726284535,0.04254656357585117,0.9254807466245105,1,0.16039691965794742,0.16361275341811135,0.19857104259291392,0,24,0,9.68866388308977,D-glucose_peak_2,glucose_160_rt9.81,9.688902439,9.69,0.035670823,9.8,9.4,0.4,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,0.08680328271385189,0.08570890385470542,6,0.03499051347621509,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.10756362732716034,0.08680328271385189,0.04665964887717518,0.03499051347621509,0.7313141246251386,1,0.1542232762043355,0.12179379619006697,0.6774067991148656,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_6,0.10756362732716034,0.10433414669563544,5,0.04665964887717518,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,0.11180905827396719,0.028122583560089988,6,0.011480996661833878,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.10756362732716034,0.11180905827396719,0.04665964887717518,0.011480996661833878,0.9334033841068892,1,0.1542232762043355,0.12329005493580106,0.6774067991148656,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_6,0.39103084332804894,0.5026535905115795,5,0.224793519503647,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.10756362732716034,0.39103084332804894,0.04665964887717518,0.224793519503647,0.27952906447062553,1,0.1542232762043355,0.615824362831696,0.6774067991148656,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,0.24114374879734365,0.31766469189920327,6,0.1296860674085795,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.10984711225002042,0.24114374879734365,0.037441209225458724,0.1296860674085795,0.3693303763137598,1,0.14728832147547916,0.37082981620592315,0.4079127978265155,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_6,0.10984711225002042,0.09171185795516004,6,0.037441209225458724,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,0.10497391158229892,0.07613157074218249,6,0.031080583605824656,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.10984711225002042,0.10497391158229892,0.037441209225458724,0.031080583605824656,0.9222729973251975,1,0.14728832147547916,0.13605449518812357,0.4079127978265155,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_6,0.11624816110664811,0.10254318845800003,6,0.041863081386692244,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.10984711225002042,0.11624816110664811,0.037441209225458724,0.041863081386692244,0.9115437626190027,1,0.14728832147547916,0.15811124249334035,0.4079127978265155,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,0.19307367135333722,0.1574923116962184,6,0.06429596701118304,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.198498914701387,0.19307367135333722,0.11613701115466411,0.06429596701118304,0.9686551411532351,1,0.3146359258560511,0.25736963836452026,0.34609951844165626,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_6,0.198498914701387,0.2596902516454803,5,0.11613701115466411,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,0.15594880518319307,0.12884477364783892,6,0.05260065857693363,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.198498914701387,0.15594880518319307,0.11613701115466411,0.05260065857693363,0.75067112782333,1,0.3146359258560511,0.2085494637601267,0.34609951844165626,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_6,0.17657705234009993,0.15666532528810392,6,0.06395835122383343,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.198498914701387,0.17657705234009993,0.11613701115466411,0.06395835122383343,0.8738299262510402,1,0.3146359258560511,0.24053540356393338,0.34609951844165626,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,0.16686397561727895,0.17364373747651218,6,0.07088975897454193,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.3254196195260456,0.16686397561727895,0.14333475326387146,0.07088975897454193,0.3602414764622193,1,0.46875437278991705,0.23775373459182086,0.5156298100689088,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_6,0.3254196195260456,0.3205062518361765,5,0.14333475326387146,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,0.23080372049498346,0.14906477510281022,6,0.06085543960410249,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.3254196195260456,0.23080372049498346,0.14333475326387146,0.06085543960410249,0.5679614367751431,1,0.46875437278991705,0.29165916009908593,0.5156298100689088,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_6,0.27652911623706783,0.3127696207941992,6,0.12768766299826254,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.3254196195260456,0.27652911623706783,0.14333475326387146,0.12768766299826254,0.8049775692876413,1,0.46875437278991705,0.4042167792353304,0.5156298100689088,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,0.21414536318631863,0.14143121496230832,6,0.057739051726589496,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.10524066517917907,0.21414536318631863,0.024900217606335286,0.057739051726589496,0.12816042356331617,1,0.13014088278551436,0.27188441491290816,0.299072856404199,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_6,0.10524066517917907,0.060992827619787374,6,0.024900217606335286,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,0.13386957516575182,0.08920171605657883,6,0.03641644808654123,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.10524066517917907,0.13386957516575182,0.024900217606335286,0.03641644808654123,0.5328694775055667,1,0.13014088278551436,0.17028602325229306,0.299072856404199,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_6,0.15023608924013884,0.12377167384765786,6,0.050529574256157145,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.10524066517917907,0.15023608924013884,0.024900217606335286,0.050529574256157145,0.4496559127647318,1,0.13014088278551436,0.200765663496296,0.299072856404199,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,0.14836787017292574,0.18687819049954607,6,0.07629270179641982,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.13146557016176508,0.14836787017292574,0.06268455434735659,0.07629270179641982,0.8676251785060274,1,0.19415012450912167,0.22466057196934558,0.24712662916628017,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_6,0.13146557016176508,0.15354517290478464,6,0.06268455434735659,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,0.11934985235990585,0.10276031607710143,6,0.04195172336600288,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.13146557016176508,0.11934985235990585,0.06268455434735659,0.04195172336600288,0.8760419047804093,1,0.19415012450912167,0.16130157572590872,0.24712662916628017,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_6,0.07442920177145022,0.06988561287117225,6,0.028530681982675412,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.13146557016176508,0.07442920177145022,0.06268455434735659,0.028530681982675412,0.4349596424622755,1,0.19415012450912167,0.10295988375412564,0.24712662916628017,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,0.11302202317780212,0.060614965092170216,6,0.024745955875405224,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.16831058183837866,0.11302202317780212,0.06214148048531241,0.024745955875405224,0.4375516831359101,1,0.23045206232369106,0.13776797905320734,0.6868555862948388,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_6,0.16831058183837866,0.15221491905013376,6,0.06214148048531241,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,0.4309651599386685,0.4738513643265319,6,0.1934490094202758,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.16831058183837866,0.4309651599386685,0.06214148048531241,0.1934490094202758,0.2435056571908786,1,0.23045206232369106,0.6244141693589443,0.6868555862948388,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_6,0.24840123196702782,0.37054816164826965,6,0.15127565352743327,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.16831058183837866,0.24840123196702782,0.06214148048531241,0.15127565352743327,0.6400880539539364,1,0.23045206232369106,0.3996768854944611,0.6868555862948388,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_6,0.13611795367742863,0.11536375969811367,6,0.04709705767823881,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.07072871139382479,0.13611795367742863,0.020344738876762396,0.04709705767823881,0.24426903013320508,1,0.09107345027058719,0.18321501135566742,0.28091510838444217,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_6,0.07072871139382479,0.04983422919823164,6,0.020344738876762396,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_6,0.09934144037348373,0.06719783907829327,6,0.027433402926578997,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.07072871139382479,0.09934144037348373,0.020344738876762396,0.027433402926578997,0.4233470755783626,1,0.09107345027058719,0.12677484330006272,0.28091510838444217,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_6,0.15614992679255538,0.24305660742212404,6,0.09922744446602842,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.07072871139382479,0.15614992679255538,0.020344738876762396,0.09922744446602842,0.4346819554843908,1,0.09107345027058719,0.2553773712585838,0.28091510838444217,0,24,0,5.679728033472804,L-alanine_peak_2,alanine_188_262_rt5.78,5.690609756,5.69,0.028921199,5.76,5.46,0.3,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,0.07138905050606799,0.09066460000493569,6,0.03701366795760495,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.30671794073436043,0.07138905050606799,0.14019901297637957,0.03701366795760495,0.17114158557641926,1,0.44691695371074003,0.10840271846367294,0.49160864908181406,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_11,0.30671794073436043,0.3134945233935599,5,0.14019901297637957,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,0.21775285503242178,0.13446571307277538,6,0.054895397487964875,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.30671794073436043,0.21775285503242178,0.14019901297637957,0.054895397487964875,0.5792474255121515,1,0.44691695371074003,0.27264825252038666,0.49160864908181406,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_11,0.27564029058946654,0.28485422225133766,5,0.12739068092636482,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.30671794073436043,0.27564029058946654,0.14019901297637957,0.12739068092636482,0.873791155797814,1,0.44691695371074003,0.40303097151583134,0.49160864908181406,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,0.1698344511824529,0.12891405580555154,6,0.05262894289937946,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.13123856723977986,0.1698344511824529,0.043144876621970946,0.05262894289937946,0.5835966894936158,1,0.1743834438617508,0.22246339408183236,0.29480280760287,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_11,0.13123856723977986,0.10568293273916356,6,0.043144876621970946,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,0.1615943910891633,0.10971189268802449,6,0.04478969263344079,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.13123856723977986,0.1615943910891633,0.043144876621970946,0.04478969263344079,0.6360087849000946,1,0.1743834438617508,0.20638408372260408,0.29480280760287,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_11,0.20998596585224782,0.14211103357732996,6,0.058016586513997596,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.13123856723977986,0.20998596585224782,0.043144876621970946,0.058016586513997596,0.30368579778545274,1,0.1743834438617508,0.26800255236624543,0.29480280760287,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,0.08345102982786057,0.12221409510206561,6,0.049893695396006264,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.23575687568836426,0.08345102982786057,0.06284918047281296,0.049893695396006264,0.09395346584989375,1,0.2986060561611772,0.13334472522386684,0.32846666177729494,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_11,0.23575687568836426,0.14053503986736215,5,0.06284918047281296,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,0.1688198634440088,0.14876491210760762,6,0.06073302104893765,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.23575687568836426,0.1688198634440088,0.06284918047281296,0.06073302104893765,0.46376761974327096,1,0.2986060561611772,0.22955288449294645,0.32846666177729494,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_11,0.06551687265432753,0.0747362160025739,6,0.030510932418788796,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.23575687568836426,0.06551687265432753,0.06284918047281296,0.030510932418788796,0.051751308948855504,1,0.2986060561611772,0.09602780507311633,0.32846666177729494,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,0.09714052485304843,0.12174876530294211,6,0.049703725301012205,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.10819217617250709,0.09714052485304843,0.03898838270250659,0.049703725301012205,0.8650546384049167,1,0.1471805588750137,0.14684425015406063,0.1935904941759324,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_11,0.10819217617250709,0.08718067405558169,5,0.03898838270250659,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,0.11361671766355896,0.15278604255103173,6,0.06237464067819774,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.10819217617250709,0.11361671766355896,0.03898838270250659,0.06237464067819774,0.9429969258660629,1,0.1471805588750137,0.17599135834175672,0.1935904941759324,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_11,0.09061769796663437,0.07706474828723257,6,0.031461551743290614,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.10819217617250709,0.09061769796663437,0.03898838270250659,0.031461551743290614,0.7346453735348799,1,0.1471805588750137,0.12207924970992498,0.1935904941759324,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,0.12499703520369605,0.12201581718288447,6,0.04981274877446383,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.14057432468502062,0.12499703520369605,0.04951179536881508,0.04981274877446383,0.8289387729722115,1,0.1900861200538357,0.17480978397815988,0.2792610529892206,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_11,0.14057432468502062,0.1212786349026922,6,0.04951179536881508,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,0.1845721927249809,0.11430092641153311,6,0.046663157805944204,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.14057432468502062,0.1845721927249809,0.04951179536881508,0.046663157805944204,0.532445840954705,1,0.1900861200538357,0.23123535053092512,0.2792610529892206,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_11,0.17335086846721434,0.197239812019662,6,0.08052281606844072,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.14057432468502062,0.17335086846721434,0.04951179536881508,0.08052281606844072,0.7374040346781114,1,0.1900861200538357,0.25387368453565506,0.2792610529892206,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,0.11899711315389183,0.221920058953829,6,0.09059848468754039,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.9881732978455263,0.11899711315389183,0.49425399942953047,0.09059848468754039,0.14054271216289074,1,1.4824272972750567,0.20959559784143222,1.6306700270025625,3,24,12.5,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_11,0.9881732978455263,1.2106701019321975,6,0.49425399942953047,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,0.05682996481789315,0.04235103804906096,6,0.017289738882899152,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.9881732978455263,0.05682996481789315,0.49425399942953047,0.017289738882899152,0.11824901174739558,1,1.4824272972750567,0.07411970370079231,1.6306700270025625,3,24,12.5,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_11,0.48667531333679587,0.9726715546272524,6,0.3970914993594038,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.9881732978455263,0.48667531333679587,0.49425399942953047,0.3970914993594038,0.4481332513292742,1,1.4824272972750567,0.8837668126961997,1.6306700270025625,3,24,12.5,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,0.11980044144596791,0.07256064868409698,6,0.029622760780231547,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.08924865699800237,0.11980044144596791,0.028287339612599476,0.029622760780231547,0.4729316387023419,1,0.11753599661060185,0.14942320222619945,1.5534368757238068,4,24,16.666666666666664,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_11,0.08924865699800237,0.06928954823168669,6,0.028287339612599476,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,1.0757833566864379,0.8240866961093601,6,0.3364319848806593,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.08924865699800237,1.0757833566864379,0.028287339612599476,0.3364319848806593,0.03238759429993191,0.7773022631983659,0.11753599661060185,1.412215341567097,1.5534368757238068,4,24,16.666666666666664,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_11,0.48317742417147924,0.8820808223341405,6,0.3601079877688714,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.08924865699800237,0.48317742417147924,0.028287339612599476,0.3601079877688714,0.32463871356333823,1,0.11753599661060185,0.8432854119403506,1.5534368757238068,4,24,16.666666666666664,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_11,0.20279611066584743,0.18034444485194998,6,0.073625311305463,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.26979017504057784,0.20279611066584743,0.11785991142268332,0.073625311305463,0.6420738266189283,1,0.38765008646326116,0.2764214219713104,0.43173133082261494,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_11,0.26979017504057784,0.2886966441151967,6,0.11785991142268332,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_11,0.24803234892338524,0.35383045678659153,6,0.14445067909717377,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.26979017504057784,0.24803234892338524,0.11785991142268332,0.14445067909717377,0.9094948477739607,1,0.38765008646326116,0.392483028020559,0.43173133082261494,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_11,0.22198230778830155,0.1587152903314181,6,0.06479524594827712,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.26979017504057784,0.22198230778830155,0.11785991142268332,0.06479524594827712,0.731703722441543,1,0.38765008646326116,0.28677755373657865,0.43173133082261494,0,24,0,8.893842105263158,L-asparagine_peak_2,asparagine_116_188_rt9.00,8.897654321,8.9,0.011611903,8.99,8.87,0.12,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,0.22538544669401803,0.1891125518092322,6,0.07720487598137778,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.2774793402120622,0.22538544669401803,0.12439477388468409,0.07720487598137778,0.7326653654220274,1,0.40187411409674634,0.3025903226753958,0.5925359738762941,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_46,0.2774793402120622,0.2781551704518692,5,0.12439477388468409,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.1412505808390819,0.1568191634660116,6,0.06402115539697233,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.2774793402120622,0.1412505808390819,0.12439477388468409,0.06402115539697233,0.3674385978099713,1,0.40187411409674634,0.20527173623605421,0.5925359738762941,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_46,0.38183529029505997,0.3506909862386374,5,0.1568337768652073,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.2774793402120622,0.38183529029505997,0.12439477388468409,0.1568337768652073,0.6169785681466446,1,0.40187411409674634,0.5386690671602673,0.5925359738762941,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,0.19269214244754673,0.19064136461397233,6,0.0778290111953522,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.1752164653906858,0.19269214244754673,0.06326589872958642,0.0778290111953522,0.8652999071849916,1,0.23848236412027224,0.2705211536428989,0.29757326900718883,0,23,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_46,0.1752164653906858,0.1549691700060812,6,0.06326589872958642,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.17326140135286763,0.07043993694038383,6,0.028756983836294017,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.1752164653906858,0.17326140135286763,0.06326589872958642,0.028756983836294017,0.9783437586140382,1,0.23848236412027224,0.20201838518916165,0.29757326900718883,0,23,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_46,0.15320338554489724,0.15473579026327997,5,0.06919994911616881,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.1752164653906858,0.15320338554489724,0.06326589872958642,0.06919994911616881,0.8198456429432361,1,0.23848236412027224,0.22240333466106604,0.29757326900718883,0,23,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,0.18307194530184026,0.08139922391930512,6,0.03323109401014151,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.20475518990937153,0.18307194530184026,0.09198238288700905,0.03323109401014151,0.8332392049964743,1,0.2967375727963806,0.21630303931198178,0.3455768518401945,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_46,0.20475518990937153,0.2056788608677656,5,0.09198238288700905,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.24848758441912575,0.16086580523443547,6,0.06567318998105104,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.20475518990937153,0.24848758441912575,0.09198238288700905,0.06567318998105104,0.7094793972680351,1,0.2967375727963806,0.31416077440017676,0.3455768518401945,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_46,0.20142369454613748,0.18350566786921751,6,0.0749158751980375,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.20475518990937153,0.20142369454613748,0.09198238288700905,0.0749158751980375,0.9782685971311955,1,0.2967375727963806,0.27633956974417495,0.3455768518401945,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,0.15698771388309588,0.09877717225258677,6,0.04032561170897308,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.14349876539092943,0.15698771388309588,0.04841546115276568,0.04032561170897308,0.8356615941362319,1,0.1919142265436951,0.19731332559206896,0.21704465815127588,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_46,0.14349876539092943,0.1082602622995844,5,0.04841546115276568,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.12698981021748645,0.13300819567014993,6,0.0543003685000217,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.14349876539092943,0.12698981021748645,0.04841546115276568,0.0543003685000217,0.8255513930254629,1,0.1919142265436951,0.18129017871750816,0.21704465815127588,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_46,0.12527806432457758,0.12279247475404317,6,0.050129817900165186,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.14349876539092943,0.12527806432457758,0.04841546115276568,0.050129817900165186,0.7996689481815352,1,0.1919142265436951,0.17540788222474277,0.21704465815127588,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,0.068683930152129,0.05180360693545305,6,0.021148733971260627,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.11926239323748715,0.068683930152129,0.049170756087890406,0.021148733971260627,0.37709995016392867,1,0.16843314932537756,0.08983266412338962,0.18527646425791533,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_46,0.11926239323748715,0.12044326268218106,6,0.049170756087890406,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.05878293326281292,0.05555647283929139,6,0.02268083506084275,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.11926239323748715,0.05878293326281292,0.049170756087890406,0.02268083506084275,0.30072492417819957,1,0.16843314932537756,0.08146376832365568,0.18527646425791533,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_46,0.11030756382763822,0.10626770517044909,6,0.04338360896735366,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.11926239323748715,0.11030756382763822,0.049170756087890406,0.04338360896735366,0.894129007833494,1,0.16843314932537756,0.1536911727949919,0.18527646425791533,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,0.14282007967556787,0.07795669614171508,6,0.03182568793006601,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.15368579513849415,0.14282007967556787,0.05227536310508508,0.03182568793006601,0.8633610081384535,1,0.20596115824357922,0.17464576760563388,0.22655727406793716,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_46,0.15368579513849415,0.12804796572617208,6,0.05227536310508508,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.07234306898678462,0.07393903695026321,6,0.03018548543348936,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.15368579513849415,0.07234306898678462,0.05227536310508508,0.03018548543348936,0.21472491485922507,1,0.20596115824357922,0.10252855442027398,0.22655727406793716,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_46,0.10152107879084848,0.14197131541283106,6,0.057959546812194174,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.15368579513849415,0.10152107879084848,0.05227536310508508,0.057959546812194174,0.5192027935810515,1,0.20596115824357922,0.15948062560304266,0.22655727406793716,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,0.11372082953869533,0.034575913815692624,6,0.014115557706482379,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.18408916667732989,0.11372082953869533,0.055830139793220525,0.014115557706482379,0.2703539439044992,1,0.2399193064705504,0.1278363872451777,0.26391123711760545,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_46,0.18408916667732989,0.1367553547616446,6,0.055830139793220525,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.0749445198700766,0.07743407342873684,6,0.03161232810093506,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.18408916667732989,0.0749445198700766,0.055830139793220525,0.03161232810093506,0.12777071695371148,1,0.2399193064705504,0.10655684797101166,0.26391123711760545,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_46,0.12013225526126929,0.0470637869882128,6,0.019213710580693277,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.18408916667732989,0.12013225526126929,0.055830139793220525,0.019213710580693277,0.319231921025694,1,0.2399193064705504,0.13934596584196257,0.26391123711760545,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_46,0.16809718133795024,0.1157522274192608,6,0.04725564896129752,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.15484607421015228,0.16809718133795024,0.05265037273245844,0.04725564896129752,0.8552120197151953,1,0.2074964469426107,0.21535283029924776,0.3183395016834203,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_46,0.15484607421015228,0.12896654796186807,6,0.05265037273245844,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_46,0.1854202201034867,0.2546962946575886,6,0.10397932688144088,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.15484607421015228,0.1854202201034867,0.05265037273245844,0.10397932688144088,0.8002169997220454,1,0.2074964469426107,0.28939954698492754,0.3183395016834203,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_46,0.10703911844864071,0.1401250321520038,6,0.0572058048272494,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.15484607421015228,0.10703911844864071,0.05265037273245844,0.0572058048272494,0.5524436223773607,1,0.2074964469426107,0.1642449232758901,0.3183395016834203,0,24,0,9.690730688935282,L-glutamine_peak_2,glutamine_156_245_rt9.80,9.718353659,9.73,0.032920753,9.8,9.49,0.31,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,0.11462587035215248,0.1264522472006024,6,0.05162391374495975,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.14241437308536647,0.11462587035215248,0.10034762124130883,0.05162391374495975,0.8136225611603979,1,0.2427619943266753,0.16624978409711222,0.26703819375934285,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_54,0.14241437308536647,0.22438410247596838,5,0.10034762124130883,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.10512689995081015,0.06823888081697821,6,0.02785840643669865,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.14241437308536647,0.10512689995081015,0.10034762124130883,0.02785840643669865,0.7360888000110353,1,0.2427619943266753,0.1329853063875088,0.26703819375934285,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_54,0.13177270768319627,0.11890869351356861,5,0.05317758436240554,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.14241437308536647,0.13177270768319627,0.10034762124130883,0.05317758436240554,0.928355107719326,1,0.2427619943266753,0.18495029204560182,0.26703819375934285,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,0.17878738928930202,0.1653379713237199,6,0.06749894414167186,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.05368738085634458,0.17878738928930202,0.00947815322071498,0.06749894414167186,0.1236820067271333,1,0.06316553407705956,0.2462863334309739,0.2709149667740713,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_54,0.05368738085634458,0.023216639094668687,6,0.00947815322071498,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.0856846429032266,0.09483098323508268,6,0.038714586788729764,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.05368738085634458,0.0856846429032266,0.00947815322071498,0.038714586788729764,0.45482596180179286,1,0.06316553407705956,0.12439922969195635,0.2709149667740713,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_54,0.06511050402890255,0.060754997247746384,6,0.024803123763529167,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.05368738085634458,0.06511050402890255,0.00947815322071498,0.024803123763529167,0.6810909115805639,1,0.06316553407705956,0.08991362779243171,0.2709149667740713,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,0.10283977817521757,0.0972087619020198,6,0.03968531086460828,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.19164447038742133,0.10283977817521757,0.04893770134980513,0.03968531086460828,0.19562908107978585,1,0.24058217173722646,0.14252508903982586,0.30696395111090563,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_54,0.19164447038742133,0.10942802688074749,5,0.04893770134980513,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.2190139491082744,0.14707762326953605,6,0.060044188265276174,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.19164447038742133,0.2190139491082744,0.04893770134980513,0.060044188265276174,0.7320405109367322,1,0.24058217173722646,0.27905813737355056,0.30696395111090563,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_54,0.13084409428991198,0.05149127750503426,6,0.021021226015230605,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.19164447038742133,0.13084409428991198,0.04893770134980513,0.021021226015230605,0.3011945139147424,1,0.24058217173722646,0.15186532030514258,0.30696395111090563,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,0.10627512729824184,0.09592233895113707,6,0.03916013089409693,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.0951186195274408,0.10627512729824184,0.053179814701399354,0.03916013089409693,0.8702039711531121,1,0.14829843422884015,0.14543525819233877,0.19099607695367912,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_54,0.0951186195274408,0.11891368070317164,5,0.053179814701399354,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.09430935236066691,0.049406180862536314,6,0.020169988875478877,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.0951186195274408,0.09430935236066691,0.053179814701399354,0.020169988875478877,0.9891826505868048,1,0.14829843422884015,0.11447934123614578,0.19099607695367912,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_54,0.14076543983233814,0.08050825481947375,6,0.03286735739827922,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.0951186195274408,0.14076543983233814,0.053179814701399354,0.03286735739827922,0.4895393112720927,1,0.14829843422884015,0.17363279723061736,0.19099607695367912,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,0.043261372757403826,0.054271083028982536,6,0.02215607686820449,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.0477580614000952,0.043261372757403826,0.006796845418001873,0.02215607686820449,0.8526248695482816,1,0.05455490681809707,0.06541744962560832,0.09724716655338111,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_54,0.0477580614000952,0.01664880313467843,6,0.006796845418001873,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.03117072800307885,0.04012547486548854,6,0.0163811565178864,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.0477580614000952,0.03117072800307885,0.006796845418001873,0.0163811565178864,0.38225117189981933,1,0.05455490681809707,0.04755188452096525,0.09724716655338111,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_54,0.06529099381791292,0.056621232153479105,6,0.02311552123061536,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.0477580614000952,0.06529099381791292,0.006796845418001873,0.02311552123061536,0.49484836994142356,1,0.05455490681809707,0.08840651504852828,0.09724716655338111,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,0.06928326520836985,0.05506976205799591,6,0.022482136216428538,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.12733273908578524,0.06928326520836985,0.023489717103519082,0.022482136216428538,0.1045767265617704,1,0.15082245618930432,0.09176540142479839,0.16590470180823477,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_54,0.12733273908578524,0.05753782110594857,6,0.023489717103519082,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.07301524381023568,0.12382629687829368,6,0.05055187401503418,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.12733273908578524,0.07301524381023568,0.023489717103519082,0.05055187401503418,0.362026629816867,1,0.15082245618930432,0.12356711782526986,0.16590470180823477,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_54,0.06867884337489179,0.05856369899966467,6,0.023908529999853347,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.12733273908578524,0.06867884337489179,0.023489717103519082,0.023908529999853347,0.11069432005133512,1,0.15082245618930432,0.09258737337474514,0.16590470180823477,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,0.03349166459677422,0.04763377417989759,6,0.01944640687728489,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.054914710791510966,0.03349166459677422,0.015794771961399327,0.01944640687728489,0.41332422140421954,1,0.0707094827529103,0.05293807147405911,0.10367961073490992,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_54,0.054914710791510966,0.03868913190904699,6,0.015794771961399327,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.05652115916443501,0.08092637544890222,6,0.03303805443045107,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.054914710791510966,0.05652115916443501,0.015794771961399327,0.03303805443045107,0.9662055485861459,1,0.0707094827529103,0.08955921359488608,0.10367961073490992,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_54,0.07241844462419837,0.05348643818736405,6,0.021835746952992455,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.054914710791510966,0.07241844462419837,0.015794771961399327,0.021835746952992455,0.5320508351159254,1,0.0707094827529103,0.09425419157719082,0.10367961073490992,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_54,0.04551045367120551,0.0462799802151665,6,0.01889372280554313,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.10388772985290196,0.04551045367120551,0.041387441915308465,0.01889372280554313,0.24030841023985483,1,0.14527517176821042,0.06440417647674863,0.21460445225273492,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_54,0.10388772985290196,0.10137811445158265,6,0.041387441915308465,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_54,0.11326190465603636,0.200449221341204,6,0.08183305193735903,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.10388772985290196,0.11326190465603636,0.041387441915308465,0.08183305193735903,0.9212950729798864,1,0.14527517176821042,0.19509495659339537,0.21460445225273492,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_54,0.07918462231910928,0.035250785793810226,6,0.014391073037830854,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.10388772985290196,0.07918462231910928,0.041387441915308465,0.014391073037830854,0.5927319605008623,1,0.14527517176821042,0.09357569535694013,0.21460445225273492,0,24,0,5.205146443514645,L-glycine_peak_2,glycine_174_248_rt.5.31,5.216463415,5.22,0.024762526,5.23,5.02,0.21,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.18010384008195335,0.2281250454894031,6,0.09313165983303981,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.052454347382875355,0.18010384008195335,0.024036509340271316,0.09313165983303981,0.235506851684491,1,0.07649085672314668,0.2732354999149932,0.3005590499064925,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_109,0.052454347382875355,0.05374726882665529,5,0.024036509340271316,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.07354384651498676,0.05261645287779048,6,0.02148057693763037,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.052454347382875355,0.07354384651498676,0.024036509340271316,0.02148057693763037,0.5301358839889574,1,0.07649085672314668,0.09502442345261713,0.3005590499064925,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_109,0.12375498146931711,0.10492280924376331,5,0.04692290677185961,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.052454347382875355,0.12375498146931711,0.024036509340271316,0.04692290677185961,0.22526822987159156,1,0.07649085672314668,0.17067788824117672,0.3005590499064925,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.05490322695615483,0.05944083786428917,6,0.024266620441835716,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.09523155790286437,0.05490322695615483,0.03706046640695303,0.024266620441835716,0.3873659857880276,1,0.1322920243098174,0.07916984739799054,0.21404218123360222,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_109,0.09523155790286437,0.09077923232659198,6,0.03706046640695303,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.10875576754927081,0.1045780130219387,6,0.04269379503631408,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.09523155790286437,0.10875576754927081,0.03706046640695303,0.04269379503631408,0.8158625997303097,1,0.1322920243098174,0.1514495625855849,0.21404218123360222,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_109,0.14356738876442984,0.12496417878213388,6,0.051016412357026704,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.09523155790286437,0.14356738876442984,0.03706046640695303,0.051016412357026704,0.4627157647759337,1,0.1322920243098174,0.19458380112145654,0.21404218123360222,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.05175947485257115,0.06227705886101135,6,0.025424502815125257,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.1072165669766699,0.05175947485257115,0.04263170620152445,0.025424502815125257,0.30247916849541506,1,0.14984827317819435,0.07718397766769641,0.1648331004960138,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_109,0.1072165669766699,0.09532739306340803,5,0.04263170620152445,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.13116884628291417,0.03307753300664379,6,0.013503846302724332,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.1072165669766699,0.13116884628291417,0.04263170620152445,0.013503846302724332,0.6160779225563506,1,0.14984827317819435,0.1446726925856385,0.1648331004960138,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_109,0.08191614633603266,0.05205224964997655,6,0.02125024193440114,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.1072165669766699,0.08191614633603266,0.04263170620152445,0.02125024193440114,0.6145833637315267,1,0.14984827317819435,0.1031663882704338,0.1648331004960138,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.09565937234158677,0.116077551563657,6,0.047388461987093886,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.2622381241438688,0.09565937234158677,0.1181252544672338,0.047388461987093886,0.2446565896811637,1,0.38036337861110264,0.14304783432868065,0.46513992350916394,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_109,0.2622381241438688,0.2641360988481955,5,0.1181252544672338,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.27648936116643125,0.35851984728383407,6,0.1463651147509905,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.2622381241438688,0.27648936116643125,0.1181252544672338,0.1463651147509905,0.941276267908733,1,0.38036337861110264,0.42285447591742176,0.46513992350916394,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_109,0.18993946369523218,0.11935777190448993,6,0.048727606333583716,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.2622381241438688,0.18993946369523218,0.1181252544672338,0.048727606333583716,0.5944265004834772,1,0.38036337861110264,0.2386670700288159,0.46513992350916394,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.0833497405119507,0.07365675259792111,6,0.030070243329220994,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.030595375642805456,0.0833497405119507,0.009449562451439825,0.030070243329220994,0.14540168128970335,1,0.04004493809424528,0.11341998384117169,0.16022614647294298,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_109,0.030595375642805456,0.023146606298590913,6,0.009449562451439825,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.10432128057082246,0.10125909538880874,6,0.041338852586398404,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.030595375642805456,0.10432128057082246,0.009449562451439825,0.041338852586398404,0.1370470834546382,1,0.04004493809424528,0.14566013315722087,0.16022614647294298,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_109,0.0952986255135233,0.08335481941712121,6,0.03402946252896375,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.030595375642805456,0.0952986255135233,0.009449562451439825,0.03402946252896375,0.11864100239160466,1,0.04004493809424528,0.12932808804248705,0.16022614647294298,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.06230033350567665,0.05145695995507224,6,0.0210072159341257,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.060217575627683186,0.06230033350567665,0.019885574419222115,0.0210072159341257,0.9440243450181882,1,0.0801031500469053,0.08330754943980236,0.09792562302386351,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_109,0.060217575627683186,0.04870951056923612,6,0.019885574419222115,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.06318206550883398,0.06329782329244352,6,0.025841228149223756,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.060217575627683186,0.06318206550883398,0.019885574419222115,0.025841228149223756,0.9294703178286035,1,0.0801031500469053,0.08902329365805774,0.09792562302386351,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_109,0.055417279865961566,0.046257358322672054,6,0.018884487456605214,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.060217575627683186,0.055417279865961566,0.019885574419222115,0.018884487456605214,0.864549332354345,1,0.0801031500469053,0.07430176732256678,0.09792562302386351,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.06804605120159168,0.08511756662700519,6,0.03474910106391883,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.11211516158874717,0.06804605120159168,0.0325850196950346,0.03474910106391883,0.3767846138977925,1,0.14470018128378176,0.10279515226551052,0.15917019941215996,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_109,0.11211516158874717,0.07981667151137509,6,0.0325850196950346,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.08789794657863255,0.06458375435262503,6,0.026366207306197244,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.11211516158874717,0.08789794657863255,0.0325850196950346,0.026366207306197244,0.5767523425983185,1,0.14470018128378176,0.1142641538848298,0.15917019941215996,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_109,0.10079671782166244,0.055149055140151684,6,0.022514507481664243,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.11211516158874717,0.10079671782166244,0.0325850196950346,0.022514507481664243,0.7816015721505992,1,0.14470018128378176,0.12331122530332668,0.15917019941215996,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_109,0.05336341296793893,0.046571730532043464,6,0.01901282937365044,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.08211467518548037,0.05336341296793893,0.03269611300154584,0.01901282937365044,0.4688715045832469,1,0.1148107881870262,0.07237624234158938,0.1367509285871766,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_109,0.08211467518548037,0.08008879342616623,6,0.03269611300154584,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_109,0.11071280121428669,0.0333283080220517,6,0.01360622477405566,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.08211467518548037,0.11071280121428669,0.03269611300154584,0.01360622477405566,0.44714997208660157,1,0.1148107881870262,0.12431902598834235,0.1367509285871766,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_109,0.06899042800214887,0.07177844951702075,6,0.02930342930747042,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.08211467518548037,0.06899042800214887,0.03269611300154584,0.02930342930747042,0.7711941541140293,1,0.1148107881870262,0.09829385730961929,0.1367509285871766,0,24,0,13.209157894736842,L-tryptophan_peak_2,tryptophan_130_218_rt13.35,13.2168323,13.22,0.006166681,13.23,13.17,0.06,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.090432977811277307,0.08250625351589261,6,0.033683036950441246,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.2326670179810027,0.090432977811277307,0.15672442559435262,0.033683036950441246,0.4210643247112376,1,0.3893914435753553,0.12411601476171855,0.4283305879328909,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_28,0.2326670179810027,0.35044646936358037,5,0.15672442559435262,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.13340263150335074,0.1418694728955034,6,0.057917969778598616,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.2326670179810027,0.13340263150335074,0.15672442559435262,0.057917969778598616,0.5778605306610116,1,0.3893914435753553,0.19132060128194936,0.4283305879328909,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_28,0.2443676691010686,0.22679079578060513,5,0.1014239272073411,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.2326670179810027,0.2443676691010686,0.15672442559435262,0.1014239272073411,0.9518126762861207,1,0.3893914435753553,0.3457915963084097,0.4283305879328909,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.1747736713951001,0.15187760255283386,6,0.062003771601944466,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.29204348945851694,0.1747736713951001,0.07935602751687766,0.062003771601944466,0.2727963878078004,1,0.3713995169753946,0.23677744299704456,0.40853946867293406,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_28,0.29204348945851694,0.19438177543061144,6,0.07935602751687766,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.20520215144389867,0.23070425046140308,6,0.09418461585361469,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.29204348945851694,0.20520215144389867,0.07935602751687766,0.09418461585361469,0.4972860836229789,1,0.3713995169753946,0.29938676729751335,0.40853946867293406,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_28,0.16517387929334834,0.191678231796903,6,0.07825231045022173,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.29204348945851694,0.16517387929334834,0.07935602751687766,0.07825231045022173,0.2815092160739889,1,0.3713995169753946,0.24342618974357005,0.40853946867293406,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.15792186770771124,0.2528752510374799,6,0.10323588893667138,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.2672394373903527,0.15792186770771124,0.14049874733107492,0.10323588893667138,0.5488102185965338,1,0.40773818472142764,0.2611577566443826,0.9564982424538239,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_28,0.2672394373903527,0.3141647497858507,5,0.14049874733107492,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.5419714343167876,0.8023852888329769,6,0.3275724224594158,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.2672394373903527,0.5419714343167876,0.14049874733107492,0.3275724224594158,0.46704718138291723,1,0.40773818472142764,0.8695438567762035,0.9564982424538239,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_28,0.2951060563334871,0.2808976587194135,6,0.11467598896750221,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.2672394373903527,0.2951060563334871,0.14049874733107492,0.11467598896750221,0.881597598832352,1,0.40773818472142764,0.4097820453009893,0.9564982424538239,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.29533778656935566,0.3017477300907178,6,0.12318799496088671,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.31488108008357524,0.29533778656935566,0.1186803195345061,0.12318799496088671,0.9115609562899417,1,0.4335613996180813,0.4185257815302424,0.47691753957988947,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_28,0.31488108008357524,0.26537726207055184,5,0.1186803195345061,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.21688729927774963,0.13509172210722625,6,0.05515096460609437,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.31488108008357524,0.21688729927774963,0.1186803195345061,0.05515096460609437,0.4837148270073972,1,0.4335613996180813,0.272038263883844,0.47691753957988947,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_28,0.17392670271802632,0.1233467583714546,6,0.05035610323940553,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.31488108008357524,0.17392670271802632,0.1186803195345061,0.05035610323940553,0.32036831138812905,1,0.4335613996180813,0.22428280595743186,0.47691753957988947,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.18599397833670897,0.16915998524188547,6,0.06905927478989204,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.155109608220695,0.18599397833670897,0.07858952315022624,0.06905927478989204,0.7739749955402874,1,0.23369913137092124,0.255053253126601,0.28055857843926113,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_28,0.155109608220695,0.1925042308467003,6,0.07858952315022624,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.1215684705163859,0.13637972985544344,6,0.05567679156740825,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.155109608220695,0.1215684705163859,0.07858952315022624,0.05567679156740825,0.7356509502328277,1,0.23369913137092124,0.17724526208379415,0.28055857843926113,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_28,0.13208635489399212,0.12268310395100647,6,0.05008516745679879,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.155109608220695,0.13208635489399212,0.07858952315022624,0.05008516745679879,0.8107413423153309,1,0.23369913137092124,0.18217152235079093,0.28055857843926113,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.17146903550683334,0.18425414777154955,6,0.07522144083861111,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.15145794185182293,0.17146903550683334,0.04700735563294724,0.07522144083861111,0.8269120676620026,1,0.19846529748477015,0.24669047634544444,0.29859617201287375,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_28,0.15145794185182293,0.11514403545826529,6,0.04700735563294724,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.19016115762152075,0.19911879545745131,6,0.08128990784472812,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.15145794185182293,0.19016115762152075,0.04700735563294724,0.08128990784472812,0.6910332570158375,1,0.19846529748477015,0.27145106546624886,0.29859617201287375,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_28,0.15988376274597535,0.08749899784741497,6,0.035721316288508394,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.15145794185182293,0.15988376274597535,0.04700735563294724,0.035721316288508394,0.8895504549920491,1,0.19846529748477015,0.19560507903448374,0.29859617201287375,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.12557355043878685,0.0519896523514377,6,0.021224686694285,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.19488383303094184,0.12557355043878685,0.0890468700347171,0.021224686694285,0.4797711022531419,1,0.28393070306565893,0.14679823713307186,0.31232377337222483,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_28,0.19488383303094184,0.21811939477698628,6,0.0890468700347171,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.10117798476968083,0.06576136348598455,6,0.0268469642217259,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.19488383303094184,0.10117798476968083,0.0890468700347171,0.0268469642217259,0.3531906548442218,1,0.28393070306565893,0.12802494899140673,0.31232377337222483,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_28,0.16417426721899453,0.1101206564943307,6,0.04495656975856881,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.19488383303094184,0.16417426721899453,0.0890468700347171,0.04495656975856881,0.766682148709577,1,0.28393070306565893,0.20913083697756335,0.31232377337222483,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_28,0.174177209028436,0.15415467314541154,6,0.06293338177862984,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.12734346148898198,0.174177209028436,0.04741395334929925,0.06293338177862984,0.566450306564694,1,0.17475741483828122,0.23711059080706584,0.46683611476858006,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_28,0.12734346148898198,0.11613999239390861,6,0.04741395334929925,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_28,0.32981808035250443,0.23166879036154533,6,0.09457838761893196,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.12734346148898198,0.32981808035250443,0.04741395334929925,0.09457838761893196,0.09515062899709964,1,0.17475741483828122,0.4243964679714364,0.46683611476858006,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_28,0.2162710264250526,0.1259864204054558,6,0.05143374075218888,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.12734346148898198,0.2162710264250526,0.04741395334929925,0.05143374075218888,0.23260176899546772,1,0.17475741483828122,0.2677047671772415,0.46683611476858006,0,24,0,12.44442105263158,fructose-6-phosphate_peak_2,fructose-6-phosphate_459_315_rt12.57,12.44559006,12.45,0.013268606,12.47,12.42,0.05,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.1524273695741546,0.09976707182024716,6,0.04072973651520135,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.1985805506634227,0.1524273695741546,0.11042415783959482,0.04072973651520135,0.710847539830793,1,0.30900470850301753,0.19315710608935593,0.3399051793533193,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_31,0.1985805506634227,0.24691592328750034,5,0.11042415783959482,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.14665975965182776,0.08654499591709858,6,0.0353318466313575,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.1985805506634227,0.14665975965182776,0.11042415783959482,0.0353318466313575,0.6736820423865445,1,0.30900470850301753,0.18199160628318525,0.3399051793533193,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_31,0.11217141128666319,0.1445873313119556,5,0.06466142029976332,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.1985805506634227,0.11217141128666319,0.11042415783959482,0.06466142029976332,0.5229508425685043,1,0.30900470850301753,0.17683283158642651,0.3399051793533193,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.11386447256201455,0.1120994766625062,6,0.04576441970936187,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.05994199463360206,0.11386447256201455,0.019988328221749632,0.04576441970936187,0.3168396562210713,1,0.07993032285535169,0.15962889227137642,0.2200193056957203,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_31,0.05994199463360206,0.04896120495455924,6,0.019988328221749632,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.10892339136347706,0.060244847490788574,6,0.024594855997370584,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.05994199463360206,0.10892339136347706,0.019988328221749632,0.024594855997370584,0.15452856234678264,1,0.07993032285535169,0.13351824736084764,0.2200193056957203,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_31,0.14990076488660029,0.12276055262577737,6,0.05011678574587271,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.05994199463360206,0.14990076488660029,0.019988328221749632,0.05011678574587271,0.14232749064666753,1,0.07993032285535169,0.200017550632473,0.2200193056957203,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.15012826615063943,0.2266516781185243,6,0.0925301601226533,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.11163119064708696,0.15012826615063943,0.0536373893853639,0.0925301601226533,0.7284132926131235,1,0.16526858003245087,0.24265842627329273,0.31064231425387917,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_31,0.11163119064708696,0.11993684880129935,5,0.0536373893853639,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.20991955651793748,0.1568366722251902,6,0.06402830331797514,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.11163119064708696,0.20991955651793748,0.0536373893853639,0.06402830331797514,0.2696049388052985,1,0.16526858003245087,0.27394785983591263,0.31064231425387917,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_31,0.20649219291720367,0.18594054824750947,6,0.07590991094995919,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.11163119064708696,0.20649219291720367,0.0536373893853639,0.07590991094995919,0.33539859527362137,1,0.16526858003245087,0.28240210386716286,0.31064231425387917,2,24,8.333333333333332,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.07658679091881186,0.09737068800812526,6,0.03975141692060731,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.20503237022765425,0.07658679091881186,0.11043550437374351,0.03975141692060731,0.32336117747406307,1,0.31546787460139775,0.11633820783941917,0.3470146620615375,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_31,0.20503237022765425,0.24694129490916586,5,0.11043550437374351,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.08873936404338816,0.04310329114317123,6,0.017596844922565823,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.20503237022765425,0.08873936404338816,0.11043550437374351,0.017596844922565823,0.3544513718944617,1,0.31546787460139775,0.10633620896595397,0.3470146620615375,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_31,0.11586720759701552,0.12029400482741745,6,0.049109821823844865,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.20503237022765425,0.11586720759701552,0.11043550437374351,0.049109821823844865,0.4905983762378503,1,0.31546787460139775,0.1649770294208604,0.3470146620615375,1,24,4.166666666666666,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.0321063754937263,0.01993750415911157,6,0.008139451989073457,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,*,0.007001773392423767,0.0321063754937263,0.0028390166591205513,0.008139451989073457,0.025912258517433003,0.621894204418392,0.00984079005154432,0.040245827482799756,0.14273691375456993,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_31,0.007001773392423767,0.006954142186106356,6,0.0028390166591205513,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.07637791309108517,0.13076090908851654,6,0.05338291759488749,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.007001773392423767,0.07637791309108517,0.0028390166591205513,0.05338291759488749,0.2507111141488967,1,0.00984079005154432,0.12976083068597266,0.14273691375456993,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_31,0.02350817758248162,0.025250060731516928,6,0.010308294127750505,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.007001773392423767,0.02350817758248162,0.0028390166591205513,0.010308294127750505,0.17567290757818105,1,0.00984079005154432,0.033816471710232124,0.14273691375456993,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.021718128536674024,0.013213825031257252,6,0.005394521479499375,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.04272939180223053,0.021718128536674024,0.00802746992052432,0.005394521479499375,0.05872167762189844,1,0.05075686172275485,0.027112650016173398,0.12601749499248227,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_31,0.04272939180223053,0.019663205230824817,6,0.00802746992052432,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.05869050285400471,0.11228256027929583,6,0.045839163282928176,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.04272939180223053,0.05869050285400471,0.00802746992052432,0.045839163282928176,0.744787402927555,1,0.05075686172275485,0.10452966613693289,0.12601749499248227,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_31,0.07218433537317319,0.10380208490953298,6,0.042377023710901594,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.04272939180223053,0.07218433537317319,0.00802746992052432,0.042377023710901594,0.523062488413002,1,0.05075686172275485,0.11456135908407478,0.12601749499248227,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.024099565832326864,0.02644288196573706,6,0.01079526135744987,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.026335820089175305,0.024099565832326864,0.01126913143273125,0.01079526135744987,0.8889054031874082,1,0.03760495152190656,0.03489482718977673,0.0659502703416424,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_31,0.026335820089175305,0.027603621854550696,6,0.01126913143273125,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.037939245719859814,0.05392685288357343,6,0.022015545499815097,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.026335820089175305,0.037939245719859814,0.01126913143273125,0.022015545499815097,0.6523708800424783,1,0.03760495152190656,0.05995479121967491,0.0659502703416424,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_31,0.022886449693604982,0.012956425876506947,6,0.00528943871460572,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.026335820089175305,0.022886449693604982,0.01126913143273125,0.00528943871460572,0.7896071539546359,1,0.03760495152190656,0.0281758884082107,0.0659502703416424,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_31,0.0801967287527751,0.054469566021949606,6,0.02223710721076945,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.10339156389680275,0.0801967287527751,0.04639029661765572,0.02223710721076945,0.6653804579361622,1,0.14978186051445846,0.10243383596354455,0.1791546123861466,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_31,0.10339156389680275,0.11363255572961685,6,0.04639029661765572,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_31,0.0944018559285753,0.1677066998506796,6,0.06846597351337615,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.10339156389680275,0.0944018559285753,0.04639029661765572,0.06846597351337615,0.9158809789794078,1,0.14978186051445846,0.16286782944195144,0.1791546123861466,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_31,0.058886506527054516,0.06304314021319718,6,0.025737254217511368,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.10339156389680275,0.058886506527054516,0.04639029661765572,0.025737254217511368,0.4264483499981503,1,0.14978186051445846,0.08462376074456589,0.1791546123861466,0,24,0,8.568482587064677,fucose_peak_2,fucose_117_160_rt8.64,8.552628205,8.58,0.061298973,8.73,8.44,0.29,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.020779616385207866,0.01700858899189002,6,0.00694372737914158,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,*,0.11427202097748443,0.020779616385207866,0.033025569185571535,0.00694372737914158,0.04578074240843348,1,0.14729759016305596,0.027723343764349446,0.16202734917936157,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_34,0.11427202097748443,0.07384741769456032,5,0.033025569185571535,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.05086203670059275,0.022200411906626766,6,0.009063280208473967,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.11427202097748443,0.05086203670059275,0.033025569185571535,0.009063280208473967,0.1282920202766295,1,0.14729759016305596,0.05992531690906672,0.16202734917936157,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_34,0.08268210154824569,0.07030455114053755,5,0.03144115109557046,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.11427202097748443,0.08268210154824569,0.033025569185571535,0.03144115109557046,0.5081004020983155,1,0.14729759016305596,0.11412325264381615,0.16202734917936157,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.012444717979746075,0.016739399006901474,6,0.006833831027960014,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.025781696504436402,0.012444717979746075,0.0061688269307809025,0.006833831027960014,0.1783576117992439,1,0.0319505234352173,0.019278549007706088,0.06892851209711615,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_34,0.025781696504436402,0.015110478291952454,6,0.0061688269307809025,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.04951556675295669,0.032202748373438825,6,0.013146716971694348,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.025781696504436402,0.04951556675295669,0.0061688269307809025,0.013146716971694348,0.1456023914961636,1,0.0319505234352173,0.06266228372465103,0.06892851209711615,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_34,0.02718716989433882,0.008095976719016771,6,0.0033051686551738317,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.025781696504436402,0.02718716989433882,0.0061688269307809025,0.0033051686551738317,0.846069398627854,1,0.0319505234352173,0.03049233854951265,0.06892851209711615,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.03807396228783063,0.04229735653116504,6,0.01726782349498864,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.04467345875911803,0.03807396228783063,0.014700162308385462,0.01726782349498864,0.7776510355821127,1,0.05937362106750349,0.05534178578281927,0.07863373837153662,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_34,0.04467345875911803,0.03287056220183012,5,0.014700162308385462,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.056195901703397055,0.03745102026178165,6,0.015289314997999856,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.04467345875911803,0.056195901703397055,0.014700162308385462,0.015289314997999856,0.6002136311589978,1,0.05937362106750349,0.07148521670139692,0.07863373837153662,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_34,0.024091772112373677,0.016607204143708414,6,0.006779862701053342,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.04467345875911803,0.024091772112373677,0.014700162308385462,0.006779862701053342,0.25318970446788747,1,0.05937362106750349,0.03087163481342702,0.07863373837153662,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.025430131008682782,0.019137807288875406,6,0.007812977108910242,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.03007629176194948,0.025430131008682782,0.015002115490267092,0.007812977108910242,0.7926198665922944,1,0.045078407252216575,0.033243108117593026,0.10545746619352951,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_34,0.03007629176194948,0.033545750042539804,5,0.015002115490267092,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.05998591649856796,0.08789873258981347,6,0.03588450731373159,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.03007629176194948,0.05998591649856796,0.015002115490267092,0.03588450731373159,0.468332439028069,1,0.045078407252216575,0.09587042381229954,0.10545746619352951,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_34,0.06310403556018462,0.06420973136586292,6,0.02621351306125742,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.03007629176194948,0.06310403556018462,0.015002115490267092,0.02621351306125742,0.3069007235929633,1,0.045078407252216575,0.08931754862144205,0.10545746619352951,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.03718358200693217,0.02322162262150249,6,0.009480187737025362,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.054629375893454846,0.03718358200693217,0.026998066519273754,0.009480187737025362,0.5636802084618291,1,0.0816274424127286,0.04666376974395753,0.08979018665400146,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_34,0.054629375893454846,0.06613148701393899,6,0.026998066519273754,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.04390885840830908,0.05110968489506393,6,0.020865441484556574,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.054629375893454846,0.04390885840830908,0.026998066519273754,0.020865441484556574,0.7602376967724847,1,0.0816274424127286,0.06477429989286565,0.08979018665400146,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_34,0.05621701966264592,0.04177248117226022,6,0.017053544027009142,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.054629375893454846,0.05621701966264592,0.026998066519273754,0.017053544027009142,0.9615035001037235,1,0.0816274424127286,0.07327056368965507,0.08979018665400146,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.027337368645779254,0.011383855549753387,6,0.00464743956707438,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.07100965806035416,0.027337368645779254,0.04280426687831491,0.00464743956707438,0.35595806665028096,1,0.11381392493866907,0.031984808212853634,0.12519531743253598,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_34,0.07100965806035416,0.10484861266578609,6,0.04280426687831491,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.0733460476271713,0.05065249896423372,6,0.02067879610987101,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.07100965806035416,0.0733460476271713,0.04280426687831491,0.02067879610987101,0.9621343957704214,1,0.11381392493866907,0.09402484373704231,0.12519531743253598,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_34,0.04617340160070249,0.018550514659879645,6,0.007573215897120695,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.07100965806035416,0.04617340160070249,0.04280426687831491,0.007573215897120695,0.59108484207473,1,0.11381392493866907,0.05374661749782318,0.12519531743253598,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.07184171231713436,0.037521960687706246,6,0.01531827630560835,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.10149376786851771,0.07184171231713436,0.04589780693828741,0.01531827630560835,0.5621331295758689,1,0.14739157480680512,0.08715998862274271,0.16213073228748565,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_34,0.10149376786851771,0.11242620731157758,6,0.04589780693828741,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.07850495370879311,0.06547454916322659,6,0.02672987276477941,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.10149376786851771,0.07850495370879311,0.04589780693828741,0.02672987276477941,0.6765189975496271,1,0.14739157480680512,0.10523482647357252,0.16213073228748565,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_34,0.11374671638191562,0.06442289576150599,6,0.02630053706136647,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.10149376786851771,0.11374671638191562,0.04589780693828741,0.02630053706136647,0.8226673242937984,1,0.14739157480680512,0.1400472534432821,0.16213073228748565,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_34,0.07842157294448793,0.06158572573860858,6,0.025142267249763282,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.05415014566247223,0.07842157294448793,0.0186966125257045,0.025142267249763282,0.4579197273087877,1,0.07284675818817672,0.10356384019425122,0.1768731281448666,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_34,0.05415014566247223,0.045797160606504655,6,0.0186966125257045,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_34,0.1191059595042659,0.10211382222161151,6,0.04168779335470373,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.05415014566247223,0.1191059595042659,0.0186966125257045,0.04168779335470373,0.19849542460467326,1,0.07284675818817672,0.16079375285896963,0.1768731281448666,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_34,0.039575600748433803,0.04345364853348146,6,0.017739877728211353,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.05415014566247223,0.039575600748433803,0.0186966125257045,0.017739877728211353,0.584239107390803,1,0.07284675818817672,0.05731547847664516,0.1768731281448666,0,24,0,15.362457983193275,galactinol_peak_2,galactinol_204_191_rt15.50,15.36240741,15.36,0.021948714,15.37,15.14,0.23,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.025478965645630902,0.019808191499151463,6,0.00808666031670941,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.01227902336059299,0.025478965645630902,0.006488335053818382,0.00808666031670941,0.23521070695845658,1,0.01876735841441137,0.03356562596234031,0.10348959565715424,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_42,0.01227902336059299,0.014508358241132658,5,0.006488335053818382,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.033365868779447215,0.02563828690393429,6,0.010466786798953224,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.01227902336059299,0.033365868779447215,0.006488335053818382,0.010466786798953224,0.12478183575168278,1,0.01876735841441137,0.04383265557840044,0.10348959565715424,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_42,0.06261689779616045,0.07035687894523197,5,0.03146455280125248,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.01227902336059299,0.06261689779616045,0.006488335053818382,0.03146455280125248,0.1866709936428214,1,0.01876735841441137,0.09408145059741294,0.10348959565715424,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.019609947729075133,0.025892234304175824,6,0.010570460390969571,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.03148431083745514,0.019609947729075133,0.008692770096100928,0.010570460390969571,0.40666688669583506,1,0.04017708093355607,0.030180408120044702,0.04419478902691168,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_42,0.03148431083745514,0.021292851186771565,6,0.008692770096100928,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.016969361026884733,0.0176617219421703,6,0.007210367789539124,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.03148431083745514,0.016969361026884733,0.008692770096100928,0.007210367789539124,0.22865232483009723,1,0.04017708093355607,0.024179728816423857,0.04419478902691168,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_42,0.023536183751052337,0.03349734744109078,6,0.013675234827899369,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.03148431083745514,0.023536183751052337,0.008692770096100928,0.013675234827899369,0.6362314535237799,1,0.04017708093355607,0.0372114185789517,0.04419478902691168,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.037611363656101515,0.047749480391146876,6,0.019493643740223464,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.0480788671519901,0.037611363656101515,0.017612820984221803,0.019493643740223464,0.699601505874502,1,0.0656916881362119,0.05710500739632498,0.0722608569498331,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_42,0.0480788671519901,0.039383464996254704,5,0.017612820984221803,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.030274726297341254,0.028565092384506375,6,0.011661650132917041,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.0480788671519901,0.030274726297341254,0.017612820984221803,0.011661650132917041,0.42651721388817443,1,0.0656916881362119,0.0419363764302583,0.0722608569498331,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_42,0.014303998496407289,0.020706030340511543,6,0.008453201488806718,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.0480788671519901,0.014303998496407289,0.017612820984221803,0.008453201488806718,0.1362044392645777,1,0.0656916881362119,0.022757199985214006,0.0722608569498331,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.05960631057595511,0.04518276433713701,6,0.018445786299067783,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.03427873652172671,0.05960631057595511,0.01660561232163584,0.018445786299067783,0.33414711263351654,1,0.05088434884336255,0.0780520968750229,0.1020501248070422,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_42,0.03427873652172671,0.037131277959185846,5,0.01660561232163584,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.06417372760371938,0.07005323426452134,6,0.02859911312995535,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.03427873652172671,0.06417372760371938,0.01660561232163584,0.02859911312995535,0.3929772176429458,1,0.05088434884336255,0.09277284073367473,0.1020501248070422,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_42,0.03732745769155806,0.02798028061129399,6,0.011422901726259945,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.03427873652172671,0.03732745769155806,0.01660561232163584,0.011422901726259945,0.8838301189023012,1,0.05088434884336255,0.04875035941781801,0.1020501248070422,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.0148701828755049,0.012465019848549806,6,0.005088823043768579,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.016071932313528253,0.0148701828755049,0.0036441050026658805,0.005088823043768579,0.8519749062718902,1,0.019716037316194132,0.01995900591927348,0.04033470346880649,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_42,0.016071932313528253,0.008926197825654939,6,0.0036441050026658805,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.02903938635883052,0.018685995909183777,6,0.007628525885539015,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.016071932313528253,0.02903938635883052,0.0036441050026658805,0.007628525885539015,0.16793718765449137,1,0.019716037316194132,0.036667912244369535,0.04033470346880649,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_42,0.01230976502901641,0.007766942956187602,6,0.0031708411839939314,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.016071932313528253,0.01230976502901641,0.0036441050026658805,0.0031708411839939314,0.4544483614895246,1,0.019716037316194132,0.015480606213010341,0.04033470346880649,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.030096268674848048,0.03514262951272208,6,0.01434691842097369,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.037076577975972226,0.030096268674848048,0.013186234708082055,0.01434691842097369,0.7276779222337206,1,0.05026281268405428,0.044443187095821735,0.05528909395245971,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_42,0.037076577975972226,0.032299546663378524,6,0.013186234708082055,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.012353836920090696,0.007784978155958046,6,0.003178204023468389,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.037076577975972226,0.012353836920090696,0.013186234708082055,0.003178204023468389,0.12188315088509363,1,0.05026281268405428,0.015532040943559085,0.05528909395245971,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_42,0.029611050788484066,0.025330700351648392,6,0.01034121511481283,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.037076577975972226,0.029611050788484066,0.013186234708082055,0.01034121511481283,0.6659765592036269,1,0.05026281268405428,0.039952265903296896,0.05528909395245971,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.02926785561854735,0.025970213358983276,6,0.010602295206786702,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.034097786207656355,0.02926785561854735,0.006755680159625211,0.010602295206786702,0.7102867689040535,1,0.040853466367281564,0.03987015082533405,0.05470115510054855,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_42,0.034097786207656355,0.016547969256525775,6,0.006755680159625211,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.036922053256229916,0.03136882593653911,6,0.012806269562450581,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.034097786207656355,0.036922053256229916,0.006755680159625211,0.012806269562450581,0.8504702191030415,1,0.040853466367281564,0.0497283228186805,0.05470115510054855,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_42,0.02120600431040957,0.019759572023472574,6,0.008066811498880253,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.034097786207656355,0.02120600431040957,0.006755680159625211,0.008066811498880253,0.2494068227287898,1,0.040853466367281564,0.029272815809289823,0.05470115510054855,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_42,0.03770705927391408,0.03083585233717254,6,0.012588684001646805,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.030101120844882773,0.03770705927391408,0.01034122499411787,0.012588684001646805,0.6509739690302685,1,0.040442345839000644,0.050295743275560884,0.05532531760311698,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_42,0.030101120844882773,0.02533072455090475,6,0.01034122499411787,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_42,0.034295355456936814,0.03102771964613255,6,0.012667013502525632,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.030101120844882773,0.034295355456936814,0.01034122499411787,0.012667013502525632,0.8029740238071317,1,0.040442345839000644,0.046962368959462444,0.05532531760311698,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_42,0.010803967243913673,0.011998589665131983,6,0.004898403718767507,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.030101120844882773,0.010803967243913673,0.01034122499411787,0.004898403718767507,0.13475979556580067,1,0.040442345839000644,0.01570237096268118,0.05532531760311698,0,24,0,12.631052631578948,glucose-6-phosphate_peak_2,glucose-6-phosphate_160_387_rt12.76,12.63559006,12.64,0.014527763,12.72,12.53,0.19,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.005624681544622885,0.0067005742042507,6,0.0027354979640116074,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.011604200476255854,0.005624681544622885,0.008017570415442783,0.0027354979640116074,0.5122160464656327,1,0.019621770891698635,0.008360179508634493,0.5065826152895269,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_78,0.011604200476255854,0.017927832463321292,5,0.008017570415442783,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.008588430938595848,0.004782964025993754,6,0.0019526368869621058,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.011604200476255854,0.008588430938595848,0.008017570415442783,0.0019526368869621058,0.7313918306222651,1,0.019621770891698635,0.010541067825557953,0.5065826152895269,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_78,0.23892553815043574,0.49552185877763943,5,0.2216041121127705,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.011604200476255854,0.23892553815043574,0.008017570415442783,0.2216041121127705,0.36310711751853536,1,0.019621770891698635,0.46052965026320625,0.5065826152895269,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.24071182932990287,0.5711694181320006,6,0.23317893851762864,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.014551967296953886,0.24071182932990287,0.003922951494491876,0.23317893851762864,0.37668091344224663,1,0.018474918791445763,0.4738907678475315,0.5212798446322847,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_78,0.014551967296953886,0.00960922944719379,6,0.003922951494491876,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.011147322815502125,0.010107363076948392,6,0.004126313697261751,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.014551967296953886,0.011147322815502125,0.003922951494491876,0.004126313697261751,0.5631786850605358,1,0.018474918791445763,0.015273636512763877,0.5212798446322847,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_78,0.013002429487264081,0.00910946264161398,6,0.003718922550483333,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.014551967296953886,0.013002429487264081,0.003922951494491876,0.003718922550483333,0.7802427250067191,1,0.018474918791445763,0.016721352037747415,0.5212798446322847,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.02966501578542476,0.02492366827800184,6,0.010175044966582664,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.017418657465792096,0.02966501578542476,0.004785871866149621,0.010175044966582664,0.31204009188412873,1,0.022204529331941718,0.039840060752007425,0.04382406682720817,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_78,0.017418657465792096,0.010701534824314329,5,0.004785871866149621,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.01175571246222451,0.017761078755561998,6,0.007250930038752222,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.017418657465792096,0.01175571246222451,0.004785871866149621,0.007250930038752222,0.5320903961266379,1,0.022204529331941718,0.019006642500976733,0.04382406682720817,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_78,0.016385078399017743,0.011396165395374818,6,0.004652465040505203,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.017418657465792096,0.016385078399017743,0.004785871866149621,0.004652465040505203,0.8804202916024071,1,0.022204529331941718,0.021037543439522945,0.04382406682720817,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.024161944583967736,0.011595559883211181,6,0.004733867499292316,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.23271646621469572,0.024161944583967736,0.22996104786412394,0.004733867499292316,0.41579638889803927,1,0.46267751407881963,0.02889581208326005,0.5525381747655739,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_78,0.23271646621469572,0.514208535201264,5,0.22996104786412394,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.007558326087716487,0.007165359986688429,6,0.00292524596512372,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.23271646621469572,0.007558326087716487,0.22996104786412394,0.00292524596512372,0.3829796659028286,1,0.46267751407881963,0.010483572052840206,0.5525381747655739,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_78,0.2573950288769259,0.5999104183629647,6,0.2449124027281412,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.23271646621469572,0.2573950288769259,0.22996104786412394,0.2449124027281412,0.943051725852018,1,0.46267751407881963,0.5023074316050671,0.5525381747655739,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.015293549177679925,0.011936620066296812,6,0.004873104735982317,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.010127686826801393,0.015293549177679925,0.0046338105475461685,0.004873104735982317,0.46016195365718926,1,0.014761497374347562,0.020166653913662243,0.022183319305028468,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_78,0.010127686826801393,0.01135047140621484,6,0.0046338105475461685,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.008084942084538064,0.007048822395688288,6,0.0028776696928231355,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.010127686826801393,0.008084942084538064,0.0046338105475461685,0.0028776696928231355,0.7173599044263768,1,0.014761497374347562,0.010962611777361199,0.022183319305028468,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_78,0.00942536662748709,0.007338265248586683,6,0.0029958342427058885,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.010127686826801393,0.00942536662748709,0.0046338105475461685,0.0029958342427058885,0.9016586987127343,1,0.014761497374347562,0.012421200870192977,0.022183319305028468,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.019807440763176604,0.013207714180787672,6,0.0053920267352418885,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.021973650259355677,0.019807440763176604,0.006545704143694541,0.0053920267352418885,0.803753166758441,1,0.02851935440305022,0.025199467498418494,0.03243583311772094,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_78,0.021973650259355677,0.016033635159273123,6,0.006545704143694541,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.017352464914005217,0.014370555895835871,6,0.0058667548774903825,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.021973650259355677,0.017352464914005217,0.006545704143694541,0.0058667548774903825,0.6106694924074463,1,0.02851935440305022,0.023219219791495598,0.03243583311772094,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_78,0.02114563876937514,0.020432375202984878,6,0.008341482246734803,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.021973650259355677,0.02114563876937514,0.006545704143694541,0.008341482246734803,0.9393816661699196,1,0.02851935440305022,0.029487121016109945,0.03243583311772094,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.012701241632475399,0.009436086279663242,6,0.003852266092342032,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.01146553927641177,0.012701241632475399,0.0030918741656739486,0.003852266092342032,0.8077591856011441,1,0.014557413442085719,0.01655350772481743,0.03090874911049766,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_78,0.01146553927641177,0.007573514054794633,6,0.0030918741656739486,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.024057102650163326,0.009679894937097379,6,0.003951800559939808,leaf_1_transp1-1,1,967514 MM WT,leaf,*,0.01146553927641177,0.024057102650163326,0.0030918741656739486,0.003951800559939808,0.03218438278424097,0.7724251868217833,0.014557413442085719,0.028008903210103134,0.03090874911049766,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_78,0.015766339735567552,0.03020838881687669,6,0.012332523092157587,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.01146553927641177,0.015766339735567552,0.0030918741656739486,0.012332523092157587,0.747424959416868,1,0.014557413442085719,0.02809886282772514,0.03090874911049766,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_78,0.005724673238139559,0.00359949210494316,6,0.001469486498381217,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.011145751089320477,0.005724673238139559,0.004376302578822998,0.001469486498381217,0.28398152044868696,1,0.015522053668143476,0.007194159736520776,0.030148067076334086,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_78,0.011145751089320477,0.010719708278142503,6,0.004376302578822998,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_78,0.020694162475536498,0.016443844069975327,6,0.00671317123022176,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.011145751089320477,0.020694162475536498,0.004376302578822998,0.00671317123022176,0.2652949245248901,1,0.015522053668143476,0.027407333705758256,0.030148067076334086,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_78,0.004333790649345581,0.00135985558955697,6,5.551587197143616e-4,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.011145751089320477,0.004333790649345581,0.004376302578822998,5.551587197143616e-4,0.18139651968024145,1,0.015522053668143476,0.004888949369059943,0.030148067076334086,0,24,0,9.227014613778708,ornithine_peak_2,ornithine_142_174_rt9.34,9.233841463,9.23,0.046091392,9.45,9.08,0.37,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.09398096799569877,0.10652281129241262,6,0.043487755605532134,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.021483260290738437,0.09398096799569877,0.008473876748298123,0.043487755605532134,0.15859173542417818,1,0.02995713703903656,0.1374687236012309,0.24433351100218012,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_101,0.021483260290738437,0.01894816444214948,5,0.008473876748298123,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,0.07363834193003005,0.058554152760493645,6,0.02390463276403142,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.021483260290738437,0.07363834193003005,0.008473876748298123,0.02390463276403142,0.08387145590373656,1,0.02995713703903656,0.09754297469406147,0.24433351100218012,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_101,0.1522627552285055,0.15620861957862064,5,0.06985861840984006,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.021483260290738437,0.1522627552285055,0.008473876748298123,0.06985861840984006,0.13460092518559721,1,0.02995713703903656,0.22212137363834555,0.24433351100218012,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.05632090266111315,0.059385682996025466,6,0.024244103561156298,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.07653085309585823,0.05632090266111315,0.02884585376106529,0.024244103561156298,0.6037877524924286,1,0.10537670685692352,0.08056500622226945,0.12290351464558248,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_101,0.07653085309585823,0.07065762290955298,6,0.02884585376106529,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,0.028024903137373974,0.04629925687690858,6,0.018901592469745182,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.07653085309585823,0.028024903137373974,0.02884585376106529,0.018901592469745182,0.19456714712204295,1,0.10537670685692352,0.04692649560711916,0.12290351464558248,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_101,0.061353174794545016,0.12339866263208434,6,0.05037729306507541,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.07653085309585823,0.061353174794545016,0.02884585376106529,0.05037729306507541,0.800380689485622,1,0.10537670685692352,0.11173046785962043,0.12290351464558248,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.045005661182861645,0.0533624275418816,6,0.021785119818974925,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.06747141994808299,0.045005661182861645,0.029033174448093224,0.021785119818974925,0.5536129734408687,1,0.09650459439617622,0.06679078100183657,0.11087032146240514,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_101,0.06747141994808299,0.0649201516685464,5,0.029033174448093224,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,0.0630237899871698,0.05661361364092907,6,0.023112410985890928,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.06747141994808299,0.0630237899871698,0.029033174448093224,0.023112410985890928,0.9075270461751938,1,0.09650459439617622,0.08613620097306073,0.11087032146240514,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_101,0.05535646619488858,0.11129191767820125,6,0.045434735134570636,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.06747141994808299,0.05535646619488858,0.029033174448093224,0.045434735134570636,0.8277152329751247,1,0.09650459439617622,0.1007912013294592,0.11087032146240514,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.09406400343288175,0.0565475153251993,6,0.02308542646149171,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.17479446327782783,0.09406400343288175,0.09410983638659885,0.02308542646149171,0.44686812337116427,1,0.2689042996644267,0.11714942989437346,0.2957947296308694,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_101,0.17479446327782783,0.21043599151181822,5,0.09410983638659885,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,0.1196431128825715,0.1331049165088617,6,0.05433985461707801,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.17479446327782783,0.1196431128825715,0.09410983638659885,0.05433985461707801,0.6284819146175007,1,0.2689042996644267,0.1739829674996495,0.2957947296308694,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_101,0.0657687049082436,0.05292513370844963,6,0.021606595359045935,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.17479446327782783,0.0657687049082436,0.09410983638659885,0.021606595359045935,0.31633870921346186,1,0.2689042996644267,0.08737530026728954,0.2957947296308694,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.07930086777637635,0.09074444105414589,6,0.03704626292945385,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.30264371598047884,0.07930086777637635,0.12781434968554348,0.03704626292945385,0.1456975156316832,1,0.4304580656660223,0.11634713070583019,0.4735038722326246,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_101,0.30264371598047884,0.3130799385352411,6,0.12781434968554348,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,0.2760094067638359,0.27887961775929954,6,0.11385212719544961,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.30264371598047884,0.2760094067638359,0.12781434968554348,0.11385212719544961,0.8794829646237583,1,0.4304580656660223,0.3898615339592855,0.4735038722326246,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_101,0.21077840255433902,0.11607077301036522,6,0.047385694654300696,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.30264371598047884,0.21077840255433902,0.12781434968554348,0.047385694654300696,0.524129390084714,1,0.4304580656660223,0.2581640972086397,0.4735038722326246,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.3280567259004414,0.4289383423820456,6,0.17511334499187328,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.3077772863078061,0.3280567259004414,0.07436208598346587,0.17511334499187328,0.9182107212593031,1,0.382139372291272,0.5031700708923147,0.5534870779815462,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_101,0.3077772863078061,0.1821491668684604,6,0.07436208598346587,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,0.2769460122319857,0.16650028103967748,6,0.06797345509620108,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.3077772863078061,0.2769460122319857,0.07436208598346587,0.06797345509620108,0.7659116953518672,1,0.382139372291272,0.3449194673281868,0.5534870779815462,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_101,0.19077127149273118,0.1619430163634487,6,0.06611295958293933,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.3077772863078061,0.19077127149273118,0.07436208598346587,0.06611295958293933,0.2672264343197586,1,0.382139372291272,0.2568842310756705,0.5534870779815462,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.2806950505826571,0.14589364469273555,6,0.059560831035351536,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.41496388373232235,0.2806950505826571,0.05814308514544285,0.059560831035351536,0.13781054108486762,1,0.4731069688777652,0.3402558816180086,0.587193297060559,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_101,0.41496388373232235,0.14242089067753122,6,0.05814308514544285,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,0.39860188243357636,0.23430818672449197,6,0.09565591667196145,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.41496388373232235,0.39860188243357636,0.05814308514544285,0.09565591667196145,0.8872978557526263,1,0.4731069688777652,0.4942577991055378,0.587193297060559,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_101,0.46592487744287786,0.16628902650604752,6,0.0678872107939939,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.41496388373232235,0.46592487744287786,0.05814308514544285,0.0678872107939939,0.5814548661657664,1,0.4731069688777652,0.5338120882368718,0.587193297060559,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_101,0.27070113407009283,0.3073872804513496,6,0.1254903317545995,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.3273281444623082,0.27070113407009283,0.07320555112210442,0.1254903317545995,0.7068143713577625,1,0.4005336955844126,0.39619146582469233,0.5809802489558825,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_101,0.3273281444623082,0.17931624658838433,6,0.07320555112210442,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_101,0.34316359309070116,0.3112920843165198,6,0.12708446125715192,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.3273281444623082,0.34316359309070116,0.07320555112210442,0.12708446125715192,0.9166795641047785,1,0.4005336955844126,0.4702480543478531,0.5809802489558825,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_101,0.31961113778410627,0.5108477604795263,6,0.2085527249030596,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,ns,0.3273281444623082,0.31961113778410627,0.07320555112210442,0.2085527249030596,0.9732428660388907,1,0.4005336955844126,0.5281638626871659,0.5809802489558825,0,24,0,11.787578947368422,spermidine_peak_2,spermidine_174_200_rt11.94,11.79236025,11.79,0.044095288,12,11.71,0.29,FALSE,NA +fruit,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.290960842747738,0.2939670975859197,6,0.12001156504207533,fruit_0.8_panK4-1,0.8,967514 MM WT,fruit,ns,0.3604018895406515,0.290960842747738,0.181365054531925,0.12001156504207533,0.7585984866771274,1,0.5417669440725765,0.4109724077898133,0.7652757260845495,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.8,967514 MM WT,MoneyMaker,m_103,0.3604018895406515,0.40554459067634063,5,0.181365054531925,fruit_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.33442843265317507,0.3035486752364274,6,0.12392322773784185,fruit_0.8_transp1-1,0.8,967514 MM WT,fruit,ns,0.3604018895406515,0.33442843265317507,0.181365054531925,0.12392322773784185,0.909050085765952,1,0.5417669440725765,0.45835166039101694,0.7652757260845495,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.8,1017361 Sl10g086080 #2,*log2-1*,m_103,0.4649584615619271,0.5159654051025002,5,0.23074674396948144,fruit_0.8_log2-1,0.8,967514 MM WT,fruit,ns,0.3604018895406515,0.4649584615619271,0.181365054531925,0.23074674396948144,0.7313678506628358,1,0.5417669440725765,0.6957052055314086,0.7652757260845495,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.24489022099876334,0.25679268718415194,6,0.10483517554655158,fruit_0.6_panK4-1,0.6,967514 MM WT,fruit,ns,0.11314634160596133,0.24489022099876334,0.05483020724273686,0.10483517554655158,0.29967861693669534,1,0.1679765488486982,0.3497253965453149,0.5328930927701733,0,23,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.6,967514 MM WT,MoneyMaker,m_103,0.11314634160596133,0.13430603023575985,6,0.05483020724273686,fruit_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.2575492598733882,0.22720026744635943,6,0.09275412077790872,fruit_0.6_transp1-1,0.6,967514 MM WT,fruit,ns,0.11314634160596133,0.2575492598733882,0.05483020724273686,0.09275412077790872,0.21649811898575907,1,0.1679765488486982,0.35030338065129696,0.5328930927701733,0,23,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.6,1017361 Sl10g086080 #2,*log2-1*,m_103,0.2953197819441159,0.42290414717636826,5,0.18912848421058703,fruit_0.6_log2-1,0.6,967514 MM WT,fruit,ns,0.11314634160596133,0.2953197819441159,0.05483020724273686,0.18912848421058703,0.40014225095643036,1,0.1679765488486982,0.48444826615470293,0.5328930927701733,0,23,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.1108099625694204,0.07067837911408152,6,0.028854327446080585,fruit_1_panK4-1,1,967514 MM WT,fruit,ns,0.14902865725308329,0.1108099625694204,0.11154438548282442,0.028854327446080585,0.7548730764783447,1,0.2605730427359077,0.13966429001550099,0.5590287636588028,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,1,967514 MM WT,MoneyMaker,m_103,0.14902865725308329,0.24942082844803612,5,0.11154438548282442,fruit_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.3330164885338102,0.42912972943421346,6,0.17519147842873775,fruit_1_transp1-1,1,967514 MM WT,fruit,ns,0.14902865725308329,0.3330164885338102,0.11154438548282442,0.17519147842873775,0.40093301924610625,1,0.2605730427359077,0.508207966962548,0.5590287636588028,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,1,1017361 Sl10g086080 #2,*log2-1*,m_103,0.25265213203003767,0.16228956719222545,6,0.06625443836634627,fruit_1_log2-1,1,967514 MM WT,fruit,ns,0.14902865725308329,0.25265213203003767,0.11154438548282442,0.06625443836634627,0.45200171853391935,1,0.2605730427359077,0.3189065703963839,0.5590287636588028,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.5946616673328131,0.6716716722150273,6,0.2742088119347891,fruit_0.4_panK4-1,0.4,967514 MM WT,fruit,ns,0.6410122743924906,0.5946616673328131,0.3554210316249802,0.2742088119347891,0.9203253475141582,1,0.9964333060174708,0.8688704792676022,1.5394733997254273,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.4,967514 MM WT,MoneyMaker,m_103,0.6410122743924906,0.7947455873465583,5,0.3554210316249802,fruit_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.34290491675197315,0.5763869096653742,6,0.23530897051663807,fruit_0.4_transp1-1,0.4,967514 MM WT,fruit,ns,0.6410122743924906,0.34290491675197315,0.3554210316249802,0.23530897051663807,0.5063660741154308,1,0.9964333060174708,0.5782138872686112,1.5394733997254273,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +fruit,0.4,1017361 Sl10g086080 #2,*log2-1*,m_103,1.0773635170352356,0.789122117514273,6,0.3221577554424256,fruit_0.4_log2-1,0.4,967514 MM WT,fruit,ns,0.6410122743924906,1.0773635170352356,0.3554210316249802,0.3221577554424256,0.3877439899619939,1,0.9964333060174708,1.3995212724776611,1.5394733997254273,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.8,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.023586665569377423,0.022705352936420495,6,0.00926942152067232,leaf_0.8_panK4-1,0.8,967514 MM WT,leaf,ns,0.02159635168769129,0.023586665569377423,0.007309924475195238,0.00926942152067232,0.869652467031875,1,0.028906276162886525,0.032856087090049745,0.057144583190862505,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.8,967514 MM WT,MoneyMaker,m_103,0.02159635168769129,0.01790558502251044,6,0.007309924475195238,leaf_0.8_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.8,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.022484822161901914,0.027842100972693507,6,0.011366490125024383,leaf_0.8_transp1-1,0.8,967514 MM WT,leaf,ns,0.02159635168769129,0.022484822161901914,0.007309924475195238,0.011366490125024383,0.9490964524635436,1,0.028906276162886525,0.0338513122869263,0.057144583190862505,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.8,1017361 Sl10g086080 #2,*log2-1*,m_103,0.03459491578775934,0.04251017260874268,6,0.017354705294842936,leaf_0.8_log2-1,0.8,967514 MM WT,leaf,ns,0.02159635168769129,0.03459491578775934,0.007309924475195238,0.017354705294842936,0.5131552200194929,1,0.028906276162886525,0.051949621082602274,0.057144583190862505,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.6,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.05510431553920784,0.06774865546697996,6,0.02765827277561982,leaf_0.6_panK4-1,0.6,967514 MM WT,leaf,ns,0.05939488064474974,0.05510431553920784,0.036325527006508956,0.02765827277561982,0.9271146554784803,1,0.0957204076512587,0.08276258831482766,0.13083693454222084,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.6,967514 MM WT,MoneyMaker,m_103,0.05939488064474974,0.088979005803637,6,0.036325527006508956,leaf_0.6_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.6,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.07256088779819218,0.09246764897661237,6,0.037749759617914574,leaf_0.6_transp1-1,0.6,967514 MM WT,leaf,ns,0.05939488064474974,0.07256088779819218,0.036325527006508956,0.037749759617914574,0.8066681732353691,1,0.0957204076512587,0.11031064741610676,0.13083693454222084,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.6,1017361 Sl10g086080 #2,*log2-1*,m_103,0.11100392366534839,0.019445872244282257,6,0.007938744100306915,leaf_0.6_log2-1,0.6,967514 MM WT,leaf,ns,0.05939488064474974,0.11100392366534839,0.036325527006508956,0.007938744100306915,0.21896764309560846,1,0.0957204076512587,0.1189426677656553,0.13083693454222084,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,1,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.03005558858949442,0.022962638715819085,6,0.009374458000272458,leaf_1_panK4-1,1,967514 MM WT,leaf,ns,0.025231288042276773,0.03005558858949442,0.005756505963636528,0.009374458000272458,0.6721841749403367,1,0.0309877940059133,0.03943004658976688,0.04337305124874357,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,1,967514 MM WT,MoneyMaker,m_103,0.025231288042276773,0.014100502312197867,6,0.005756505963636528,leaf_1_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,1,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.0227217199977446,0.03134566473600984,6,0.012796814041929413,leaf_1_transp1-1,1,967514 MM WT,leaf,ns,0.025231288042276773,0.0227217199977446,0.005756505963636528,0.012796814041929413,0.8631643389558686,1,0.0309877940059133,0.03551853403967401,0.04337305124874357,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,1,1017361 Sl10g086080 #2,*log2-1*,m_103,0.029452229734703888,0.024250776586001336,6,0.009900338083656122,leaf_1_log2-1,1,967514 MM WT,leaf,ns,0.025231288042276773,0.029452229734703888,0.005756505963636528,0.009900338083656122,0.7219722482358432,1,0.0309877940059133,0.03935256781836001,0.04337305124874357,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.4,1015695 Sl10g074590 #30.1,*panK4-1*,m_103,0.06504180513704864,0.08446475027077387,6,0.03448258990250055,leaf_0.4_panK4-1,0.4,967514 MM WT,leaf,ns,0.044776879866909404,0.06504180513704864,0.022851095473453136,0.03448258990250055,0.6363574727714372,1,0.06762797534036254,0.09952439503954918,0.16898147476407724,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.4,967514 MM WT,MoneyMaker,m_103,0.044776879866909404,0.055973523973582566,6,0.022851095473453136,leaf_0.4_MoneyMaker,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,NA,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.4,1017363 Sl10g007190 #19.2,*transp1-1*,m_103,0.03288727957223466,0.026996361757900017,6,0.011021218536406691,leaf_0.4_transp1-1,0.4,967514 MM WT,leaf,ns,0.044776879866909404,0.03288727957223466,0.022851095473453136,0.011021218536406691,0.6531677861950399,1,0.06762797534036254,0.04390849810864135,0.16898147476407724,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA +leaf,0.4,1017361 Sl10g086080 #2,*log2-1*,m_103,0.13141670757517362,0.05438556745062276,6,0.022202814937623855,leaf_0.4_log2-1,0.4,967514 MM WT,leaf,*,0.044776879866909404,0.13141670757517362,0.022851095473453136,0.022202814937623855,0.021601748584124798,0.5184419660189952,0.06762797534036254,0.15361952251279748,0.16898147476407724,0,24,0,13.638846960167715,sucrose_peak_2,sucrose2_204_361_rt13.79,13.63746914,13.64,0.027870859,13.71,13.3,0.41,FALSE,NA diff --git a/runs/GC-MS analysis/p_values.csv b/runs/GC-MS analysis/p_values.csv new file mode 100644 index 0000000000000000000000000000000000000000..f94a780216bbe57449f5dd4f087f4a196e0a25d8 --- /dev/null +++ b/runs/GC-MS analysis/p_values.csv @@ -0,0 +1,2737 @@ +met,treatment,treatment2,group1,group2,tissue,tissue2,p.signif,mean1,mean2,se1,se2,p.value,adj.p.value,tot_val1,tot_val2,y.position,na,n_treat,percent_na +m_1,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,107.3144045406429,109.07984105976276,48.123355327400176,34.338556804607215,0.976951232513027,1,155.4377598680431,143.41839786436998,219.769671864217,0,24,0 +m_1,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,107.3144045406429,97.42552034755052,48.123355327400176,29.915464442873798,0.866490697370267,1,155.4377598680431,127.34098479042432,219.769671864217,0,24,0 +m_1,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,107.3144045406429,165.39918461814366,48.123355327400176,34.39142616750815,0.3565012941460791,1,155.4377598680431,199.7906107856518,219.769671864217,0,24,0 +m_1,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,28.494451034551066,27.77134186604891,3.9056513934149115,9.021580622997227,0.9434771686846446,1,32.400102427965976,36.792922489046134,188.12613213281418,0,24,0 +m_1,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,28.494451034551066,77.44995523290586,3.9056513934149115,5.865681627705073,7.898062469523088e-5,0.0018955349926855411,32.400102427965976,83.31563686061094,188.12613213281418,0,24,0 +m_1,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,28.494451034551066,151.30751709839825,3.9056513934149115,19.716239385978266,0.0012989720527645035,0.02987635721358358,32.400102427965976,171.02375648437652,188.12613213281418,0,24,0 +m_1,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,69.95599667579123,4.741114843908732,12.187557441373785,1.0342463883499302,0.005722235236113695,0.1258891751945013,82.14355411716501,5.775361232258662,265.6624534877313,0,24,0 +m_1,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,69.95599667579123,117.56420854415879,12.187557441373785,14.670674291737074,0.03811067809364219,0.6097708494982751,82.14355411716501,132.23488283589586,265.6624534877313,0,24,0 +m_1,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,69.95599667579123,199.33263946471737,12.187557441373785,42.178681887765606,0.026669011991963094,0.5067112278472988,82.14355411716501,241.51132135248298,265.6624534877313,0,24,0 +m_1,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,73.06854961986588,24.22943113548801,7.867648272604712,14.840041279824213,0.021173391557386137,0.42346783114772274,80.93619789247059,39.06947241531222,276.2257073251035,0,24,0 +m_1,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,73.06854961986588,95.43547249320949,7.867648272604712,22.638198012570495,0.3857605208180578,1,80.93619789247059,118.07367050577999,276.2257073251035,0,24,0 +m_1,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,73.06854961986588,215.692699417453,7.867648272604712,35.42157996900468,0.009198538796345886,0.1931693147232636,80.93619789247059,251.1142793864577,276.2257073251035,0,24,0 +m_1,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3598.7667073883795,471.32876451547156,2291.872035664174,192.39174274262047,0.23123617416662945,1,5890.638743052554,663.7205072580921,6479.70261735781,0,24,0 +m_1,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3598.7667073883795,201.54205999221287,2291.872035664174,151.59114942004848,0.1986926003077129,1,5890.638743052554,353.13320941226135,6479.70261735781,0,24,0 +m_1,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3598.7667073883795,448.50428274243717,2291.872035664174,174.15168989010644,0.22820292572860476,1,5890.638743052554,622.6559726325436,6479.70261735781,0,24,0 +m_1,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2121.817723717922,333.49141131101067,979.8172894222147,128.12627285219082,0.12817868152734016,1,3101.635013140137,461.6176841632015,3411.798514454151,0,24,0 +m_1,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2121.817723717922,293.52110956330426,979.8172894222147,183.1085415573096,0.1222712593382726,1,3101.635013140137,476.62965112061386,3411.798514454151,0,24,0 +m_1,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2121.817723717922,199.88815688141747,979.8172894222147,80.4575553516526,0.10722071630154162,1,3101.635013140137,280.34571223307006,3411.798514454151,0,24,0 +m_1,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1565.6515982902422,427.6874064613816,578.1355305840946,163.7922009768912,0.10878642064172095,1,2143.7871288743368,591.4796074382728,2358.1658417617705,0,24,0 +m_1,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1565.6515982902422,299.12287208164,578.1355305840946,193.637102905509,0.08222158090186121,1,2143.7871288743368,492.759974987149,2358.1658417617705,0,24,0 +m_1,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1565.6515982902422,141.7518800251138,578.1355305840946,76.82549578629009,0.05686082455545779,0.8529123683318668,2143.7871288743368,218.5773758114039,2358.1658417617705,0,24,0 +m_1,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,990.9231863649335,384.28992236052306,272.5205374787977,126.5359933413306,0.08290873420082313,1,1263.4437238437313,510.82591570185366,1389.7880962281045,0,24,0 +m_1,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,990.9231863649335,177.48181663566564,272.5205374787977,128.07612391159316,0.030144632447489904,0.5426033840548182,1263.4437238437313,305.5579405472588,1389.7880962281045,0,24,0 +m_1,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,990.9231863649335,200.69402929535732,272.5205374787977,95.9043859620906,0.032734133179319336,0.5564802640484288,1263.4437238437313,296.5984152574479,1389.7880962281045,0,24,0 +m_2,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,95.39739495383115,163.98559621683123,85.70136047662916,53.34344790527963,0.5190682334778495,1,181.0987554304603,217.32904412211087,388.46996685865895,0,24,0 +m_2,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,95.39739495383115,241.71177695908167,85.70136047662916,111.44273836697191,0.32570589109036024,1,181.0987554304603,353.15451532605357,388.46996685865895,0,24,0 +m_2,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,95.39739495383115,192.1570674276271,85.70136047662916,80.30266472339419,0.4319515114279301,1,181.0987554304603,272.4597321510213,388.46996685865895,0,24,0 +m_2,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,46.85884269760951,108.86499249776432,33.468237365180194,75.05770592617107,0.4754596899520589,1,80.3270800627897,183.9226984239354,3183770.1957672285,0,24,0 +m_2,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,46.85884269760951,1447217.0866858205,33.468237365180194,1447119.4549207506,0.3632020528357218,1,80.3270800627897,2894336.541606571,3183770.1957672285,0,24,0 +m_2,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,46.85884269760951,83.81583692471304,33.468237365180194,50.755662403755956,0.5588766363414186,1,80.3270800627897,134.571499328469,3183770.1957672285,0,24,0 +m_2,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,237.21552821537,136.3706299217489,54.09325691501473,61.766151308052066,0.2505161048203768,1,291.3087851303847,198.13678122980096,320.4396636434232,0,24,0 +m_2,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,237.21552821537,61.49408570839168,54.09325691501473,21.368237203982282,0.0278198634214285,0.667676722114284,291.3087851303847,82.86232291237397,320.4396636434232,0,24,0 +m_2,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,237.21552821537,113.8076255133503,54.09325691501473,76.52674549276638,0.22201103563799826,1,291.3087851303847,190.33437100611667,320.4396636434232,0,24,0 +m_2,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,73.62821549612136,17012.476912641727,20.004474150430376,16913.72991366323,0.3625656396603306,1,93.63268964655174,33926.20682630496,37318.82750893546,0,24,0 +m_2,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,73.62821549612136,39.7711875623984,20.004474150430376,21.37621051072172,0.27732864696266446,1,93.63268964655174,61.14739807312012,37318.82750893546,0,24,0 +m_2,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,73.62821549612136,108.59095121010357,20.004474150430376,58.1539036152559,0.5898406380049926,1,93.63268964655174,166.74485482535948,37318.82750893546,0,24,0 +m_2,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,411.1774328528891,662.8775826227752,123.96489907035236,88.88691223569249,0.13307897680934935,1,535.1423319232415,751.7644948584677,826.9409443443146,0,24,0 +m_2,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,411.1774328528891,570.7682927558225,123.96489907035236,44.19019004279228,0.2690985872468697,1,535.1423319232415,614.9584827986148,826.9409443443146,0,24,0 +m_2,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,411.1774328528891,477.89067007225583,123.96489907035236,95.33441043879424,0.6792939977058499,1,535.1423319232415,573.22508051105,826.9409443443146,0,24,0 +m_2,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1596.411502396993,943.4626981744109,827.8259967339623,69.24776817603853,0.4669929411854389,1,2424.2374991309553,1012.7104663504495,2666.661249044051,0,24,0 +m_2,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1596.411502396993,1097.6041636001632,827.8259967339623,103.3464838206237,0.5751950094318683,1,2424.2374991309553,1200.950647420787,2666.661249044051,0,24,0 +m_2,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1596.411502396993,716.6505033622822,827.8259967339623,58.40599082498444,0.3371478404547071,1,2424.2374991309553,775.0564941872666,2666.661249044051,0,24,0 +m_2,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2368.794325253014,1056.2325849442288,820.9851822776571,83.08034242724995,0.17139580154065176,1,3189.7795075306713,1139.3129273714787,3508.7574582837387,0,24,0 +m_2,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2368.794325253014,1789.4882323800055,820.9851822776571,795.8340333460065,0.6233933530750388,1,3189.7795075306713,2585.322265726012,3508.7574582837387,0,24,0 +m_2,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2368.794325253014,923.2793455762742,820.9851822776571,85.77899443682023,0.13905668360038623,1,3189.7795075306713,1009.0583400130944,3508.7574582837387,0,24,0 +m_2,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1923.334023596175,1015.8659852911703,622.5408108369254,168.42737455992025,0.21127473122315857,1,2545.8748344331007,1184.2933598510906,2800.462317876411,0,24,0 +m_2,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1923.334023596175,1189.1033742221096,622.5408108369254,213.2903933560194,0.3061708105964386,1,2545.8748344331007,1402.393767578129,2800.462317876411,0,24,0 +m_2,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1923.334023596175,779.3874187010663,622.5408108369254,114.26099908945645,0.12682153563639204,1,2545.8748344331007,893.6484177905227,2800.462317876411,0,24,0 +m_3,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,77.74641135651298,57.078740602895515,18.987698141593402,8.97048236501684,0.36457624227742386,1,96.73410949810638,66.04922296791236,326.2344849856906,0,24,0 +m_3,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,77.74641135651298,82.40035977589565,18.987698141593402,20.957405102291148,0.8729213335295368,1,96.73410949810638,103.3577648781868,326.2344849856906,0,24,0 +m_3,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,77.74641135651298,187.3543144040097,18.987698141593402,109.2224901284363,0.36576802948045795,1,96.73410949810638,296.576804532446,326.2344849856906,0,24,0 +m_3,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,43.59527500577515,83.6502498775153,7.937766566894656,25.935066205716506,0.190771744534205,1,51.53304157266981,109.5853160832318,153.13873729235476,0,24,0 +m_3,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,43.59527500577515,84.69164103852995,7.937766566894656,54.525392863610726,0.48801525697470194,1,51.53304157266981,139.21703390214068,153.13873729235476,0,24,0 +m_3,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,43.59527500577515,78.32484328296238,7.937766566894656,32.40381358234703,0.34073412777941586,1,51.53304157266981,110.7286568653094,153.13873729235476,0,24,0 +m_3,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,88.82681214690514,70.03385487579287,34.66326608523606,25.668701814989966,0.6749631782339625,1,123.4900782321412,95.70255669078284,257.105341091664,0,24,0 +m_3,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,88.82681214690514,28.065181836510337,34.66326608523606,9.011815963129825,0.1564846325150938,1,123.4900782321412,37.07699779964016,257.105341091664,0,24,0 +m_3,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,88.82681214690514,144.14631819378133,34.66326608523606,89.58581007136776,0.5842691220104909,1,123.4900782321412,233.73212826514907,257.105341091664,0,24,0 +m_3,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,33.931355493730415,86.39966996257411,8.730479323522687,28.180976785478954,0.12616685759253357,1,42.6618348172531,114.58064674805306,312.7464300862574,0,24,0 +m_3,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,33.931355493730415,69.23928438086467,8.730479323522687,53.791498903423715,0.5442524581600434,1,42.6618348172531,123.03078328428839,312.7464300862574,0,24,0 +m_3,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,33.931355493730415,189.44582761380676,8.730479323522687,94.86910882824539,0.16256110763942203,1,42.6618348172531,284.31493644205216,312.7464300862574,0,24,0 +m_3,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,47.13773895217496,73.82850471248624,23.31259242606545,27.559735882072804,0.4771125077143755,1,70.4503313782404,101.38824059455904,114.13261319749495,0,24,0 +m_3,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,47.13773895217496,48.64441370527989,23.31259242606545,11.90246989178126,0.9556138362758386,1,70.4503313782404,60.54688359706115,114.13261319749495,0,24,0 +m_3,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,47.13773895217496,62.19088575765353,23.31259242606545,41.566035330978224,0.7603283319855874,1,70.4503313782404,103.75692108863176,114.13261319749495,0,24,0 +m_3,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,46.62277463490239,69.43346670726937,12.898264216147403,26.55534068009152,0.46420992987546195,1,59.521038851049795,95.9888073873609,106.61609634117748,0,24,0 +m_3,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,46.62277463490239,69.32522590847293,12.898264216147403,27.59849803805205,0.4801215641417972,1,59.521038851049795,96.92372394652497,106.61609634117748,0,24,0 +m_3,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,46.62277463490239,34.19923846133384,12.898264216147403,11.526699473768485,0.4892778221482108,1,59.521038851049795,45.72593793510232,106.61609634117748,0,24,0 +m_3,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,132.13528223496579,59.41759830437589,38.453165199193755,22.170444347120736,0.1400284716456088,1,170.58844743415955,81.58804265149664,187.6472921775755,0,24,0 +m_3,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,132.13528223496579,115.63282475554142,38.453165199193755,31.576177839458982,0.7472431450034664,1,170.58844743415955,147.2090025950004,187.6472921775755,0,24,0 +m_3,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,132.13528223496579,114.52073482834432,38.453165199193755,23.721634488412672,0.7064244396135234,1,170.58844743415955,138.242369316757,187.6472921775755,0,24,0 +m_3,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,76.3332642617619,130.02711150698568,20.016562629227533,95.56605098990096,0.6042049129292622,1,96.34982689098943,225.59316249688663,248.15247874657533,0,24,0 +m_3,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,76.3332642617619,148.21155076544628,20.016562629227533,29.037111751188295,0.07242364666152995,1,96.34982689098943,177.24866251663457,248.15247874657533,0,24,0 +m_3,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,76.3332642617619,66.98339210848539,20.016562629227533,14.71258707625244,0.7151887124659594,1,96.34982689098943,81.69597918473784,248.15247874657533,0,24,0 +m_4,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,86.08956686842208,72.78477348713456,35.43468485656824,12.537524465084973,0.7377945670028052,1,121.52425172499032,85.32229795221953,133.67667689748936,0,24,0 +m_4,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,86.08956686842208,78.01142192145578,35.43468485656824,12.867202407910419,0.8387042192212946,1,121.52425172499032,90.8786243293662,133.67667689748936,0,24,0 +m_4,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,86.08956686842208,33.61317250911322,35.43468485656824,10.066494487770477,0.21782501736848578,1,121.52425172499032,43.6796669968837,133.67667689748936,0,24,0 +m_4,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,36.08101832204369,46.298005412344686,11.2990523517643,11.328578461731453,0.5374616732197397,1,47.38007067380799,57.62658387407614,63.38924226148376,0,24,0 +m_4,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,36.08101832204369,41.1860945214746,11.2990523517643,6.8460735481603745,0.7089797874126026,1,47.38007067380799,48.03216806963498,63.38924226148376,0,24,0 +m_4,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,36.08101832204369,48.41948792302227,11.2990523517643,6.388719572961208,0.3699941890843592,1,47.38007067380799,54.808207495983474,63.38924226148376,0,24,0 +m_4,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,42.42090007874332,83.12539528843877,9.424534897449679,20.328359027046222,0.11226051012869849,1,51.845434976193005,103.45375431548499,113.79912974703349,0,24,0 +m_4,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,42.42090007874332,56.3265730148829,9.424534897449679,11.69988452523191,0.3829199835915383,1,51.845434976193005,68.0264575401148,113.79912974703349,0,24,0 +m_4,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,42.42090007874332,52.8938241779348,9.424534897449679,12.654112275338331,0.5239847527280941,1,51.845434976193005,65.54793645327314,113.79912974703349,0,24,0 +m_4,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,48.89133349009634,32.81289354220424,9.010153260483843,5.578656770754547,0.17393011237327022,1,57.90148675058019,38.39155031295879,246.24947218094775,0,24,0 +m_4,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,48.89133349009634,149.30020485149745,9.010153260483843,74.56295167663684,0.23731165128972037,1,57.90148675058019,223.8631565281343,246.24947218094775,0,24,0 +m_4,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,48.89133349009634,70.32001358314761,9.010153260483843,24.45868257788998,0.44099426739454717,1,57.90148675058019,94.7786961610376,246.24947218094775,0,24,0 +m_4,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,191.3222338888669,246.6364766229459,50.389531173531964,36.54136599910251,0.3970194419078905,1,241.71176506239885,283.1778426220484,491.7826912542116,0,24,0 +m_4,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,191.3222338888669,282.5371281516442,50.389531173531964,106.41501481225666,0.4634130709094597,1,241.71176506239885,388.9521429639009,491.7826912542116,0,24,0 +m_4,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,191.3222338888669,391.6079695330013,50.389531173531964,55.467204334463744,0.023557643125695447,0.5653834350166907,241.71176506239885,447.0751738674651,491.7826912542116,0,24,0 +m_4,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,156.99879987379498,243.3251812159728,27.20827390953425,33.72715112956432,0.0756339280148887,1,184.20707378332924,277.05233234553714,317.06933305455993,0,24,0 +m_4,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,156.99879987379498,187.20748909312988,27.20827390953425,21.258121360485944,0.4033233335942522,1,184.20707378332924,208.46561045361582,317.06933305455993,0,24,0 +m_4,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,156.99879987379498,252.75585465348257,27.20827390953425,35.488993577935496,0.05971414026500818,1,184.20707378332924,288.2448482314181,317.06933305455993,0,24,0 +m_4,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,197.48449906618674,204.76557105567636,15.342615657686661,37.32411852370331,0.8621969802200861,1,212.8271147238734,242.08968957937967,313.6362199098955,0,24,0 +m_4,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,197.48449906618674,233.06279827389696,15.342615657686661,52.061038007826184,0.5369922666289639,1,212.8271147238734,285.12383628172313,313.6362199098955,0,24,0 +m_4,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,197.48449906618674,198.65585466466956,15.342615657686661,47.18074677499437,0.9819236866876279,1,212.8271147238734,245.83660143966392,313.6362199098955,0,24,0 +m_4,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,307.70649021557807,240.01306897043577,41.34700073485669,85.95660043961865,0.5002375298722239,1,349.05349095043476,325.9696694100544,419.6871212485218,0,24,0 +m_4,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,307.70649021557807,332.29481855291624,41.34700073485669,49.238928036649,0.7103865333631808,1,349.05349095043476,381.5337465895652,419.6871212485218,0,24,0 +m_4,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,307.70649021557807,201.64186434087114,41.34700073485669,36.81495593834276,0.08477663045968131,1,349.05349095043476,238.4568202792139,419.6871212485218,0,24,0 +m_5,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,489.8310188956316,494.35190342464387,151.71731415621852,151.44170598103904,0.9836402035742877,1,641.5483330518501,645.7936094056829,1254.4504811788804,0,24,0 +m_5,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,489.8310188956316,612.2261821661872,151.71731415621852,170.81666529665247,0.6051319990739366,1,641.5483330518501,783.0428474628396,1254.4504811788804,0,24,0 +m_5,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,489.8310188956316,968.6497401128061,151.71731415621852,171.75978823163067,0.06625819666463781,1,641.5483330518501,1140.4095283444367,1254.4504811788804,0,24,0 +m_5,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,269.3893985537138,928.1848834788062,31.089885393957992,234.74866966478143,0.03737621449333198,0.7101480753733076,300.47928394767183,1162.9335531435877,1279.2269084579466,0,24,0 +m_5,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,269.3893985537138,703.1181560542741,31.089885393957992,62.34151372626037,3.58269124409958e-4,0.008598458985838992,300.47928394767183,765.4596697805345,1279.2269084579466,0,24,0 +m_5,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,269.3893985537138,968.9634476848063,31.089885393957992,147.6403375994304,0.004560718638118546,0.100335810038608,300.47928394767183,1116.6037852842367,1279.2269084579466,0,24,0 +m_5,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,516.6174457020956,806.7653356000371,121.61915874489958,167.06126995353003,0.19510675958310877,1,638.2366044469951,973.8266055535671,1662.4955013973308,0,24,0 +m_5,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,516.6174457020956,930.171473477025,121.61915874489958,185.05951064223316,0.10459268687033314,1,638.2366044469951,1115.2309841192582,1662.4955013973308,0,24,0 +m_5,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,516.6174457020956,1358.7120993464446,121.61915874489958,152.6474473784014,0.0020069080467059095,0.04615888507423592,638.2366044469951,1511.359546724846,1662.4955013973308,0,24,0 +m_5,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,628.1906149122311,784.173301058232,197.66179291584712,208.3389696845926,0.6002673539060989,1,825.8524078280782,992.5122707428246,2224.65744496035,0,24,0 +m_5,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,628.1906149122311,775.1634691259692,197.66179291584712,221.10882112760493,0.6320794975094031,1,825.8524078280782,996.272290253574,2224.65744496035,0,24,0 +m_5,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,628.1906149122311,1679.762730636507,197.66179291584712,342.65312841835635,0.029524552879118995,0.5904910575823799,825.8524078280782,2022.4158590548634,2224.65744496035,0,24,0 +m_5,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,37488.7107258936,31888.389312390857,2838.4084596088287,2352.578881971495,0.1607442874051112,1,40327.11918550243,34240.96819436235,46684.358916016456,0,24,0 +m_5,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,37488.7107258936,37270.54449155081,2838.4084596088287,3410.795098616802,0.9617866750759856,1,40327.11918550243,40681.33959016761,46684.358916016456,0,24,0 +m_5,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,37488.7107258936,39193.41026547814,2838.4084596088287,3246.916021809539,0.7010840185639202,1,40327.11918550243,42440.32628728768,46684.358916016456,0,24,0 +m_5,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,19199.883087461036,26308.82433899483,1023.9920150059218,1702.8979545897193,0.006929524968744525,0.14552002434363503,20223.87510246696,28011.72229358455,30812.894522943006,0,24,0 +m_5,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,19199.883087461036,22783.45643263405,1023.9920150059218,3486.1243252245813,0.36297089324606036,1,20223.87510246696,26269.580757858632,30812.894522943006,0,24,0 +m_5,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,19199.883087461036,19784.00329597413,1023.9920150059218,2602.988731177767,0.8409651398572902,1,20223.87510246696,22386.992027151897,30812.894522943006,0,24,0 +m_5,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,14569.968625724923,15816.63999078849,1404.8743723332368,769.7950266108721,0.4595244807652663,1,15974.84299805816,16586.435017399363,25547.14163662881,0,24,0 +m_5,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,14569.968625724923,19705.67525771475,1404.8743723332368,3518.998957402351,0.22013675679278538,1,15974.84299805816,23224.6742151171,25547.14163662881,0,24,0 +m_5,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,14569.968625724923,17063.6219799931,1404.8743723332368,1221.8186771461915,0.21066027138702878,1,15974.84299805816,18285.44065713929,25547.14163662881,0,24,0 +m_5,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,10551.186365326936,12455.481145211106,795.4324475164594,712.5258733308381,0.10523966050213913,1,11346.618812843395,13168.007018541944,15517.662875628364,0,24,0 +m_5,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,10551.186365326936,11066.549896095728,795.4324475164594,675.8379927440516,0.6324206889386129,1,11346.618812843395,11742.38788883978,15517.662875628364,0,24,0 +m_5,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,10551.186365326936,12459.444644281599,795.4324475164594,1647.521606289639,0.33062559555030746,1,11346.618812843395,14106.966250571239,15517.662875628364,0,24,0 +m_6,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,144.99452130321535,72.95905526105436,81.81878332978482,19.329117846245712,0.4352539472972661,1,226.81330463300017,92.28817310730007,249.49463509630021,0,24,0 +m_6,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,144.99452130321535,97.57001392723303,81.81878332978482,41.98011542978429,0.6243616443366367,1,226.81330463300017,139.55012935701734,249.49463509630021,0,24,0 +m_6,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,144.99452130321535,126.86276050691674,81.81878332978482,27.348732508342692,0.8419964008653783,1,226.81330463300017,154.21149301525944,249.49463509630021,0,24,0 +m_6,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,37.92571906158621,274.59862540890435,4.922896737418345,150.09716718206033,0.17573424454621328,1,42.84861579900455,424.6957925909647,467.1653718500612,0,24,0 +m_6,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,37.92571906158621,125.34951446060516,4.922896737418345,22.12074375077773,0.009935681791688484,0.21858499941714665,42.84861579900455,147.47025821138288,467.1653718500612,0,24,0 +m_6,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,37.92571906158621,153.41743455127153,4.922896737418345,20.519779859880426,0.001970329564894133,0.04531757999256506,42.84861579900455,173.93721441115196,467.1653718500612,0,24,0 +m_6,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,69.91267905552463,117.89106329355809,11.033105345943062,15.178536179589475,0.03177631193393485,0.635526238678697,80.94578440146769,133.06959947314758,1158.8499691383117,0,24,0 +m_6,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,69.91267905552463,603.6907715664482,11.033105345943062,449.8092003774716,0.3010709829910461,1,80.94578440146769,1053.4999719439197,1158.8499691383117,0,24,0 +m_6,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,69.91267905552463,190.86686827045975,11.033105345943062,21.987989420778185,0.0015490191264468864,0.03717645903472527,80.94578440146769,212.85485769123792,1158.8499691383117,0,24,0 +m_6,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,76.68368758811918,180.1333305088184,28.834855901305307,52.553408043532635,0.12463767156081809,1,105.51854348942449,232.68673855235104,286.00410746588943,0,24,0 +m_6,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,76.68368758811918,98.80681926413712,28.834855901305307,27.711368616949667,0.5939116534585633,1,105.51854348942449,126.51818788108679,286.00410746588943,0,24,0 +m_6,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,76.68368758811918,220.29299433231515,28.834855901305307,39.710739727584304,0.017563831665138564,0.36884046496790984,105.51854348942449,260.00373405989944,286.00410746588943,0,24,0 +m_6,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,246.58718140799678,232.13986683918816,20.88246251395289,36.45866075687896,0.7398591433631133,1,267.4696439219497,268.59852759606713,297.5419802970374,0,24,0 +m_6,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,246.58718140799678,229.7856492312163,20.88246251395289,39.322573775796684,0.7162060216634152,1,267.4696439219497,269.10822300701295,297.5419802970374,0,24,0 +m_6,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,246.58718140799678,244.06310333933178,20.88246251395289,26.4296060216113,0.94182253286829,1,267.4696439219497,270.4927093609431,297.5419802970374,0,24,0 +m_6,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,134.48026664533523,147.60318598969857,22.563442524206476,23.88276485145466,0.6980140801249404,1,157.0437091695417,171.48595084115323,197.2339496743343,0,24,0 +m_6,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,134.48026664533523,146.65509294840237,22.563442524206476,14.866371803691248,0.6633738977387512,1,157.0437091695417,161.5214647520936,197.2339496743343,0,24,0 +m_6,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,134.48026664533523,155.00706270344753,22.563442524206476,24.29652790958364,0.5497888032365341,1,157.0437091695417,179.30359061303116,197.2339496743343,0,24,0 +m_6,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,120.95047046700823,124.25816597048801,14.908059913440853,26.396077549631535,0.915836886904311,1,135.85853038044908,150.65424352011954,214.26553600624402,0,24,0 +m_6,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,120.95047046700823,163.56408409861228,14.908059913440853,31.222766816155012,0.25696256930548766,1,135.85853038044908,194.78685091476729,214.26553600624402,0,24,0 +m_6,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,120.95047046700823,148.6561611201547,14.908059913440853,24.50761941723561,0.36156784392432595,1,135.85853038044908,173.16378053739032,214.26553600624402,0,24,0 +m_6,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,81.06808963980528,86.16714273032761,20.231590528822874,10.446439038732724,0.8287889141130882,1,101.29968016862816,96.61358176906033,251.98416075245711,0,24,0 +m_6,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,81.06808963980528,66.26831205670335,20.231590528822874,13.932172659575732,0.5619343990653947,1,101.29968016862816,80.20048471627908,251.98416075245711,0,24,0 +m_6,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,81.06808963980528,176.40019955807463,20.231590528822874,52.676310216886364,0.13867475586346137,1,101.29968016862816,229.07650977496098,251.98416075245711,0,24,0 +m_7,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,148.51093397482484,154.5665961726473,33.14004875750468,23.494601132126864,0.8854228109669793,1,181.6509827323295,178.06119730477417,253.43504923586167,0,24,0 +m_7,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,148.51093397482484,127.84103980944074,33.14004875750468,49.42558532138373,0.73688509865226,1,181.6509827323295,177.26662513082448,253.43504923586167,0,24,0 +m_7,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,148.51093397482484,195.37910247714967,33.14004875750468,35.01639682817908,0.35646795079754123,1,181.6509827323295,230.39549930532877,253.43504923586167,0,24,0 +m_7,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,95.45141044703405,116.5614153489916,14.391314009084958,40.10211015339487,0.6371642713864265,1,109.84272445611902,156.66352550238648,172.32987805262513,0,24,0 +m_7,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,95.45141044703405,66.20647800465032,14.391314009084958,13.960066399163601,0.17538090749378232,1,109.84272445611902,80.16654440381393,172.32987805262513,0,24,0 +m_7,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,95.45141044703405,54.68988867349941,14.391314009084958,10.238071854368712,0.04630491321336788,1,109.84272445611902,64.92796052786812,172.32987805262513,0,24,0 +m_7,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,78.71265911723815,83.3625660025005,25.496794538282444,16.133417258635248,0.8818999271041887,1,104.20945365552059,99.49598326113575,114.63039902107266,0,24,0 +m_7,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,78.71265911723815,47.69517740841939,25.496794538282444,11.465980245272629,0.31292741864035506,1,104.20945365552059,59.161157653692015,114.63039902107266,0,24,0 +m_7,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,78.71265911723815,68.21768653588903,25.496794538282444,10.306046917286174,0.7175640092752089,1,104.20945365552059,78.5237334531752,114.63039902107266,0,24,0 +m_7,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,42.30806113801961,55.7825927267206,9.48547205178768,8.641620586247036,0.3221680784601018,1,51.79353318980729,64.42421331296764,70.86663464426441,0,24,0 +m_7,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,42.30806113801961,40.483425379602,9.48547205178768,15.682975305832004,0.9231519472507599,1,51.79353318980729,56.166400685434,70.86663464426441,0,24,0 +m_7,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,42.30806113801961,45.386907313545066,9.48547205178768,10.539440137857728,0.8329451031470427,1,51.79353318980729,55.92634745140279,70.86663464426441,0,24,0 +m_7,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1086.30495066497,551.1188909047758,355.0254296831319,138.88207181589078,0.2063214270018768,1,1441.330380348102,690.0009627206665,1585.4634183829123,0,24,0 +m_7,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1086.30495066497,471.6061137851945,355.0254296831319,99.41390436236031,0.14839193771604578,1,1441.330380348102,571.0200181475548,1585.4634183829123,0,24,0 +m_7,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1086.30495066497,834.5408501232764,355.0254296831319,375.3291340724653,0.6365745740438162,1,1441.330380348102,1209.8699841957418,1585.4634183829123,0,24,0 +m_7,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,396.90247784911963,224.2462386455303,70.19879111813373,26.03675323265509,0.05823626729518502,1,467.10126896725336,250.28299187818538,513.8113958639788,0,24,0 +m_7,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,396.90247784911963,345.8494535628582,70.19879111813373,56.13375042006644,0.5831586226924955,1,467.10126896725336,401.98320398292464,513.8113958639788,0,24,0 +m_7,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,396.90247784911963,360.87681906085294,70.19879111813373,99.01516599320769,0.7733359630087833,1,467.10126896725336,459.8919850540606,513.8113958639788,0,24,0 +m_7,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,273.43390468143775,287.8213452293091,76.99170171329676,38.98411454263873,0.8720543617283643,1,350.42560639473453,326.8054597719478,385.468167034208,0,24,0 +m_7,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,273.43390468143775,221.7290059516809,76.99170171329676,18.46483897197031,0.5397110226442606,1,350.42560639473453,240.19384492365123,385.468167034208,0,24,0 +m_7,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,273.43390468143775,237.1989353281877,76.99170171329676,36.79768418135252,0.683558118119624,1,350.42560639473453,273.9966195095402,385.468167034208,0,24,0 +m_7,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,205.3077634331321,280.48000352288955,35.245546160597875,61.60806738938985,0.32064566064425987,1,240.55330959372998,342.0880709122794,398.74941571268977,0,24,0 +m_7,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,205.3077634331321,233.22017291712035,35.245546160597875,15.047132901932393,0.4908428576646393,1,240.55330959372998,248.26730581905275,398.74941571268977,0,24,0 +m_7,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,205.3077634331321,281.1172890504536,35.245546160597875,81.38217977926432,0.42170287262994965,1,240.55330959372998,362.49946882971796,398.74941571268977,0,24,0 +m_8,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,260.4210704881606,100.7123128630121,22.683766456162946,22.819790144841026,8.028737535177447e-4,0.019268970084425872,283.10483694432355,123.53210300785312,331.4407203301448,0,24,0 +m_8,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,260.4210704881606,238.02002279720222,22.683766456162946,63.28972295747485,0.7499050465558712,1,283.10483694432355,301.30974575467707,331.4407203301448,0,24,0 +m_8,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,260.4210704881606,187.0347219879663,22.683766456162946,12.902398267532606,0.02832243161580021,0.6514159271634049,283.10483694432355,199.9371202554989,331.4407203301448,0,24,0 +m_8,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,68.72795682159015,66.85320135155287,11.879131137155024,7.441220777128054,0.8967527461861706,1,80.60708795874518,74.29442212868092,88.66779675461972,0,24,0 +m_8,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,68.72795682159015,66.98138268206893,11.879131137155024,8.37435354779252,0.9069927449363108,1,80.60708795874518,75.35573622986145,88.66779675461972,0,24,0 +m_8,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,68.72795682159015,64.81660280475936,11.879131137155024,10.22001693734888,0.808059142418342,1,80.60708795874518,75.03661974210823,88.66779675461972,0,24,0 +m_8,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,92.60275567830311,64.78033166413577,35.54580834781078,11.673655870984968,0.4914266102970831,1,128.1485640261139,76.45398753512075,140.9634204287253,0,24,0 +m_8,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,92.60275567830311,67.49680936726074,35.54580834781078,14.845975856083253,0.5415114448944032,1,128.1485640261139,82.342785223344,140.9634204287253,0,24,0 +m_8,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,92.60275567830311,67.61444744596463,35.54580834781078,8.61237174352024,0.5282421433241768,1,128.1485640261139,76.22681918948487,140.9634204287253,0,24,0 +m_8,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,49.66723175069083,56.444602594253226,12.095813156113396,8.04942831411033,0.6546748049730033,1,61.763044906804225,64.49403090836356,104.57377948932834,0,24,0 +m_8,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,49.66723175069083,58.03870108900584,12.095813156113396,23.2428600777751,0.7581839634840073,1,61.763044906804225,81.28156116678093,104.57377948932834,0,24,0 +m_8,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,49.66723175069083,81.78377810660729,12.095813156113396,13.283294156418476,0.1074730638062206,1,61.763044906804225,95.06707226302576,104.57377948932834,0,24,0 +m_8,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,512.5015882285733,408.23417430043673,40.30357908553947,31.62514722630617,0.07078107830130805,1,552.8051673141127,439.8593215267429,608.0856840455241,0,24,0 +m_8,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,512.5015882285733,426.7464794535214,40.30357908553947,34.011415670081384,0.13585085517625578,1,552.8051673141127,460.75789512360274,608.0856840455241,0,24,0 +m_8,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,512.5015882285733,458.5302649398327,40.30357908553947,84.73497968010626,0.5827959856980177,1,552.8051673141127,543.2652446199389,608.0856840455241,0,24,0 +m_8,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,462.61573765775836,498.0839938273633,34.606995769746426,31.20329331767008,0.4643102619090904,1,497.2227334275048,529.2872871450334,582.2160158595367,0,24,0 +m_8,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,462.61573765775836,461.81401079312843,34.606995769746426,37.388117614960095,0.987755778287573,1,497.2227334275048,499.2021284080885,582.2160158595367,0,24,0 +m_8,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,462.61573765775836,394.1192505513697,34.606995769746426,35.41429855158063,0.19668206602298677,1,497.2227334275048,429.53354910295036,582.2160158595367,0,24,0 +m_8,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,307.6241012562848,353.53080083177997,19.12088234807718,44.0641192524166,0.37186346874643483,1,326.744983604362,397.5949200841966,532.2553010151685,0,24,0 +m_8,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,307.6241012562848,428.57502850595387,19.12088234807718,55.293426962381005,0.0828444082249347,1,326.744983604362,483.8684554683349,532.2553010151685,0,24,0 +m_8,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,307.6241012562848,314.2605732592822,19.12088234807718,19.9854491338697,0.8152344062657724,1,326.744983604362,334.24602239315186,532.2553010151685,0,24,0 +m_8,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,318.9289567276793,297.96843109712984,29.43931337288151,16.138605264881903,0.5503272533011251,1,348.3682701005608,314.10703636201174,423.1699443774342,0,24,0 +m_8,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,318.9289567276793,354.3726925427298,29.43931337288151,30.32725689130125,0.4213106660011485,1,348.3682701005608,384.69994943403105,423.1699443774342,0,24,0 +m_8,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,318.9289567276793,298.0926301796173,29.43931337288151,21.279666188066223,0.5801229533073122,1,348.3682701005608,319.37229636768353,423.1699443774342,0,24,0 +m_9,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,46.97439971609506,72.58906699687994,21.907378608349745,30.753139390130944,0.5153734119504696,1,68.88177832444481,103.34220638701088,113.67642702571197,0,24,0 +m_9,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,46.97439971609506,70.25897913351315,21.907378608349745,22.909235424580388,0.4813801579209116,1,68.88177832444481,93.16821455809354,113.67642702571197,0,24,0 +m_9,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,46.97439971609506,29.26423564187027,21.907378608349745,10.644416162135558,0.49520233765258637,1,68.88177832444481,39.90865180400583,113.67642702571197,0,24,0 +m_9,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,56.086167734335305,155.32317299799763,17.10036636482229,91.72397259443176,0.33317180666951257,1,73.1865340991576,247.0471455924294,271.75186015167236,0,23,0 +m_9,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,56.086167734335305,63.266992302885974,17.10036636482229,16.0670603401673,0.766557606326002,1,73.1865340991576,79.33405264305327,271.75186015167236,0,23,0 +m_9,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,56.086167734335305,42.2847041455791,17.10036636482229,9.917752423971603,0.504807009919964,1,73.1865340991576,52.202456569550705,271.75186015167236,0,23,0 +m_9,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,46.86535158575682,70.31385856717075,6.831135811865268,14.807407622901348,0.19385217144848632,1,53.696487397622086,85.1212661900721,97.08447706078758,0,24,0 +m_9,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,46.86535158575682,60.0231755900795,6.831135811865268,28.235439919727394,0.6717355376560281,1,53.696487397622086,88.25861550980689,97.08447706078758,0,24,0 +m_9,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,46.86535158575682,52.16721642131594,6.831135811865268,18.406299278434634,0.7957231203698741,1,53.696487397622086,70.57351569975057,97.08447706078758,0,24,0 +m_9,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,44.60879663763593,36.75445630554941,4.56691891534069,7.289328272748594,0.38746454908568595,1,49.17571555297663,44.043784578298,54.093287108274296,0,24,0 +m_9,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,44.60879663763593,37.35976899983371,4.56691891534069,5.182274188668923,0.32133835274760325,1,49.17571555297663,42.54204318850263,54.093287108274296,0,24,0 +m_9,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,44.60879663763593,35.3168111931711,4.56691891534069,7.718047423078668,0.33080255611852355,1,49.17571555297663,43.034858616249764,54.093287108274296,0,24,0 +m_9,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,141.34954949170626,136.40687636128706,2.7717305986798673,1.7224138931468362,0.16672003694403342,1,144.12128009038614,138.1292902544339,162.89864236806613,0,24,0 +m_9,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,141.34954949170626,136.98838070462313,2.7717305986798673,0.8010817720164654,0.1828157622719011,1,144.12128009038614,137.78946247663959,162.89864236806613,0,24,0 +m_9,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,141.34954949170626,143.3632726208472,2.7717305986798673,4.726402259212917,0.7226747486396269,1,144.12128009038614,148.0896748800601,162.89864236806613,0,24,0 +m_9,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,140.44444451760862,142.15368990629935,4.166353908477347,3.663825412902074,0.7644488934844658,1,144.61079842608595,145.81751531920142,160.39926685112158,0,24,0 +m_9,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,140.44444451760862,141.12735782162923,4.166353908477347,3.181467549118479,0.8991096688914291,1,144.61079842608595,144.3088253707477,160.39926685112158,0,24,0 +m_9,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,140.44444451760862,140.88308043968797,4.166353908477347,3.739140747253656,0.939110412429184,1,144.61079842608595,144.62222118694163,160.39926685112158,0,24,0 +m_9,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,133.19324921762612,135.35551505737482,2.2317096492479345,2.338768168980947,0.5187514860691049,1,135.42495886687405,137.69428322635576,152.7484912336935,0,24,0 +m_9,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,133.19324921762612,136.67383195428522,2.2317096492479345,2.1884328036179492,0.2915313212956138,1,135.42495886687405,138.86226475790318,152.7484912336935,0,24,0 +m_9,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,133.19324921762612,133.6311778545308,2.2317096492479345,1.0555495084764508,0.8641369385846647,1,135.42495886687405,134.68672736300724,152.7484912336935,0,24,0 +m_9,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,136.29080299882398,139.78879422089815,1.9478848588652713,2.038823323091407,0.24315389985064065,1,138.23868785768926,141.82761754398956,156.01037929838853,0,24,0 +m_9,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,136.29080299882398,135.62168933941328,1.9478848588652713,4.0505019076424595,0.8857408789865862,1,138.23868785768926,139.67219124705574,156.01037929838853,0,24,0 +m_9,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,136.29080299882398,137.56664662298567,1.9478848588652713,3.8065207268506023,0.7735670800901345,1,138.23868785768926,141.37316734983628,156.01037929838853,0,24,0 +m_10,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,60.843437367344755,53.8979361032224,14.262782245087353,2.999003470895074,0.6566218384899705,1,75.10621961243211,56.896939574117475,82.61684157367533,0,24,0 +m_10,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,60.843437367344755,52.69079479652976,14.262782245087353,2.5903957197534377,0.6020986498712938,1,75.10621961243211,55.281190516283196,82.61684157367533,0,24,0 +m_10,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,60.843437367344755,56.15142494389485,14.262782245087353,12.49896032109655,0.8104659334011726,1,75.10621961243211,68.6503852649914,82.61684157367533,0,24,0 +m_10,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,53.473171744944786,70.98940965119385,3.2253051654469935,6.8183976122358825,0.05255677618823844,1,56.698476910391776,77.80780726342974,85.58858798977272,0,24,0 +m_10,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,53.473171744944786,52.85640636808108,3.2253051654469935,2.7092962488260577,0.8865828069729865,1,56.698476910391776,55.56570261690714,85.58858798977272,0,24,0 +m_10,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,53.473171744944786,55.01744732042167,3.2253051654469935,0.5565998943192839,0.6558495997891255,1,56.698476910391776,55.57404721474095,85.58858798977272,0,24,0 +m_10,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,58.146813886140436,50.28482143803452,1.3252028981986586,2.853257929760027,0.041126004651633845,0.9870241116392122,59.4720167843391,53.138079367794546,67.90181281047772,0,24,0 +m_10,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,58.146813886140436,55.849860169565765,1.3252028981986586,2.2187046581084178,0.40565218278320564,1,59.4720167843391,58.06856482767418,67.90181281047772,0,24,0 +m_10,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,58.146813886140436,57.36380752527171,1.3252028981986586,4.365113211526216,0.8694525110141219,1,59.4720167843391,61.728920736797924,67.90181281047772,0,24,0 +m_10,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,50.719124328797626,56.67256537001427,2.5916333136798877,3.4380033762450806,0.2009542422338692,1,53.31075764247751,60.11056874625935,66.12162562088528,0,24,0 +m_10,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,50.719124328797626,53.15855933724037,2.5916333136798877,3.071248721088052,0.558876327847063,1,53.31075764247751,56.22980805832842,66.12162562088528,0,24,0 +m_10,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,50.719124328797626,57.31373052464746,2.5916333136798877,2.659715399472978,0.10974401327679206,1,53.31075764247751,59.97344592412044,66.12162562088528,0,24,0 +m_10,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,331.30021128283045,336.6596950581852,6.803321380803072,6.4206786125146085,0.579394423613705,1,338.10353266363353,343.0803736706998,395.9247288761318,0,24,0 +m_10,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,331.30021128283045,348.1372872397417,6.803321380803072,11.794284465832606,0.25133038464178425,1,338.10353266363353,359.9315717055743,395.9247288761318,0,24,0 +m_10,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,331.30021128283045,344.740486648726,6.803321380803072,10.352855553643288,0.30729741944088784,1,338.10353266363353,355.0933422023693,395.9247288761318,0,24,0 +m_10,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,348.8037372156643,341.8031398732081,9.481134701100967,9.150654066958374,0.6068343514130241,1,358.28487191676527,350.9537939401665,394.11335910844184,0,24,0 +m_10,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,348.8037372156643,349.92134968997823,9.481134701100967,7.309854871656226,0.927584201250114,1,358.28487191676527,357.23120456163446,394.11335910844184,0,24,0 +m_10,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,348.8037372156643,331.58987153254157,9.481134701100967,14.900262303124405,0.35670243092918597,1,358.28487191676527,346.490133835666,394.11335910844184,0,24,0 +m_10,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,332.598016334585,339.34238102598374,14.122869614025669,5.769252929008398,0.6725002799971582,1,346.72088594861066,345.11163395499216,381.3929745434718,0,24,0 +m_10,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,332.598016334585,321.16434702553613,14.122869614025669,5.8249480319495746,0.47981735106195733,1,346.72088594861066,326.9892950574857,381.3929745434718,0,24,0 +m_10,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,332.598016334585,330.4597381416579,14.122869614025669,7.212352150637569,0.8963135608168571,1,346.72088594861066,337.6720902922955,381.3929745434718,0,24,0 +m_10,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,319.2477137201226,338.3271115799352,6.910293690162065,3.572125582717958,0.041726425338517156,0.9870241116392122,326.15800741028465,341.89923716265315,387.7956114136813,0,24,0 +m_10,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,319.2477137201226,340.99239150648503,6.910293690162065,11.549073415043363,0.14402635189682844,1,326.15800741028465,352.5414649215284,387.7956114136813,0,24,0 +m_10,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,319.2477137201226,332.5337802412721,6.910293690162065,12.450456319890908,0.378731118982463,1,326.15800741028465,344.984236561163,387.7956114136813,0,24,0 +m_11,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,3424.839294922844,2336.142097627411,525.3357570379915,314.1410499199992,0.12051888311929569,1,3950.175051960836,2650.2831475474104,4345.19255715692,0,24,0 +m_11,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,3424.839294922844,3265.6303060457303,525.3357570379915,373.44591811791906,0.8115041527687111,1,3950.175051960836,3639.0762241636494,4345.19255715692,0,24,0 +m_11,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,3424.839294922844,3010.4089684308,525.3357570379915,489.2315601908202,0.5783474832882209,1,3950.175051960836,3499.6405286216204,4345.19255715692,0,24,0 +m_11,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,795.170846690925,1204.2558321637866,147.5082272508144,244.79241623806655,0.18927853411838508,1,942.6790739417395,1449.0482484018532,1593.9530732420387,0,24,0 +m_11,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,795.170846690925,898.0174157445875,147.5082272508144,233.98618411128433,0.7191958880887497,1,942.6790739417395,1132.003599855872,1593.9530732420387,0,24,0 +m_11,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,795.170846690925,1077.601249050895,147.5082272508144,225.42297412022555,0.3229703696127867,1,942.6790739417395,1303.0242231711204,1593.9530732420387,0,24,0 +m_11,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1537.890144855133,964.7993328196176,842.7096237967187,117.74046577395931,0.5362217081155077,1,2380.5997686518517,1082.539798593577,2618.659745517037,0,24,0 +m_11,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1537.890144855133,1165.229507214906,842.7096237967187,580.1732032011884,0.7262891037127717,1,2380.5997686518517,1745.4027104160946,2618.659745517037,0,24,0 +m_11,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1537.890144855133,1186.7405401626343,842.7096237967187,244.97675846949505,0.7066753645087476,1,2380.5997686518517,1431.7172986321293,2618.659745517037,0,24,0 +m_11,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,518.6000624505415,461.9853917823508,147.6501309391878,78.61980401181219,0.7462083849951165,1,666.2501933897292,540.605195794163,779.8372000258006,0,24,0 +m_11,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,518.6000624505415,246.13933485627,147.6501309391878,23.332354583240946,0.13900862263617592,1,666.2501933897292,269.47168943951095,779.8372000258006,0,24,0 +m_11,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,518.6000624505415,572.3953994758899,147.6501309391878,136.54750963847428,0.7953348241361826,1,666.2501933897292,708.9429091143642,779.8372000258006,0,24,0 +m_11,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,11533.138351348207,3427.758213371754,5318.433009515515,1035.402393327118,0.19088207578241723,1,16851.571360863723,4463.1606066988725,18536.728496950098,0,24,0 +m_11,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,11533.138351348207,3753.2933460537092,5318.433009515515,852.917796340055,0.2054842080197463,1,16851.571360863723,4606.211142393764,18536.728496950098,0,24,0 +m_11,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,11533.138351348207,7263.380239511223,5318.433009515515,4389.000638014204,0.5501173578407743,1,16851.571360863723,11652.380877525427,18536.728496950098,0,24,0 +m_11,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1839.5605127726085,2605.2686746933073,860.868808608275,841.4075723410522,0.5390088617874912,1,2700.4293213808833,3446.676247034359,3791.3438717377953,3,24,12.5 +m_11,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1839.5605127726085,1260.416006763062,860.868808608275,286.6794510065254,0.5465072555784332,1,2700.4293213808833,1547.0954577695873,3791.3438717377953,3,24,12.5 +m_11,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1839.5605127726085,1896.2041983317977,860.868808608275,123.32150966088794,0.9504958166432353,1,2700.4293213808833,2019.5257079926855,3791.3438717377953,3,24,12.5 +m_11,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,968.5904234769334,1239.6492746461554,204.0267996016681,207.2790454712547,0.3733131496762502,1,1172.6172230786015,1446.92832011741,2222.9665773542342,0,24,0 +m_11,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,968.5904234769334,1523.258936339582,204.0267996016681,497.6197703460853,0.33850984316057303,1,1172.6172230786015,2020.8787066856673,2222.9665773542342,0,24,0 +m_11,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,968.5904234769334,1002.4086788914115,204.0267996016681,210.03540609287938,0.9103426855300067,1,1172.6172230786015,1212.4440849842908,2222.9665773542342,0,24,0 +m_11,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,841.89306662726494,848.4688824956387,89.48158235090453,115.15575122795438,0.9649758944012248,1,931.3746489781695,963.6246337235931,1246.4715573475146,4,24,16.666666666666664 +m_11,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,841.89306662726494,902.9950622843176,89.48158235090453,230.1608989406957,0.8122306806291835,1,931.3746489781695,1133.1559612250132,1246.4715573475146,4,24,16.666666666666664 +m_11,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,841.89306662726494,369.10752095777326,89.48158235090453,163.74136842007712,0.03596807390785047,0.8632337737884113,931.3746489781695,532.8488893778504,1246.4715573475146,4,24,16.666666666666664 +m_12,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,469.9959426691561,354.1141384699872,79.52337454843953,38.91111839359715,0.23942508286576136,1,549.5193172175956,393.02525686358433,617.0259160675239,0,24,0 +m_12,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,469.9959426691561,489.38874041096796,79.52337454843953,71.54391055950826,0.8603420095946304,1,549.5193172175956,560.9326509704762,617.0259160675239,0,24,0 +m_12,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,469.9959426691561,444.9687338934747,79.52337454843953,70.23919331764763,0.8190946252956344,1,549.5193172175956,515.2079272111223,617.0259160675239,0,24,0 +m_12,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,144.40246858092212,212.03873935941704,26.196060912639513,43.06609025760066,0.21540390235888637,1,170.59852949356164,255.10482961701769,280.61531257871945,0,24,0 +m_12,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,144.40246858092212,161.11963067639203,26.196060912639513,35.60379189301498,0.7138773066483796,1,170.59852949356164,196.723422569407,280.61531257871945,0,24,0 +m_12,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,144.40246858092212,174.75889436588037,26.196060912639513,25.531181448472402,0.42599158968793904,1,170.59852949356164,200.29007581435278,280.61531257871945,0,24,0 +m_12,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,253.150013869321,158.05917884303292,129.34959524156886,26.432025457818156,0.5082984322825238,1,382.4996091108899,184.49120430085108,420.7495700219789,0,24,0 +m_12,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,253.150013869321,198.76019337378187,129.34959524156886,99.70306799902605,0.7482100177766824,1,382.4996091108899,298.4632613728079,420.7495700219789,0,24,0 +m_12,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,253.150013869321,207.34843309859104,129.34959524156886,42.03698707282267,0.7503933092024682,1,382.4996091108899,249.38542017141373,420.7495700219789,0,24,0 +m_12,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,118.38689307733607,82.31494250342251,42.51833221062219,12.262790502531953,0.45454774254680913,1,160.90522528795827,94.57773300595447,176.99574781675412,0,24,0 +m_12,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,118.38689307733607,43.623498313660974,42.51833221062219,2.4726412184429845,0.1535573394225404,1,160.90522528795827,46.09613953210396,176.99574781675412,0,24,0 +m_12,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,118.38689307733607,108.08609341170703,42.51833221062219,31.798432473495538,0.8511371664542204,1,160.90522528795827,139.88452588520255,176.99574781675412,0,24,0 +m_12,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1217.3018534016187,344.50923912195054,388.11712345421853,91.65100648066998,0.07481289000126219,1,1605.4189768558372,436.16024560262053,2398.410612465347,0,24,0 +m_12,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1217.3018534016187,409.2684124964324,388.11712345421853,101.4121396337052,0.09328971756050472,1,1605.4189768558372,510.6805521301376,2398.410612465347,0,24,0 +m_12,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1217.3018534016187,1282.3408768507963,388.11712345421853,898.0324072086098,0.9489059755573478,1,1605.4189768558372,2180.373284059406,2398.410612465347,0,24,0 +m_12,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,131.9396798879633,208.1534247909197,46.174685286655645,37.56478541216569,0.23047870302847073,1,178.11436517461897,245.7182102030854,270.29003122339395,0,24,0 +m_12,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,131.9396798879633,144.48562189793458,46.174685286655645,21.909806205126788,0.8129937316544157,1,178.11436517461897,166.39542810306136,270.29003122339395,0,24,0 +m_12,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,131.9396798879633,116.27339622240903,46.174685286655645,26.519233181078807,0.7761080466673942,1,178.11436517461897,142.79262940348784,270.29003122339395,0,24,0 +m_12,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,63.24945076096688,90.85187652090627,24.287513890069793,32.17320600970099,0.5102132100619414,1,87.53696465103667,123.02508253060726,279.66558062489764,0,24,0 +m_12,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,63.24945076096688,161.12663217781417,24.287513890069793,93.11480475391092,0.35046815077245963,1,87.53696465103667,254.2414369317251,279.66558062489764,0,24,0 +m_12,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,63.24945076096688,69.08278020488449,24.287513890069793,20.992260265934984,0.8595151847923265,1,87.53696465103667,90.07504047081947,279.66558062489764,0,24,0 +m_12,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,43.003791743375764,86.59338559733551,6.804887600258875,22.513558160271014,0.11404409417077165,1,49.80867934363464,109.10694375760653,126.64539314541388,0,24,0 +m_12,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,43.003791743375764,56.411872933066554,6.804887600258875,7.838119332601866,0.22606182869516064,1,49.80867934363464,64.24999226566842,126.64539314541388,0,24,0 +m_12,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,43.003791743375764,88.79007109030891,6.804887600258875,26.34210449643096,0.14631327809187436,1,49.80867934363464,115.13217558673988,126.64539314541388,0,24,0 +m_13,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,14139.754847965227,12071.264358980941,3788.8220977174606,863.7279613772995,0.6201863717658749,1,17928.57694568269,12934.99232035824,19721.434640250958,0,24,0 +m_13,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,14139.754847965227,12234.037810329544,3788.8220977174606,1405.401709025441,0.6567119350966153,1,17928.57694568269,13639.439519354986,19721.434640250958,0,24,0 +m_13,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,14139.754847965227,13874.115650320895,3788.8220977174606,835.8684614685385,0.9484219131048044,1,17928.57694568269,14709.984111789434,19721.434640250958,0,24,0 +m_13,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,3242.9918126710536,5808.892641194294,547.0979451312567,589.845032856906,0.00973071921405673,0.2335372611373615,3790.0897578023105,6398.7376740512,7038.611441456321,0,24,0 +m_13,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,3242.9918126710536,2849.087562906141,547.0979451312567,663.3214958174957,0.6570097407437921,1,3790.0897578023105,3512.409058723637,7038.611441456321,0,24,0 +m_13,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,3242.9918126710536,3982.8150308007253,547.0979451312567,532.8721675623805,0.35555080882273904,1,3790.0897578023105,4515.687198363105,7038.611441456321,0,24,0 +m_13,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,4657.011589311893,2613.393592453395,1888.6081109547733,631.9477414862893,0.35281198959052756,1,6545.619700266666,3245.341333939684,7200.181670293333,0,24,0 +m_13,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,4657.011589311893,2820.292346089806,1888.6081109547733,1495.709690764928,0.4688194587931922,1,6545.619700266666,4316.002036854734,7200.181670293333,0,24,0 +m_13,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,4657.011589311893,2588.215132312351,1888.6081109547733,492.77237293256496,0.34221104884510845,1,6545.619700266666,3080.987505244916,7200.181670293333,0,24,0 +m_13,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1229.7970051816276,1546.5953467202253,399.5945692233763,357.18290133000676,0.5697244938274169,1,1629.391574405004,1903.778248050232,2094.1560728552554,0,24,0 +m_13,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1229.7970051816276,904.7139850462563,399.5945692233763,129.1102218805977,0.474973747441018,1,1629.391574405004,1033.824206926854,2094.1560728552554,0,24,0 +m_13,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1229.7970051816276,1524.2893307112633,399.5945692233763,251.33439511987794,0.5527221701395071,1,1629.391574405004,1775.6237258311412,2094.1560728552554,0,24,0 +m_13,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,193088.67571119935,182382.0667404689,21770.810752621834,15405.83220704508,0.6974558195764009,1,214859.48646382117,197787.89894751398,276267.53821126884,0,24,0 +m_13,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,193088.67571119935,172554.79712913872,21770.810752621834,10872.64265781246,0.4253919113004745,1,214859.48646382117,183427.43978695117,276267.53821126884,0,24,0 +m_13,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,193088.67571119935,215559.13031230573,21770.810752621834,35593.177152484095,0.6043621545478399,1,214859.48646382117,251152.30746478983,276267.53821126884,0,24,0 +m_13,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,116500.2187851441,118894.44977326578,12927.350676052998,11253.632085066682,0.8917291462613908,1,129427.5694611971,130148.08185833246,143162.89004416572,0,24,0 +m_13,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,116500.2187851441,118174.81767219224,12927.350676052998,11031.581299287454,0.9234998307300792,1,129427.5694611971,129206.39897147969,143162.89004416572,0,24,0 +m_13,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,116500.2187851441,112099.80003252538,12927.350676052998,6764.8262230350065,0.7711009471519655,1,129427.5694611971,118864.62625556039,143162.89004416572,0,24,0 +m_13,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,67954.86845850368,89813.82545027474,5654.844614625991,6021.024461936651,0.024542970363162706,0.5399453479895795,73609.71307312968,95834.8499122114,113642.72738973887,0,24,0 +m_13,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,67954.86845850368,95353.48549676099,5654.844614625991,7958.084857547058,0.020443892120801083,0.4702095187784249,73609.71307312968,103311.57035430805,113642.72738973887,0,24,0 +m_13,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,67954.86845850368,81917.47480318,5654.844614625991,3142.2581637571975,0.06373430771460474,1,73609.71307312968,85059.7329669372,113642.72738973887,0,24,0 +m_13,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,50083.06853493704,64720.25148071609,6711.322448359777,4848.046361481564,0.1104922360558496,1,56794.39098329682,69568.29784219766,84540.70511562808,0,24,0 +m_13,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,50083.06853493704,68028.53330852347,6711.322448359777,8826.653160229333,0.13882303333570614,1,56794.39098329682,76855.1864687528,84540.70511562808,0,24,0 +m_13,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,50083.06853493704,58509.78369052397,6711.322448359777,6695.444602386252,0.39494049936786324,1,56794.39098329682,65205.22829291022,84540.70511562808,0,24,0 +m_14,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,271.461416509586,83.67292264666017,213.23594127513718,19.879984902201432,0.42927835858223945,1,484.6973577847232,103.5529075488616,533.1670935631955,0,24,0 +m_14,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,271.461416509586,54.77106872361428,213.23594127513718,24.60214274091337,0.36845943696779965,1,484.6973577847232,79.37321146452764,533.1670935631955,0,24,0 +m_14,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,271.461416509586,39.31137345632611,213.23594127513718,13.619604834160725,0.3378965874377397,1,484.6973577847232,52.930978290486834,533.1670935631955,0,24,0 +m_14,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,37.03971255186034,44.868631731754434,13.191394508673213,13.52327537215634,0.6873262899585422,1,50.23110706053355,58.391907103910775,97.99519276238136,0,24,0 +m_14,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,37.03971255186034,65.16720741700705,13.191394508673213,23.91933145788509,0.3340724672030754,1,50.23110706053355,89.08653887489214,97.99519276238136,0,24,0 +m_14,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,37.03971255186034,57.79072912490277,13.191394508673213,20.071286789989053,0.41094446865435197,1,50.23110706053355,77.86201591489183,97.99519276238136,0,24,0 +m_14,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,58.34972890670202,34.181662998305285,10.82209075165354,8.892482222398302,0.12169599214383263,1,69.17181965835556,43.074145220703585,82.42920977058841,0,24,0 +m_14,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,58.34972890670202,52.50984892774863,10.82209075165354,22.42579631824083,0.8226778968870756,1,69.17181965835556,74.93564524598946,82.42920977058841,0,24,0 +m_14,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,58.34972890670202,34.42037258412377,10.82209075165354,11.469354479572647,0.16355080130827773,1,69.17181965835556,45.88972706369641,82.42920977058841,0,24,0 +m_14,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,35.678906774941794,25.19575293896499,10.778376169699468,5.011850756925792,0.4134358010992711,1,46.457282944641264,30.207603695890782,55.903084644171074,0,24,0 +m_14,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,35.678906774941794,42.164134721396366,10.778376169699468,8.65685131875915,0.6513239874362488,1,46.457282944641264,50.82098604015552,55.903084644171074,0,24,0 +m_14,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,35.678906774941794,29.557346863098637,10.778376169699468,6.812188535157699,0.645905745340435,1,46.457282944641264,36.36953539825634,55.903084644171074,0,24,0 +m_14,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,114.5648925093318,139.19629085601053,53.271390231616664,53.19183558525741,0.7502679060139749,1,167.83628274094846,192.38812644126796,223.34925856386718,0,24,0 +m_14,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,114.5648925093318,169.2485886102512,53.271390231616664,33.796191902355304,0.4099554268048399,1,167.83628274094846,203.0447805126065,223.34925856386718,0,24,0 +m_14,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,114.5648925093318,94.14407311506747,53.271390231616664,30.56001403110369,0.7480835195937445,1,167.83628274094846,124.70408714617116,223.34925856386718,0,24,0 +m_14,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,102.66297958653877,91.66724384379783,31.20879525503371,20.788788303696325,0.7762154445920625,1,133.8717748415725,112.45603214749416,227.88905088063794,0,24,0 +m_14,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,102.66297958653877,124.08431139108932,31.20879525503371,12.627032608697958,0.5460336861607862,1,133.8717748415725,136.71134399978726,227.88905088063794,0,24,0 +m_14,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,102.66297958653877,159.17497909713205,31.20879525503371,47.99688533981151,0.3505938187035637,1,133.8717748415725,207.17186443694357,227.88905088063794,0,24,0 +m_14,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,139.79541672099538,90.7339854377651,33.578177531606634,17.506946382868797,0.23341178719043404,1,173.373594252602,108.2409318206339,190.71095367786222,0,24,0 +m_14,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,139.79541672099538,71.12931711665738,33.578177531606634,30.820703570654526,0.16306780904038626,1,173.373594252602,101.9500206873119,190.71095367786222,0,24,0 +m_14,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,139.79541672099538,83.52437721341943,33.578177531606634,21.865777681078267,0.19531680839715587,1,173.373594252602,105.3901548944977,190.71095367786222,0,24,0 +m_14,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,67.70693010562654,92.00687142076873,16.136679730514263,14.592852313864492,0.29040587558763403,1,83.8436098361408,106.59972373463323,170.65326045921526,0,24,0 +m_14,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,67.70693010562654,102.21334401138857,16.136679730514263,52.92598367880709,0.5561122567264006,1,83.8436098361408,155.13932769019567,170.65326045921526,0,24,0 +m_14,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,67.70693010562654,40.714913680705926,16.136679730514263,16.82142570038188,0.27383254631584053,1,83.8436098361408,57.53633938108781,170.65326045921526,0,24,0 +m_15,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,40.8376556803037,76.0115084023071,6.561943233333071,8.248161519790859,0.008858378106081725,0.2126010745459614,47.399598913636765,84.25966992209796,97.75817436151237,0,24,0 +m_15,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,40.8376556803037,34.06787373448869,6.561943233333071,15.257360177368449,0.6962101654247934,1,47.399598913636765,49.32523391185714,97.75817436151237,0,24,0 +m_15,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,40.8376556803037,71.82155465563953,6.561943233333071,17.04951294573534,0.1376007378064061,1,47.399598913636765,88.87106760137488,97.75817436151237,0,24,0 +m_15,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,77.7384945663005,52.144255862265055,22.40711675821752,13.992489965156611,0.35973446752658417,1,100.14561132451803,66.13674582742166,110.16017245696985,0,24,0 +m_15,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,77.7384945663005,74.35166241220108,22.40711675821752,7.283851173675245,0.8903735858878921,1,100.14561132451803,81.63551358587632,110.16017245696985,0,24,0 +m_15,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,77.7384945663005,59.14673822646013,22.40711675821752,9.07693546812892,0.4685075156580907,1,100.14561132451803,68.22367369458905,110.16017245696985,0,24,0 +m_15,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,72.75482247834161,118.10528815561626,6.518631959837352,24.524947609293942,0.126780363074079,1,79.27345443817896,142.6302357649102,156.89325934140123,0,24,0 +m_15,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,72.75482247834161,52.89024827901581,6.518631959837352,14.266389050803244,0.2554688517394846,1,79.27345443817896,67.15663732981905,156.89325934140123,0,24,0 +m_15,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,72.75482247834161,78.1275138582808,6.518631959837352,16.48521789010789,0.7713179771409627,1,79.27345443817896,94.6127317483887,156.89325934140123,0,24,0 +m_15,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,64.01321127549492,70.31213607745954,12.419205215150516,7.206417221820088,0.6749858096663548,1,76.43241649064544,77.51855329927963,90.86969631283543,0,24,0 +m_15,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,64.01321127549492,67.72313244925068,12.419205215150516,10.547866798662167,0.8253547661785983,1,76.43241649064544,78.27099924791285,90.86969631283543,0,24,0 +m_15,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,64.01321127549492,72.85212684858155,12.419205215150516,9.756687981268836,0.5909982120423553,1,76.43241649064544,82.60881482985039,90.86969631283543,0,24,0 +m_15,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,646.9840564977002,693.8970981458789,80.84799216038712,80.42509077787318,0.6894706979635927,1,727.8320486580873,774.322188923752,895.3766339046647,0,24,0 +m_15,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,646.9840564977002,610.1873262139134,80.84799216038712,76.68128460949768,0.7480620388955185,1,727.8320486580873,686.868610823411,895.3766339046647,0,24,0 +m_15,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,646.9840564977002,777.2208388741237,80.84799216038712,36.75791922102584,0.1860665283888407,1,727.8320486580873,813.9787580951496,895.3766339046647,0,24,0 +m_15,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,620.7309740782359,621.3890891452388,52.48287081241077,49.1912525386785,0.9928808582131384,1,673.2138448906467,670.5803416839174,789.1801181644629,0,24,0 +m_15,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,620.7309740782359,649.4584850798128,52.48287081241077,48.69551557269078,0.6967185161844678,1,673.2138448906467,698.1540006525036,789.1801181644629,0,24,0 +m_15,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,620.7309740782359,654.8410978020079,52.48287081241077,62.59537325659469,0.6853454076831811,1,673.2138448906467,717.4364710586026,789.1801181644629,0,24,0 +m_15,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,976.9586659136668,595.4346557678666,329.32211093251044,39.57553148253245,0.30069175943310883,1,1306.280776846177,635.0101872503991,1436.908854530795,0,24,0 +m_15,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,976.9586659136668,721.175176826235,329.32211093251044,67.96751897222019,0.47859814800069334,1,1306.280776846177,789.1426957984552,1436.908854530795,0,24,0 +m_15,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,976.9586659136668,588.839506501011,329.32211093251044,42.65444253682334,0.2935663634011207,1,1306.280776846177,631.4939490378343,1436.908854530795,0,24,0 +m_15,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1060.427767412219,806.520701879274,294.82770002155263,66.50570898144974,0.4357973894962347,1,1355.2554674337716,873.0264108607238,1490.781014177149,0,24,0 +m_15,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1060.427767412219,932.7866013646243,294.82770002155263,110.61361963325967,0.6984678146865879,1,1355.2554674337716,1043.400220997884,1490.781014177149,0,24,0 +m_15,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1060.427767412219,678.1574669815874,294.82770002155263,61.43590128846092,0.25598032111040986,1,1355.2554674337716,739.5933682700484,1490.781014177149,0,24,0 +m_16,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,16.490691474938743,80.39653765348156,5.270368557591953,40.8987244611147,0.18004095055866237,1,21.761060032530697,121.29526211459626,133.4247883260559,0,24,0 +m_16,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,16.490691474938743,40.47810216922594,5.270368557591953,15.605974438398244,0.19473636501787522,1,21.761060032530697,56.08407660762418,133.4247883260559,0,24,0 +m_16,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,16.490691474938743,17.65506248746383,5.270368557591953,6.208225842040805,0.8894647314883589,1,21.761060032530697,23.863288329504634,133.4247883260559,0,24,0 +m_16,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,117.66848915359355,46.01230967378751,86.60668508648298,20.30588353024463,0.45364235996093133,1,204.27517424007652,66.31819320403214,224.7026916640842,0,24,0 +m_16,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,117.66848915359355,44.186238706356164,86.60668508648298,11.01055485407466,0.4372124778723329,1,204.27517424007652,55.19679356043083,224.7026916640842,0,24,0 +m_16,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,117.66848915359355,32.71071649800286,86.60668508648298,9.780523590452354,0.37339093878695434,1,204.27517424007652,42.491240088455214,224.7026916640842,0,24,0 +m_16,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,69.34508353878805,22.542113554114998,16.189030557315558,7.725542752228915,0.0415204090050328,0.9964898161207872,85.53411409610361,30.267656306343913,131.21556933317382,0,24,0 +m_16,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,69.34508353878805,51.67095904511086,16.189030557315558,18.890092711673113,0.4980823553633217,1,85.53411409610361,70.56105175678397,131.21556933317382,0,24,0 +m_16,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,69.34508353878805,74.16837629978032,16.189030557315558,45.11850491219586,0.9230059264051158,1,85.53411409610361,119.28688121197618,131.21556933317382,0,24,0 +m_16,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,57.09593719876665,59.64934255767396,18.102859284587307,26.58544232165795,0.9385736831895525,1,75.19879648335396,86.23478487933191,94.85826336726511,0,24,0 +m_16,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,57.09593719876665,59.966265914172496,18.102859284587307,24.16190740622247,0.9264008254280169,1,75.19879648335396,84.12817332039496,94.85826336726511,0,24,0 +m_16,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,57.09593719876665,51.59466056074995,18.102859284587307,22.328499508143032,0.8525129417794228,1,75.19879648335396,73.92316006889298,94.85826336726511,0,24,0 +m_16,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,79.00242850020761,55.044308729685106,47.937337518501764,33.29058093464622,0.6911311973900247,1,126.93976601870938,88.33488966433133,166.22018256238078,0,24,0 +m_16,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,79.00242850020761,103.3579785631502,47.937337518501764,46.701741884546664,0.7234996388872525,1,126.93976601870938,150.05972044769686,166.22018256238078,0,24,0 +m_16,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,79.00242850020761,100.29209251900511,47.937337518501764,50.8171643558865,0.7668261592069701,1,126.93976601870938,151.1092568748916,166.22018256238078,0,24,0 +m_16,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,47.12936719750331,171.03457910971724,13.250491954272666,132.4601875873081,0.3939004925161391,1,60.37985915177598,303.49476669702534,389.6098366307304,0,24,0 +m_16,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,47.12936719750331,246.73899768363455,13.250491954272666,107.4517628897567,0.12283138671180355,1,60.37985915177598,354.19076057339123,389.6098366307304,0,24,0 +m_16,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,47.12936719750331,80.57899310684242,13.250491954272666,27.94551790377947,0.31462678228848734,1,60.37985915177598,108.5245110106219,389.6098366307304,0,24,0 +m_16,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,93.67793470084389,100.13796051833079,30.985495839360514,28.45995026224001,0.8810435190765464,1,124.6634305402044,128.5979107805708,204.54778930586903,0,24,0 +m_16,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,93.67793470084389,90.62101978540797,30.985495839360514,54.555066979977354,0.9623458515317255,1,124.6634305402044,145.17608676538532,204.54778930586903,0,24,0 +m_16,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,93.67793470084389,133.4211452878673,30.985495839360514,52.531390444740914,0.532671317760807,1,124.6634305402044,185.9525357326082,204.54778930586903,0,24,0 +m_16,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,50.205845180981015,138.2488865882756,21.882677396281615,41.05021964911075,0.09682371559593332,1,72.08852257726264,179.29910623738635,197.22901686112502,0,24,0 +m_16,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,50.205845180981015,90.05648112519526,21.882677396281615,27.694245048470233,0.2866079807610343,1,72.08852257726264,117.7507261736655,197.22901686112502,0,24,0 +m_16,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,50.205845180981015,88.32419185986639,21.882677396281615,51.7760883757243,0.5203075306297489,1,72.08852257726264,140.10028023559067,197.22901686112502,0,24,0 +m_17,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,32896.69984242266,11992.268302107643,7137.1078980457705,2929.8113762876465,0.03951855425442778,0.6718154223252722,40033.80774046843,14922.07967839529,44037.18851451528,0,24,0 +m_17,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,32896.69984242266,24821.790390242648,7137.1078980457705,7113.249728912002,0.44383282851039674,1,40033.80774046843,31935.040119154648,44037.18851451528,0,24,0 +m_17,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,32896.69984242266,15347.62033183076,7137.1078980457705,1569.5440414272443,0.06858192796871339,1,40033.80774046843,16917.164373258005,44037.18851451528,0,24,0 +m_17,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,7851.66608672626,3282.9464734557887,2250.017703206182,1085.78833105564,0.10892112338242028,1,10101.683789932442,4368.734804511429,11111.852168925687,0,24,0 +m_17,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,7851.66608672626,2797.6605171272868,2250.017703206182,1025.2620002287333,0.08029174240003135,1,10101.683789932442,3822.92251735602,11111.852168925687,0,24,0 +m_17,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,7851.66608672626,2958.6147804943807,2250.017703206182,721.4857905058266,0.08365735092317736,1,10101.683789932442,3680.1005710002073,11111.852168925687,0,24,0 +m_17,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,10591.387819563437,1500.3520502909798,8491.23855051692,174.37845690470053,0.34467793993340556,1,19082.626370080357,1674.7305071956803,20990.889007088394,0,24,0 +m_17,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,10591.387819563437,2538.463944069799,8491.23855051692,1550.9046260842283,0.4005723099692902,1,19082.626370080357,4089.368570154027,20990.889007088394,0,24,0 +m_17,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,10591.387819563437,2131.816369961244,8491.23855051692,457.74765788147084,0.3758251691804977,1,19082.626370080357,2589.564027842715,20990.889007088394,0,24,0 +m_17,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1506.8779059558976,1129.385190144351,746.5677399146275,197.49104733602675,0.647551570271083,1,2253.4456458705254,1326.8762374803778,3529.319121531911,0,24,0 +m_17,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1506.8779059558976,675.097724787492,746.5677399146275,97.91822103241462,0.32935675477263193,1,2253.4456458705254,773.0159458199066,3529.319121531911,0,24,0 +m_17,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1506.8779059558976,2251.397678523735,746.5677399146275,957.0742501416382,0.5550773139755049,1,2253.4456458705254,3208.4719286653735,3529.319121531911,0,24,0 +m_17,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,52622.90803874885,38792.761297383084,6480.037786899388,3271.5894902881764,0.0962209041101132,1,59102.94582564824,42064.35078767126,96000.56521510758,0,24,0 +m_17,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,52622.90803874885,58086.55761370011,6480.037786899388,5908.31639911248,0.547313867788985,1,59102.94582564824,63994.874012812594,96000.56521510758,0,24,0 +m_17,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,52622.90803874885,74575.06981341507,6480.037786899388,12698.171291228158,0.16498236100096883,1,59102.94582564824,87273.24110464324,96000.56521510758,0,24,0 +m_17,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,27932.670478349937,46258.96688276055,1569.0286141512981,6180.842139033085,0.030322171736800168,0.5870691862871826,29501.699092501236,52439.80902179363,57683.789923973,0,24,0 +m_17,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,27932.670478349937,45634.65515690188,1569.0286141512981,5537.580367372014,0.022767175937307732,0.5008778706207702,29501.699092501236,51172.23552427389,57683.789923973,0,24,0 +m_17,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,27932.670478349937,48003.72822074467,1569.0286141512981,3460.0450061212223,0.0011585668669061627,0.027805604805747904,29501.699092501236,51463.773226865895,57683.789923973,0,24,0 +m_17,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,18175.558131964863,25003.14211897931,1852.3903292828065,1927.9409183876915,0.028715705222647978,0.5870691862871826,20027.94846124767,26931.083037367003,35297.7787662325,0,24,0 +m_17,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,18175.558131964863,28628.628003507783,1852.3903292828065,3460.2617839763047,0.029822147929995952,0.5870691862871826,20027.94846124767,32088.889787484088,35297.7787662325,0,24,0 +m_17,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,18175.558131964863,27935.82708304838,1852.3903292828065,1569.046183681881,0.002570974445994383,0.05913241225787081,20027.94846124767,29504.87326673026,35297.7787662325,0,24,0 +m_17,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,16162.128318216166,21930.462813905935,1504.5160778513555,1662.2155972512644,0.027955675537484886,0.5870691862871826,17666.64439606752,23592.678411157198,39943.227288650734,0,24,0 +m_17,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,16162.128318216166,21955.163529867652,1504.5160778513555,2384.282968125588,0.07214292865376827,1,17666.64439606752,24339.446497993238,39943.227288650734,0,24,0 +m_17,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,16162.128318216166,30594.086727280315,1504.5160778513555,5717.938080583981,0.05262627920778143,0.8420204673245029,17666.64439606752,36312.0248078643,39943.227288650734,0,24,0 +m_18,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,97.14629652433442,74.85867365129671,18.2872094185139,50.276691342454804,0.6908534460157998,1,115.43350594284831,125.13536499375152,245.34295576740263,0,24,0 +m_18,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,97.14629652433442,179.00834436693427,18.2872094185139,44.03070633070446,0.1320875019609627,1,115.43350594284831,223.03905069763874,245.34295576740263,0,24,0 +m_18,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,97.14629652433442,115.89269840556757,18.2872094185139,71.7690823456528,0.8091484380628899,1,115.43350594284831,187.66178075122036,245.34295576740263,0,24,0 +m_18,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,67.97713571873399,38.77794882419713,15.908678749835968,12.687833500491271,0.1833003079189355,1,83.88581446856996,51.465782324688405,174.707600053773,1,24,4.166666666666666 +m_18,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,67.97713571873399,136.96872681266026,15.908678749835968,21.856364145315187,0.03073483065465025,0.6454314437476553,83.88581446856996,158.82509095797545,174.707600053773,1,24,4.166666666666666 +m_18,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,67.97713571873399,115.71884434235403,15.908678749835968,32.67936508608391,0.22907513583472378,1,83.88581446856996,148.39820942843795,174.707600053773,1,24,4.166666666666666 +m_18,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,108.24606877291988,63.444511443884345,64.5757058588266,6.9306104954525045,0.5274352638218521,1,172.82177463174648,70.37512193933685,190.10395209492114,0,24,0 +m_18,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,108.24606877291988,53.571168587516844,64.5757058588266,9.932914639677547,0.4477712149776795,1,172.82177463174648,63.50408322719439,190.10395209492114,0,24,0 +m_18,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,108.24606877291988,111.28456844121622,64.5757058588266,30.863626682322707,0.9675620313218506,1,172.82177463174648,142.14819512353893,190.10395209492114,0,24,0 +m_18,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,24.995311385825953,37.929388052929156,4.772066212052826,20.634096043296243,0.5656274747058303,1,29.767377597878777,58.563484096225395,64.41983250584794,0,24,0 +m_18,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,24.995311385825953,37.056768853383005,4.772066212052826,10.00954424249956,0.3123880185256883,1,29.767377597878777,47.06631309588256,64.41983250584794,0,24,0 +m_18,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,24.995311385825953,32.21993865635937,4.772066212052826,8.369717750343982,0.4754668662698921,1,29.767377597878777,40.58965640670335,64.41983250584794,0,24,0 +m_18,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,803.7025457024738,1170.8056157509416,209.3827417027884,325.19781893991563,0.3686403975800502,1,1013.0852874052622,1496.0034346908571,2776.9863399178757,0,24,0 +m_18,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,803.7025457024738,2153.4253786092477,209.3827417027884,371.1076576797298,0.013479148794634237,0.31002042227658744,1013.0852874052622,2524.5330362889777,2776.9863399178757,0,24,0 +m_18,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,803.7025457024738,942.6705533719263,209.3827417027884,441.2860472921679,0.7840891235930754,1,1013.0852874052622,1383.9566006640941,2776.9863399178757,0,24,0 +m_18,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1157.7489646589358,1494.8551269463458,259.8523857543363,429.2294268839141,0.5200877054047444,1,1417.601350413272,1924.08455383026,6360.0197652730885,0,24,0 +m_18,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1157.7489646589358,5058.244972713104,259.8523857543363,723.5911775351577,0.002004581930526935,0.04810996633264644,1417.601350413272,5781.836150248262,6360.0197652730885,0,24,0 +m_18,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1157.7489646589358,1985.5168479940962,259.8523857543363,321.33877053993285,0.0742631908253869,1,1417.601350413272,2306.855618534029,6360.0197652730885,0,24,0 +m_18,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,734.9367301749817,829.5268275766446,146.4678040846416,136.67919936276448,0.6469946476016077,1,881.4045342596232,966.2060269394091,3228.3801745196097,0,24,0 +m_18,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,734.9367301749817,2267.3322086686385,146.4678040846416,539.0334417968087,0.0351861923122851,0.703723846245702,881.4045342596232,2806.3656504654473,3228.3801745196097,0,24,0 +m_18,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,734.9367301749817,2396.033506302852,146.4678040846416,538.8575614422476,0.026197648179310848,0.5763482599448386,881.4045342596232,2934.8910677450995,3228.3801745196097,0,24,0 +m_18,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,522.7489803443298,250.37741421080986,245.24219250195205,100.37476543115895,0.34004857350124384,1,767.9911728462819,350.75217964196884,2149.126954031489,0,24,0 +m_18,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,522.7489803443298,1580.1842366382143,245.24219250195205,373.56753975404814,0.043290811705868924,0.8225254224115096,767.9911728462819,1953.7517763922624,2149.126954031489,0,24,0 +m_18,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,522.7489803443298,722.4512206432156,245.24219250195205,364.9856475683325,0.6607738182087062,1,767.9911728462819,1087.4368682115482,2149.126954031489,0,24,0 +m_19,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,3.6030854327723314,4.298113922662474,0.40343767843115913,0.579602110241505,0.35214199153139536,1,4.0065231112034905,4.8777160329039795,6.789064830349588,7,24,29.166666666666668 +m_19,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,3.6030854327723314,4.062746036398289,0.40343767843115913,0.5558630504610932,0.5207938425195873,1,4.0065231112034905,4.618609086859382,6.789064830349588,7,24,29.166666666666668 +m_19,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,3.6030854327723314,5.072129219544465,0.40343767843115913,1.0997478989551601,0.25438010217299173,1,4.0065231112034905,6.171877118499625,6.789064830349588,7,24,29.166666666666668 +m_19,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,3.6684167119083524,3.8504013490598172,0.3557387838841327,0.8363771059397168,0.8471992465448855,1,4.024155495792485,4.686778454999534,5.1554563004994884,6,24,25 +m_19,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,3.6684167119083524,4.173991889585674,0.3557387838841327,0.3882525461104316,0.3598091571892782,1,4.024155495792485,4.562244435696105,5.1554563004994884,6,24,25 +m_19,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,3.6684167119083524,3.560846772652198,0.3557387838841327,0.4038883145009488,0.8456554896521654,1,4.024155495792485,3.9647350871531466,5.1554563004994884,6,24,25 +m_19,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,4.341760330997487,4.218687095939611,0.9709164685175341,0.2779280308188553,0.9080873721071021,1,5.312676799515021,4.496615126758466,5.843944479466524,4,24,16.666666666666664 +m_19,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,4.341760330997487,3.2767840272500495,0.9709164685175341,0.0584639628609663,0.334655845857804,1,5.312676799515021,3.3352479901110157,5.843944479466524,4,24,16.666666666666664 +m_19,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,4.341760330997487,3.434900524874606,0.9709164685175341,0.4025028295464002,0.4251100738652475,1,5.312676799515021,3.837403354421006,5.843944479466524,4,24,16.666666666666664 +m_19,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,2.8430683750443606,3.5367796802936198,0.18322507822913692,0.40221957177792567,0.16101916438718078,1,3.0262934532734977,3.9389992520715453,4.3328991772787004,7,24,29.166666666666668 +m_19,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,2.8430683750443606,2.7250905433469526,0.18322507822913692,0.10120857764310047,0.5923693208995906,1,3.0262934532734977,2.826299120990053,4.3328991772787004,7,24,29.166666666666668 +m_19,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,2.8430683750443606,3.0339450740808793,0.18322507822913692,0.30895372578923014,0.609734509635809,1,3.0262934532734977,3.3428987998701096,4.3328991772787004,7,24,29.166666666666668 +m_19,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1334.356469548242,1811.6377479830755,144.5607574779614,260.41465430668137,0.1486237278884838,1,1478.9172270262036,2072.052402289757,3198.7561261777087,0,24,0 +m_19,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1334.356469548242,2645.9954280249704,144.5607574779614,261.96468668203704,0.0024936836767384895,0.057354724564985256,1478.9172270262036,2907.9601147070075,3198.7561261777087,0,24,0 +m_19,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1334.356469548242,1716.1160484714699,144.5607574779614,421.420298739028,0.4235872734572925,1,1478.9172270262036,2137.5363472104978,3198.7561261777087,0,24,0 +m_19,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1734.7229038168994,2539.123484557517,133.37182282426986,340.71711668949916,0.06682876370417058,1,1868.0947266411692,2879.840601247016,5959.67264963079,0,24,0 +m_19,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1734.7229038168994,5019.703021182,133.37182282426986,398.18120575508146,2.1087610722300595e-4,0.005061026573352143,1868.0947266411692,5417.884226937082,5959.67264963079,0,24,0 +m_19,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,1734.7229038168994,2406.8514954733364,133.37182282426986,208.56288220091426,0.025029276074754286,0.5506440736445943,1868.0947266411692,2615.4143776742508,5959.67264963079,0,24,0 +m_19,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1627.0311167099667,1856.9663128233233,159.9667287159492,140.77421098860353,0.3062981852843694,1,1786.9978454259158,1997.7405238119268,3966.2482176039284,0,24,0 +m_19,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1627.0311167099667,3113.440184529157,159.9667287159492,492.24001329259613,0.02812505301490916,0.5906261133130923,1786.9978454259158,3605.6801978217527,3966.2482176039284,0,24,0 +m_19,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,1627.0311167099667,2814.9352000523145,159.9667287159492,399.4448344536033,0.029938277940649093,0.5987655588129819,1786.9978454259158,3214.3800345059176,3966.2482176039284,0,24,0 +m_19,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1771.7543971110147,1551.2092926148991,368.4154353380637,233.0878055640809,0.625868804941297,1,2140.1698324490785,1784.29709817898,4210.725661524045,0,24,0 +m_19,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1771.7543971110147,3216.760188962542,368.4154353380637,611.1722306047716,0.07656515831343198,1,2140.1698324490785,3827.9324195673134,4210.725661524045,0,24,0 +m_19,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1771.7543971110147,1845.1066535412383,368.4154353380637,491.8011878321092,0.907529171741791,1,2140.1698324490785,2336.9078413733473,4210.725661524045,0,24,0 +m_20,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,43.73069247291231,42.18705559300633,16.600614771246892,16.302599643274757,0.9485781554352959,1,60.331307244159206,58.48965523628108,66.75014788739554,0,24,0 +m_20,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,43.73069247291231,36.438367851445285,16.600614771246892,8.235613331021701,0.7077101637664811,1,60.331307244159206,44.67398118246699,66.75014788739554,0,24,0 +m_20,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,43.73069247291231,46.568945074556964,16.600614771246892,14.113007550348064,0.8994353002666209,1,60.331307244159206,60.68195262490503,66.75014788739554,0,24,0 +m_20,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,52.2545894269321,65.98029116809933,24.555341203532063,18.989981183096724,0.6683594841102248,1,76.80993063046417,84.97027235119606,93.46729958631568,0,24,0 +m_20,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,52.2545894269321,31.7692905231694,24.555341203532063,7.420562974687735,0.4554382998283356,1,76.80993063046417,39.189853497857136,93.46729958631568,0,24,0 +m_20,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,52.2545894269321,38.05536013908963,24.555341203532063,9.793108386086589,0.6089361040585101,1,76.80993063046417,47.848468525176216,93.46729958631568,0,24,0 +m_20,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,45.24742404315837,21.56539904657082,14.688246684326169,7.557739665554751,0.20119541037318292,1,59.935670727484535,29.123138712125574,65.929237800233,0,24,0 +m_20,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,45.24742404315837,33.98903768242757,14.688246684326169,9.826312116896126,0.5443894321726621,1,59.935670727484535,43.8153497993237,65.929237800233,0,24,0 +m_20,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,45.24742404315837,42.654022467618326,14.688246684326169,10.018573050241386,0.8879651281179501,1,59.935670727484535,52.67259551785971,65.929237800233,0,24,0 +m_20,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,51.40813337414527,59.892275816138635,16.538016199790277,19.078659365696247,0.7445629687963097,1,67.94614957393554,78.97093518183488,86.86802870001837,0,24,0 +m_20,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,51.40813337414527,50.41806036840318,16.538016199790277,8.22395148687817,0.9590096828964756,1,67.94614957393554,58.64201185528135,86.86802870001837,0,24,0 +m_20,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,51.40813337414527,37.95602990677334,16.538016199790277,11.344734805362192,0.5228928973123451,1,67.94614957393554,49.30076471213553,86.86802870001837,0,24,0 +m_20,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,30.4739112955606,31.459739284329736,8.96018604677285,11.065946714440686,0.94622485713229,1,39.43409734233345,42.52568599877042,79.76016324152964,0,24,0 +m_20,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,30.4739112955606,48.27318832373558,8.96018604677285,24.23605098674591,0.5153200701617382,1,39.43409734233345,72.50923931048149,79.76016324152964,0,24,0 +m_20,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,30.4739112955606,44.42842038626968,8.96018604677285,10.80568643012111,0.34440237940294927,1,39.43409734233345,55.23410681639079,79.76016324152964,0,24,0 +m_20,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,41.9261339817193,63.57237421896626,4.383338106153433,16.145217225761982,0.24538066017744775,1,46.309472087872734,79.71759144472824,192.11314791924497,0,24,0 +m_20,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,41.9261339817193,123.68983743219611,4.383338106153433,50.95847885802657,0.1699513137725235,1,46.309472087872734,174.64831629022268,192.11314791924497,0,24,0 +m_20,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,41.9261339817193,72.34378901695959,4.383338106153433,30.386796332592446,0.3655746713000113,1,46.309472087872734,102.73058534955203,192.11314791924497,0,24,0 +m_20,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,53.05748186434992,75.14320285351441,18.987195661636466,19.05546591949846,0.43077132660383244,1,72.04467752598639,94.19866877301287,103.61853565031416,0,24,0 +m_20,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,53.05748186434992,62.75850857196542,18.987195661636466,13.22464747989255,0.6849393725814061,1,72.04467752598639,75.98315605185797,103.61853565031416,0,24,0 +m_20,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,53.05748186434992,21.062812241614477,18.987195661636466,6.030595730943769,0.1594070836529113,1,72.04467752598639,27.093407972558246,103.61853565031416,0,24,0 +m_20,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,89.1451395839603,52.78562454087198,11.062431391745132,13.59490398449168,0.06593748868296335,1,100.20757097570544,66.38052852536366,121.94985956196699,0,24,0 +m_20,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,89.1451395839603,90.13860100314889,11.062431391745132,20.72490768954836,0.9673536520198416,1,100.20757097570544,110.86350869269725,121.94985956196699,0,24,0 +m_20,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,89.1451395839603,54.97409980097915,11.062431391745132,28.580513717464743,0.30457425107419706,1,100.20757097570544,83.55461351844389,121.94985956196699,0,24,0 +m_21,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,14870.988564881356,13987.438383707395,2181.788891877769,2307.945860867289,0.7871648532484096,1,17052.777456759126,16295.384244574683,22194.030489803277,0,24,0 +m_21,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,14870.988564881356,13607.920015240092,2181.788891877769,2788.7045764709383,0.7296579287176875,1,17052.777456759126,16396.62459171103,22194.030489803277,0,24,0 +m_21,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,14870.988564881356,17134.570853305955,2181.788891877769,3041.8205010606594,0.560967300961271,1,17052.777456759126,20176.391354366613,22194.030489803277,0,24,0 +m_21,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,6144.915402466982,6973.170690336532,753.1748196830871,1053.7085819886145,0.5383597148623951,1,6898.090222150069,8026.879272325146,8829.567199557661,0,23,0 +m_21,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,6144.915402466982,5879.979772553261,753.1748196830871,1676.814091761928,0.8904497572377987,1,6898.090222150069,7556.793864315188,8829.567199557661,0,23,0 +m_21,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,6144.915402466982,5238.275880758423,753.1748196830871,951.1898373136852,0.4729912544020348,1,6898.090222150069,6189.465718072109,8829.567199557661,0,23,0 +m_21,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,14732.995385867538,8064.18191623999,5395.066090223546,1121.7391420126621,0.28786573297202495,1,20128.061476091083,9185.921058252652,22140.867623700193,0,24,0 +m_21,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,14732.995385867538,9044.299790132725,5395.066090223546,3620.115528256368,0.41031602712859727,1,20128.061476091083,12664.415318389094,22140.867623700193,0,24,0 +m_21,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,14732.995385867538,5651.92631283653,5395.066090223546,938.668649403915,0.16850141216020975,1,20128.061476091083,6590.594962240445,22140.867623700193,0,24,0 +m_21,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,4771.656231796832,5015.2897547384155,969.9007462135248,737.7522915135241,0.8466102593169721,1,5741.556978010357,5753.04204625194,9494.329532538033,0,24,0 +m_21,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,4771.656231796832,7494.576706410576,969.9007462135248,1136.631959533091,0.10179928356702553,1,5741.556978010357,8631.208665943666,9494.329532538033,0,24,0 +m_21,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,4771.656231796832,6747.2163613571865,969.9007462135248,1651.8211929544589,0.33302089476685026,1,5741.556978010357,8399.037554311646,9494.329532538033,0,24,0 +m_21,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,555524.7560967305,738045.8786643707,39438.76417718343,61840.94880509329,0.035991910133866094,0.755830112811188,594963.5202739139,799886.827469464,902214.0377225857,0,24,0 +m_21,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,555524.7560967305,655084.1488899597,39438.76417718343,67411.65090117644,0.2378989931933003,1,594963.5202739139,722495.79979113606,902214.0377225857,0,24,0 +m_21,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,555524.7560967305,739452.2707059756,39438.76417718343,80742.30904182953,0.07847534396569648,1,594963.5202739139,820194.5797478051,902214.0377225857,0,24,0 +m_21,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,282288.5411128951,376440.23125482217,31620.297150150167,39849.55753503861,0.09545841412997527,1,313908.8382630453,416289.7887898608,554965.6889693474,0,24,0 +m_21,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,282288.5411128951,338280.511042375,31620.297150150167,49511.04771660008,0.3668599182468595,1,313908.8382630453,387791.55875897506,554965.6889693474,0,24,0 +m_21,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,282288.5411128951,444137.86370401556,31620.297150150167,60376.398995391115,0.04671647179625088,0.9343294359250176,313908.8382630453,504514.26269940665,554965.6889693474,0,24,0 +m_21,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,249083.98538682997,298849.64627018786,53828.81273245457,37628.99173241023,0.46810303628868366,1,302912.79811928456,336478.6380025981,409528.0146438533,0,24,0 +m_21,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,249083.98538682997,307955.49564471305,53828.81273245457,64342.69948606262,0.49931703882697076,1,302912.79811928456,372298.1951307757,409528.0146438533,0,24,0 +m_21,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,249083.98538682997,332681.5590591274,53828.81273245457,22434.237512473606,0.19677299597055214,1,302912.79811928456,355115.796571601,409528.0146438533,0,24,0 +m_21,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,209884.98459768714,406023.36849716166,41289.4385277325,40610.271569818215,0.006926489752993244,0.15930926431884462,251174.42312541965,446633.64006697986,730719.8133637583,0,24,0 +m_21,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,209884.98459768714,395571.83456919144,41289.4385277325,40721.120173029914,0.009462423277403716,0.20817331210288176,251174.42312541965,436292.95474222134,730719.8133637583,0,24,0 +m_21,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,209884.98459768714,582561.8064464973,41289.4385277325,81728.93297510102,0.004227913733489631,0.10146992960375115,251174.42312541965,664290.7394215984,730719.8133637583,0,24,0 +m_22,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,49.461843943893925,67.34844749111075,17.70167458931118,29.080225954328398,0.6135283162657388,1,67.1635185332051,96.42867344543914,106.07154078998308,0,24,0 +m_22,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,49.461843943893925,49.72094162236044,17.70167458931118,24.569317228942143,0.993367745716498,1,67.1635185332051,74.29025885130258,106.07154078998308,0,24,0 +m_22,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,49.461843943893925,36.23720535442992,17.70167458931118,13.832156786736025,0.5723354727177882,1,67.1635185332051,50.06936214116594,106.07154078998308,0,24,0 +m_22,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,33.61695054137823,18.067021991126882,12.763428023654686,5.56338467321517,0.3017878851834754,1,46.38037856503291,23.630406664342054,174.29943910216676,0,24,0 +m_22,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,33.61695054137823,69.56467873752992,12.763428023654686,44.83632361932564,0.470846758855354,1,46.38037856503291,114.40100235685556,174.29943910216676,0,24,0 +m_22,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,33.61695054137823,93.38676738263071,12.763428023654686,65.06726816479362,0.40588595046328657,1,46.38037856503291,158.45403554742433,174.29943910216676,0,24,0 +m_22,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,74.33856569071685,58.270301618224174,30.87041293792315,29.789401723178624,0.7168509479908279,1,105.20897862864,88.0597033414028,140.65970755363546,0,24,0 +m_22,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,74.33856569071685,91.29721449783624,30.87041293792315,36.575246914559614,0.732504598807669,1,105.20897862864,127.87246141239585,140.65970755363546,0,24,0 +m_22,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,74.33856569071685,44.58963588465756,30.87041293792315,11.407102649611971,0.40676922781755076,1,105.20897862864,55.99673853426953,140.65970755363546,0,24,0 +m_22,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,22.903585106474594,88.86321803022811,8.553318528151502,32.78414491953831,0.10229849231981654,1,31.456903634626094,121.64736294976643,133.81209924474308,0,24,0 +m_22,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,22.903585106474594,27.486472349546442,8.553318528151502,7.289628253605792,0.6936417079734725,1,31.456903634626094,34.77610060315224,133.81209924474308,0,24,0 +m_22,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,22.903585106474594,44.89195500806812,8.553318528151502,14.758335092375164,0.23420002346038454,1,31.456903634626094,59.650290100443286,133.81209924474308,0,24,0 +m_22,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,42.95666164521154,64.85368406177513,7.823720613025413,17.18582660238724,0.2842905323642503,1,50.780382258236955,82.03951066416236,90.2434617305786,0,24,0 +m_22,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,42.95666164521154,35.595149554208206,7.823720613025413,13.345840305002156,0.646786764650453,1,50.780382258236955,48.94098985921036,90.2434617305786,0,24,0 +m_22,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,42.95666164521154,43.125226446533475,7.823720613025413,13.484484533171928,0.9916370479119012,1,50.780382258236955,56.609710979705405,90.2434617305786,0,24,0 +m_22,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,38.19014008622118,88.13274406292382,15.099196186508573,28.750523344251498,0.16478834987540122,1,53.28933627272975,116.88326740717531,128.57159414789285,0,24,0 +m_22,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,38.19014008622118,64.84406985093825,15.099196186508573,23.76551551792647,0.37004193627052695,1,53.28933627272975,88.60958536886473,128.57159414789285,0,24,0 +m_22,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,38.19014008622118,52.768984285705415,15.099196186508573,15.84950972792856,0.5205184642491905,1,53.28933627272975,68.61849401363398,128.57159414789285,0,24,0 +m_22,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,61.12333088964788,52.88042935096677,24.445197692278956,12.616633134183662,0.7725977748395726,1,85.56852858192684,65.49706248515044,192.36535114442233,0,24,0 +m_22,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,61.12333088964788,120.61051619418791,24.445197692278956,54.267075755286925,0.35109146554029813,1,85.56852858192684,174.87759194947483,192.36535114442233,0,24,0 +m_22,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,61.12333088964788,54.78363676668903,24.445197692278956,29.996196456015536,0.8732553433885077,1,85.56852858192684,84.77983322270457,192.36535114442233,0,24,0 +m_22,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,83.56495705722055,132.2510806262414,13.846212753280717,48.917854478789536,0.37646543136696947,1,97.41116981050126,181.16893510503093,199.28582861553403,0,24,0 +m_22,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,83.56495705722055,45.047389271223174,13.846212753280717,7.827018684993645,0.042115321538532854,0.9686523953862557,97.41116981050126,52.87440795621682,199.28582861553403,0,24,0 +m_22,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,83.56495705722055,42.31180032178798,13.846212753280717,8.830083017198644,0.03466063843945951,0.8318553225470282,97.41116981050126,51.141883338986624,199.28582861553403,0,24,0 +m_23,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1837.7951123566618,2978.7215498809874,391.34909213920616,478.43308876019785,0.09825017684840574,1,2229.144204495868,3457.154638641185,3802.8701025053037,0,24,0 +m_23,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1837.7951123566618,1508.5467012707788,391.34909213920616,173.6973705627071,0.47330144010785113,1,2229.144204495868,1682.244071833486,3802.8701025053037,0,24,0 +m_23,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1837.7951123566618,2481.472576696326,391.34909213920616,108.54217037605787,0.17862913111934636,1,2229.144204495868,2590.014747072384,3802.8701025053037,0,24,0 +m_23,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1638.301953251459,1740.6874938013984,154.29985892562917,207.08644518870324,0.7007637296932856,1,1792.6018121770883,1947.7739389901017,2305.123703258642,0,24,0 +m_23,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1638.301953251459,1901.772103589616,154.29985892562917,193.79489937278552,0.31374537662097013,1,1792.6018121770883,2095.5670029624016,2305.123703258642,0,24,0 +m_23,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1638.301953251459,1781.7467333338525,154.29985892562917,230.95124760269442,0.6183797136733876,1,1792.6018121770883,2012.6979809365469,2305.123703258642,0,24,0 +m_23,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1802.943737311288,1717.2799964713888,158.8627269626688,129.40833433558274,0.6866430811393054,1,1961.8064642739569,1846.6883308069716,2323.3340028316775,0,24,0 +m_23,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1802.943737311288,1653.2961452668821,158.8627269626688,180.16392249288467,0.5508855141377484,1,1961.8064642739569,1833.4600677597668,2323.3340028316775,0,24,0 +m_23,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1802.943737311288,1856.917478888147,158.8627269626688,255.20434186792338,0.8619159632565498,1,1961.8064642739569,2112.12182075607,2323.3340028316775,0,24,0 +m_23,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1829.6496491832456,2082.0162315059556,383.2399950747661,246.01890021878773,0.5966721601492437,1,2212.8896442580117,2328.035131724743,2560.838644897218,0,24,0 +m_23,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1829.6496491832456,2060.7706951097252,383.2399950747661,254.00090465617035,0.630238036838463,1,2212.8896442580117,2314.7715997658956,2560.838644897218,0,24,0 +m_23,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1829.6496491832456,1931.242720294579,383.2399950747661,220.7170754473584,0.8253512479763664,1,2212.8896442580117,2151.9597957419373,2560.838644897218,0,24,0 +m_23,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,182892.4575613467,214302.03471981242,11238.670923466163,12826.850737361528,0.09583514880988692,1,194131.12848481286,227128.88545717395,297213.82411225967,0,24,0 +m_23,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,182892.4575613467,256280.750805725,11238.670923466163,13913.634750874646,0.0023366646639368196,0.056079951934483674,194131.12848481286,270194.38555659965,297213.82411225967,0,24,0 +m_23,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,182892.4575613467,187379.20120562424,11238.670923466163,20270.346411422433,0.85144352769794,1,194131.12848481286,207649.5476170467,297213.82411225967,0,24,0 +m_23,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,177379.52939365336,161756.97934144997,19620.53949782072,16896.71380444539,0.5600057683676591,1,197000.06889147407,178653.69314589538,253882.68134285384,0,24,0 +m_23,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,177379.52939365336,215534.97923578136,19620.53949782072,15267.458348631231,0.1576808464565223,1,197000.06889147407,230802.43758441258,253882.68134285384,0,24,0 +m_23,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,177379.52939365336,148782.5457775433,19620.53949782072,17632.570331178587,0.3040605462036061,1,197000.06889147407,166415.11610872188,253882.68134285384,0,24,0 +m_23,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,116150.89887372612,148496.7620948546,16824.732969924407,14284.217643194846,0.1742786964965653,1,132975.63184365054,162780.97973804944,179059.0777118544,0,24,0 +m_23,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,116150.89887372612,94480.64659794339,16824.732969924407,10081.714546928255,0.3006658870036329,1,132975.63184365054,104562.36114487164,179059.0777118544,0,24,0 +m_23,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,116150.89887372612,118083.23636422363,16824.732969924407,10397.495833031524,0.924479769296011,1,132975.63184365054,128480.73219725516,179059.0777118544,0,24,0 +m_23,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,96234.19538703516,89844.22007339937,11404.797842789905,14219.291354658151,0.7335277381520962,1,107638.99322982506,104063.51142805752,136044.5752333686,0,24,0 +m_23,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,96234.19538703516,109495.89703513795,11404.797842789905,14180.98954065169,0.4836283986240024,1,107638.99322982506,123676.88657578964,136044.5752333686,0,24,0 +m_23,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,96234.19538703516,82592.13544682456,11404.797842789905,10091.712276754291,0.3917094914561128,1,107638.99322982506,92683.84772357885,136044.5752333686,0,24,0 +m_24,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,126.85249659832706,312.45958857125123,35.66017122925648,37.929590487293524,0.006093656313115968,0.12187312626231936,162.51266782758353,350.38917905854476,385.4280969643993,0,24,0 +m_24,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,126.85249659832706,163.17868616674272,35.66017122925648,56.28341691720938,0.600174535575278,1,162.51266782758353,219.46210308395212,385.4280969643993,0,24,0 +m_24,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,126.85249659832706,203.77904045266,35.66017122925648,56.683121779538126,0.2832828190143607,1,162.51266782758353,260.4621622321981,385.4280969643993,0,24,0 +m_24,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,54.32395707904711,258.4159549533905,4.4543594173889485,24.750852364745075,3.412653715056791e-4,0.007849103544630618,58.77831649643606,283.16680731813557,311.48348804994913,0,24,0 +m_24,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,54.32395707904711,81.55974463954254,4.4543594173889485,9.335601257990138,0.03306987070601995,0.5291179312963192,58.77831649643606,90.89534589753268,311.48348804994913,0,24,0 +m_24,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,54.32395707904711,93.43681788439535,4.4543594173889485,9.543209993300268,0.00736500754704313,0.13993514339381946,58.77831649643606,102.98002787769562,311.48348804994913,0,24,0 +m_24,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,61.95997476126221,210.5093881364922,3.7998057780121006,23.506824957047897,0.0012878423216059233,0.028332531075330313,65.75978053927432,234.0162130935401,257.41783440289413,0,24,0 +m_24,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,61.95997476126221,109.41799002242371,3.7998057780121006,14.648085286921415,0.029442937876721646,0.500529943904268,65.75978053927432,124.06607530934512,257.41783440289413,0,24,0 +m_24,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,61.95997476126221,129.98011540245827,3.7998057780121006,12.939660417394125,0.0025333321373849573,0.0531999748850841,65.75978053927432,142.9197758198524,257.41783440289413,0,24,0 +m_24,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,77.99112650544876,260.00373439740116,8.811111109537146,11.743722170833612,7.559641213866526e-7,1.814313891327966e-5,86.80223761498591,271.7474565682348,298.9222022250583,0,24,0 +m_24,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,77.99112650544876,82.27788454983359,8.811111109537146,9.67440237767775,0.7507109465063565,1,86.80223761498591,91.95228692751134,298.9222022250583,0,24,0 +m_24,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,77.99112650544876,122.08981873659016,8.811111109537146,20.75596325942909,0.09329302330257214,1,86.80223761498591,142.84578199601924,298.9222022250583,0,24,0 +m_24,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,175.71017590561945,303.63385999220225,47.05090752422348,25.327642002854947,0.04485667706864734,0.6728501560297101,222.76108342984293,328.9615019950572,361.85765219456295,0,24,0 +m_24,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,175.71017590561945,179.7175092570932,47.05090752422348,74.81271410722904,0.9648909765249694,1,222.76108342984293,254.53022336432224,361.85765219456295,0,24,0 +m_24,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,175.71017590561945,206.3839077160251,47.05090752422348,36.067038954602666,0.6168712237229106,1,222.76108342984293,242.4509466706278,361.85765219456295,0,24,0 +m_24,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,124.48673168765345,251.95804422837,13.249514319334935,73.61046092492198,0.14547384190146787,1,137.73624600698838,325.568505153292,358.12535566862124,0,24,0 +m_24,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,124.48673168765345,105.3490086848621,13.249514319334935,17.25706877781615,0.4010494538219165,1,137.73624600698838,122.60607746267826,358.12535566862124,0,24,0 +m_24,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,124.48673168765345,159.07993666313308,13.249514319334935,31.80828172513296,0.35035691841805744,1,137.73624600698838,190.88821838826604,358.12535566862124,0,24,0 +m_24,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,164.1705511120883,158.58177480258354,23.914809484826364,42.14404290537986,0.9110503845565872,1,188.08536059691465,200.72581770796342,220.79839947875976,1,24,4.166666666666666 +m_24,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,164.1705511120883,108.88935652184401,23.914809484826364,29.74904939348016,0.17952780176865696,1,188.08536059691465,138.63840591532417,220.79839947875976,1,24,4.166666666666666 +m_24,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,164.1705511120883,79.81554212692664,23.914809484826364,16.023849780376473,0.01727922999707809,0.31102613994740563,188.08536059691465,95.83939190730311,220.79839947875976,1,24,4.166666666666666 +m_24,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,110.33780757772625,131.90355713625146,19.958833609030098,29.255639219058512,0.5579121157467934,1,130.29664118675635,161.15919635530997,177.275115990841,0,24,0 +m_24,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,110.33780757772625,95.40818403225126,19.958833609030098,9.259569989178633,0.5190457926955925,1,130.29664118675635,104.66775402142989,177.275115990841,0,24,0 +m_24,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,110.33780757772625,87.76592475347513,19.958833609030098,12.18525592566781,0.36178595717825907,1,130.29664118675635,99.95118067914294,177.275115990841,0,24,0 +m_25,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,70.75960095774181,61.74577798033598,11.937954620103934,2.121763433159153,0.496210233895256,1,82.69755557784575,63.86754141349513,90.96731113563033,0,24,0 +m_25,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,70.75960095774181,59.35322436742505,11.937954620103934,6.1484946223891255,0.42790658357940914,1,82.69755557784575,65.50171898981418,90.96731113563033,0,24,0 +m_25,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,70.75960095774181,60.18217123284992,11.937954620103934,4.631360726716661,0.44500805336514293,1,82.69755557784575,64.81353195956657,90.96731113563033,0,24,0 +m_25,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,65.60581592875346,65.78951296517464,3.0481698247678684,3.27951566331813,0.9680852754362901,1,68.65398575352133,69.06902862849277,75.97593149134205,0,24,0 +m_25,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,65.60581592875346,60.055784109381015,3.0481698247678684,4.699390510466948,0.348902756307935,1,68.65398575352133,64.75517461984796,75.97593149134205,0,24,0 +m_25,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,65.60581592875346,57.02418787087251,3.0481698247678684,2.4262534443979984,0.05350748424398818,1,68.65398575352133,59.45044131527051,75.97593149134205,0,24,0 +m_25,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,74.21279837099323,67.52218514991657,1.80267728392819,5.83617046873549,0.315832820615517,1,76.01547565492142,73.35835561865206,83.61702322041357,0,24,0 +m_25,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,74.21279837099323,58.010743899958335,1.80267728392819,5.381422121909557,0.03657325252134912,0.7680383029483314,76.01547565492142,63.392166021867894,83.61702322041357,0,24,0 +m_25,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,74.21279837099323,67.2086936995742,1.80267728392819,5.641985516079866,0.281763930373318,1,76.01547565492142,72.85067921565407,83.61702322041357,0,24,0 +m_25,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,67.31067174214355,79.53915682090833,4.89643447207069,4.831735474019423,0.10970439562308178,1,72.20710621421425,84.37089229492776,100.1685027669173,0,24,0 +m_25,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,67.31067174214355,77.04194323620895,4.89643447207069,14.020332006443125,0.5359122775914062,1,72.20710621421425,91.06227524265208,100.1685027669173,0,24,0 +m_25,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,67.31067174214355,73.64013524867829,4.89643447207069,5.175430399741986,0.3975213874760639,1,72.20710621421425,78.81556564842028,100.1685027669173,0,24,0 +m_25,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5006.190523434829,5402.361264141028,366.6790319821758,276.78939045273603,0.4101874353204924,1,5372.869555417004,5679.150654593765,6718.5851088998525,0,24,0 +m_25,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5006.190523434829,4828.568787923016,366.6790319821758,228.4968565771722,0.691306856813872,1,5372.869555417004,5057.065644500189,6718.5851088998525,0,24,0 +m_25,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5006.190523434829,5913.625243128536,366.6790319821758,194.17940132587475,0.061952274168037474,1,5372.869555417004,6107.804644454411,6718.5851088998525,0,24,0 +m_25,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3573.7784712771745,3781.600551693705,287.09548501558515,230.89607386773415,0.585686141147731,1,3860.8739562927594,4012.496625561439,4953.714929204907,0,24,0 +m_25,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3573.7784712771745,3486.962078482,287.09548501558515,182.22299547105595,0.8045771954709665,1,3860.8739562927594,3669.185073953056,4953.714929204907,0,24,0 +m_25,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3573.7784712771745,4235.909384513671,287.09548501558515,267.46782385442543,0.12255744160880963,1,3860.8739562927594,4503.377208368097,4953.714929204907,0,24,0 +m_25,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3012.0998337470505,3738.719441938012,255.28697140887937,215.47761430728616,0.05544364458835497,1,3267.38680515593,3954.1970562452984,4349.616761869828,0,24,0 +m_25,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3012.0998337470505,3010.1249041847714,255.28697140887937,335.3061562242433,0.9963594902462745,1,3267.38680515593,3345.4310604090147,4349.616761869828,0,24,0 +m_25,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3012.0998337470505,3412.8215599797177,255.28697140887937,167.42552448978677,0.22315471424815309,1,3267.38680515593,3580.2470844695044,4349.616761869828,0,24,0 +m_25,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,2375.529574917848,3241.899618864671,143.8133845440661,118.0604425769002,9.933917709656357e-4,0.023841402503175256,2519.3429594619142,3359.9600614415713,4299.295664462531,0,24,0 +m_25,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,2375.529574917848,3451.5846624989745,143.8133845440661,312.13314036372685,0.0164896876765713,0.3627731288845686,2519.3429594619142,3763.7178028627013,4299.295664462531,0,24,0 +m_25,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,2375.529574917848,3605.806180261158,143.8133845440661,302.64442379568834,0.007659479655702964,0.17616803208116816,2519.3429594619142,3908.4506040568463,4299.295664462531,0,24,0 +m_26,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,342.1843940518575,245.06515992850214,90.82676453449538,15.413245726401781,0.34822843829589156,1,433.0111585863529,260.4784056549039,543.6335487077008,0,24,0 +m_26,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,342.1843940518575,378.5357426759977,90.82676453449538,68.82471539121961,0.7580631558544737,1,433.0111585863529,447.36045806721734,543.6335487077008,0,24,0 +m_26,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,342.1843940518575,363.94252695323166,90.82676453449538,130.26979005376904,0.8942040942713052,1,433.0111585863529,494.2123170070007,543.6335487077008,0,24,0 +m_26,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,169.54097585575812,231.16889105526383,18.306753485230818,9.849811376222245,0.018889086594477574,0.43444899167298423,187.84772934098893,241.01870243148608,348.2509266186245,0,24,0 +m_26,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,169.54097585575812,286.4126986715356,18.306753485230818,30.17905279994116,0.010245851707539472,0.24590044098094732,187.84772934098893,316.59175147147675,348.2509266186245,0,24,0 +m_26,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,169.54097585575812,230.86992498027047,18.306753485230818,20.10771658334779,0.04796695543671756,1,187.84772934098893,250.97764156361825,348.2509266186245,0,24,0 +m_26,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,184.64393780493563,234.19902348297876,19.754059372029673,16.222520144293753,0.08754542364418684,1,204.3979971769653,250.4215436272725,277.48731155385997,0,24,0 +m_26,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,184.64393780493563,239.70711024284023,19.754059372029673,12.55408207885064,0.05206028678051175,1,204.3979971769653,252.26119232169088,277.48731155385997,0,24,0 +m_26,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,184.64393780493563,204.8085196385753,19.754059372029673,26.89929378098083,0.5611481260608107,1,204.3979971769653,231.70781341955612,277.48731155385997,0,24,0 +m_26,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,194.62377093849457,176.03784377728292,28.013901164407145,20.79942544645356,0.6091951292463667,1,222.63767210290172,196.83726922373648,293.0261820963826,0,24,0 +m_26,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,194.62377093849457,204.36909914311198,28.013901164407145,11.865321473774161,0.7606965412466706,1,222.63767210290172,216.23442061688615,293.0261820963826,0,24,0 +m_26,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,194.62377093849457,238.05253640232607,28.013901164407145,28.334901867112663,0.30433864511647485,1,222.63767210290172,266.38743826943875,293.0261820963826,0,24,0 +m_26,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,4609.031241393571,3794.0636374960454,333.99771206969797,180.48180659463995,0.06546794746514442,1,4943.028953463268,3974.5454440906856,6056.558281792772,0,24,0 +m_26,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,4609.031241393571,3970.0557226691517,333.99771206969797,211.08903904767416,0.14250522105258465,1,4943.028953463268,4181.144761716826,6056.558281792772,0,24,0 +m_26,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,4609.031241393571,4921.4731704973265,333.99771206969797,584.4889038597382,0.6550025707120857,1,4943.028953463268,5505.962074357065,6056.558281792772,0,24,0 +m_26,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,4005.4248717955033,4734.957315978656,204.09018209241341,223.87516803546922,0.03699359480206298,0.8138590856453857,4209.515053887917,4958.832484014125,6160.74711308914,0,24,0 +m_26,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,4005.4248717955033,4800.007319588903,204.09018209241341,586.3708277866972,0.24646536190561893,1,4209.515053887917,5386.3781473756,6160.74711308914,0,24,0 +m_26,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,4005.4248717955033,4757.651183977379,204.09018209241341,843.0280097400203,0.4215081218974326,1,4209.515053887917,5600.679193717399,6160.74711308914,0,24,0 +m_26,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3667.535086571359,3840.5080581752836,252.42850722598908,116.59511280022028,0.5534917346808254,1,3919.963593797348,3957.103170975504,5396.759024345265,0,24,0 +m_26,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3667.535086571359,4530.246773463926,252.42850722598908,375.8977941226782,0.09006745982475012,1,3919.963593797348,4906.144567586604,5396.759024345265,0,24,0 +m_26,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3667.535086571359,4209.748231906278,252.42850722598908,160.60574739361667,0.10540910263022941,1,3919.963593797348,4370.353979299895,5396.759024345265,0,24,0 +m_26,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3728.1507253933823,3917.2486346125374,174.35338699194574,164.7702473121119,0.44888319085055495,1,3902.504112385328,4082.0188819246496,5327.059858071127,0,24,0 +m_26,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3728.1507253933823,4248.390540948416,174.35338699194574,260.55277850177606,0.1324480554245229,1,3902.504112385328,4508.943319450192,5327.059858071127,0,24,0 +m_26,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3728.1507253933823,4141.926255645261,174.35338699194574,700.8554335103082,0.5888769910702553,1,3902.504112385328,4842.781689155569,5327.059858071127,0,24,0 +m_27,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,134.14587241019797,101.829883811238,28.819243023496103,14.858300916328545,0.35700603280978077,1,162.96511543369408,116.68818472756655,207.01150916537514,0,24,0 +m_27,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,134.14587241019797,85.04783223492215,28.819243023496103,13.34827074635158,0.17574380378774201,1,162.96511543369408,98.39610298127374,207.01150916537514,0,24,0 +m_27,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,134.14587241019797,151.99729281683915,28.819243023496103,36.1949882425928,0.7086937622221309,1,162.96511543369408,188.19228105943193,207.01150916537514,0,24,0 +m_27,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,75.94941968237427,103.19533277957504,11.724021301673599,6.878906375667401,0.07962642170463612,1,87.67344098404787,110.07423915524244,136.0536743201039,0,24,0 +m_27,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,75.94941968237427,101.69759388950116,11.724021301673599,21.98756458332056,0.33309037734987434,1,87.67344098404787,123.68515847282173,136.0536743201039,0,24,0 +m_27,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,75.94941968237427,96.31721238449799,11.724021301673599,22.137501252383803,0.44090003994629956,1,87.67344098404787,118.45471363688179,136.0536743201039,0,24,0 +m_27,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,92.04846594796135,133.24920369655445,25.29039818716798,15.281697233029625,0.20748002206575292,1,117.33886413512933,148.53090092958408,181.26407152644728,0,24,0 +m_27,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,92.04846594796135,106.45238619680421,25.29039818716798,18.01527740468429,0.6563793609523227,1,117.33886413512933,124.46766360148851,181.26407152644728,0,24,0 +m_27,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,92.04846594796135,132.82011764507385,25.29039818716798,31.965401924423666,0.3436703113843075,1,117.33886413512933,164.78551956949752,181.26407152644728,0,24,0 +m_27,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,68.78582331086372,92.89069820082709,11.748116444696352,17.981155999956332,0.29319696981541327,1,80.53393975556007,110.87185420078342,121.95903962086177,0,24,0 +m_27,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,68.78582331086372,84.32720503684375,11.748116444696352,12.774808631587119,0.3938712795565861,1,80.53393975556007,97.10201366843087,121.95903962086177,0,24,0 +m_27,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,68.78582331086372,80.4502951351552,11.748116444696352,15.521568787845448,0.5641845255080529,1,80.53393975556007,95.97186392300065,121.95903962086177,0,24,0 +m_27,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,448.31159247106757,653.3536313137067,75.01378210844575,95.76650626821116,0.12453257264300205,1,523.3253745795133,749.1201375819179,824.0321513401097,0,24,0 +m_27,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,448.31159247106757,576.4106361436051,75.01378210844575,49.05839198893977,0.18819236770182296,1,523.3253745795133,625.4690281325448,824.0321513401097,0,24,0 +m_27,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,448.31159247106757,536.8919681355684,75.01378210844575,149.63649883468915,0.6122421081208791,1,523.3253745795133,686.5284669702576,824.0321513401097,0,24,0 +m_27,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,763.5316695393151,820.9785521177942,96.86111768361263,37.269257821546894,0.5985593009417549,1,860.3927872229277,858.2478099393411,1015.1916895246566,0,24,0 +m_27,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,763.5316695393151,857.2600620145377,96.86111768361263,65.64147391696825,0.4442131530167154,1,860.3927872229277,922.9015359315059,1015.1916895246566,0,24,0 +m_27,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,763.5316695393151,644.2260590556,96.86111768361263,105.6618972033045,0.4248002259917515,1,860.3927872229277,749.8879562589045,1015.1916895246566,0,24,0 +m_27,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,758.070539804449,731.1298029385192,49.62257864254461,70.303433258732,0.7613642569219359,1,807.6931184469936,801.4332361972512,1118.6017623492173,0,24,0 +m_27,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,758.070539804449,889.0926393584326,49.62257864254461,127.8180536863103,0.37359415482276814,1,807.6931184469936,1016.9106930447429,1118.6017623492173,0,24,0 +m_27,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,758.070539804449,568.3430068011716,49.62257864254461,58.42733842226051,0.03339551993019185,0.8014924783246045,807.6931184469936,626.7703452234321,1118.6017623492173,0,24,0 +m_27,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,696.3940975413478,744.7754933275622,118.594171635506,53.78129502069782,0.7212686432978055,1,814.9882691768538,798.55678834826,1339.6449679715756,0,24,0 +m_27,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,696.3940975413478,1092.2818917480008,118.594171635506,125.57717004434062,0.04494133288546302,1,814.9882691768538,1217.8590617923414,1339.6449679715756,0,24,0 +m_27,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,696.3940975413478,724.7422276537833,118.594171635506,60.18396242765049,0.8369466001921924,1,814.9882691768538,784.9261900814338,1339.6449679715756,0,24,0 +m_28,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,80.58597426466274,112.56122585886142,37.58414414069468,46.830221290436874,0.6074132139679391,1,118.17011840535741,159.3914471492983,175.33059186422815,0,24,0 +m_28,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,80.58597426466274,55.17398025664881,37.58414414069468,10.119938244334016,0.5451581462180481,1,118.17011840535741,65.29391850098283,175.33059186422815,0,24,0 +m_28,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,80.58597426466274,93.76393349635067,37.58414414069468,21.519503803747973,0.7704322437089403,1,118.17011840535741,115.28343730009865,175.33059186422815,0,24,0 +m_28,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,86.85286698928837,82.38678716101917,29.681113735474565,15.845170813541776,0.8978313863098676,1,116.53398072476294,98.23195797456094,128.18737879723923,0,24,0 +m_28,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,86.85286698928837,82.99122031227283,29.681113735474565,22.960330657322796,0.9201967622207808,1,116.53398072476294,105.95155096959563,128.18737879723923,0,24,0 +m_28,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,86.85286698928837,90.27972802673972,29.681113735474565,25.952682070156786,0.9324841172885745,1,116.53398072476294,116.2324100968965,128.18737879723923,0,24,0 +m_28,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,127.56726455889998,72.88867280025754,71.7794899564418,8.678107440647116,0.49046840626450355,1,199.3467545153418,81.56678024090465,219.28142996687598,0,24,0 +m_28,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,127.56726455889998,89.43503805998326,71.7794899564418,35.26011863509108,0.6508535292923301,1,199.3467545153418,124.69515669507433,219.28142996687598,0,24,0 +m_28,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,127.56726455889998,109.35687067950656,71.7794899564418,24.742739022299247,0.820060202268974,1,199.3467545153418,134.0996097018058,219.28142996687598,0,24,0 +m_28,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,81.2393188807366,71.89705618768888,23.571389191032086,12.708185476689918,0.7386581961048688,1,104.81070807176869,84.6052416643788,162.17316814422705,0,24,0 +m_28,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,81.2393188807366,109.76011350396264,23.571389191032086,37.67003935442559,0.5386681758481013,1,104.81070807176869,147.43015285838823,162.17316814422705,0,24,0 +m_28,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,81.2393188807366,94.07403888239776,23.571389191032086,41.00291718793506,0.7931579178460858,1,104.81070807176869,135.0769560703328,162.17316814422705,0,24,0 +m_28,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,221.26482630199942,295.65621495248496,33.26408051355073,61.1802084533174,0.31767444852324084,1,254.52890681555016,356.83642340580235,530.6654122829154,0,24,0 +m_28,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,221.26482630199942,288.9412467025692,33.26408051355073,69.92178744382649,0.41048831101137306,1,254.52890681555016,358.86303414639565,530.6654122829154,0,24,0 +m_28,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,221.26482630199942,341.79196403704555,33.26408051355073,140.63113803833204,0.43863143645337443,1,254.52890681555016,482.4231020753776,530.6654122829154,0,24,0 +m_28,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,358.9988639482563,458.49424774446004,70.16671337524036,109.68466306484224,0.46546016681499836,1,429.1655773234967,568.1789108093022,624.9968018902325,0,24,0 +m_28,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,358.9988639482563,365.2357733440356,70.16671337524036,63.350104771374276,0.9487109116438501,1,429.1655773234967,428.58587811540986,624.9968018902325,0,24,0 +m_28,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,358.9988639482563,378.0597771722677,70.16671337524036,120.24849855072016,0.8944643883133836,1,429.1655773234967,498.30827572298784,624.9968018902325,0,24,0 +m_28,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,524.2097360890472,440.8945416782723,118.3031619291325,132.0911256808989,0.6486613040443207,1,642.5128980181796,572.9856673591712,706.7641878199977,0,24,0 +m_28,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,524.2097360890472,350.3590033511612,118.3031619291325,60.5883421011511,0.22977249364323885,1,642.5128980181796,410.94734545231233,706.7641878199977,0,24,0 +m_28,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,524.2097360890472,198.10258976498505,118.3031619291325,40.69952203827876,0.039300761582636276,0.9432182779832706,642.5128980181796,238.8021118032638,706.7641878199977,0,24,0 +m_28,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,543.8205698619286,303.7003205639448,148.85262032021146,41.0886850260552,0.17300858249249582,1,692.67319018214,344.78900559,959.0357026108062,0,24,0 +m_28,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,543.8205698619286,728.3979603919477,148.85262032021146,143.45267834514877,0.39294009921713147,1,692.67319018214,871.8506387370965,959.0357026108062,0,24,0 +m_28,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,543.8205698619286,298.20344867193137,148.85262032021146,38.23798476591633,0.16409937939136046,1,692.67319018214,336.4414334378477,959.0357026108062,0,24,0 +m_29,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,840829.3783393475,1042678.686658541,189171.55722401093,195220.59523633003,0.47681688608954576,1,1030000.9355633585,1237899.281894871,2080193.4041571342,0,24,0 +m_29,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,840829.3783393475,788478.5110398139,189171.55722401093,162667.75156434355,0.8387899037222069,1,1030000.9355633585,951146.2626041574,2080193.4041571342,0,24,0 +m_29,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,840829.3783393475,1713754.0602328912,189171.55722401093,177330.85263723062,0.008674062803376405,0.1908293816742809,1030000.9355633585,1891084.912870122,2080193.4041571342,0,24,0 +m_29,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,284061.4228530423,385658.89091896324,47909.709438701844,98259.52358171676,0.3825923252248249,1,331971.1322917442,483918.41450068,532310.255950748,0,23,0 +m_29,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,284061.4228530423,319317.13249394385,47909.709438701844,80892.3359107853,0.7193429603426497,1,331971.1322917442,400209.46840472915,532310.255950748,0,23,0 +m_29,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,284061.4228530423,270195.35353523743,47909.709438701844,62266.7333526068,0.8636585711922045,1,331971.1322917442,332462.08688784426,532310.255950748,0,23,0 +m_29,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,392563.02776640607,278422.7559598261,84103.81699862266,64493.53592229063,0.31328292455998363,1,476666.84476502874,342916.29188211676,524333.5292415316,0,24,0 +m_29,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,392563.02776640607,269909.05460300465,84103.81699862266,109798.93603375668,0.4027481855789634,1,476666.84476502874,379707.9906367613,524333.5292415316,0,24,0 +m_29,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,392563.02776640607,231714.36002965842,84103.81699862266,53159.08419025767,0.15031269868654779,1,476666.84476502874,284873.44421991607,524333.5292415316,0,24,0 +m_29,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,306516.0644612488,202476.4761782058,64129.353892514686,15769.720654429675,0.18259643566334055,1,370645.4183537635,218246.19683263547,453018.72679800243,0,24,0 +m_29,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,306516.0644612488,302362.43492744764,64129.353892514686,35918.42978248192,0.9566592892320662,1,370645.4183537635,338280.86470992956,453018.72679800243,0,24,0 +m_29,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,306516.0644612488,335842.41414845124,64129.353892514686,75992.79203155094,0.7747610048536641,1,370645.4183537635,411835.2061800022,453018.72679800243,0,24,0 +m_29,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,1584621.3921934753,1107171.9494474228,160222.73761358723,124782.68749140885,0.042002810773118154,0.8820590262354813,1744844.1298070624,1231954.6369388315,1919328.5427877689,0,24,0 +m_29,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1584621.3921934753,1249085.6472476665,160222.73761358723,75100.57975294787,0.09919371251877128,1,1744844.1298070624,1324186.2270006144,1919328.5427877689,0,24,0 +m_29,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1584621.3921934753,1363012.5417039413,160222.73761358723,113232.81925160757,0.28788899495477843,1,1744844.1298070624,1476245.360955549,1919328.5427877689,0,24,0 +m_29,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,1207671.3606646094,731779.5322848298,86178.87694177101,61688.14581642734,0.00148561856477249,0.03427840653476772,1293850.2376063804,793467.6781012571,1441434.145241814,0,24,0 +m_29,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1207671.3606646094,733693.6531744967,86178.87694177101,48361.397027042905,0.001428266938948655,0.03427840653476772,1293850.2376063804,782055.0502015396,1441434.145241814,0,24,0 +m_29,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1207671.3606646094,1189544.0972735405,86178.87694177101,120850.58021901759,0.9054708216598129,1,1293850.2376063804,1310394.677492558,1441434.145241814,0,24,0 +m_29,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,441052.22347842244,466374.93039054686,84998.98503846534,49664.94311912944,0.8034506360229701,1,526051.2085168877,516039.8735096763,771159.6464264466,0,24,0 +m_29,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,441052.22347842244,587237.7952661085,84998.98503846534,113816.42875793386,0.32958193178008344,1,526051.2085168877,701054.2240240424,771159.6464264466,0,24,0 +m_29,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,441052.22347842244,472286.29564227944,84998.98503846534,64807.13507511828,0.7765053641804865,1,526051.2085168877,537093.4307173977,771159.6464264466,0,24,0 +m_29,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,335923.8645439917,438709.7268368219,77249.95941119082,52282.42024503621,0.2997660809989719,1,413173.8239551825,490992.1470818581,599904.8681170195,0,24,0 +m_29,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,335923.8645439917,499284.73881822557,77249.95941119082,46083.32310633757,0.10616174087155725,1,413173.8239551825,545368.0619245631,599904.8681170195,0,24,0 +m_29,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,335923.8645439917,477792.02316800726,77249.95941119082,47734.370744226304,0.1553453891977722,1,413173.8239551825,525526.3939122335,599904.8681170195,0,24,0 +m_30,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,337.38926398860315,204.157339606467,92.57929012915056,10.8239499689617,0.22429156291195873,1,429.9685541177537,214.9812895754287,472.9654095295291,0,24,0 +m_30,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,337.38926398860315,185.23758839571738,92.57929012915056,48.76890385043247,0.19499172979990256,1,429.9685541177537,234.00649224614986,472.9654095295291,0,24,0 +m_30,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,337.38926398860315,352.55021732837054,92.57929012915056,25.257048812130733,0.8811683923118037,1,429.9685541177537,377.80726614050127,472.9654095295291,0,24,0 +m_30,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,133.76145724135475,204.18878403243974,11.812719700129358,23.266918147547496,0.029063055284656348,0.6393872162624397,145.5741769414841,227.45570217998724,250.20127239798597,0,24,0 +m_30,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,133.76145724135475,144.59785192688923,11.812719700129358,19.255289585318007,0.6438323374965509,1,145.5741769414841,163.85314151220723,250.20127239798597,0,24,0 +m_30,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,133.76145724135475,145.66530228109863,11.812719700129358,12.899236682081774,0.511706558587657,1,145.5741769414841,158.5645389631804,250.20127239798597,0,24,0 +m_30,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,153.5003270717614,162.44174875762465,13.303852083333304,31.206047166151485,0.8000220254145649,1,166.80417915509472,193.64779592377613,221.4447147434222,0,24,0 +m_30,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,153.5003270717614,152.08733354585544,13.303852083333304,49.22604349361928,0.9790594297395284,1,166.80417915509472,201.31337703947472,221.4447147434222,0,24,0 +m_30,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,153.5003270717614,160.9300493742433,13.303852083333304,35.03957436569228,0.8490315943514819,1,166.80417915509472,195.9696237399356,221.4447147434222,0,24,0 +m_30,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,130.67426801703346,138.27070520281973,18.878124563815085,27.4018455123896,0.8248272561961096,1,149.55239258084853,165.67255071520933,246.01794037479783,2,24,8.333333333333332 +m_30,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,130.67426801703346,124.86740077508352,18.878124563815085,34.39664313404354,0.8861948572780766,1,149.55239258084853,159.26404390912705,246.01794037479783,2,24,8.333333333333332 +m_30,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,130.67426801703346,196.30108841564405,18.878124563815085,27.351584652353974,0.08165696362815851,1,149.55239258084853,223.65267306799802,246.01794037479783,2,24,8.333333333333332 +m_30,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,8037.742033674774,7710.897239548695,317.6192843395805,449.9912421225142,0.5675345079333141,1,8355.361318014355,8160.88848167121,9752.442297746395,0,24,0 +m_30,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,8037.742033674774,8607.081810809594,317.6192843395805,258.77482350530977,0.19598333820102254,1,8355.361318014355,8865.856634314903,9752.442297746395,0,24,0 +m_30,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,8037.742033674774,7674.44344398781,317.6192843395805,506.09799358325296,0.5592323147798541,1,8355.361318014355,8180.5414375710625,9752.442297746395,0,24,0 +m_30,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,7907.402766392693,7923.588997955006,656.4670665296335,426.1450893399463,0.983972983403064,1,8563.869832922326,8349.734087294952,9420.25681621456,0,24,0 +m_30,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,7907.402766392693,7867.069164838068,656.4670665296335,149.15608147479247,0.9543360421638298,1,8563.869832922326,8016.225246312861,9420.25681621456,0,24,0 +m_30,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,7907.402766392693,8001.553322307964,656.4670665296335,465.7184366130941,0.909445258827059,1,8563.869832922326,8467.271758921059,9420.25681621456,0,24,0 +m_30,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5768.45735214601,7080.76884014429,483.74560906534924,399.274232098086,0.06388175395563662,1,6252.202961211359,7480.043072242376,8228.047379466614,0,24,0 +m_30,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5768.45735214601,6850.310402697784,483.74560906534924,282.22545950697577,0.08925885255503575,1,6252.202961211359,7132.535862204761,8228.047379466614,0,24,0 +m_30,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5768.45735214601,7024.772418449541,483.74560906534924,236.38508527546776,0.05107805615653192,1,6252.202961211359,7261.157503725009,8228.047379466614,0,24,0 +m_30,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,5444.214081294075,6736.800295609484,388.99489029479935,364.22237511424834,0.03581576582154454,0.7521310822524353,5833.208971588874,7101.0226707237325,9625.04833521744,0,24,0 +m_30,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,5444.214081294075,8360.448967461902,388.99489029479935,389.59497364485946,3.490498276920573e-4,0.008377195864609374,5833.208971588874,8750.043941106762,9625.04833521744,0,24,0 +m_30,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,5444.214081294075,7131.292696931583,388.99489029479935,242.72444657837852,0.005741514745226896,0.13205483914021862,5833.208971588874,7374.017143509962,9625.04833521744,0,24,0 +m_31,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,163.61302797402348,136.9699700415583,37.71100429068172,15.083087844853198,0.5393738760808966,1,201.3240322647052,152.0530578864115,281.96341907651004,1,24,4.166666666666666 +m_31,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,163.61302797402348,220.30128556805704,37.71100429068172,36.029095410588404,0.3060101058062042,1,201.3240322647052,256.33038097864545,281.96341907651004,1,24,4.166666666666666 +m_31,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,163.61302797402348,150.81495408648468,37.71100429068172,14.583330979009297,0.7639316160438525,1,201.3240322647052,165.39828506549398,281.96341907651004,1,24,4.166666666666666 +m_31,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,90.63433132622828,85.14389988921029,7.123078756795345,12.035167015165644,0.7047262583835722,1,97.75741008302363,97.17906690437593,115.32090106182154,1,24,4.166666666666666 +m_31,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,90.63433132622828,89.36608612495377,7.123078756795345,15.471096658520349,0.9427177501556809,1,97.75741008302363,104.83718278347412,115.32090106182154,1,24,4.166666666666666 +m_31,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,90.63433132622828,83.97118285961452,7.123078756795345,10.445632662511368,0.6111738879285882,1,97.75741008302363,94.41681552212589,115.32090106182154,1,24,4.166666666666666 +m_31,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,102.77547900711112,92.06813933258167,40.467836009155384,17.669680724011773,0.817176910407412,1,143.2433150162665,109.73782005659343,157.56764651789317,2,24,8.333333333333332 +m_31,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,102.77547900711112,66.19390378919238,40.467836009155384,15.118129753073019,0.43506358121661354,1,143.2433150162665,81.3120335422654,157.56764651789317,2,24,8.333333333333332 +m_31,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,102.77547900711112,107.9924285545599,40.467836009155384,18.27366613734779,0.9105616759676973,1,143.2433150162665,126.26609469190768,157.56764651789317,2,24,8.333333333333332 +m_31,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,100.67607722942154,66.18046118028086,15.809230476584567,22.508559918275047,0.24300131546054515,1,116.4853077060061,88.68902109855591,128.32282020074547,2,24,8.333333333333332 +m_31,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,100.67607722942154,64.58360862839353,15.809230476584567,17.70667584670101,0.1627089260041724,1,116.4853077060061,82.29028447509455,128.32282020074547,2,24,8.333333333333332 +m_31,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,100.67607722942154,96.08125528542602,15.809230476584567,20.575853987978924,0.8634515658976629,1,116.4853077060061,116.65710927340496,128.32282020074547,2,24,8.333333333333332 +m_31,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,861.904905932057,716.0551152337496,128.31767896240558,62.44340596503441,0.33968294524926734,1,990.2225848944626,778.498521198784,1089.2448433839088,0,24,0 +m_31,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,861.904905932057,662.6158908181567,128.31767896240558,57.38733190929417,0.19966008737229263,1,990.2225848944626,720.0032227274509,1089.2448433839088,0,24,0 +m_31,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,861.904905932057,792.1459333818466,128.31767896240558,182.25733926672612,0.761454465380579,1,990.2225848944626,974.4032726485727,1089.2448433839088,0,24,0 +m_31,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,615.1727567931816,566.6490299435309,29.32300588658978,14.367321190619148,0.17929968328333268,1,644.4957626797714,581.01635113415,859.6799708493384,0,24,0 +m_31,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,615.1727567931816,686.1525546388515,29.32300588658978,95.3746915878197,0.5038390207620134,1,644.4957626797714,781.5272462266712,859.6799708493384,0,24,0 +m_31,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,615.1727567931816,655.9802530091821,29.32300588658978,90.87384715160105,0.6839576705378994,1,644.4957626797714,746.8541001607831,859.6799708493384,0,24,0 +m_31,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,622.6376018892105,567.3445396883089,5.814990720050899,21.57832230072416,0.05011937363603629,1,628.4525926092614,588.9228619890331,835.7807842435226,0,24,0 +m_31,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,622.6376018892105,588.8151486186631,5.814990720050899,17.9362848706498,0.12268315415620552,1,628.4525926092614,606.751433489313,835.7807842435226,0,24,0 +m_31,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,622.6376018892105,647.8710249395838,5.814990720050899,111.92968800907308,0.8307393079511264,1,628.4525926092614,759.8007129486568,835.7807842435226,0,24,0 +m_31,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,599.1099853739104,555.2843300746506,22.522604997628076,18.587837978225735,0.16539872063872618,1,621.6325903715384,573.8721680528763,683.7958494086923,0,24,0 +m_31,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,599.1099853739104,542.4725596501721,22.522604997628076,14.220517316069923,0.0643958526405248,1,621.6325903715384,556.6930769662421,683.7958494086923,0,24,0 +m_31,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,599.1099853739104,580.9967597664966,22.522604997628076,36.49000064467557,0.6834254253498748,1,621.6325903715384,617.4867604111721,683.7958494086923,0,24,0 +m_32,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,65.4469105341879,112.03926164700127,10.875225680544693,5.017010358639979,0.0089937258617252,0.21584942068140478,76.32213621473258,117.05627200564125,144.77151601186662,0,24,0 +m_32,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,65.4469105341879,92.46931987656569,10.875225680544693,18.547580887122724,0.24485430671752856,1,76.32213621473258,111.01690076368841,144.77151601186662,0,24,0 +m_32,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,65.4469105341879,116.67969401791835,10.875225680544693,14.93077508377856,0.022402024486847485,0.45894767974096734,76.32213621473258,131.6104691016969,144.77151601186662,0,24,0 +m_32,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,76.092625486902,103.30768849341624,12.775870950753085,28.9120770647818,0.4182318559147038,1,88.86849643765508,132.21976555819805,145.6433740012988,0,24,0 +m_32,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,76.092625486902,120.70350391774974,12.775870950753085,11.699563356158238,0.027801455061443887,0.5282276461674339,88.86849643765508,132.403067273908,145.6433740012988,0,24,0 +m_32,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,76.092625486902,113.9523815236551,12.775870950753085,12.92373355819998,0.06384307743382718,1,88.86849643765508,126.87611508185509,145.6433740012988,0,24,0 +m_32,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,70.085128352437,164.90356816640565,8.93392359648465,54.74461785019612,0.14511304991171886,1,79.01905194892164,219.64818601660176,241.61300461826195,0,24,0 +m_32,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,70.085128352437,119.49035092677076,8.93392359648465,33.9587284365488,0.22391310568612147,1,79.01905194892164,153.44907936331956,241.61300461826195,0,24,0 +m_32,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,70.085128352437,170.98462686500002,8.93392359648465,29.44068561280906,0.01724428918230081,0.3966186511929186,79.01905194892164,200.4253124778091,241.61300461826195,0,24,0 +m_32,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,114.30018844822946,161.64597733886646,27.698908247806788,21.308850875418663,0.21287481122281532,1,141.99909669603625,182.95482821428513,201.6111134410231,0,24,0 +m_32,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,114.30018844822946,164.24638618104058,27.698908247806788,19.03644421988949,0.17880162312172854,1,141.99909669603625,183.28283040093007,201.6111134410231,0,24,0 +m_32,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,114.30018844822946,162.6176313472703,27.698908247806788,18.363125242386154,0.18825044054627801,1,141.99909669603625,180.98075658965647,201.6111134410231,0,24,0 +m_32,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3828.061910443504,4161.470620662274,371.8909367588645,194.8317835076691,0.45134243673783225,1,4199.9528472023685,4356.302404169943,6394.677583736838,0,24,0 +m_32,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3828.061910443504,4028.762541214621,371.8909367588645,233.55410899966762,0.6592245698717305,1,4199.9528472023685,4262.3166502142885,6394.677583736838,0,24,0 +m_32,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,3828.061910443504,5380.9869871689525,371.8909367588645,432.35627077362665,0.02185465141623654,0.45894767974096734,4199.9528472023685,5813.343257942579,6394.677583736838,0,24,0 +m_32,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2752.0651526476513,2701.8360291869076,310.1903504456946,118.09774148614895,0.8843576082822007,1,3062.255503093346,2819.9337706730566,3922.935750282335,0,24,0 +m_32,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2752.0651526476513,2596.744550816971,310.1903504456946,141.3512618711075,0.6624589501160987,1,3062.255503093346,2738.0958126880782,3922.935750282335,0,24,0 +m_32,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2752.0651526476513,3204.152173469819,310.1903504456946,362.1530540595763,0.3659422091540059,1,3062.255503093346,3566.3052275293953,3922.935750282335,0,24,0 +m_32,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2195.671783895496,2203.0461942501383,174.66191372994447,78.42384739245763,0.9703607100166345,1,2370.3336976254404,2281.470041642596,3321.824906787861,0,24,0 +m_32,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2195.671783895496,2585.8809004503155,174.66191372994447,433.959923902285,0.43343501340589596,1,2370.3336976254404,3019.8408243526005,3321.824906787861,0,24,0 +m_32,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2195.671783895496,2340.3979063966676,174.66191372994447,131.5379873669772,0.5241109715783189,1,2370.3336976254404,2471.935893763645,3321.824906787861,0,24,0 +m_32,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,1759.6959467320276,2196.715241943205,126.98143992021245,126.00907335733763,0.03467699886546161,0.624185979578309,1886.67738665224,2322.7243153005425,3357.8906915021576,0,24,0 +m_32,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1759.6959467320276,2220.7695777818954,126.98143992021245,96.99629671369851,0.017334303923849933,0.3966186511929186,1886.67738665224,2317.765874495594,3357.8906915021576,0,24,0 +m_32,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1759.6959467320276,2672.643720705732,126.98143992021245,379.9841806598658,0.06217745418923031,1,1886.67738665224,3052.6279013655976,3357.8906915021576,0,24,0 +m_33,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,137.6213551512786,63.652475610067384,86.91100474433712,10.955861426630019,0.44461285415048857,1,224.53235989561574,74.6083370366974,454.9295284803637,0,24,0 +m_33,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,137.6213551512786,93.01521408110612,86.91100474433712,26.399203455300185,0.6452530871160009,1,224.53235989561574,119.4144175364063,454.9295284803637,0,24,0 +m_33,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,137.6213551512786,241.10879418838323,86.91100474433712,172.46350443012918,0.6080423525652483,1,224.53235989561574,413.5722986185124,454.9295284803637,0,24,0 +m_33,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,34.143275362773906,130.1601226834029,5.639550248801515,18.104547671484465,0.0023467706941213595,0.05632249665891263,39.78282561157542,148.26467035488736,163.0911373903761,0,24,0 +m_33,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,34.143275362773906,67.27203193044073,5.639550248801515,14.595463540994334,0.07530160975452833,1,39.78282561157542,81.86749547143506,163.0911373903761,0,24,0 +m_33,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,34.143275362773906,75.34843313638099,5.639550248801515,11.929914235374113,0.01639568605805647,0.3607050932772423,39.78282561157542,87.2783473717551,163.0911373903761,0,24,0 +m_33,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,33.4859581094603,467.2215633106875,3.967021586476678,379.7088049757272,0.305081030755699,1,37.452979695936975,846.9303682864147,931.6234051150562,0,24,0 +m_33,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,33.4859581094603,119.35151446712823,3.967021586476678,24.910301208089212,0.02515531713651318,0.5282616598667768,37.452979695936975,144.26181567521743,931.6234051150562,0,24,0 +m_33,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,33.4859581094603,115.44022426583055,3.967021586476678,29.303476959646524,0.03780133561136144,0.7560267122272288,37.452979695936975,144.74370122547708,931.6234051150562,0,24,0 +m_33,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,38.77498679262034,301.88591931530686,14.563323814417851,132.01090116100104,0.10307671088364931,1,53.33831060703819,433.8968204763079,563.044381190393,0,24,0 +m_33,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,38.77498679262034,237.5138024259211,14.563323814417851,54.25427267282305,0.013304927908423162,0.30601334189373275,53.33831060703819,291.76807509874413,563.044381190393,0,24,0 +m_33,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,38.77498679262034,316.0487599985725,14.563323814417851,195.80976835633018,0.21640171454938642,1,53.33831060703819,511.85852835490266,563.044381190393,0,24,0 +m_33,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1220.855697218344,1277.17010407264,190.90647605163105,195.80618491607024,0.8409831681129447,1,1411.762173269975,1472.9762889887102,1620.2739178875813,0,24,0 +m_33,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1220.855697218344,935.336648892066,190.90647605163105,44.502272524353074,0.19945751557649477,1,1411.762173269975,979.8389214164191,1620.2739178875813,0,24,0 +m_33,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1220.855697218344,1159.2915647213185,190.90647605163105,250.004195218059,0.8490196105158321,1,1411.762173269975,1409.2957599393776,1620.2739178875813,0,24,0 +m_33,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3112.414292548593,2907.2863012020375,471.66478308938196,250.06526315625442,0.7113205174818168,1,3584.079075637975,3157.351564358292,3942.486983201773,0,24,0 +m_33,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3112.414292548593,2014.2605295764868,471.66478308938196,166.73945467769036,0.06891676419531381,1,3584.079075637975,2180.999984254177,3942.486983201773,0,24,0 +m_33,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3112.414292548593,2181.636605281137,471.66478308938196,236.9091905819357,0.1190349546407098,1,3584.079075637975,2418.5457958630723,3942.486983201773,0,24,0 +m_33,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2214.515456593377,1735.3556495316277,291.19471492845895,175.2224004024622,0.19534100966381587,1,2505.710171521836,1910.57804993409,2756.2811886740196,0,24,0 +m_33,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,2214.515456593377,1387.0696047678487,291.19471492845895,212.13456144784607,0.0468259361977969,0.8896927877581411,2505.710171521836,1599.2041662156948,2756.2811886740196,0,24,0 +m_33,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2214.515456593377,2204.1396838340625,291.19471492845895,183.2855521575634,0.9766452747760168,1,2505.710171521836,2387.425235991626,2756.2811886740196,0,24,0 +m_33,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2284.874121495706,1526.934105109315,407.14541323274597,226.17529083439086,0.143193136687944,1,2692.0195347284516,1753.1093959437057,2961.2214882012972,0,24,0 +m_33,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2284.874121495706,1450.9257850208332,407.14541323274597,225.84004584894024,0.11194688183474763,1,2692.0195347284516,1676.7658308697735,2961.2214882012972,0,24,0 +m_33,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2284.874121495706,1537.9509265901895,407.14541323274597,237.37431049405401,0.15143988738575384,1,2692.0195347284516,1775.3252370842436,2961.2214882012972,0,24,0 +m_34,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,536.5557691849363,473.8461621772796,26.317768286195214,15.031708509579275,0.0805095510209153,1,562.8735374711315,488.8778706868589,671.6592147463177,0,24,0 +m_34,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,536.5557691849363,456.1416393416587,26.317768286195214,42.856067567278934,0.1482600640575192,1,562.8735374711315,498.99770690893763,671.6592147463177,0,24,0 +m_34,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,536.5557691849363,547.7982392519947,26.317768286195214,62.801046881021406,0.8737642287336843,1,562.8735374711315,610.5992861330161,671.6592147463177,0,24,0 +m_34,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,471.4475545368258,398.844067313019,14.273447112262815,7.637636946711215,0.0022866846957814812,0.054880432698755546,485.72100164908863,406.48170425973024,534.2931018139975,0,24,0 +m_34,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,471.4475545368258,432.6355433009229,14.273447112262815,12.528127103943232,0.06870260594092294,1,485.72100164908863,445.16367040486614,534.2931018139975,0,24,0 +m_34,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,471.4475545368258,426.1435562384727,14.273447112262815,25.0666675642475,0.1552373865407705,1,485.72100164908863,451.2102238027202,534.2931018139975,0,24,0 +m_34,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,481.26413198214993,341.1612173750279,71.50002567923256,8.99733154051679,0.1216011735112425,1,552.7641576613825,350.15854891554466,608.0405734275207,0,24,0 +m_34,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,481.26413198214993,382.0243698793675,71.50002567923256,46.07839913870429,0.2824332385599109,1,552.7641576613825,428.1027690180718,608.0405734275207,0,24,0 +m_34,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,481.26413198214993,325.79478090556006,71.50002567923256,18.27316011005038,0.09484041750474505,1,552.7641576613825,344.0679410156104,608.0405734275207,0,24,0 +m_34,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,306.4947439651267,318.4760604828544,18.34070265998307,15.48480319721829,0.6305665603458355,1,324.8354466251098,333.9608636800727,378.9340751339744,0,24,0 +m_34,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,306.4947439651267,334.43377863818677,18.34070265998307,9.818207406681854,0.22625177688265327,1,324.8354466251098,344.2519860448686,378.9340751339744,0,24,0 +m_34,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,306.4947439651267,322.7425005932039,18.34070265998307,21.7430222558637,0.5818963283956637,1,324.8354466251098,344.4855228490676,378.9340751339744,0,24,0 +m_34,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,23826.379007651816,25492.551315314453,1704.5102418364836,2337.099267281918,0.5785090763459908,1,25530.8892494883,27829.650582596372,30612.615640856013,0,24,0 +m_34,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,23826.379007651816,25969.757718173583,1704.5102418364836,1401.0796732430997,0.35508462782434547,1,25530.8892494883,27370.837391416684,30612.615640856013,0,24,0 +m_34,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,23826.379007651816,23595.36449539317,1704.5102418364836,3687.640833300944,0.956232457341729,1,25530.8892494883,27283.00532869411,30612.615640856013,0,24,0 +m_34,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,43767.717192848075,46441.23408139987,6086.63064062151,1396.8396829817068,0.6847480953646586,1,49854.34783346958,47838.073764381574,70134.29750185249,0,24,0 +m_34,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,43767.717192848075,60698.04184379099,6086.63064062151,3060.4104306203576,0.04021710016534002,0.9249933038028204,49854.34783346958,63758.45227441135,70134.29750185249,0,24,0 +m_34,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,43767.717192848075,37172.69656427245,6086.63064062151,3457.7544619097325,0.37396859643430636,1,49854.34783346958,40630.451026182185,70134.29750185249,0,24,0 +m_34,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,51121.150229780935,51610.26366825283,3572.295960740689,2264.3300429032,0.910633112249938,1,54693.44619052162,53874.593711156034,72513.7763081729,0,24,0 +m_34,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,51121.150229780935,61650.460411963984,3572.295960740689,4271.154413647749,0.08883858799873903,1,54693.44619052162,65921.61482561173,72513.7763081729,0,24,0 +m_34,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,51121.150229780935,50106.88710916736,3572.295960740689,2774.2889620482,0.8273553406754867,1,54693.44619052162,52881.17607121556,72513.7763081729,0,24,0 +m_34,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,53872.22448470133,49103.97737699806,8044.532920805756,3990.9422392356732,0.6111565812553367,1,61916.75740550709,53094.91961623373,85768.58119889823,0,24,0 +m_34,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,53872.22448470133,68367.14688942806,8044.532920805756,9604.290564115789,0.274973660985181,1,61916.75740550709,77971.43745354384,85768.58119889823,0,24,0 +m_34,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,53872.22448470133,49697.28828453136,8044.532920805756,5427.49661971038,0.6774144593722733,1,61916.75740550709,55124.78490424174,85768.58119889823,0,24,0 +m_35,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,365.27598513085104,209.3050701287212,169.3903988005318,83.08787449988523,0.44064496205766474,1,534.6663839313828,292.3929446286064,588.1330223245211,0,24,0 +m_35,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,365.27598513085104,142.70495844562686,169.3903988005318,41.15016179884337,0.2639195719639041,1,534.6663839313828,183.85512024447024,588.1330223245211,0,24,0 +m_35,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,365.27598513085104,150.0535061611592,169.3903988005318,34.824542135218806,0.2762922288020499,1,534.6663839313828,184.87804829637798,588.1330223245211,0,24,0 +m_35,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,329.90779525640346,745.072421336339,111.41750980566233,416.4717075492064,0.374525478764085,1,441.3253050620658,1161.5441288855454,1277.6985417741,0,24,0 +m_35,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,329.90779525640346,209.71095861895174,111.41750980566233,80.05765834204838,0.4035723388257356,1,441.3253050620658,289.76861696100013,1277.6985417741,0,24,0 +m_35,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,329.90779525640346,275.53238109865816,111.41750980566233,147.9293520056467,0.7755067721463984,1,441.3253050620658,423.46173310430487,1277.6985417741,0,24,0 +m_35,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,94.07329888858635,449.0121212004132,4.328923628781142,248.45968863739222,0.21252791796891904,1,98.40222251736749,697.4718098378055,767.2189908215861,0,24,0 +m_35,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,94.07329888858635,157.39553115796718,4.328923628781142,49.512068369465766,0.2706680112198502,1,98.40222251736749,206.90759952743295,767.2189908215861,0,24,0 +m_35,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,94.07329888858635,221.78610829015798,4.328923628781142,79.63071713877916,0.16983544048599933,1,98.40222251736749,301.41682542893716,767.2189908215861,0,24,0 +m_35,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,320.29657233769314,131.6274476248788,101.45045586672117,45.790980023761016,0.14443894795358317,1,421.7470282044143,177.41842764863983,646.1044071617212,0,24,0 +m_35,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,320.29657233769314,353.17933026780037,101.45045586672117,160.9764208978418,0.8670105390679266,1,421.7470282044143,514.1557511656422,646.1044071617212,0,24,0 +m_35,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,320.29657233769314,347.20491786411,101.45045586672117,240.16272501018204,0.9208260305165519,1,421.7470282044143,587.367642874292,646.1044071617212,0,24,0 +m_35,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5373.772694005134,7205.507754604335,1399.773643027653,1655.4870223787582,0.418446373824115,1,6773.546337032787,8860.994776983092,13829.524832452391,0,24,0 +m_35,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5373.772694005134,9394.29760159789,1399.773643027653,2395.8036186268664,0.18512171560772955,1,6773.546337032787,11790.101220224755,13829.524832452391,0,24,0 +m_35,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5373.772694005134,8599.935131090453,1399.773643027653,3972.360171138994,0.4717311072453384,1,6773.546337032787,12572.295302229446,13829.524832452391,0,24,0 +m_35,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,12254.879383219153,26707.887364706323,4507.50010756636,3863.8424246952313,0.03570995150663932,0.785618933146065,16762.37949078551,30571.729789401554,42289.498368506815,0,24,0 +m_35,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,12254.879383219153,35092.874770911396,4507.50010756636,3352.1237459129757,0.0026709124075320035,0.06410189778076808,16762.37949078551,38444.99851682437,42289.498368506815,0,24,0 +m_35,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,12254.879383219153,15724.2232196437,4507.50010756636,3290.8618768902215,0.5493519438141943,1,16762.37949078551,19015.08509653392,42289.498368506815,0,24,0 +m_35,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,7012.146275150198,11070.867531772095,1318.7324874291292,1947.622042692449,0.11931301645355649,1,8330.878762579327,13018.489574464544,17160.97752675095,0,24,0 +m_35,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,7012.146275150198,13644.699260118792,1318.7324874291292,1591.7025671382507,0.00975684683049808,0.22440747710145584,8330.878762579327,15236.401827257043,17160.97752675095,0,24,0 +m_35,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,7012.146275150198,12946.788692822132,1318.7324874291292,2654.0999678605504,0.08348727689192975,1,8330.878762579327,15600.888660682682,17160.97752675095,0,24,0 +m_35,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6299.521117687065,6347.398823621008,2050.112006089729,1174.7857855010236,0.9843322997278974,1,8349.633123776795,7522.184609122031,16792.13967152622,0,24,0 +m_35,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,6299.521117687065,11687.235638376864,2050.112006089729,3578.345881192424,0.22787665500772408,1,8349.633123776795,15265.581519569289,16792.13967152622,0,24,0 +m_35,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6299.521117687065,7104.289055824436,2050.112006089729,1554.154976688409,0.7613036749814948,1,8349.633123776795,8658.444032512845,16792.13967152622,0,24,0 +m_36,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,2331.9860486025223,2760.5553616340467,491.80903292694035,481.60303070746886,0.5492561773115786,1,2823.7950815294625,3242.1583923415155,3706.292996789883,0,24,0 +m_36,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,2331.9860486025223,1596.1678532088113,491.80903292694035,227.93758912703973,0.2259807047385789,1,2823.7950815294625,1824.105442335851,3706.292996789883,0,24,0 +m_36,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,2331.9860486025223,2947.7903368254215,491.80903292694035,421.5669329835628,0.3683023219803202,1,2823.7950815294625,3369.3572698089843,3706.292996789883,0,24,0 +m_36,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,2871.8036363753326,2647.5665743608565,360.9570729159549,355.62807983494105,0.6675260299570864,1,3232.7607092912876,3003.1946541957977,3556.036780220417,0,24,0 +m_36,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,2871.8036363753326,2136.3529221395675,360.9570729159549,196.5858176243686,0.11267819084907463,1,3232.7607092912876,2332.938739763936,3556.036780220417,0,24,0 +m_36,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,2871.8036363753326,2692.1134972636805,360.9570729159549,282.5568439483087,0.703750739779667,1,3232.7607092912876,2974.670341211989,3556.036780220417,0,24,0 +m_36,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,2417.263897147184,2386.3008761825604,355.1340354316534,200.98503947670164,0.9418175551056069,1,2772.3979325788373,2587.285915659262,3114.1794683556063,0,24,0 +m_36,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,2417.263897147184,1572.3966068033944,355.1340354316534,225.65024827979315,0.08596010237976758,1,2772.3979325788373,1798.0468550831877,3114.1794683556063,0,24,0 +m_36,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,2417.263897147184,2335.256482888677,355.1340354316534,495.81576107096487,0.8961245858225204,1,2772.3979325788373,2831.072243959642,3114.1794683556063,0,24,0 +m_36,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1965.7827420843205,2213.5860509917998,160.07853883057606,196.10127096477066,0.35340257081526716,1,2125.8612809148967,2409.6873219565705,2650.6560541522276,0,24,0 +m_36,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,1965.7827420843205,1348.677260804901,160.07853883057606,99.29208751828705,0.013961484851141213,0.30715266672510666,2125.8612809148967,1447.969348323188,2650.6560541522276,0,24,0 +m_36,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1965.7827420843205,1828.2579990823835,160.07853883057606,192.29213114517927,0.5959963008313152,1,2125.8612809148967,2020.550130227563,2650.6560541522276,0,24,0 +m_36,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5331.149304314183,7130.240375700231,1145.280621242515,1314.4023395679326,0.3268440760599527,1,6476.4299255566975,8444.642715268164,11689.571214805357,0,24,0 +m_36,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5331.149304314183,8745.382251066081,1145.280621242515,1769.817703450476,0.1414902270510059,1,6476.4299255566975,10515.199954516556,11689.571214805357,0,24,0 +m_36,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5331.149304314183,7500.766779812532,1145.280621242515,3126.116142737791,0.5375822457448298,1,6476.4299255566975,10626.882922550323,11689.571214805357,0,24,0 +m_36,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,9671.754311800127,19997.0124256736,3250.078961606029,2436.1943294722932,0.030915118884196662,0.6492174965681299,12921.833273406155,22433.206755145897,30348.757635832484,0,24,0 +m_36,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,9671.754311800127,25360.49852022306,3250.078961606029,2229.281148715558,0.0033100584151058254,0.0794414019625398,12921.833273406155,27589.77966893862,30348.757635832484,0,24,0 +m_36,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,9671.754311800127,12977.349889749414,3250.078961606029,2378.764376116428,0.43263048467442855,1,12921.833273406155,15356.114265865843,30348.757635832484,0,24,0 +m_36,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5029.583915146937,9113.57915404853,1404.9324176325474,1261.110347816801,0.0561113675067574,1,6434.516332779484,10374.68950186533,13043.347270041773,0,24,0 +m_36,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,5029.583915146937,10945.016894366247,1404.9324176325474,912.571532944456,0.0069035926888418525,0.1587826318433626,6434.516332779484,11857.588427310702,13043.347270041773,0,24,0 +m_36,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5029.583915146937,9205.19890317969,1404.9324176325474,2121.047735972925,0.13640795587224908,1,6434.516332779484,11326.246639152614,13043.347270041773,0,24,0 +m_36,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6243.797224888628,5890.402304937651,1674.1510404222845,886.8787433831515,0.8569091083034166,1,7917.948265310913,6777.281048320802,13057.010599443007,0,24,0 +m_36,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,6243.797224888628,9647.40880613714,1674.1510404222845,2222.6008297201365,0.25137289501181803,1,7917.948265310913,11870.009635857277,13057.010599443007,0,24,0 +m_36,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6243.797224888628,7474.645476548912,1674.1510404222845,1343.5333667542209,0.5796241534704328,1,7917.948265310913,8818.178843303132,13057.010599443007,0,24,0 +m_37,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,630.933410607765,678.1472131336193,126.62823171945234,124.54315990091038,0.7964588360906776,1,757.5616423272174,802.6903730345297,1035.9613704795904,0,24,0 +m_37,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,630.933410607765,447.41062509921375,126.62823171945234,72.84015904075557,0.25218589496442106,1,757.5616423272174,520.2507841399693,1035.9613704795904,0,24,0 +m_37,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,630.933410607765,828.4515308490966,126.62823171945234,113.33153322325826,0.2764449992184892,1,757.5616423272174,941.7830640723548,1035.9613704795904,0,24,0 +m_37,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,671.4142285388855,659.9111421453067,85.13355504952595,74.55160208105582,0.9210771655232575,1,756.5477835884114,734.4627442263625,832.2025619472527,0,24,0 +m_37,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,671.4142285388855,515.1652179746056,85.13355504952595,34.23670793971671,0.1351466207693364,1,756.5477835884114,549.4019259143223,832.2025619472527,0,24,0 +m_37,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,671.4142285388855,662.1415440344607,85.13355504952595,52.401117196185766,0.9282935964206341,1,756.5477835884114,714.5426612306464,832.2025619472527,0,24,0 +m_37,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,569.6195574885154,587.7362574667691,83.69920786736944,44.458954035866704,0.8545273305528398,1,653.3187653558848,632.1952115026357,759.7588669428513,0,24,0 +m_37,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,569.6195574885154,420.1609965948351,83.69920786736944,54.4372836301559,0.1788744644568073,1,653.3187653558848,474.598280224991,759.7588669428513,0,24,0 +m_37,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,569.6195574885154,587.4929187071393,83.69920786736944,103.19696033181646,0.8959823336211666,1,653.3187653558848,690.6898790389557,759.7588669428513,0,24,0 +m_37,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,477.14850073021523,538.5276170541296,40.434268654435684,35.04034429206043,0.28274925128052925,1,517.5827693846509,573.56796134619,630.924757480809,0,24,0 +m_37,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,477.14850073021523,354.1642408929372,40.434268654435684,20.93530435646429,0.035051917046752396,0.7711421750285528,517.5827693846509,375.0995452494015,630.924757480809,0,24,0 +m_37,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,477.14850073021523,453.9171771559271,40.434268654435684,42.22122087629373,0.7003829899630174,1,517.5827693846509,496.13839803222083,630.924757480809,0,24,0 +m_37,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,250.24465111006373,282.06179247164005,40.38957298522776,50.3017473179239,0.6330026216292504,1,290.6342240952915,332.36353978956396,587.8781245672358,0,24,0 +m_37,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,250.24465111006373,350.74518460356626,40.38957298522776,38.31849790845533,0.1012821948752899,1,290.6342240952915,389.0636825120216,587.8781245672358,0,24,0 +m_37,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,250.24465111006373,412.8716895874611,40.38957298522776,121.56296911002597,0.2505917568283908,1,290.6342240952915,534.4346586974871,587.8781245672358,0,24,0 +m_37,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,267.57829794057477,471.605568459588,75.68230207878146,62.113762203568534,0.0648289722651357,1,343.2606000193562,533.7193306631566,587.0912637294723,0,24,0 +m_37,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,267.57829794057477,433.8812997586509,75.68230207878146,46.21896701127023,0.09638078055855376,1,343.2606000193562,480.1002667699212,587.0912637294723,0,24,0 +m_37,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,267.57829794057477,379.80520211141044,75.68230207878146,52.54839244545363,0.2544696806530998,1,343.2606000193562,432.3535945568641,587.0912637294723,0,24,0 +m_37,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,203.851551099135,397.11923984971156,36.69693185673012,24.36349261934581,0.0019050239262496371,0.04572057422999129,240.54848295586513,421.4827324690574,475.1591004275123,0,24,0 +m_37,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,203.851551099135,295.13786715645807,36.69693185673012,35.30738865640892,0.1033354943322689,1,240.54848295586513,330.445255812867,475.1591004275123,0,24,0 +m_37,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,203.851551099135,351.9351421423537,36.69693185673012,80.02767642811202,0.13636729554674926,1,240.54848295586513,431.96281857046574,475.1591004275123,0,24,0 +m_37,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,205.1372392304115,272.0453628918733,41.431878377928655,88.31260091494791,0.5145469463407606,1,246.56911760834015,360.3579638068212,499.2014197150579,0,24,0 +m_37,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,205.1372392304115,204.80421524331123,41.431878377928655,89.79011627585338,0.9974064666704999,1,246.56911760834015,294.5943315191646,499.2014197150579,0,24,0 +m_37,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,205.1372392304115,413.62949043843366,41.431878377928655,40.189982029800795,0.004759366734622128,0.10946543489630894,246.56911760834015,453.81947246823444,499.2014197150579,0,24,0 +m_38,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,90.80875218539262,21.431965049038293,27.487557303734583,9.177862031099389,0.06318595241640994,1,118.2963094891272,30.609827080137684,130.12594043803992,0,24,0 +m_38,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,90.80875218539262,42.85283495586406,27.487557303734583,8.073389522121657,0.158830212595951,1,118.2963094891272,50.92622447798572,130.12594043803992,0,24,0 +m_38,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,90.80875218539262,37.38985001327557,27.487557303734583,16.29262672354705,0.14075669770716967,1,118.2963094891272,53.68247673682262,130.12594043803992,0,24,0 +m_38,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,48.329899897422315,28.027288567905657,16.178423539185108,10.00808341687008,0.3157941542606211,1,64.50832343660743,38.035371984775736,112.27397060863107,0,24,0 +m_38,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,48.329899897422315,78.77068865090811,16.178423539185108,23.296557356938308,0.3113565900837912,1,64.50832343660743,102.06724600784642,112.27397060863107,0,24,0 +m_38,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,48.329899897422315,64.74480536301407,16.178423539185108,15.436897891298761,0.47980115175340976,1,64.50832343660743,80.18170325431282,112.27397060863107,0,24,0 +m_38,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,54.48911300487965,56.22161928878398,14.309540904858983,24.50920984414937,0.952848801137915,1,68.79865390973863,80.73082913293335,109.0601233016898,0,24,0 +m_38,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,54.48911300487965,23.8494962386342,14.309540904858983,13.24352803525493,0.15494295231717128,1,68.79865390973863,37.09302427388913,109.0601233016898,0,24,0 +m_38,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,54.48911300487965,76.21386611020085,14.309540904858983,22.931700527698954,0.44446187592578146,1,68.79865390973863,99.1455666378998,109.0601233016898,0,24,0 +m_38,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,44.32085041603382,68.4006998091503,9.76582914472858,30.15599748391499,0.47613458173335876,1,54.0866795607624,98.55669729306528,132.91148300971315,0,24,0 +m_38,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,44.32085041603382,86.7718985586236,9.76582914472858,34.05672235929743,0.27744665240492977,1,54.0866795607624,120.82862091792103,132.91148300971315,0,24,0 +m_38,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,44.32085041603382,44.196045686926425,9.76582914472858,8.416974213044437,0.992501494637299,1,54.0866795607624,52.613019899970865,132.91148300971315,0,24,0 +m_38,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,60.3026106268076,30.291440592418297,23.073922897774125,16.87493225100386,0.3206990299009858,1,83.37653352458173,47.16637284342215,136.09351268001072,0,24,0 +m_38,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,60.3026106268076,26.91621003161888,23.073922897774125,13.082300804516036,0.24400132395256421,1,83.37653352458173,39.99851083613492,136.09351268001072,0,24,0 +m_38,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,60.3026106268076,93.3475387750244,23.073922897774125,30.373836388621676,0.40804395466794086,1,83.37653352458173,123.72137516364609,136.09351268001072,0,24,0 +m_38,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,58.46217480274284,86.85214825880769,16.45692583302689,23.428816617155302,0.34740177655985116,1,74.91910063576972,110.280964875963,121.30906136355931,0,24,0 +m_38,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,58.46217480274284,69.8720152442817,16.45692583302689,10.047356733498106,0.5698336681785676,1,74.91910063576972,79.9193719777798,121.30906136355931,0,24,0 +m_38,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,58.46217480274284,66.59772829716573,16.45692583302689,18.579644038815445,0.7499327888434084,1,74.91910063576972,85.17737233598118,121.30906136355931,0,24,0 +m_38,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,110.78516263154074,80.50649887769023,44.57437274113807,26.842354527866455,0.5762579717138938,1,155.3595353726788,107.3488534055567,170.8954889099467,0,24,0 +m_38,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,110.78516263154074,97.85981641861169,44.57437274113807,23.518701422679523,0.8044126347691694,1,155.3595353726788,121.37851784129121,170.8954889099467,0,24,0 +m_38,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,110.78516263154074,67.78239695477023,44.57437274113807,15.963385033339856,0.3973514716439672,1,155.3595353726788,83.7457819881101,170.8954889099467,0,24,0 +m_38,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,73.02499011367847,60.713583145686094,29.359775066814258,13.598494750062327,0.7147799862496156,1,102.38476518049274,74.31207789574842,273.24476266530723,0,24,0 +m_38,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,73.02499011367847,100.67052585740609,29.359775066814258,59.362324870136796,0.6883465481137343,1,102.38476518049274,160.0328507275429,273.24476266530723,0,24,0 +m_38,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,73.02499011367847,168.6703566654216,29.359775066814258,79.73397303031227,0.30115839477769973,1,102.38476518049274,248.40432969573385,273.24476266530723,0,24,0 +m_39,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,21012.266447056198,131.59467765043757,17459.76728346674,21.08648064625327,0.2977696224764307,1,38472.03373052293,152.68115829669085,116187.29057306626,0,24,0 +m_39,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,21012.266447056198,434.7733975634532,17459.76728346674,231.0395219087522,0.30390813725042026,1,38472.03373052293,665.8129194722054,116187.29057306626,0,24,0 +m_39,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,21012.266447056198,56448.91308335485,17459.76728346674,49175.896528523575,0.521555867257061,1,38472.03373052293,105624.80961187842,116187.29057306626,0,24,0 +m_39,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,485.8868353275857,790.2193491918338,291.20120940189275,508.2837978563366,0.6175228612519919,1,777.0880447294785,1298.5031470481704,1428.3534617529876,0,24,0 +m_39,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,485.8868353275857,152.89695125000202,291.20120940189275,74.43721205588157,0.31282893578559007,1,777.0880447294785,227.33416330588358,1428.3534617529876,0,24,0 +m_39,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,485.8868353275857,218.0473675139583,291.20120940189275,117.47651735252134,0.42360440388805476,1,777.0880447294785,335.52388486647965,1428.3534617529876,0,24,0 +m_39,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,86.29379057559308,661.0198143781186,9.17346213552125,407.0105785213517,0.21707484545546687,1,95.46725271111433,1068.0303928994704,2919.1073468000454,0,24,0 +m_39,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,86.29379057559308,119.19781966713546,9.17346213552125,20.86111819005236,0.20331126755760712,1,95.46725271111433,140.05893785718783,2919.1073468000454,0,24,0 +m_39,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,86.29379057559308,1390.3261013614965,9.17346213552125,1263.407850274908,0.34932315409476816,1,95.46725271111433,2653.7339516364045,2919.1073468000454,0,24,0 +m_39,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,446.9213615105917,142.71127518827794,338.9970170832694,38.36885866720366,0.42177311196955247,1,785.918378593861,181.0801338554816,2573.778874550035,0,24,0 +m_39,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,446.9213615105917,553.5021402608854,338.9970170832694,472.63318491607765,0.8588461739931631,1,785.918378593861,1026.135325176963,2573.778874550035,0,24,0 +m_39,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,446.9213615105917,1542.0564781079806,338.9970170832694,797.7424987556874,0.24863767805030293,1,785.918378593861,2339.798976863668,2573.778874550035,0,24,0 +m_39,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2294.416365312902,2436.714978952926,361.7929881251648,136.90002830407772,0.7248335796822896,1,2656.209353438067,2573.6150072570035,3547.401727915165,0,24,0 +m_39,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2294.416365312902,1887.8369139046147,361.7929881251648,104.8961399803474,0.3230201485875712,1,2656.209353438067,1992.7330538849621,3547.401727915165,0,24,0 +m_39,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2294.416365312902,2921.7718916056037,361.7929881251648,303.1387701354552,0.21420984057189021,1,2656.209353438067,3224.910661741059,3547.401727915165,0,24,0 +m_39,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1950.165652917846,2320.0996755825436,149.25815627510346,184.6783199276102,0.1516458219225583,1,2099.4238091929496,2504.7779955101537,4256.016019210796,0,24,0 +m_39,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1950.165652917846,2420.7645360281613,149.25815627510346,395.41038791089085,0.3055921411015919,1,2099.4238091929496,2816.174923939052,4256.016019210796,0,24,0 +m_39,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1950.165652917846,3111.616573476426,149.25815627510346,757.4888985333889,0.188683074252303,1,2099.4238091929496,3869.1054720098145,4256.016019210796,0,24,0 +m_39,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2379.522620020415,2779.961115788635,195.12572115591078,180.47845303098677,0.16302227728569138,1,2574.648341176326,2960.439568819622,3427.3595975423573,0,24,0 +m_39,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2379.522620020415,2684.0240298593117,195.12572115591078,431.75742245192197,0.5410168702533069,1,2574.648341176326,3115.781452311234,3427.3595975423573,0,24,0 +m_39,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2379.522620020415,2349.9901870373783,195.12572115591078,162.8220525208493,0.9098614282019036,1,2574.648341176326,2512.8122395582277,3427.3595975423573,0,24,0 +m_39,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2631.000022355788,2818.033797069825,212.1129838351329,130.41518099704936,0.47330400258915717,1,2843.113006190921,2948.4489780668746,4694.719097919006,0,24,0 +m_39,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2631.000022355788,3044.0264546918615,212.1129838351329,172.35505293100104,0.16293779643011083,1,2843.113006190921,3216.3815076228625,4694.719097919006,0,24,0 +m_39,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2631.000022355788,3562.4840148223198,212.1129838351329,705.4424378313219,0.25372848879127324,1,2843.113006190921,4267.926452653642,4694.719097919006,0,24,0 +m_40,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,355.0424155203622,380.95164866120643,83.10080445108618,34.23836171280138,0.7839761724519921,1,438.1432199714484,415.1900103740078,481.95754196859326,1,24,4.166666666666666 +m_40,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,355.0424155203622,245.21513389525606,83.10080445108618,49.70383631137734,0.2957093167399116,1,438.1432199714484,294.9189702066334,481.95754196859326,1,24,4.166666666666666 +m_40,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,355.0424155203622,331.67868427027884,83.10080445108618,50.62529155270299,0.8173540627419769,1,438.1432199714484,382.30397582298184,481.95754196859326,1,24,4.166666666666666 +m_40,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,216.58890202511628,147.1768971681124,12.37806225309633,20.080957221561057,0.017857936277390046,0.26786904416085067,228.9669642782126,167.25785438967344,251.86366070603387,1,24,4.166666666666666 +m_40,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,216.58890202511628,147.94200876247555,12.37806225309633,9.998741434888286,0.0016878826715012731,0.033757653430025465,228.9669642782126,157.94075019736383,251.86366070603387,1,24,4.166666666666666 +m_40,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,216.58890202511628,152.35328176868774,12.37806225309633,8.064469859001871,0.0020678083307835637,0.03928835828488771,228.9669642782126,160.4177516276896,251.86366070603387,1,24,4.166666666666666 +m_40,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,175.8338395211693,151.32200834592092,20.8916119440102,13.717845443766418,0.35880318234628517,1,196.7254514651795,165.03985378968733,216.39799661169747,4,24,16.666666666666664 +m_40,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,175.8338395211693,114.85463383672192,20.8916119440102,15.723253071901912,0.05037782098920796,0.5509053998815531,196.7254514651795,130.57788690862384,216.39799661169747,4,24,16.666666666666664 +m_40,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,175.8338395211693,117.32803882838058,20.8916119440102,9.009099921500603,0.04590878332346276,0.5509053998815531,196.7254514651795,126.33713874988119,216.39799661169747,4,24,16.666666666666664 +m_40,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,154.19153082843468,140.43583317138746,18.28645679610293,13.07336386227431,0.558541693545435,1,172.4779876245376,153.50919703366176,189.7257863869914,7,24,29.166666666666668 +m_40,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,154.19153082843468,117.81297542300182,18.28645679610293,13.519568541950694,0.1496972973944421,0.9824509296959613,172.4779876245376,131.33254396495252,189.7257863869914,7,24,29.166666666666668 +m_40,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,154.19153082843468,103.93898273335657,18.28645679610293,9.511143575602224,0.04994663998320289,0.5509053998815531,172.4779876245376,113.45012630895879,189.7257863869914,7,24,29.166666666666668 +m_40,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,7631.591331979115,8379.09071924385,135.75295555854487,170.69557145319877,0.006946129181838205,0.11113806690941128,7767.34428753766,8549.78629069705,10357.178902168886,0,24,0 +m_40,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,7631.591331979115,8677.970059231557,135.75295555854487,98.31158764285553,1.4309031202611598e-4,0.0034341674886267833,7767.34428753766,8776.281646874411,10357.178902168886,0,24,0 +m_40,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,7631.591331979115,9107.688434073858,135.75295555854487,307.9287497160375,0.0033539804234382713,0.05701766719845061,7767.34428753766,9415.617183789895,10357.178902168886,0,24,0 +m_40,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,7509.682335202002,8088.776195105068,175.47163746787254,164.4096246524912,0.036888435361314705,0.5164380950584059,7685.153972669875,8253.185819757558,9095.70796220034,0,24,0 +m_40,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,7509.682335202002,8057.737236520813,175.47163746787254,211.088183661314,0.07475889831483962,0.5980711865187169,7685.153972669875,8268.825420182127,9095.70796220034,0,24,0 +m_40,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,7509.682335202002,7893.573142295434,175.47163746787254,163.14845061709337,0.14035013281370876,0.9824509296959613,7685.153972669875,8056.721592912528,9095.70796220034,0,24,0 +m_40,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,6811.967443514581,7592.771319496247,125.84500622384995,108.28224273461205,8.8919722522132e-4,0.01867314172964772,6937.812449738431,7701.053562230859,8471.158918453946,0,24,0 +m_40,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,6811.967443514581,7320.724761007298,125.84500622384995,170.5795923652593,0.03933272512966532,0.5164380950584059,6937.812449738431,7491.304353372558,8471.158918453946,0,24,0 +m_40,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,6811.967443514581,7523.186352164674,125.84500622384995,127.65091878160213,0.0026543458932566295,0.04777822607861933,6937.812449738431,7650.837270946276,8471.158918453946,0,24,0 +m_40,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,6593.957266089812,7228.026466310379,100.60061123096631,63.4413532692882,5.887491660414274e-4,0.01354123081895283,6694.557877320778,7291.467819579667,8283.98814451778,0,24,0 +m_40,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,6593.957266089812,7400.783472128924,100.60061123096631,130.11484106905775,7.39731565587352e-4,0.016274094442921744,6694.557877320778,7530.898313197981,8283.98814451778,0,24,0 +m_40,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6593.957266089812,7214.774735679081,100.60061123096631,248.94675860673652,0.05627171811057918,0.5509053998815531,6694.557877320778,7463.721494285817,8283.98814451778,0,24,0 +m_41,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,189.63060680137917,220.13408664383292,22.704904629509592,9.021430125060904,0.2645495974269472,1,212.33551143088877,229.15551676889382,308.63671884563564,0,24,0 +m_41,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,189.63060680137917,208.7687225842842,22.704904629509592,21.99743951118744,0.5601805809146779,1,212.33551143088877,230.76616209547166,308.63671884563564,0,24,0 +m_41,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,189.63060680137917,248.21460009556236,22.704904629509592,32.36423521865181,0.1742861096821658,1,212.33551143088877,280.5788353142142,308.63671884563564,0,24,0 +m_41,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,153.34593364144732,195.9661873265021,29.58790062477528,18.372705133266553,0.25443471448940225,1,182.9338342662226,214.33889245976866,235.77278170574553,0,24,0 +m_41,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,153.34593364144732,143.67050867050926,29.58790062477528,18.509445049703615,0.7883100414682211,1,182.9338342662226,162.1799537202129,235.77278170574553,0,24,0 +m_41,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,153.34593364144732,165.7114815658931,29.58790062477528,5.215853224326711,0.6967358861016405,1,182.9338342662226,170.92733479021982,235.77278170574553,0,24,0 +m_41,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,141.2439687942744,195.45085754874265,27.008566258885768,29.60304965255707,0.20916027538886148,1,168.25253505316016,225.05390720129972,247.5592979214297,0,24,0 +m_41,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,141.2439687942744,146.45897330967503,27.008566258885768,18.823261194566797,0.8785183149753559,1,168.25253505316016,165.28223450424184,247.5592979214297,0,24,0 +m_41,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,141.2439687942744,201.78328487129767,27.008566258885768,21.593562645626232,0.11763623536785127,1,168.25253505316016,223.3768475169239,247.5592979214297,0,24,0 +m_41,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,127.96554716912783,158.6593874252516,25.768197053155166,16.199575398120274,0.3471930561112806,1,153.733744222283,174.85896282337188,202.45074839966108,0,24,0 +m_41,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,127.96554716912783,152.71785060579072,25.768197053155166,10.706111939544938,0.4129929462540295,1,153.733744222283,163.42396254533566,202.45074839966108,0,24,0 +m_41,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,127.96554716912783,172.73467605312487,25.768197053155166,11.311458855657918,0.16695767015999352,1,153.733744222283,184.0461349087828,202.45074839966108,0,24,0 +m_41,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1096.1753684476357,1362.137478881085,111.44065709199002,177.38076274523073,0.23820617785444526,1,1207.6160255396258,1539.5182416263156,1693.4700657889473,0,24,0 +m_41,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1096.1753684476357,1234.864485575801,111.44065709199002,90.49339110505355,0.35770913064128085,1,1207.6160255396258,1325.3578766808546,1693.4700657889473,0,24,0 +m_41,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1096.1753684476357,1160.7507859517978,111.44065709199002,255.76052981269595,0.8237316441942184,1,1207.6160255396258,1416.5113157644937,1693.4700657889473,0,24,0 +m_41,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1742.7181828386567,1839.9733067147351,282.5495976574364,159.98062158860893,0.772260962631686,1,2025.267780496093,1999.9539283033441,2359.2219808067694,0,24,0 +m_41,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1742.7181828386567,2007.5992740666309,282.5495976574364,137.14798121225016,0.4260352606202418,1,2025.267780496093,2144.747255278881,2359.2219808067694,0,24,0 +m_41,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1742.7181828386567,1292.2619469871158,282.5495976574364,89.91925907490602,0.1795024170316389,1,2025.267780496093,1382.1812060620218,2359.2219808067694,0,24,0 +m_41,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1608.416778757095,1723.6531889896294,97.71431149651424,113.34582239321985,0.45946070328548005,1,1706.1310902536093,1836.9990113828492,2646.478019388192,0,24,0 +m_41,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1608.416778757095,2137.6713408522232,97.71431149651424,268.21776768249663,0.11079037272023029,1,1706.1310902536093,2405.88910853472,2646.478019388192,0,24,0 +m_41,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1608.416778757095,1510.4856057960158,97.71431149651424,157.1480684025188,0.6104123358258152,1,1706.1310902536093,1667.6336741985347,2646.478019388192,0,24,0 +m_41,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1681.9358703135756,1746.491415035427,200.89707921554785,153.36950834018762,0.8039332228768127,1,1882.8329495291234,1899.8609233756147,2828.3947341912913,0,24,0 +m_41,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1681.9358703135756,2344.7410989562254,200.89707921554785,226.52684121767544,0.05379200070872903,1,1882.8329495291234,2571.267940173901,2828.3947341912913,0,24,0 +m_41,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1681.9358703135756,1655.950301549136,200.89707921554785,128.46085726537007,0.9157513839888566,1,1882.8329495291234,1784.411158814506,2828.3947341912913,0,24,0 +m_42,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,44.611568620898424,45.34094005322163,2.081185577191857,3.0779903582290498,0.8490305517440981,1,46.692754198090284,48.41893041145068,53.26082345259575,0,24,0 +m_42,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,44.611568620898424,42.11169062055779,2.081185577191857,1.8702844715614337,0.39597484144703543,1,46.692754198090284,43.98197509211922,53.26082345259575,0,24,0 +m_42,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,44.611568620898424,42.66048402254175,2.081185577191857,3.8203599785399756,0.6663591373624005,1,46.692754198090284,46.48084400108173,53.26082345259575,0,24,0 +m_42,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,47.20488920389556,44.52508944356565,1.7894707268880534,1.3707588855698933,0.2637773567716173,1,48.99435993078362,45.89584832913554,53.89379592386198,0,24,0 +m_42,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,47.20488920389556,44.192542175989736,1.7894707268880534,1.6554083337431382,0.24497250154841216,1,48.99435993078362,45.847950509732875,53.89379592386198,0,24,0 +m_42,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,47.20488920389556,45.16060306607211,1.7894707268880534,1.089886007902752,0.35692671645685503,1,48.99435993078362,46.25048907397486,53.89379592386198,0,24,0 +m_42,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,46.92967360200102,49.29436518423791,0.9168451017441558,1.570183521349063,0.23030016268357364,1,47.846518703745176,50.86454870558698,68.40446138167307,0,24,0 +m_42,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,46.92967360200102,56.233230535646996,0.9168451017441558,5.952643447692162,0.19411579473417037,1,47.846518703745176,62.18587398333916,68.40446138167307,0,24,0 +m_42,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,46.92967360200102,41.798355281245016,0.9168451017441558,1.6662098538417052,0.028405595532126897,0.6533286972389186,47.846518703745176,43.46456513508672,68.40446138167307,0,24,0 +m_42,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,45.403354316773296,48.267917268377886,3.2002017394952453,2.889547387688482,0.5238547288177025,1,48.603556056268545,51.15746465606637,56.27321112167301,0,24,0 +m_42,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,45.403354316773296,46.92005796764858,3.2002017394952453,1.1031790525935232,0.6730314284173273,1,48.603556056268545,48.02323702024211,56.27321112167301,0,24,0 +m_42,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,45.403354316773296,44.8946312195692,3.2002017394952453,1.7961528086013592,0.8940017164611551,1,48.603556056268545,46.690784028170555,56.27321112167301,0,24,0 +m_42,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,155.57157896848796,156.59213104072242,5.675416064320361,7.419037811861978,0.9153060856238632,1,161.24699503280831,164.0111688525844,183.62577381634952,0,24,0 +m_42,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,155.57157896848796,147.55953715790878,5.675416064320361,2.342209427276796,0.23521496349221377,1,161.24699503280831,149.90174658518558,183.62577381634952,0,24,0 +m_42,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,155.57157896848796,159.62124973503302,5.675416064320361,7.311271916193819,0.6715795978739605,1,161.24699503280831,166.93252165122684,183.62577381634952,0,24,0 +m_42,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,170.56888222906514,168.79811222186484,8.127226613048585,6.49868402197655,0.8684327372962044,1,178.69610884211372,175.29679624384138,196.5657197263251,0,24,0 +m_42,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,170.56888222906514,169.33549465580046,8.127226613048585,6.043452506096681,0.9056816266475792,1,178.69610884211372,175.37894716189714,196.5657197263251,0,24,0 +m_42,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,170.56888222906514,156.7788969446508,8.127226613048585,2.3000675594255267,0.15540329856221793,1,178.69610884211372,159.0789645040763,196.5657197263251,0,24,0 +m_42,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,158.94702995466218,176.78800844042186,2.9462468374615667,3.3525835657110923,0.0026128861443707884,0.06270926746489892,161.89327679212374,180.14059200613295,198.15465120674625,0,24,0 +m_42,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,158.94702995466218,162.41593816177016,2.9462468374615667,2.3066542195994897,0.3769464693246206,1,161.89327679212374,164.72259238136965,198.15465120674625,0,24,0 +m_42,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,158.94702995466218,163.16269181275706,2.9462468374615667,5.400309338031809,0.5131768947876383,1,161.89327679212374,168.56300115078886,198.15465120674625,0,24,0 +m_42,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,171.72890790902974,170.0621722592949,6.410072165529577,6.364964195570327,0.857302671115534,1,178.13898007455933,176.42713645486523,197.06737139629516,0,24,0 +m_42,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,171.72890790902974,173.66013104892897,6.410072165529577,4.844115653188675,0.8152596020805765,1,178.13898007455933,178.50424670211765,197.06737139629516,0,24,0 +m_42,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,171.72890790902974,170.96412778903698,6.410072165529577,8.188028025776788,0.9429042952325952,1,178.13898007455933,179.15215581481377,197.06737139629516,0,24,0 +m_43,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,2525.1080246002184,352.99625938849067,1820.6282891675442,126.7857070520668,0.2992003261088581,1,4345.736313767762,479.7819664405575,4780.309945144539,0,24,0 +m_43,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,2525.1080246002184,883.6800167733705,1820.6282891675442,272.59785532839595,0.4209502080737652,1,4345.736313767762,1156.2778721017664,4780.309945144539,0,24,0 +m_43,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,2525.1080246002184,680.8781703835269,1820.6282891675442,151.01113921771883,0.3691213667995557,1,4345.736313767762,831.8893096012457,4780.309945144539,0,24,0 +m_43,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,295.4450076895346,372.2827635381618,127.76728266678951,175.58681095723315,0.7314862419982797,1,423.2122903563241,547.869574495395,809.4485695597074,3,24,12.5 +m_43,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,295.4450076895346,149.08787003977852,127.76728266678951,102.76007328262824,0.3939740495928501,1,423.2122903563241,251.84794332240676,809.4485695597074,3,24,12.5 +m_43,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,295.4450076895346,519.5383217724622,127.76728266678951,216.32401419090814,0.39810771524975785,1,423.2122903563241,735.8623359633702,809.4485695597074,3,24,12.5 +m_43,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,253.40112834502855,201.248843806041,135.57962327586364,106.96013397192043,0.7703209113741605,1,388.9807516208922,308.2089777779614,427.87882678298143,0,24,0 +m_43,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,253.40112834502855,86.53537614660112,135.57962327586364,33.04125767177168,0.2913002337044838,1,388.9807516208922,119.57663381837281,427.87882678298143,0,24,0 +m_43,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,253.40112834502855,132.75943041576411,135.57962327586364,39.912456757366975,0.4347008027450806,1,388.9807516208922,172.6718871731311,427.87882678298143,0,24,0 +m_43,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,385.5886159476326,246.35716806168514,281.0315290136118,89.63524814903921,0.6575358834656408,1,666.6201449612445,335.99241621072434,734.2949584672313,1,24,4.166666666666666 +m_43,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,385.5886159476326,87.13333692140954,281.0315290136118,34.122129796081126,0.34964757485574216,1,666.6201449612445,121.25546671749066,734.2949584672313,1,24,4.166666666666666 +m_43,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,385.5886159476326,439.7341171711843,281.0315290136118,227.8067541626622,0.8846566486955743,1,666.6201449612445,667.5408713338466,734.2949584672313,1,24,4.166666666666666 +m_43,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,298.9200070222308,344.8720855450007,38.106212417427,39.6085424838945,0.4226790470263364,1,337.0262194396578,384.4806280288952,531.613653761683,0,24,0 +m_43,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,298.9200070222308,369.18719982458174,38.106212417427,114.09793995876639,0.5800699166260161,1,337.0262194396578,483.28513978334814,531.613653761683,0,24,0 +m_43,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,298.9200070222308,362.3260230964016,38.106212417427,39.21449290849999,0.2731748192339564,1,337.0262194396578,401.54051600490163,531.613653761683,0,24,0 +m_43,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,301.094161850299,356.30930936299694,36.92572785282825,28.176314307778327,0.26385670991600385,1,338.0198897031272,384.4856236707753,422.93418603785284,0,24,0 +m_43,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,301.094161850299,245.45743678903585,36.92572785282825,17.71160467428338,0.2154057975477061,1,338.0198897031272,263.1690414633192,422.93418603785284,0,24,0 +m_43,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,301.094161850299,274.51925566255323,36.92572785282825,13.847581257238017,0.5240551781529033,1,338.0198897031272,288.36683691979124,422.93418603785284,0,24,0 +m_43,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,333.9562473577739,353.98647015630274,24.26051679391336,23.33032256022319,0.5650150832642479,1,358.2167641516873,377.3167927165259,467.3094147470229,0,24,0 +m_43,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,333.9562473577739,365.9798898121974,24.26051679391336,56.61680021518934,0.619678781211856,1,358.2167641516873,422.5966900273868,467.3094147470229,0,24,0 +m_43,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,333.9562473577739,403.906557670877,24.26051679391336,20.920183008234716,0.054486126247995384,1,358.2167641516873,424.8267406791117,467.3094147470229,0,24,0 +m_43,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,430.1288265554666,386.40012982820383,36.090508376366124,20.04652494393122,0.32113219793206277,1,466.21933493183275,406.44665477213505,571.605205480574,0,24,0 +m_43,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,430.1288265554666,415.2929632080567,36.090508376366124,35.69463838710877,0.7760536733473724,1,466.21933493183275,450.9876015951654,571.605205480574,0,24,0 +m_43,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,430.1288265554666,459.71916634267194,36.090508376366124,59.9219295487589,0.6831533887240726,1,466.21933493183275,519.6410958914308,571.605205480574,0,24,0 +m_44,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,192060.23236008408,222415.5859862716,38083.560295550684,30187.63460600634,0.5494787876726239,1,230143.79265563475,252603.22059227794,461241.94565213,0,24,0 +m_44,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,192060.23236008408,201412.7206795571,38083.560295550684,31847.672280102233,0.8550967411284532,1,230143.79265563475,233260.39295965934,461241.94565213,0,24,0 +m_44,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,192060.23236008408,369311.08140045434,38083.560295550684,49999.778283300184,0.020508390861131973,0.47169298980603536,230143.79265563475,419310.8596837545,461241.94565213,0,24,0 +m_44,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,69848.89080575254,109606.67950176453,12127.749491211818,46473.4000189226,0.44119356436540974,1,81976.64029696435,156080.07952068714,171688.08747275587,0,23,0 +m_44,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,69848.89080575254,42651.19389281426,12127.749491211818,12388.845565061534,0.15174135643288264,1,81976.64029696435,55040.0394578758,171688.08747275587,0,23,0 +m_44,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,69848.89080575254,57610.723631553825,12127.749491211818,14940.227471024959,0.5396622052659206,1,81976.64029696435,72550.95110257878,171688.08747275587,0,23,0 +m_44,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,79532.364127079,50849.93353699915,18955.515427275448,13022.982858775744,0.25057692761508166,1,98487.87955435444,63872.9163957749,126784.2175293852,0,24,0 +m_44,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,79532.364127079,72446.77187472551,18955.515427275448,42811.60769744284,0.8850975294358807,1,98487.87955435444,115258.37957216836,126784.2175293852,0,24,0 +m_44,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,79532.364127079,38123.685725038275,18955.515427275448,7161.6945943893015,0.09489972457144522,1,98487.87955435444,45285.380319427575,126784.2175293852,0,24,0 +m_44,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,54695.927744901994,42181.307061226544,10263.966494484275,5044.564527761882,0.3165545751502769,1,64959.89423938627,47225.871588988426,73260.87020040711,0,24,0 +m_44,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,54695.927744901994,52072.310322126454,10263.966494484275,4959.137043128984,0.8258298678866002,1,64959.89423938627,57031.44736525544,73260.87020040711,0,24,0 +m_44,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,54695.927744901994,54137.069546851286,10263.966494484275,12463.721544427892,0.9731489033140024,1,64959.89423938627,66600.79109127918,73260.87020040711,0,24,0 +m_44,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,520758.58072309656,374499.5237249493,58468.97701071167,49591.46651448452,0.08631002496046714,1,579227.5577338082,424090.9902394338,637150.313507189,0,24,0 +m_44,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,520758.58072309656,442240.03782261244,58468.97701071167,48876.152807022154,0.32787158749570966,1,579227.5577338082,491116.1906296346,637150.313507189,0,24,0 +m_44,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,520758.58072309656,401147.2163790973,58468.97701071167,72783.55269593708,0.23034470730582446,1,579227.5577338082,473930.7690750344,637150.313507189,0,24,0 +m_44,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,435369.2858404519,407736.4106703871,50302.39775287875,54220.142981736724,0.7165314162727827,1,485671.6835933307,461956.55365212384,611545.5948907583,0,24,0 +m_44,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,435369.2858404519,379504.5515099007,50302.39775287875,30446.42225410357,0.3691257493299521,1,485671.6835933307,409950.9737640043,611545.5948907583,0,24,0 +m_44,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,435369.2858404519,493375.94925288606,50302.39775287875,62574.591556894185,0.4872892572091536,1,485671.6835933307,555950.5408097802,611545.5948907583,0,24,0 +m_44,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,150322.29374910297,195772.7448046761,46900.62688175075,34924.98451987513,0.45644551326979665,1,197222.92063085374,230697.72932455124,291706.8100476143,0,24,0 +m_44,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,150322.29374910297,227870.4684020652,46900.62688175075,37317.54073212954,0.22622301020711716,1,197222.92063085374,265188.00913419476,291706.8100476143,0,24,0 +m_44,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,150322.29374910297,187595.7387219332,46900.62688175075,28585.42267095745,0.5159285988980875,1,197222.92063085374,216181.16139289064,291706.8100476143,0,24,0 +m_44,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,97212.60478924697,156769.1047067124,25827.71977625757,25480.8431849614,0.1317293500344712,1,123040.32456550453,182249.94789167377,303273.25690392713,0,24,0 +m_44,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,97212.60478924697,241969.3932534772,25827.71977625757,33733.56756827472,0.007350587453146781,0.17641409887552273,123040.32456550453,275702.9608217519,303273.25690392713,0,24,0 +m_44,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,97212.60478924697,181061.1133523565,25827.71977625757,18846.806528638594,0.02733581294838298,0.6013878848644256,123040.32456550453,199907.9198809951,303273.25690392713,0,24,0 +m_45,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,226597.130556835,284262.8618738064,45092.41466679766,46643.74059295141,0.39735235957382187,1,271689.54522363265,330906.6024667578,523098.1299212722,0,24,0 +m_45,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,226597.130556835,225757.13166774675,45092.41466679766,37689.07816233234,0.988933649408818,1,271689.54522363265,263446.2098300791,523098.1299212722,0,24,0 +m_45,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,226597.130556835,436322.73558207724,45092.41466679766,39221.01889180653,0.007289869589822434,0.1749568701557384,271689.54522363265,475543.7544738838,523098.1299212722,0,24,0 +m_45,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,80051.72893601836,130023.30121805125,14630.376643195581,45188.69768228077,0.33304316388823907,1,94682.10557921394,175211.99890033202,192733.19879036525,0,23,0 +m_45,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,80051.72893601836,53353.1482851411,14630.376643195581,12111.470722630276,0.19357061013622603,1,94682.10557921394,65464.619007771376,192733.19879036525,0,23,0 +m_45,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,80051.72893601836,71077.19825681245,14630.376643195581,16599.40881305341,0.6937121364882299,1,94682.10557921394,87676.60706986586,192733.19879036525,0,23,0 +m_45,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,98243.61846385222,71933.61353143683,22162.274998528534,18045.051151254036,0.3835983252617209,1,120405.89346238076,89978.66468269087,132446.48280861884,0,24,0 +m_45,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,98243.61846385222,73790.34308180146,22162.274998528534,36769.62181311812,0.5879047152036907,1,120405.89346238076,110559.96489491958,132446.48280861884,0,24,0 +m_45,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,98243.61846385222,53014.23690786117,22162.274998528534,11015.704417986486,0.11796186153296492,1,120405.89346238076,64029.941325847656,132446.48280861884,0,24,0 +m_45,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,62941.57202670208,48453.668206829054,12177.601277264888,4822.673197656799,0.3167629895079398,1,75119.17330396696,53276.34140448585,98584.28998146858,0,24,0 +m_45,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,62941.57202670208,66218.66962334144,12177.601277264888,6982.5540104839965,0.822588623418642,1,75119.17330396696,73201.22363382543,98584.28998146858,0,24,0 +m_45,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,62941.57202670208,72009.08863680737,12177.601277264888,17612.993164527696,0.6824764687976672,1,75119.17330396696,89622.08180133507,98584.28998146858,0,24,0 +m_45,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,138559.57143269133,92173.13175352229,19678.166563112063,14985.52734105047,0.09229883905580465,1,158237.73799580339,107158.65909457277,174061.51179538373,0,24,0 +m_45,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,138559.57143269133,116183.2388063948,19678.166563112063,18061.87932411333,0.4218931527251325,1,158237.73799580339,134245.11813050814,174061.51179538373,0,24,0 +m_45,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,138559.57143269133,92313.20541100742,19678.166563112063,22540.432562904676,0.15379282125453625,1,158237.73799580339,114853.6379739121,174061.51179538373,0,24,0 +m_45,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,108360.60770386591,96828.4281268758,23223.277513371053,22763.84882575475,0.7302385254882358,1,131583.88521723697,119592.27695263055,159247.17928251578,0,24,0 +m_45,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,108360.60770386591,82219.4312824168,23223.277513371053,10859.101583883868,0.3414231046438974,1,131583.88521723697,93078.53286630067,159247.17928251578,0,24,0 +m_45,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,108360.60770386591,125587.40470733888,23223.277513371053,19182.758276766355,0.5804506988829973,1,131583.88521723697,144770.16298410523,159247.17928251578,0,24,0 +m_45,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,25140.243395396956,33967.93582596893,10033.280157173811,7606.049044657943,0.5003436942734889,1,35173.52355257077,41573.984870626875,49394.331184290444,0,24,0 +m_45,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,25140.243395396956,38010.34467651103,10033.280157173811,6893.592763753008,0.3183722387925154,1,35173.52355257077,44903.93744026404,49394.331184290444,0,24,0 +m_45,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,25140.243395396956,32208.14720394007,10033.280157173811,6325.007769229416,0.566879428217278,1,35173.52355257077,38533.15497316948,49394.331184290444,0,24,0 +m_45,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,14728.399701289269,24042.333526245122,3628.16762013599,3562.382091268722,0.09690693698717102,1,18356.56732142526,27604.715617513844,52857.95894495413,0,24,0 +m_45,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,14728.399701289269,40714.98899658112,3628.16762013599,7337.700953377169,0.014745618246835608,0.33741487004229437,18356.56732142526,48052.689949958294,52857.95894495413,0,24,0 +m_45,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,14728.399701289269,28973.111660131446,3628.16762013599,3173.635261521603,0.014670211740969321,0.33741487004229437,18356.56732142526,32146.746921653048,52857.95894495413,0,24,0 +m_46,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,24097.880792980974,19886.10725581702,4370.611311768067,3853.790700481076,0.4891688147549068,1,28468.492104749042,23739.897956298097,39846.73820241175,0,24,0 +m_46,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,24097.880792980974,24428.183011618305,4370.611311768067,3528.3073834338975,0.9545257467150969,1,28468.492104749042,27956.490395052202,39846.73820241175,0,24,0 +m_46,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,24097.880792980974,31717.488911878874,4370.611311768067,4506.818544859076,0.255948891398609,1,28468.492104749042,36224.30745673795,39846.73820241175,0,24,0 +m_46,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,5327.213035256437,8228.682166498624,940.977688794969,2030.3048890352393,0.23557614627229287,1,6268.1907240514065,10258.987055533864,11284.885761087251,0,23,0 +m_46,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,5327.213035256437,7665.480494616647,940.977688794969,2003.5971038254877,0.33326000277402273,1,6268.1907240514065,9669.077598442134,11284.885761087251,0,23,0 +m_46,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,5327.213035256437,5500.476755411776,940.977688794969,1025.2209199872111,0.9033981621123168,1,6268.1907240514065,6525.6976753989875,11284.885761087251,0,23,0 +m_46,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,11902.281577834136,7599.575824944533,5847.987979500483,2653.8355604614917,0.5293799179359104,1,17750.269557334617,10253.411385406025,19525.296513068082,0,24,0 +m_46,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,11902.281577834136,8515.765417817043,5847.987979500483,5242.7590029631865,0.6778502527341317,1,17750.269557334617,13758.52442078023,19525.296513068082,0,24,0 +m_46,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,11902.281577834136,5375.073331171296,5847.987979500483,861.1402481881362,0.3290456389447058,1,17750.269557334617,6236.213579359432,19525.296513068082,0,24,0 +m_46,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,3575.9352491809864,2620.971055806641,829.2802442309471,475.5128840440988,0.3535271070603958,1,4405.2154934119335,3096.4839398507397,4987.679695538445,0,24,0 +m_46,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,3575.9352491809864,2332.6916090163095,829.2802442309471,611.6148508093858,0.2633251268798988,1,4405.2154934119335,2944.306459825695,4987.679695538445,0,24,0 +m_46,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,3575.9352491809864,3572.664400910962,829.2802442309471,961.5898677603517,0.9980009947161538,1,4405.2154934119335,4534.254268671313,4987.679695538445,0,24,0 +m_46,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,180207.2007030618,132663.0153838137,33695.08193474855,23082.06700878822,0.27482828531013476,1,213902.28263781033,155745.08239260194,296201.22474798147,0,24,0 +m_46,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,180207.2007030618,122789.63019449406,33695.08193474855,24636.947044801804,0.20166648416129732,1,213902.28263781033,147426.57723929588,296201.22474798147,0,24,0 +m_46,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,180207.2007030618,189199.4699739695,33695.08193474855,80074.37070601364,0.9205820409677681,1,213902.28263781033,269273.84067998314,296201.22474798147,0,24,0 +m_46,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,45540.564148331985,46317.92720022367,8327.62141907961,7436.526538185361,0.9458806223226321,1,53868.185567411594,53754.45373840903,59595.87790203614,0,24,0 +m_46,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,45540.564148331985,41979.7132379804,8327.62141907961,5991.57538271555,0.7364281024701248,1,53868.185567411594,47971.28862069595,59595.87790203614,0,24,0 +m_46,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,45540.564148331985,48738.83887591883,8327.62141907961,5439.231944114023,0.7554662202545811,1,53868.185567411594,54178.07082003285,59595.87790203614,0,24,0 +m_46,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,15102.432091624176,21803.676345404496,2972.2133726253487,1890.8493912558029,0.09156763252885568,1,18074.645464249523,23694.5257366603,32808.55236635254,0,24,0 +m_46,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,15102.432091624176,25462.096078188588,2972.2133726253487,4363.860618495537,0.08203410360557432,1,18074.645464249523,29825.956696684123,32808.55236635254,0,24,0 +m_46,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,15102.432091624176,13168.646702559021,2972.2133726253487,1015.5547021669108,0.5601839428915596,1,18074.645464249523,14184.201404725933,32808.55236635254,0,24,0 +m_46,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,12966.336321671553,13289.96190849446,2837.5669593664848,1559.803026326182,0.9229184182159555,1,15803.903281038038,14849.764934820643,18480.69458111891,0,24,0 +m_46,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,12966.336321671553,14898.134765607152,2837.5669593664848,1902.4966717736734,0.5859815875320709,1,15803.903281038038,16800.631437380827,18480.69458111891,0,24,0 +m_46,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,12966.336321671553,10720.592205216675,2837.5669593664848,1072.0303080229967,0.48535282165134075,1,15803.903281038038,11792.622513239672,18480.69458111891,0,24,0 +m_47,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,571.1451956066917,421.247712518095,105.29522992727715,45.87557014231255,0.24375640234933457,1,676.4404255339689,467.12328266040754,744.0844680873658,0,24,0 +m_47,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,571.1451956066917,602.9132734504367,105.29522992727715,52.94395296651477,0.7965775297391242,1,676.4404255339689,655.8572264169514,744.0844680873658,0,24,0 +m_47,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,571.1451956066917,506.25172866858725,105.29522992727715,84.03107685186917,0.6427723179396878,1,676.4404255339689,590.2828055204565,744.0844680873658,0,24,0 +m_47,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,183.71193195612364,179.46334794866888,23.99727646814883,29.046432649858694,0.9125281380229308,1,207.70920842427248,208.50978059852758,229.36075865838035,0,24,0 +m_47,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,183.71193195612364,139.26182217392468,23.99727646814883,30.649663016915667,0.2815872887710984,1,207.70920842427248,169.91148519084035,229.36075865838035,0,24,0 +m_47,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,183.71193195612364,175.1439095537415,23.99727646814883,28.422458562761605,0.8226038856857095,1,207.70920842427248,203.5663681165031,229.36075865838035,0,24,0 +m_47,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,252.38138876651848,150.47674687613596,105.72407447783985,17.114279970991262,0.3927236509710085,1,358.10546324435836,167.59102684712724,393.9160095687942,0,24,0 +m_47,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,252.38138876651848,184.49936415688956,105.72407447783985,88.94984831471673,0.6367783479805696,1,358.10546324435836,273.4492124716063,393.9160095687942,0,24,0 +m_47,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,252.38138876651848,164.7523230304301,105.72407447783985,26.821922684203415,0.46191097912283624,1,358.10546324435836,191.5742457146335,393.9160095687942,0,24,0 +m_47,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,103.34580193186551,80.52035193055774,24.5687162311936,14.109018696781549,0.44887749726669834,1,127.91451816305911,94.62937062733928,140.70596997936502,0,24,0 +m_47,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,103.34580193186551,62.79730101660095,24.5687162311936,4.537710784253308,0.17535242482968563,1,127.91451816305911,67.33501180085426,140.70596997936502,0,24,0 +m_47,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,103.34580193186551,89.00826483471738,24.5687162311936,19.257982798527898,0.6582388868681277,1,127.91451816305911,108.26624763324529,140.70596997936502,0,24,0 +m_47,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1790.5832878371598,1125.997201419136,363.94657171478934,204.71261256777004,0.15074214111881648,1,2154.529859551949,1330.709813986906,2864.468855837934,0,24,0 +m_47,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1790.5832878371598,979.3167178340652,363.94657171478934,85.00210040023245,0.076723860024159235,1,2154.529859551949,1064.3188182342976,2864.468855837934,0,24,0 +m_47,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1790.5832878371598,1935.069710719957,363.94657171478934,668.9928854963466,0.8544218787361093,1,2154.529859551949,2604.0625962163035,2864.468855837934,0,24,0 +m_47,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,544.0912951545876,492.37115325179207,112.1122990547292,27.957154512433174,0.6711641471499467,1,656.2035942093167,520.3283077642252,721.8239536302485,0,24,0 +m_47,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,544.0912951545876,479.5453446645997,112.1122990547292,32.44359617061405,0.6007795015541673,1,656.2035942093167,511.9889408352138,721.8239536302485,0,24,0 +m_47,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,544.0912951545876,535.0122029291007,112.1122990547292,41.954542536699506,0.9418672912450845,1,656.2035942093167,576.9667454658002,721.8239536302485,0,24,0 +m_47,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,258.95508700861023,361.96852778241134,20.26642976279649,54.477960287597185,0.12394141704824868,1,279.22151677140675,416.4464880700085,506.7350497965691,0,24,0 +m_47,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,258.95508700861023,379.36213094509736,20.26642976279649,81.3060961426927,0.20399544032814962,1,279.22151677140675,460.66822708779006,506.7350497965691,0,24,0 +m_47,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,258.95508700861023,292.4790246932459,20.26642976279649,54.170906107227324,0.5820698814646263,1,279.22151677140675,346.6499308004732,506.7350497965691,0,24,0 +m_47,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,211.8154700640626,331.53149386707787,33.88275703559322,33.72106970677076,0.031213910595664137,0.7491338542959393,245.6982270996558,365.25256357384865,401.7778199312335,0,24,0 +m_47,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,211.8154700640626,300.89397796478204,33.88275703559322,35.276344540300634,0.09863697456700891,1,245.6982270996558,336.17032250508265,401.7778199312335,0,24,0 +m_47,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,211.8154700640626,228.94159770671075,33.88275703559322,40.600175332812846,0.7529251371292183,1,245.6982270996558,269.5417730395236,401.7778199312335,0,24,0 +m_48,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,180.79939202426908,144.82653676796073,42.99786618830535,30.10041618501992,0.5138652273587119,1,223.79725821257443,174.92695295298066,246.1769840338319,0,24,0 +m_48,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,180.79939202426908,157.7682814046583,42.99786618830535,17.46379542899953,0.6395600712630936,1,223.79725821257443,175.23207683365783,246.1769840338319,0,24,0 +m_48,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,180.79939202426908,72.07816646199826,42.99786618830535,22.182946779922016,0.06520446266133666,1,223.79725821257443,94.26111324192028,246.1769840338319,0,24,0 +m_48,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,62.19449585993739,66.80431792460278,17.84185066399914,12.213774678437325,0.8360043018800032,1,80.03634652393653,79.01809260304012,113.7883907982064,0,24,0 +m_48,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,62.19449585993739,88.4964322631919,17.84185066399914,14.947559371541178,0.28563191336085214,1,80.03634652393653,103.44399163473308,113.7883907982064,0,24,0 +m_48,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,62.19449585993739,49.15337421826938,17.84185066399914,5.7916242837433565,0.5127547480744066,1,80.03634652393653,54.94499850201274,113.7883907982064,0,24,0 +m_48,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,72.34547947511997,93.80316647807537,19.86735837781151,19.36327765782341,0.45945008941086696,1,92.21283785293149,113.16644413589879,124.48308854948867,0,24,0 +m_48,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,72.34547947511997,57.47974009777483,19.86735837781151,12.680005942041939,0.548831254909415,1,92.21283785293149,70.15974603981677,124.48308854948867,0,24,0 +m_48,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,72.34547947511997,39.59421351979975,19.86735837781151,7.609892765900142,0.18241357412775286,1,92.21283785293149,47.20410628569989,124.48308854948867,0,24,0 +m_48,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,76.10596635595309,73.44165392344676,10.10604464294624,11.258782770705135,0.8641110120430446,1,86.21201099889933,84.7004366941519,94.83321209878928,0,24,0 +m_48,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,76.10596635595309,65.53663085616029,10.10604464294624,11.057692337002875,0.49832582120615154,1,86.21201099889933,76.59432319316316,94.83321209878928,0,24,0 +m_48,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,76.10596635595309,28.13972390176337,10.10604464294624,9.65807613527756,0.007769369565923039,0.17092613045030686,86.21201099889933,37.79780003704093,94.83321209878928,0,24,0 +m_48,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3485.26374561209,3530.8004998499005,588.6494932847331,361.47800424743315,0.9490007851914938,1,4073.9132388968233,3892.2785040973336,5518.41173600197,0,24,0 +m_48,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3485.26374561209,4746.832138113214,588.6494932847331,269.90580370675923,0.09234228397407519,1,4073.9132388968233,5016.737941819973,5518.41173600197,0,24,0 +m_48,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3485.26374561209,4531.7634426908035,588.6494932847331,304.5637283191974,0.1555117142542605,1,4073.9132388968233,4836.327171010001,5518.41173600197,0,24,0 +m_48,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,2414.127925275274,3130.6451723227597,213.82074150808396,223.88880744318766,0.043233231533958506,0.8646646306791701,2627.9486667833576,3354.533979765947,4453.149859972168,0,24,0 +m_48,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,2414.127925275274,3829.055243801546,213.82074150808396,219.26281071860635,9.521464275929729e-4,0.02189936783463838,2627.9486667833576,4048.3180545201526,4453.149859972168,0,24,0 +m_48,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2414.127925275274,2989.3855648452513,213.82074150808396,276.5777861788451,0.13282195400722663,1,2627.9486667833576,3265.9633510240965,4453.149859972168,0,24,0 +m_48,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2034.9557004707856,2508.0952610979225,394.24569194948816,277.23326923930864,0.3519764263409624,1,2429.201392420274,2785.3285303372313,3446.74606415608,0,24,0 +m_48,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2034.9557004707856,2603.834125287364,394.24569194948816,316.30182409052793,0.2878651206657731,1,2429.201392420274,2920.135949377892,3446.74606415608,0,24,0 +m_48,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2034.9557004707856,2818.5741436763637,394.24569194948816,314.8313691927996,0.15291760592678902,1,2429.201392420274,3133.4055128691634,3446.74606415608,0,24,0 +m_48,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,1382.686999693948,2241.2848768825834,227.40385368234428,150.19203057815167,0.012291158338804488,0.25811432511489424,1610.0908533762924,2391.476907460735,5017.98405350778,0,24,0 +m_48,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1382.686999693948,4233.9782677133435,227.40385368234428,327.8254172937288,5.679756620251383e-5,0.0013631415888603318,1610.0908533762924,4561.803685007072,5017.98405350778,0,24,0 +m_48,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1382.686999693948,2995.919427795447,227.40385368234428,706.7828496107632,0.07259797921414213,1,1610.0908533762924,3702.70227740621,5017.98405350778,0,24,0 +m_49,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,30.311166099980152,33.398850208765374,1.8936498834961677,2.70313888083216,0.375206385645949,1,32.20481598347632,36.10198908959754,39.7121879985573,0,24,0 +m_49,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,30.311166099980152,28.871305570623758,1.8936498834961677,1.8117674112994946,0.5964138637783973,1,32.20481598347632,30.683072981923253,39.7121879985573,0,24,0 +m_49,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,30.311166099980152,32.65649558990521,1.8936498834961677,1.131036072329997,0.32455220206216806,1,32.20481598347632,33.78753166223521,39.7121879985573,0,24,0 +m_49,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,32.8819090732966,30.395299208770865,0.765739900736001,0.7505700099983096,0.04285064798115153,0.9427142555853336,33.6476489740326,31.145869218769175,37.01241387143586,0,24,0 +m_49,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,32.8819090732966,31.115720808020786,0.765739900736001,1.330941427049069,0.2833339536899729,1,33.6476489740326,32.44666223506985,37.01241387143586,0,24,0 +m_49,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,32.8819090732966,30.696003506200512,0.765739900736001,0.33829968544415506,0.03538997104103984,0.8139693339439162,33.6476489740326,31.034303191644668,37.01241387143586,0,24,0 +m_49,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,32.71790847271539,30.676809740752475,0.72073914634422,0.8426547391753608,0.09885883609473614,1,33.438647619059616,31.519464479927837,36.78251238096558,0,24,0 +m_49,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,32.71790847271539,27.675319992045768,0.72073914634422,2.6168371055965864,0.12731766607785555,1,33.438647619059616,30.292157097642356,36.78251238096558,0,24,0 +m_49,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,32.71790847271539,29.857572011994893,0.72073914634422,1.3083857010071789,0.09367534104258492,1,33.438647619059616,31.165957713002072,36.78251238096558,0,24,0 +m_49,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,30.899530320120164,32.8950029584712,1.3952724146778255,0.8953583760781144,0.2677350668224484,1,32.29480273479799,33.79036133454932,37.16939746800425,0,24,0 +m_49,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,30.899530320120164,29.16919185370727,1.3952724146778255,1.405632608249045,0.4052496519832557,1,32.29480273479799,30.574824461956318,37.16939746800425,0,24,0 +m_49,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,30.899530320120164,31.290967134183816,1.3952724146778255,0.6802373851836723,0.8095152018163077,1,32.29480273479799,31.97120451936749,37.16939746800425,0,24,0 +m_49,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,31.118867348471323,31.05175807702952,0.46462642631430595,0.24690618121433036,0.9018113665374452,1,31.58349377478563,31.29866425824385,35.71808415014034,0,24,0 +m_49,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,31.118867348471323,30.90491269540312,0.46462642631430595,0.26963480988828675,0.7008106493438636,1,31.58349377478563,31.174547505291407,35.71808415014034,0,24,0 +m_49,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,31.118867348471323,31.780378627050712,0.46462642631430595,0.6906069639859611,0.44776464732508003,1,31.58349377478563,32.47098559103667,35.71808415014034,0,24,0 +m_49,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,32.9685979979179,32.39300955579721,0.5664021384676312,0.8267375293716178,0.5800380275955455,1,33.53500013638553,33.21974708516883,36.888500150024086,0,24,0 +m_49,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,32.9685979979179,32.33210189818704,0.5664021384676312,1.0480586526006792,0.6082408151232688,1,33.53500013638553,33.38016055078772,36.888500150024086,0,24,0 +m_49,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,32.9685979979179,31.949349580695184,0.5664021384676312,0.8849140111922915,0.35876235729344474,1,33.53500013638553,32.83426359188748,36.888500150024086,0,24,0 +m_49,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,31.204462508111313,31.962713661367907,0.5601016076226313,1.008157096307569,0.529758944349642,1,31.764564115733943,32.97087075767548,36.26795783344303,0,24,0 +m_49,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,31.204462508111313,30.91688012644037,0.5601016076226313,0.4403401799076509,0.6954372777204139,1,31.764564115733943,31.35722030634802,36.26795783344303,0,24,0 +m_49,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,31.204462508111313,31.373212033018255,0.5601016076226313,0.4996660638680075,0.8267015657296143,1,31.764564115733943,31.872878096886264,36.26795783344303,0,24,0 +m_49,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,31.68183515511672,33.43211205020406,0.38640549073178876,0.5466731336926611,0.028067242793428527,0.6736138270422847,32.068240645848505,33.978785183896726,37.3766637022864,0,24,0 +m_49,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,31.68183515511672,31.965130416808037,0.38640549073178876,0.8712644564781765,0.7750445453571441,1,32.068240645848505,32.83639487328622,37.3766637022864,0,24,0 +m_49,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,31.68183515511672,32.351251406585035,0.38640549073178876,0.9261911778396356,0.5270767504005386,1,32.068240645848505,33.27744258442467,37.3766637022864,0,24,0 +m_50,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,77.31509290712795,128.31854583351623,24.153930981745084,22.477429838021983,0.15768811535208838,1,101.46902388887304,150.7959756715382,165.87557323869203,0,24,0 +m_50,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,77.31509290712795,79.30646699272373,24.153930981745084,4.509561411553037,0.9390566439710915,1,101.46902388887304,83.81602840427676,165.87557323869203,0,24,0 +m_50,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,77.31509290712795,124.58594715982076,24.153930981745084,25.004424398632995,0.20719769956137682,1,101.46902388887304,149.59037155845377,165.87557323869203,0,24,0 +m_50,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,82.53517589691451,119.86983827113777,11.209195677693895,9.603433061936737,0.030400329411933352,0.6688072470625337,93.74437157460841,129.4732713330745,165.1408885024083,0,24,0 +m_50,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,82.53517589691451,138.9746783448548,11.209195677693895,11.15340211188001,0.005102472317548313,0.12245933562115952,93.74437157460841,150.1280804567348,165.1408885024083,0,24,0 +m_50,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,82.53517589691451,119.35883537215811,11.209195677693895,10.785993904650768,0.039500657220435,0.829513801629135,93.74437157460841,130.14482927680888,165.1408885024083,0,24,0 +m_50,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,90.26881905592867,132.28256724091707,22.810299286592475,23.314612633581714,0.2300966632148,1,113.07911834252116,155.59717987449878,204.0476114049559,0,24,0 +m_50,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,90.26881905592867,118.98522938337874,22.810299286592475,19.531727226062063,0.36758323010148325,1,113.07911834252116,138.5169566094408,204.0476114049559,0,24,0 +m_50,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,90.26881905592867,148.49469381196033,22.810299286592475,37.00313473799954,0.21692602026562502,1,113.07911834252116,185.49782854995988,204.0476114049559,0,24,0 +m_50,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,102.14043933131707,172.58699258525118,10.918358597856331,18.345252269151363,0.011003029743198294,0.25306968409356073,113.0587979291734,190.93224485440254,210.0254693398428,0,24,0 +m_50,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,102.14043933131707,146.03690354157746,10.918358597856331,17.766376658772394,0.06817039856618173,1,113.0587979291734,163.80328020034986,210.0254693398428,0,24,0 +m_50,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,102.14043933131707,141.28009328657538,10.918358597856331,14.771729292801227,0.0629571260622947,1,113.0587979291734,156.05182257937662,210.0254693398428,0,24,0 +m_50,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,8526.25982845922,8149.33291197157,638.0986757136295,682.9675837212528,0.6952745929734845,1,9164.35850417285,8832.300495692823,12664.48798117199,0,24,0 +m_50,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,8526.25982845922,7853.544285566985,638.0986757136295,480.25048012535063,0.4207588291715999,1,9164.35850417285,8333.794765692335,12664.48798117199,0,24,0 +m_50,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,8526.25982845922,10320.222229977298,638.0986757136295,1192.948661997236,0.22307883734585415,1,9164.35850417285,11513.170891974534,12664.48798117199,0,24,0 +m_50,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5615.659403862923,5606.811774303472,778.2231372417983,702.3518041575953,0.9934336493165938,1,6393.882541104721,6309.163578461067,9454.593926072994,0,24,0 +m_50,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5615.659403862923,6537.964919731821,778.2231372417983,1069.8219753535382,0.5030548326062514,1,6393.882541104721,7607.786895085359,9454.593926072994,0,24,0 +m_50,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5615.659403862923,7702.641124383403,778.2231372417983,892.4442629556812,0.1090224421870642,1,6393.882541104721,8595.085387339084,9454.593926072994,0,24,0 +m_50,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,4412.1170071922425,3889.5205923678923,395.66824530336413,464.9288583771535,0.4125329085574745,1,4807.785252495607,4354.449450745045,5288.563777745168,0,24,0 +m_50,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,4412.1170071922425,3821.4394367741593,395.66824530336413,773.6832578788135,0.5172385536616838,1,4807.785252495607,4595.122694652973,5288.563777745168,0,24,0 +m_50,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,4412.1170071922425,4176.00789966542,395.66824530336413,322.43380624957916,0.6539573903529379,1,4807.785252495607,4498.441705914999,5288.563777745168,0,24,0 +m_50,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,2995.2816068385046,4290.613658340917,227.28903159616723,484.72323925467015,0.04565492457955226,0.9130984915910452,3222.5706384346718,4775.336897595587,5828.881686279325,0,24,0 +m_50,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,2995.2816068385046,4655.481338451491,227.28903159616723,643.5020127115309,0.04949401891763281,0.9403863594350234,3222.5706384346718,5298.983351163022,5828.881686279325,0,24,0 +m_50,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2995.2816068385046,3885.5562064924006,227.28903159616723,659.3360985623759,0.24769261741313664,1,3222.5706384346718,4544.892305054776,5828.881686279325,0,24,0 +m_51,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,43.21860087402264,38.030443225069966,7.794198879809221,2.3643252588795884,0.5536322412261317,1,51.012799753831864,40.394768483949555,56.11407972921506,0,24,0 +m_51,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,43.21860087402264,36.43014305028413,7.794198879809221,5.87003115319063,0.5067630532842041,1,51.012799753831864,42.30017420347476,56.11407972921506,0,24,0 +m_51,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,43.21860087402264,45.248199439421825,7.794198879809221,3.232679537892605,0.8188384466762818,1,51.012799753831864,48.48087897731443,56.11407972921506,0,24,0 +m_51,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,41.10947661039426,42.774251256030226,3.4610423242009247,4.242796908232338,0.767572886864638,1,44.570518934595185,47.01704816426256,51.71875298068882,0,24,0 +m_51,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,41.10947661039426,36.42832022791259,3.4610423242009247,3.0195288105697164,0.3325726718079699,1,44.570518934595185,39.44784903848231,51.71875298068882,0,24,0 +m_51,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,41.10947661039426,35.82340041236597,3.4610423242009247,0.8153984106773294,0.1915523667890338,1,44.570518934595185,36.6387988230433,51.71875298068882,0,24,0 +m_51,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,47.074953579669376,40.90870829488114,5.6708393236808305,2.1366488323716823,0.35443386014219685,1,52.74579290335021,43.04535712725282,58.02037219368523,0,24,0 +m_51,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,47.074953579669376,30.057219451424956,5.6708393236808305,4.736124646002581,0.051210383802002685,1,52.74579290335021,34.793344097427536,58.02037219368523,0,24,0 +m_51,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,47.074953579669376,34.26398973937583,5.6708393236808305,4.037186624544912,0.10528602847064943,1,52.74579290335021,38.301176363920746,58.02037219368523,0,24,0 +m_51,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,35.73806763844074,36.777248088059345,4.256617285749501,2.938969151258715,0.8462022417684704,1,39.99468492419024,39.71621723931806,48.85500909567971,0,24,0 +m_51,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,35.73806763844074,34.01569151684135,4.256617285749501,3.960328981244079,0.7739893297331245,1,39.99468492419024,37.97602049808543,48.85500909567971,0,24,0 +m_51,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,35.73806763844074,42.044338020754594,4.256617285749501,2.3693066116815036,0.24041650812692228,1,39.99468492419024,44.413644632436096,48.85500909567971,0,24,0 +m_51,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,250.35790358286093,241.53277423356883,7.395111496186662,12.993755326154764,0.5714334582373124,1,257.7530150790476,254.5265295597236,306.3214655144496,0,24,0 +m_51,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,250.35790358286093,248.52591829226702,7.395111496186662,11.557780293579505,0.8968908227531014,1,257.7530150790476,260.08369858584655,306.3214655144496,0,24,0 +m_51,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,250.35790358286093,259.64528863170653,7.395111496186662,18.828770926883983,0.6610935542005536,1,257.7530150790476,278.4740595585905,306.3214655144496,0,24,0 +m_51,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,269.5734530668533,294.01258739373463,8.040972082471152,13.283166078739116,0.15309302657673518,1,277.61442514932446,307.29575347247373,338.02532881972115,0,24,0 +m_51,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,269.5734530668533,263.4809157249542,8.040972082471152,19.59733441312315,0.7824121018430688,1,277.61442514932446,283.07825013807735,338.02532881972115,0,24,0 +m_51,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,269.5734530668533,261.5304011417885,8.040972082471152,8.791079126406462,0.5150365058816824,1,277.61442514932446,270.321480268195,338.02532881972115,0,24,0 +m_51,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,279.3175813428644,262.7842324785183,17.526936830412293,10.851234834198605,0.44477556873958246,1,296.8445181732767,273.63546731271686,326.52896999060437,0,24,0 +m_51,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,279.3175813428644,266.04613396511877,17.526936830412293,14.23835526588111,0.5702933395838881,1,296.8445181732767,280.2844892309999,326.52896999060437,0,24,0 +m_51,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,279.3175813428644,254.0676921222444,17.526936830412293,9.357933467481098,0.24112985652172406,1,296.8445181732767,263.4256255897255,326.52896999060437,0,24,0 +m_51,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,271.6614200921023,266.700794863939,18.595369300628306,15.78027678748427,0.8430085298128052,1,290.2567893927306,282.4810716514233,319.28246833200365,0,24,0 +m_51,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,271.6614200921023,263.7974651154397,18.595369300628306,9.9237753598444165,0.7192240986613023,1,290.2567893927306,273.7212404752841,319.28246833200365,0,24,0 +m_51,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,271.6614200921023,262.7130002182521,18.595369300628306,16.02040500452264,0.7231821873718962,1,290.2567893927306,278.7334052227747,319.28246833200365,0,24,0 +m_52,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,164.69033579859368,175.34336500760702,7.858106343973116,10.401056200673596,0.43545158556070096,1,172.54844214256678,185.7444212082806,255.8928505220429,0,24,0 +m_52,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,164.69033579859368,183.20302653757687,7.858106343973116,10.638139176370322,0.1962015716933309,1,172.54844214256678,193.8411657139472,255.8928505220429,0,24,0 +m_52,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,164.69033579859368,219.25878384394494,7.858106343973116,13.371080267003112,0.008062203805623103,0.19349289133495448,172.54844214256678,232.62986411094806,255.8928505220429,0,24,0 +m_52,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,167.7025608127359,180.3636016893301,10.377501714734212,19.026724910612415,0.5757321383113436,1,178.08006252747012,199.3903265999425,224.2630103701382,0,24,0 +m_52,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,167.7025608127359,184.82330896121857,10.377501714734212,19.0521550116343,0.4535536635225501,1,178.08006252747012,203.87546397285288,224.2630103701382,0,24,0 +m_52,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,167.7025608127359,182.2503024029983,10.377501714734212,6.36421845272233,0.2651234835895894,1,178.08006252747012,188.61452085572063,224.2630103701382,0,24,0 +m_52,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,174.0566813877081,183.96900197925305,4.002371956823377,14.80338181371802,0.5430752142574063,1,178.05905334453146,198.77238379297108,221.2978397689389,0,24,0 +m_52,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,174.0566813877081,170.46733653801962,4.002371956823377,20.589107402996543,0.8718737285158845,1,178.05905334453146,191.05644394101617,221.2978397689389,0,24,0 +m_52,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,174.0566813877081,188.14582225779603,4.002371956823377,13.034032077602935,0.34179314203792693,1,178.05905334453146,201.17985433539897,221.2978397689389,0,24,0 +m_52,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,166.02715311669658,163.4137009798089,6.6149249137682515,15.774238692211506,0.8830934767682896,1,172.64207803046483,179.1879396720204,238.7699599286262,0,24,0 +m_52,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,166.02715311669658,152.79849716819007,6.6149249137682515,16.49199685530457,0.48252589901860454,1,172.64207803046483,169.29049402349463,238.7699599286262,0,24,0 +m_52,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,166.02715311669658,198.94681351295193,6.6149249137682515,18.1167864221628,0.13648863084250043,1,172.64207803046483,217.06359993511472,238.7699599286262,0,24,0 +m_52,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1813.8662527903357,1557.736777213171,182.121936697681,69.25080706220164,0.2336994832422137,1,1995.9881894880168,1626.9875842753727,2262.512087674139,0,24,0 +m_52,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1813.8662527903357,1586.2142348875382,182.121936697681,88.0465466287416,0.296459572301403,1,1995.9881894880168,1674.2607815162798,2262.512087674139,0,24,0 +m_52,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1813.8662527903357,1864.0688265276567,182.121936697681,192.7603440851968,0.8536497806473732,1,1995.9881894880168,2056.8291706128534,2262.512087674139,0,24,0 +m_52,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1614.4172016560733,1797.7465568120908,127.80386887185506,89.8988312118919,0.27088412711995685,1,1742.2210705279283,1887.6453880239828,2486.030433944885,0,24,0 +m_52,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1614.4172016560733,1733.2569298288108,127.80386887185506,129.30016163280928,0.528068623771935,1,1742.2210705279283,1862.55709146162,2486.030433944885,0,24,0 +m_52,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1614.4172016560733,1959.48561023531,127.80386887185506,300.5420569873123,0.3270355373106214,1,1742.2210705279283,2260.0276672226223,2486.030433944885,0,24,0 +m_52,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1661.828926022163,1676.3102911814774,51.51428135920491,44.17111064124349,0.8353975721151174,1,1713.3432073813678,1720.481401822721,2978.720099910177,0,24,0 +m_52,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1661.828926022163,2114.970609224803,51.51428135920491,592.9567543299033,0.48031395911486585,1,1713.3432073813678,2707.927363554706,2978.720099910177,0,24,0 +m_52,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1661.828926022163,1802.0113831465526,51.51428135920491,44.21897529603813,0.06648680328035236,1,1713.3432073813678,1846.2303584425906,2978.720099910177,0,24,0 +m_52,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1793.9624976146763,1834.600274522753,99.91816829149131,92.36515091406397,0.7713548364990739,1,1893.8806659061677,1926.965425436817,2380.748415387714,0,24,0 +m_52,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1793.9624976146763,1820.9540274856906,99.91816829149131,119.64903001879313,0.8660942606894282,1,1893.8806659061677,1940.6030575044838,2380.748415387714,0,24,0 +m_52,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1793.9624976146763,1963.5218825221314,99.91816829149131,200.79485873942647,0.47322479358775305,1,1893.8806659061677,2164.316741261558,2380.748415387714,0,24,0 +m_53,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,105.27113846800427,112.91316187604322,20.441906158730305,19.06662034901229,0.7909297503224315,1,125.71304462673457,131.97978222505552,214.84409410833425,0,24,0 +m_53,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,105.27113846800427,123.01412069004955,20.441906158730305,26.360364663048053,0.6079155078556513,1,125.71304462673457,149.3744853530976,214.84409410833425,0,24,0 +m_53,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,105.27113846800427,172.18035478999838,20.441906158730305,23.132458035759996,0.058362187563634725,1,125.71304462673457,195.31281282575839,214.84409410833425,0,24,0 +m_53,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,78.21432607771254,133.91932720327372,12.735767518661639,23.885944472952207,0.07529894691257977,1,90.95009359637419,157.80527167622594,173.58579884384855,0,24,0 +m_53,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,78.21432607771254,100.64100289934682,12.735767518661639,30.81173483623707,0.5238043277967379,1,90.95009359637419,131.4527377355839,173.58579884384855,0,24,0 +m_53,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,78.21432607771254,105.83516762159057,12.735767518661639,18.895185336360825,0.25711136101336657,1,90.95009359637419,124.7303529579514,173.58579884384855,0,24,0 +m_53,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,61.08471527662082,109.10940751134858,13.038172838579207,38.05509344964584,0.2766325237817256,1,74.12288811520003,147.16450096099442,257.6749833141624,0,24,0 +m_53,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,61.08471527662082,76.22219413801992,13.038172838579207,23.331238909680494,0.5908052200799955,1,74.12288811520003,99.55343304770041,257.6749833141624,0,24,0 +m_53,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,61.08471527662082,180.3496858223539,13.038172838579207,53.90029900870277,0.07848493138166723,1,74.12288811520003,234.24998483105668,257.6749833141624,0,24,0 +m_53,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,59.13775760336051,102.50640264872857,10.719792940622634,32.282530015576384,0.24894175638423038,1,69.85755054398315,134.78893266430495,237.93212831838758,0,24,0 +m_53,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,59.13775760336051,99.11857438344218,10.719792940622634,26.735019728024294,0.21066400243559644,1,69.85755054398315,125.85359411146648,237.93212831838758,0,24,0 +m_53,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,59.13775760336051,158.23273161459008,10.719792940622634,58.06920322030771,0.15043325066885802,1,69.85755054398315,216.3019348348978,237.93212831838758,0,24,0 +m_53,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,536.4000380099042,407.9168424493721,97.29360347310492,48.88710116014852,0.2746700503125397,1,633.6936414830091,456.8039436095206,697.06300563131,0,24,0 +m_53,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,536.4000380099042,484.2607910938652,97.29360347310492,49.21519779759963,0.6463127962258072,1,633.6936414830091,533.4759888914648,697.06300563131,0,24,0 +m_53,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,536.4000380099042,449.460533722379,97.29360347310492,71.91266421111837,0.4902235134627012,1,633.6936414830091,521.3731979334974,697.06300563131,0,24,0 +m_53,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,414.5629919813485,357.6792438866479,82.22217425907724,50.95227034357574,0.5720503673489726,1,496.7851662404257,408.6315142302236,546.4636828644683,0,24,0 +m_53,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,414.5629919813485,297.35923288166106,82.22217425907724,49.084920255348244,0.2551265006291822,1,496.7851662404257,346.4441531370093,546.4636828644683,0,24,0 +m_53,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,414.5629919813485,294.4287030774253,82.22217425907724,33.72507703196661,0.22069877686743433,1,496.7851662404257,328.15378010939196,546.4636828644683,0,24,0 +m_53,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,342.94834754763644,235.17356877783234,34.27814032731295,43.205812035797145,0.08069786985790425,1,377.2264878749494,278.3793808136295,509.8652668819559,0,24,0 +m_53,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,342.94834754763644,387.7644520184833,34.27814032731295,75.74942696511289,0.6066660157058316,1,377.2264878749494,463.5138789835962,509.8652668819559,0,24,0 +m_53,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,342.94834754763644,289.98532024706543,34.27814032731295,29.920119596382772,0.2719091904781531,1,377.2264878749494,319.9054398434482,509.8652668819559,0,24,0 +m_53,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,238.79765196261823,330.5385383775161,28.706434147883378,49.559279576673205,0.14778916110423754,1,267.5040861105016,380.0978179541893,496.98118704174107,0,24,0 +m_53,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,238.79765196261823,382.5321865045217,28.706434147883378,69.26889262433374,0.098840088941349,1,267.5040861105016,451.80107912885546,496.98118704174107,0,24,0 +m_53,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,238.79765196261823,246.42985953159248,28.706434147883378,44.436865314283665,0.8886296105641713,1,267.5040861105016,290.86672484587615,496.98118704174107,0,24,0 +m_54,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,611.689715076907,576.134396765258,81.39744518979091,80.44048739685573,0.7632151512798725,1,693.0871602666979,656.5748841621137,1020.7705707256738,0,24,0 +m_54,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,611.689715076907,788.514035113886,81.39744518979091,116.56597149805276,0.24669370000099772,1,693.0871602666979,905.0800066119389,1020.7705707256738,0,24,0 +m_54,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,611.689715076907,843.024961321354,81.39744518979091,84.94828479289478,0.08097565966209483,1,693.0871602666979,927.9732461142488,1020.7705707256738,0,24,0 +m_54,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,342.74953982550335,670.9923592349573,20.517941008645305,179.09240555890173,0.1267652422160036,1,363.26748083414867,850.0847647938591,935.0932412732451,0,24,0 +m_54,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,342.74953982550335,473.7235947078468,20.517941008645305,42.08186152969832,0.025684286887342755,0.5646359290377574,363.26748083414867,515.8054562375452,935.0932412732451,0,24,0 +m_54,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,342.74953982550335,569.9364426503513,20.517941008645305,76.54779630148333,0.03015519662971793,0.6031039325943586,363.26748083414867,646.4842389518346,935.0932412732451,0,24,0 +m_54,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,473.984189025494,564.7854356736706,162.07613472203354,98.25448093349452,0.6470096508171277,1,636.0603237475275,663.0399166071651,882.139202272513,0,24,0 +m_54,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,473.984189025494,559.2274526775557,162.07613472203354,121.33080564693921,0.6856687698473434,1,636.0603237475275,680.5582583244949,882.139202272513,0,24,0 +m_54,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,473.984189025494,712.2669287347202,162.07613472203354,89.67780060392798,0.2432246598961257,1,636.0603237475275,801.9447293386481,882.139202272513,0,24,0 +m_54,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,386.8144501381946,534.4673895400695,90.83569199979122,78.49916155354083,0.2519230291537279,1,477.6501421379858,612.9665510936103,1343.6822699437125,0,24,0 +m_54,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,386.8144501381946,405.14517960244115,90.83569199979122,58.57729332410159,0.8700964238937671,1,477.6501421379858,463.72247292654276,1343.6822699437125,0,24,0 +m_54,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,386.8144501381946,968.3011012628718,90.83569199979122,253.228235049594,0.07218231267929662,1,477.6501421379858,1221.5293363124658,1343.6822699437125,0,24,0 +m_54,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,18003.99538067502,13138.461463306387,2660.339385067128,843.7455624951331,0.1319352496368836,1,20664.334765742147,13982.20702580152,23867.747104663562,0,24,0 +m_54,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,18003.99538067502,13765.826378179738,2660.339385067128,1177.8659625916198,0.18922392583445097,1,20664.334765742147,14943.692340771358,23867.747104663562,0,24,0 +m_54,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,18003.99538067502,16884.678361761282,2660.339385067128,4813.273551569227,0.8439346808156253,1,20664.334765742147,21697.951913330508,23867.747104663562,0,24,0 +m_54,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,10947.630823279702,8747.62926890668,1491.449661984344,703.9838859686865,0.22329493516490626,1,12439.080485264047,9451.613154875366,13682.988533790452,0,24,0 +m_54,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,10947.630823279702,8213.725200130888,1491.449661984344,682.2909661571836,0.13944014384766443,1,12439.080485264047,8896.016166288071,13682.988533790452,0,24,0 +m_54,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,10947.630823279702,9163.52495872178,1491.449661984344,1481.7299605186345,0.4159463242744369,1,12439.080485264047,10645.254919240415,13682.988533790452,0,24,0 +m_54,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,7729.957270105573,5788.122863734981,387.4014765281681,335.38280256071357,0.0036763587136518206,0.08455625041399187,8117.358746633741,6123.505666295695,8929.094621297116,0,24,0 +m_54,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,7729.957270105573,6866.704948176155,387.4014765281681,590.2837834353825,0.2537921035385813,1,8117.358746633741,7456.988731611537,8929.094621297116,0,24,0 +m_54,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,7729.957270105573,5452.376783580949,387.4014765281681,232.69336827000342,9.321780154929154e-4,0.022372272371829968,8117.358746633741,5685.070151850953,8929.094621297116,0,24,0 +m_54,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,5555.372966797932,6805.2030258229215,370.19425146075554,332.57429677598816,0.031077070177157818,0.6031039325943586,5925.567218258688,7137.777322598909,9511.102912639031,0,24,0 +m_54,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,5555.372966797932,7895.247844668086,370.19425146075554,751.2093486401233,0.025665269501716242,0.5646359290377574,5925.567218258688,8646.45719330821,9511.102912639031,0,24,0 +m_54,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5555.372966797932,5554.437740915222,370.19425146075554,590.2516682790317,0.9989603126129905,1,5925.567218258688,6144.689409194254,9511.102912639031,0,24,0 +m_55,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,70.41497619545201,72.43322823440995,23.791165105713617,20.49417684963115,0.9502513464840827,1,94.20614130116563,92.9274050840411,126.56515217473554,0,24,0 +m_55,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,70.41497619545201,76.92489783749981,23.791165105713617,20.330348493679683,0.8401711341141905,1,94.20614130116563,97.25524633117949,126.56515217473554,0,24,0 +m_55,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,70.41497619545201,92.11601817189036,23.791165105713617,22.943211077869222,0.5282331059830135,1,94.20614130116563,115.05922924975958,126.56515217473554,0,24,0 +m_55,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,47.470326220221125,102.49858641556253,13.629897893794793,30.06958928121197,0.1396699783887055,1,61.100224114015916,132.5681756967745,145.82499326645194,0,24,0 +m_55,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,47.470326220221125,70.45331850700474,13.629897893794793,18.005402746091438,0.3345112672783034,1,61.100224114015916,88.45872125309617,145.82499326645194,0,24,0 +m_55,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,47.470326220221125,48.33990622345904,13.629897893794793,10.802321824915092,0.9611572782645659,1,61.100224114015916,59.14222804837413,145.82499326645194,0,24,0 +m_55,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,32.03252383585048,54.60804501025484,10.809363834453574,15.956502412782404,0.27352121109398764,1,42.84188767030406,70.56454742303724,170.83145351639126,0,24,0 +m_55,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,32.03252383585048,121.97324067330578,10.809363834453574,33.32808070523171,0.05185241414915589,1,42.84188767030406,155.3013213785375,170.83145351639126,0,24,0 +m_55,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,32.03252383585048,60.39593776207016,10.809363834453574,22.034285865852944,0.284838061744538,1,42.84188767030406,82.43022362792311,170.83145351639126,0,24,0 +m_55,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,84.54153084580483,81.82520318534272,20.007972188420048,9.27975070883756,0.9062107333225176,1,104.54950303422487,91.10495389418027,115.00445333764736,0,24,0 +m_55,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,84.54153084580483,75.8036816403513,20.007972188420048,24.592572819380134,0.7891228820215721,1,104.54950303422487,100.39625445973144,115.00445333764736,0,24,0 +m_55,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,84.54153084580483,29.261859365630194,20.007972188420048,6.714918264352049,0.04805546006060019,1,104.54950303422487,35.976777629982244,115.00445333764736,0,24,0 +m_55,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,92.23272827706609,95.06332077929525,25.835368148042647,18.70683181332238,0.931206767500709,1,118.06809642510873,113.77015259261763,256.2380083965797,0,24,0 +m_55,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,92.23272827706609,133.38021783153792,25.835368148042647,42.22049288285516,0.4291137621948219,1,118.06809642510873,175.60071071439307,256.2380083965797,0,24,0 +m_55,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,92.23272827706609,173.62617368184456,25.835368148042647,59.317470315046045,0.24967743941051343,1,118.06809642510873,232.94364399689061,256.2380083965797,0,24,0 +m_55,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,148.58380219496723,114.94402151427785,30.472616997912876,15.84100147621079,0.35779759439907477,1,179.0564191928801,130.78502299048864,207.08586092993784,0,24,0 +m_55,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,148.58380219496723,158.61397283816626,30.472616997912876,29.645900734504494,0.8182561475368209,1,179.0564191928801,188.25987357267076,207.08586092993784,0,24,0 +m_55,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,148.58380219496723,101.33086158441043,30.472616997912876,33.59811432326918,0.322279592004322,1,179.0564191928801,134.92897590767961,207.08586092993784,0,24,0 +m_55,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,152.72530124962003,103.85745890591298,33.92969293141009,30.60295373719614,0.3102367629739198,1,186.65499418103013,134.46041264310912,219.55454843019749,0,24,0 +m_55,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,152.72530124962003,163.858310163936,33.92969293141009,35.73673386351624,0.8258249324071748,1,186.65499418103013,199.59504402745225,219.55454843019749,0,24,0 +m_55,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,152.72530124962003,130.7363536370281,33.92969293141009,34.694617239177994,0.6601390416823376,1,186.65499418103013,165.4309708762061,219.55454843019749,0,24,0 +m_55,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,122.00200397429413,169.73162773282473,40.361253019503536,33.16636000062707,0.3831845653184308,1,162.36325699379768,202.8979877334518,267.4750366978405,0,24,0 +m_55,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,122.00200397429413,189.96407449785903,40.361253019503536,53.19504977290503,0.3344573858253099,1,162.36325699379768,243.15912427076407,267.4750366978405,0,24,0 +m_55,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,122.00200397429413,111.03672214083473,40.361253019503536,49.005230768857174,0.8664431794258887,1,162.36325699379768,160.0419529096919,267.4750366978405,0,24,0 +m_56,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,87.62373289528134,124.03748959682152,17.2383892758247,15.422814858215357,0.15155490081686138,1,104.86212217110604,139.46030445503686,289.780507578586,0,24,0 +m_56,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,87.62373289528134,208.83068634022564,17.2383892758247,54.60613873121618,0.07885762179896255,1,104.86212217110604,263.43682507144183,289.780507578586,0,24,0 +m_56,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,87.62373289528134,124.93123811003915,17.2383892758247,7.100341545789837,0.09807390070371265,1,104.86212217110604,132.03157965582898,289.780507578586,0,24,0 +m_56,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,130.90708250664247,152.88696993760126,22.294296272382745,17.96229072537822,0.46118074609771065,1,153.20137877902522,170.84926066297948,223.67915049913873,0,24,0 +m_56,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,130.90708250664247,163.3806943229054,22.294296272382745,39.96398794903889,0.4985042731100757,1,153.20137877902522,203.3446822719443,223.67915049913873,0,24,0 +m_56,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,130.90708250664247,154.825701692302,22.294296272382745,29.200027024293284,0.5306798911465626,1,153.20137877902522,184.0257287165953,223.67915049913873,0,24,0 +m_56,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,96.30112079815973,248.12646915914786,19.67178721097577,71.94230476789276,0.09014914604211115,1,115.9729080091355,320.06877392704064,352.07565131974474,0,24,0 +m_56,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,96.30112079815973,141.4084477948301,19.67178721097577,20.66414642910856,0.15261936564407888,1,115.9729080091355,162.07259422393867,352.07565131974474,0,24,0 +m_56,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,96.30112079815973,124.57889223564088,19.67178721097577,16.867501635335266,0.3054437785324171,1,115.9729080091355,141.44639387097615,352.07565131974474,0,24,0 +m_56,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,143.84455848940917,141.13328996835693,24.991053148545724,32.41358403150336,0.9486620734136522,1,168.83561163795488,173.54687399986028,385.58141339393893,0,24,0 +m_56,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,143.84455848940917,241.8795075897835,24.991053148545724,108.64905004107004,0.4158236413066784,1,168.83561163795488,350.5285576308535,385.58141339393893,0,24,0 +m_56,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,143.84455848940917,173.2783712562293,24.991053148545724,35.001879723138494,0.5117481801559983,1,168.83561163795488,208.2802509793678,385.58141339393893,0,24,0 +m_56,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2808.3753518095696,2561.660374775545,204.20887239730087,521.3838315990491,0.6737814603306469,1,3012.58422420687,3083.044206374594,4162.737100947869,0,24,0 +m_56,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,2808.3753518095696,1442.3747430266092,204.20887239730087,362.89809849595184,0.011421007156993998,0.27410417176785595,3012.58422420687,1805.272841522561,4162.737100947869,0,24,0 +m_56,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2808.3753518095696,3152.6042158412047,204.20887239730087,631.7022395659486,0.6225657933893878,1,3012.58422420687,3784.3064554071534,4162.737100947869,0,24,0 +m_56,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3375.8517486721166,3644.9628398243804,944.1624675073523,1085.3546445678742,0.8554168085032284,1,4320.014216179469,4730.317484392254,5930.786381785867,0,24,0 +m_56,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3375.8517486721166,2656.1193436085805,944.1624675073523,732.3256570069937,0.5611658339743215,1,4320.014216179469,3388.445000615574,5930.786381785867,0,24,0 +m_56,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3375.8517486721166,4476.134480121487,944.1624675073523,915.489503320209,0.42235825157900364,1,4320.014216179469,5391.6239834416965,5930.786381785867,0,24,0 +m_56,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6883.255846302736,3185.736906932534,2250.5967362366555,646.3367868218435,0.16692354067550605,1,9133.852582539392,3832.0736937543775,10047.237840793332,0,24,0 +m_56,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,6883.255846302736,2790.925898426943,2250.5967362366555,687.9821483039411,0.13332698310832575,1,9133.852582539392,3478.908046730884,10047.237840793332,0,24,0 +m_56,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6883.255846302736,2814.163903365561,2250.5967362366555,778.180115075422,0.13692488621023013,1,9133.852582539392,3592.344018440983,10047.237840793332,0,24,0 +m_56,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5334.764851653101,4530.895538770634,1826.103561159103,1683.779709759383,0.7529265225428408,1,7160.868412812204,6214.675248530017,7876.955254093425,0,24,0 +m_56,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5334.764851653101,2871.348051002945,1826.103561159103,689.5756330779817,0.2509998745483685,1,7160.868412812204,3560.9236840809267,7876.955254093425,0,24,0 +m_56,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5334.764851653101,3503.992749436699,1826.103561159103,538.2147127982793,0.3741917945277138,1,7160.868412812204,4042.2074622349783,7876.955254093425,0,24,0 +m_57,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,361.17496273220786,328.3572017067296,86.2874847020389,42.54790007418604,0.7448314105120571,1,447.46244743424677,370.90510178091563,492.2086921776715,0,24,0 +m_57,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,361.17496273220786,217.42335912861884,86.2874847020389,24.56392267031883,0.17435167167675059,1,447.46244743424677,241.98728179893766,492.2086921776715,0,24,0 +m_57,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,361.17496273220786,295.14571848301824,86.2874847020389,22.06155335390035,0.49511437296605004,1,447.46244743424677,317.2072718369186,492.2086921776715,0,24,0 +m_57,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,145.67395772099292,190.69288391526234,13.22715898088158,18.728018117485206,0.08120838792418028,1,158.90111670187449,209.42090203274756,230.36299223602234,0,24,0 +m_57,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,145.67395772099292,141.05925225105818,13.22715898088158,4.760809775705698,0.7533912160948718,1,158.90111670187449,145.82006202676388,230.36299223602234,0,24,0 +m_57,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,145.67395772099292,155.91459112854483,13.22715898088158,8.535253682536396,0.5324399737375178,1,158.90111670187449,164.44984481108122,230.36299223602234,0,24,0 +m_57,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,198.026734857116,179.10872808459482,31.580161574233752,30.125873032983538,0.6751425150347572,1,229.60689643134975,209.23460111757836,252.56758607448475,0,24,0 +m_57,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,198.026734857116,103.50048524737424,31.580161574233752,9.317359449088704,0.03765113956617721,0.903627349588253,229.60689643134975,112.81784469646294,252.56758607448475,0,24,0 +m_57,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,198.026734857116,178.0030740654061,31.580161574233752,24.44323741183724,0.6296752687274014,1,229.60689643134975,202.44631147724334,252.56758607448475,0,24,0 +m_57,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,159.70733471984832,158.74312883940246,15.331411736425597,18.09796684051949,0.9684639186725235,1,175.0387464562739,176.84109567992195,194.61264945477484,0,24,0 +m_57,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,159.70733471984832,127.86023911527406,15.331411736425597,17.628178056227224,0.20597824650403035,1,175.0387464562739,145.48841717150128,194.61264945477484,0,24,0 +m_57,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,159.70733471984832,159.18506148364028,15.331411736425597,17.73552892979136,0.98271293879694,1,175.0387464562739,176.92059041343165,194.61264945477484,0,24,0 +m_57,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,80410.2276443291,102259.62591869642,16767.31371776204,18830.05589601185,0.4067487426693047,1,97177.54136209114,121089.68181470827,151019.98621172403,0,24,0 +m_57,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,80410.2276443291,63937.160331373925,16767.31371776204,7281.611379090057,0.3982110696846038,1,97177.54136209114,71218.77171046399,151019.98621172403,0,24,0 +m_57,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,80410.2276443291,98515.82945741291,16767.31371776204,38775.06709869984,0.6814609125957432,1,97177.54136209114,137290.89655611274,151019.98621172403,0,24,0 +m_57,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,124896.7203757557,165055.92028685723,19018.024848730933,40269.169518515344,0.39664304963265423,1,143914.74522448663,205325.08980537258,225857.59878590985,0,24,0 +m_57,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,124896.7203757557,73751.7199281643,19018.024848730933,12824.120519580674,0.05347999629158193,1,143914.74522448663,86575.84044774497,225857.59878590985,0,24,0 +m_57,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,124896.7203757557,77153.56453025673,19018.024848730933,10492.498684494138,0.06008128395301296,1,143914.74522448663,87646.06321475087,225857.59878590985,0,24,0 +m_57,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,90727.13660269429,80043.72269614585,14094.819361657854,14007.536740121153,0.6025937127201146,1,104821.95596435214,94051.259436267,115304.15156078736,0,24,0 +m_57,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,90727.13660269429,62488.06528018351,14094.819361657854,12877.569143971687,0.1701478627800037,1,104821.95596435214,75365.6344241552,115304.15156078736,0,24,0 +m_57,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,90727.13660269429,70954.38604842544,14094.819361657854,8736.314848751208,0.2659067107857002,1,104821.95596435214,79690.70089717665,115304.15156078736,0,24,0 +m_57,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,82077.5827732141,81754.36499014238,20000.494074659207,13744.798443692345,0.9896686024314256,1,102078.07684787331,95499.16343383472,112285.88453266065,0,24,0 +m_57,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,82077.5827732141,41559.8786479968,20000.494074659207,5477.305231709902,0.10065500223799813,1,102078.07684787331,47037.183879706696,112285.88453266065,0,24,0 +m_57,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,82077.5827732141,67101.26279774959,20000.494074659207,13431.13566942338,0.5500365702703173,1,102078.07684787331,80532.39846717297,112285.88453266065,0,24,0 +m_58,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,82501.31696518448,201854.02871806346,17139.578005296567,49241.9347514685,0.06081895307790342,1,99640.89497048105,251095.96346953197,276205.5598164852,0,24,0 +m_58,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,82501.31696518448,154322.8604669282,17139.578005296567,44023.73923835023,0.17587470506258193,1,99640.89497048105,198346.5997052784,276205.5598164852,0,24,0 +m_58,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,82501.31696518448,217728.72179848675,17139.578005296567,7543.426051257734,5.130747737295432e-4,0.012313794569509037,99640.89497048105,225272.14784974448,276205.5598164852,0,24,0 +m_58,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,141960.05841440422,171880.14435739184,33659.46939388842,71462.57813067036,0.715909456694513,1,175619.52780829265,243342.7224880622,352305.41918732336,0,24,0 +m_58,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,141960.05841440422,204140.7595912829,33659.46939388842,64554.58789656025,0.4193857665865103,1,175619.52780829265,268695.34748784313,352305.41918732336,0,24,0 +m_58,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,141960.05841440422,245760.01989432695,33659.46939388842,74517.63391233064,0.24508103711449872,1,175619.52780829265,320277.6538066576,352305.41918732336,0,24,0 +m_58,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,386088.8723685524,203389.3601291343,38210.62614426083,81100.55700196732,0.08077495832115608,1,424299.4985128132,284489.9171311016,466729.44836409454,0,24,0 +m_58,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,386088.8723685524,178706.01472880953,38210.62614426083,43163.60091829967,0.007180538714397608,0.15797185171674738,424299.4985128132,221869.6156471092,466729.44836409454,0,24,0 +m_58,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,386088.8723685524,218472.298844521,38210.62614426083,99173.52431289709,0.1626301611555791,1,424299.4985128132,317645.82315741805,466729.44836409454,0,24,0 +m_58,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,170961.68742491837,335417.238912646,55731.317679269305,100373.92444203225,0.19158947828799186,1,226693.00510418767,435791.16335467825,523892.15081554,0,24,0 +m_58,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,170961.68742491837,165845.35150210987,55731.317679269305,25205.416273499814,0.9362387189566104,1,226693.00510418767,191050.76777560968,523892.15081554,0,24,0 +m_58,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,170961.68742491837,369493.4940520291,55731.317679269305,106772.0975984618,0.14090273381622004,1,226693.00510418767,476265.5916504909,523892.15081554,0,24,0 +m_58,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,405358.3256213049,307695.9825679605,35628.83446542029,39759.95776518195,0.09764453560160537,1,440987.1600867252,347455.94033314247,485085.87609539775,0,24,0 +m_58,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,405358.3256213049,373402.0539978783,35628.83446542029,26671.433799356444,0.49045245073523625,1,440987.1600867252,400073.48779723473,485085.87609539775,0,24,0 +m_58,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,405358.3256213049,335619.04745267465,35628.83446542029,32637.79826659068,0.17973911665960216,1,440987.1600867252,368256.84571926534,485085.87609539775,0,24,0 +m_58,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,327156.15189146384,249933.46491120633,30303.909341252107,28728.35862244916,0.09423226591705845,1,357460.06123271596,278661.8235336555,437720.22391277587,0,24,0 +m_58,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,327156.15189146384,297231.714974994,30303.909341252107,19416.10049985058,0.4284204122114166,1,357460.06123271596,316647.8154748446,437720.22391277587,0,24,0 +m_58,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,327156.15189146384,356205.4235216947,30303.909341252107,41722.0527626469,0.5867740660452513,1,357460.06123271596,397927.47628434165,437720.22391277587,0,24,0 +m_58,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,85003.77572834789,133291.274643902,25590.324402462436,18686.94542814718,0.16131593716234072,1,110594.10013081032,151978.22007204918,210627.36992586814,0,24,0 +m_58,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,85003.77572834789,167364.6590858765,25590.324402462436,24114.76811945813,0.0412615370628001,0.825230741256002,110594.10013081032,191479.42720533465,210627.36992586814,0,24,0 +m_58,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,85003.77572834789,137333.38760553286,25590.324402462436,19769.062371253247,0.13862057832922547,1,110594.10013081032,157102.4499767861,210627.36992586814,0,24,0 +m_58,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,55195.40432138408,90436.39003811977,19511.67768089828,13229.987934985178,0.16992587683369442,1,74707.08200228236,103666.37797310496,172571.11508056335,0,24,0 +m_58,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,55195.40432138408,141175.9504630275,19511.67768089828,15706.881428393737,0.006838822381591944,0.15729291477661472,74707.08200228236,156882.83189142123,172571.11508056335,0,24,0 +m_58,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,55195.40432138408,110475.41616705792,19511.67768089828,10926.67819562952,0.03911855807075675,0.8214897194858918,74707.08200228236,121402.09436268744,172571.11508056335,0,24,0 +m_59,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,2072.5352766906994,1937.0071790591944,302.9534872980538,98.93058063381923,0.688839972411679,1,2375.4887639887534,2035.9377596930137,2613.037640387629,0,24,0 +m_59,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,2072.5352766906994,2058.2220083509,302.9534872980538,209.17654863234827,0.9700179040855454,1,2375.4887639887534,2267.3985569832485,2613.037640387629,0,24,0 +m_59,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,2072.5352766906994,2242.4262346231026,302.9534872980538,70.18634350369483,0.6112084656168814,1,2375.4887639887534,2312.6125781267974,2613.037640387629,0,24,0 +m_59,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,701.7699791897305,1146.9335447176834,82.0890654111628,132.4247686066351,0.020339005323680718,0.48813612776833726,783.8590446008933,1279.3583133243185,1407.2941446567504,0,24,0 +m_59,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,701.7699791897305,888.532903324881,82.0890654111628,174.3749864963934,0.3643188740155041,1,783.8590446008933,1062.9078898212745,1407.2941446567504,0,24,0 +m_59,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,701.7699791897305,1085.1852435617195,82.0890654111628,120.34223369371236,0.027710138823446667,0.6373331929392734,783.8590446008933,1205.527477255432,1407.2941446567504,0,24,0 +m_59,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1020.5238026526524,707.6005138029833,452.4731966016774,66.83556721796155,0.5299683913209581,1,1472.9969992543297,774.4360810209448,1620.2966991797628,0,24,0 +m_59,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1020.5238026526524,841.2739262389317,452.4731966016774,296.32720104037224,0.750175605307136,1,1472.9969992543297,1137.601127279304,1620.2966991797628,0,24,0 +m_59,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1020.5238026526524,966.5298489223751,452.4731966016774,50.614523747006885,0.9111832346007447,1,1472.9969992543297,1017.1443726693819,1620.2966991797628,0,24,0 +m_59,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,546.121028905539,478.9281923414152,125.15459234255006,40.96910341130734,0.6322106412468526,1,671.275621248089,519.8972957527225,838.1557742460155,0,24,0 +m_59,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,546.121028905539,396.8884954185982,125.15459234255006,24.429064993317333,0.3025525030335274,1,671.275621248089,421.31756041191557,838.1557742460155,0,24,0 +m_59,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,546.121028905539,688.817378227237,125.15459234255006,73.14241654186799,0.35970611019027376,1,671.275621248089,761.959794769105,838.1557742460155,0,24,0 +m_59,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2644.0763350298016,1779.7442057656706,709.6544667375447,168.5172356446489,0.2841624388672803,1,3353.7308017673463,1948.2614414103195,3689.1038819440814,0,24,0 +m_59,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2644.0763350298016,1966.443027595263,709.6544667375447,93.16403516983951,0.3858648629806102,1,3353.7308017673463,2059.6070627651025,3689.1038819440814,0,24,0 +m_59,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2644.0763350298016,2182.983903011666,709.6544667375447,486.27776872025896,0.6051820899921506,1,3353.7308017673463,2669.2616717319247,3689.1038819440814,0,24,0 +m_59,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1627.1081887387763,1439.8351692352107,224.5790385343272,165.8077391442805,0.51879456883441,1,1851.6872272731034,1605.6429083794912,2036.855950000414,0,24,0 +m_59,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1627.1081887387763,1339.3645731557485,224.5790385343272,147.2501110519796,0.313008129826674,1,1851.6872272731034,1486.614684207728,2036.855950000414,0,24,0 +m_59,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1627.1081887387763,1290.7720269842537,224.5790385343272,110.22085010691542,0.2192074286959033,1,1851.6872272731034,1400.992877091169,2036.855950000414,0,24,0 +m_59,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1569.867622955555,1923.584758290293,230.93299840246655,319.9510380514301,0.3931284337398464,1,1800.8006213580215,2243.535796341723,2467.8893759758957,0,24,0 +m_59,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1569.867622955555,1221.818586004639,230.93299840246655,190.4620028429984,0.2728914679782031,1,1800.8006213580215,1412.2805888476373,2467.8893759758957,0,24,0 +m_59,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1569.867622955555,1173.8851319524576,230.93299840246655,130.67726949863854,0.17440408033302046,1,1800.8006213580215,1304.562401451096,2467.8893759758957,0,24,0 +m_59,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1228.731327313693,1650.8838845571677,127.19410598432803,259.7562273977184,0.18623315532158968,1,1355.925433298021,1910.6401119548862,2199.0646723509462,0,24,0 +m_59,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1228.731327313693,1740.8159640768054,127.19410598432803,258.33373806041845,0.11687802074825185,1,1355.925433298021,1999.1497021372238,2199.0646723509462,0,24,0 +m_59,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1228.731327313693,1451.6496567367806,127.19410598432803,212.9597518029357,0.3945569232786834,1,1355.925433298021,1664.6094085397162,2199.0646723509462,0,24,0 +m_60,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,99.21683767097284,153.17922659856472,23.532091797146432,72.34394004875233,0.5046095903210261,1,122.74892946811927,225.52316664731705,248.0754833120488,0,24,0 +m_60,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,99.21683767097284,123.2752209661189,23.532091797146432,23.56123602584813,0.48856917912983855,1,122.74892946811927,146.83645699196703,248.0754833120488,0,24,0 +m_60,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,99.21683767097284,68.77553761187622,23.532091797146432,11.289176727273134,0.2891342054762506,1,122.74892946811927,80.06471433914935,248.0754833120488,0,24,0 +m_60,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,97.50404477377417,119.96570062625808,41.25652894914217,46.03886417385849,0.7240019747862187,1,138.76057372291635,166.00456480011658,182.60502128012826,0,24,0 +m_60,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,97.50404477377417,40.26482833582601,41.25652894914217,5.29601491216299,0.22546462040922485,1,138.76057372291635,45.560843247989,182.60502128012826,0,24,0 +m_60,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,97.50404477377417,66.628897569659,41.25652894914217,16.4624543487551,0.5108923178826328,1,138.76057372291635,83.0913519184141,182.60502128012826,0,24,0 +m_60,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,41.6065427621918,152.6528165932689,6.209985708878686,68.51322662280762,0.166466203923806,1,47.816528471070484,221.16604321607653,243.2826475376842,0,24,0 +m_60,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,41.6065427621918,102.26730795428368,6.209985708878686,39.14988647154597,0.19732313954789396,1,47.816528471070484,141.41719442582965,243.2826475376842,0,24,0 +m_60,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,41.6065427621918,72.68639773327375,6.209985708878686,20.276915283212688,0.19379217893266135,1,47.816528471070484,92.96331301648644,243.2826475376842,0,24,0 +m_60,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,34.254424530644805,46.56909268712826,6.77112935625499,7.311120415969317,0.24785373580503417,1,41.02555388689979,53.880213103097574,168.5922815117805,0,24,0 +m_60,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,34.254424530644805,45.9221085352777,6.77112935625499,5.9081262801205146,0.22836066228199564,1,41.02555388689979,51.830234815398214,168.5922815117805,0,24,0 +m_60,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,34.254424530644805,108.2257280354482,6.77112935625499,45.039982429806784,0.1627632741387204,1,41.02555388689979,153.26571046525498,168.5922815117805,0,24,0 +m_60,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,110.20583817619577,148.73800040610297,19.738689491379642,49.46305655833802,0.49436516280634735,1,129.94452766757541,198.201056964441,218.02116266088512,0,24,0 +m_60,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,110.20583817619577,133.27990414700594,19.738689491379642,27.891320989531074,0.5164587576020041,1,129.94452766757541,161.171225136537,218.02116266088512,0,24,0 +m_60,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,110.20583817619577,157.32186679355206,19.738689491379642,32.06589097726022,0.24489418900945537,1,129.94452766757541,189.38775777081227,218.02116266088512,0,24,0 +m_60,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,70.38131587295561,68.27357982444246,4.979076302913864,22.200594455268178,0.9294703046954389,1,75.36039217586948,90.47417427971064,213.1930655699383,2,24,8.333333333333332 +m_60,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,70.38131587295561,101.38155659447042,4.979076302913864,15.537250250848775,0.106032388147202,1,75.36039217586948,116.9188068453192,213.1930655699383,2,24,8.333333333333332 +m_60,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,70.38131587295561,152.86481049005394,4.979076302913864,40.947067300799056,0.1003465197436255,1,75.36039217586948,193.811877790853,213.1930655699383,2,24,8.333333333333332 +m_60,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,85.80837164187824,131.23523649366743,20.580275567991507,75.41558078195689,0.5832460420746945,1,106.38864720986975,206.65081727562432,227.31589900318676,2,24,8.333333333333332 +m_60,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,85.80837164187824,65.38418744698727,20.580275567991507,30.652745263730562,0.5939879735728034,1,106.38864720986975,96.036932710717835,227.31589900318676,2,24,8.333333333333332 +m_60,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,85.80837164187824,64.01205516995302,20.580275567991507,20.701874399944145,0.47244780856089863,1,106.38864720986975,84.71392956989716,227.31589900318676,2,24,8.333333333333332 +m_60,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,60.87738129746832,49.69251704403595,7.393009328649157,15.330956725234572,0.5315092603571216,1,68.27039062611748,65.02347376927052,75.09742968872924,1,24,4.166666666666666 +m_60,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,60.87738129746832,55.571992982764534,7.393009328649157,11.57897416624226,0.7088508877015958,1,68.27039062611748,67.15096714900679,75.09742968872924,1,24,4.166666666666666 +m_60,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,60.87738129746832,50.22352930490611,7.393009328649157,7.672031670094612,0.34094915664363945,1,68.27039062611748,57.89556097500072,75.09742968872924,1,24,4.166666666666666 +m_61,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,93.43666829582637,134.94895117803293,16.424223774507837,9.91033950170527,0.06875803515595826,0.8495324971104359,109.8608920703342,144.8592906797382,248.99492015261382,0,24,0 +m_61,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,93.43666829582637,185.3442805598587,16.424223774507837,28.527271259309206,0.024092705092578052,0.4095759865738269,109.8608920703342,213.8715518191679,248.99492015261382,0,24,0 +m_61,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,93.43666829582637,203.28820981487615,16.424223774507837,23.070808505681832,0.004081528563380921,0.08571209983099934,109.8608920703342,226.359018320558,248.99492015261382,0,24,0 +m_61,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,52.486604591784115,111.3973548672646,9.05980193312649,10.051642394270766,0.0014722771558555803,0.03386237458467835,61.54640652491061,121.44899726153537,133.5938969876889,0,24,0 +m_61,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,52.486604591784115,110.79535808757782,9.05980193312649,8.317796125350485,8.069378333683459e-4,0.0193665080008403,61.54640652491061,119.11315421292831,133.5938969876889,0,24,0 +m_61,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,52.486604591784115,105.28013779178673,9.05980193312649,9.957961146734833,0.0029081610584462624,0.06397954328581777,61.54640652491061,115.23809893852156,133.5938969876889,0,24,0 +m_61,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,84.46456827673971,145.46984483054692,11.69825330144025,14.855960944302314,0.01059295118629311,0.21185902372586218,96.16282157817996,160.32580577484924,231.0147650319912,0,24,0 +m_61,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,84.46456827673971,165.70749717288746,11.69825330144025,44.30592558346816,0.14213178770334622,1,96.16282157817996,210.01342275635562,231.0147650319912,0,24,0 +m_61,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,84.46456827673971,157.26392211727836,11.69825330144025,30.418023420258944,0.06407376155800154,0.8495324971104359,96.16282157817996,187.6819455375373,231.0147650319912,0,24,0 +m_61,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,81.37032235510941,173.37669978361635,7.186666315193924,37.32025467102142,0.05663549980736239,0.8495324971104359,88.55698867030333,210.69695445463776,231.76664990010156,0,24,0 +m_61,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,81.37032235510941,103.83916747844282,7.186666315193924,17.872447537093908,0.2842499169032393,1,88.55698867030333,121.71161501553672,231.76664990010156,0,24,0 +m_61,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,81.37032235510941,150.7963913721599,7.186666315193924,19.801192571902693,0.015476097023459237,0.2940458434457255,88.55698867030333,170.5975839440626,231.76664990010156,0,24,0 +m_61,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,522.2710670834367,599.1308218564938,47.00989876655952,94.72880157903555,0.4899322811551122,1,569.2809658499963,693.8596234355293,894.6132972535783,0,24,0 +m_61,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,522.2710670834367,746.8484628769074,47.00989876655952,66.43635280816363,0.022126392543501232,0.3982750657830222,569.2809658499963,813.2848156850711,894.6132972535783,0,24,0 +m_61,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,522.2710670834367,630.7454441540522,47.00989876655952,118.27817344578892,0.4241685215507045,1,569.2809658499963,749.0236175998411,894.6132972535783,0,24,0 +m_61,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,697.9991773194146,878.3270648993303,104.07948550777823,70.20466246994388,0.1855937653916421,1,802.0786628271928,948.5317273692741,1100.6980006819444,0,24,0 +m_61,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,697.9991773194146,936.3993021624211,104.07948550777823,64.23524391207377,0.0856771555485171,0.9424487110336881,802.0786628271928,1000.6345460744949,1100.6980006819444,0,24,0 +m_61,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,697.9991773194146,539.7019294352596,104.07948550777823,28.4494451954656,0.194867944366772,1,802.0786628271928,568.1513746307252,1100.6980006819444,0,24,0 +m_61,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,559.3745928352228,649.4545998621514,94.52577960862114,55.11895807058235,0.4340902321731368,1,653.9003724438439,704.5735579327338,1182.631038088398,0,24,0 +m_61,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,559.3745928352228,936.8176633894647,94.52577960862114,138.30146214544257,0.05127249468569301,0.8203599149710882,653.9003724438439,1075.1191255349072,1182.631038088398,0,24,0 +m_61,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,559.3745928352228,673.2006249956185,94.52577960862114,115.33896351000239,0.46357948474268806,1,653.9003724438439,788.5395885056208,1182.631038088398,0,24,0 +m_61,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,592.3362991324378,705.5168905188561,92.63893235589153,64.25897450010531,0.3419304742766296,1,684.9752314883293,769.7758650189614,1098.0661514797137,0,24,0 +m_61,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,592.3362991324378,893.6076640519426,92.63893235589153,104.63429183870606,0.05690169791745828,0.8495324971104359,684.9752314883293,998.2419558906487,1098.0661514797137,0,24,0 +m_61,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,592.3362991324378,758.0381551437204,92.63893235589153,91.91656412245067,0.23293293163867393,1,684.9752314883293,849.954719266171,1098.0661514797137,0,24,0 +m_62,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,6585.51598012815,8522.322528920406,380.60415033309636,1427.9326944226345,0.24031679987982885,1,6966.120130461246,9950.25522334304,10945.280745677344,0,24,0 +m_62,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,6585.51598012815,5601.132277191422,380.60415033309636,845.9282111143443,0.3244360988048615,1,6966.120130461246,6447.060488305766,10945.280745677344,0,24,0 +m_62,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,6585.51598012815,8213.662971608066,380.60415033309636,739.6208301992116,0.0891832913153428,1,6966.120130461246,8953.283801807278,10945.280745677344,0,24,0 +m_62,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,3517.4773189678635,3083.079553722386,614.7289900191674,493.34657760208495,0.5942087587739868,1,4132.206308987031,3576.426131324471,4545.426939885734,0,24,0 +m_62,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,3517.4773189678635,1284.5510838027071,614.7289900191674,206.83839289216863,0.013338674619707424,0.29345084163356333,4132.206308987031,1491.3894766948758,4545.426939885734,0,24,0 +m_62,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,3517.4773189678635,2391.5884370411077,614.7289900191674,631.4739928243089,0.23028539494746197,1,4132.206308987031,3023.0624298654166,4545.426939885734,0,24,0 +m_62,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,2368.2909674273915,1193.3547125708685,289.930037567337,183.00762078601358,0.011176879227949188,0.2570682222428313,2658.2210049947284,1376.3623333568821,2924.0431054942014,0,24,0 +m_62,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,2368.2909674273915,1176.5626141590683,289.930037567337,667.7961622330406,0.15766529007512048,1,2658.2210049947284,1844.358776392109,2924.0431054942014,0,24,0 +m_62,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,2368.2909674273915,944.3789271280945,289.930037567337,190.34859828474393,0.004363938372509473,0.10473452094022737,2658.2210049947284,1134.7275254128383,2924.0431054942014,0,24,0 +m_62,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1509.2244087879828,1129.2927025431516,343.02165949490484,139.25224096508268,0.349214164095333,1,1852.2460682828878,1268.5449435082342,2037.4706751111767,0,24,0 +m_62,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,1509.2244087879828,524.9967484516578,343.02165949490484,69.10194272137795,0.04406323381219912,0.898933499711859,1852.2460682828878,594.0986911730358,2037.4706751111767,0,24,0 +m_62,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1509.2244087879828,1036.05646484146,343.02165949490484,196.86903759683017,0.2733314283021585,1,1852.2460682828878,1232.92550243829,2037.4706751111767,0,24,0 +m_62,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1060751.3020204825,768148.430275359,129371.5168803633,42342.83222516729,0.07471142013241981,1,1190122.8189008457,810491.2625005263,1309135.1007909304,0,24,0 +m_62,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1060751.3020204825,731329.6879408824,129371.5168803633,48458.16688290338,0.05199325476804214,0.9878718405928006,1190122.8189008457,779787.8548237858,1309135.1007909304,0,24,0 +m_62,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1060751.3020204825,871961.6442211049,129371.5168803633,84860.33196326811,0.2546788076245136,1,1190122.8189008457,956821.976184373,1309135.1007909304,0,24,0 +m_62,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1103756.2451948097,945779.865313808,82055.48055710495,86175.93598746213,0.21388496984438024,1,1185811.7257519148,1031955.8013012701,1411086.440018246,0,24,0 +m_62,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1103756.2451948097,1077866.123720546,82055.48055710495,94221.13330364252,0.840077391647182,1,1185811.7257519148,1172087.2570241885,1411086.440018246,0,24,0 +m_62,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1103756.2451948097,1121671.3335915369,82055.48055710495,161134.52097050467,0.9236995774755223,1,1185811.7257519148,1282805.8545620416,1411086.440018246,0,24,0 +m_62,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1021813.1477660871,1001741.7783475374,29671.126593280867,86744.41643693311,0.8337838307767943,1,1051484.274359368,1088486.1947844706,1266457.5525616622,0,24,0 +m_62,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1021813.1477660871,1069462.4162374518,29671.126593280867,81862.63154587742,0.6030792215871191,1,1051484.274359368,1151325.0477833292,1266457.5525616622,0,24,0 +m_62,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1021813.1477660871,926802.190664598,29671.126593280867,70001.76937565934,0.2530714345862309,1,1051484.274359368,996803.9600402573,1266457.5525616622,0,24,0 +m_62,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,911297.6405793307,1088112.3714791737,34476.153138075875,78307.31942422703,0.07838034814824484,1,945773.7937174066,1166419.6909034008,1391341.2200731735,0,24,0 +m_62,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,911297.6405793307,1071689.3386792643,34476.153138075875,57407.412423534,0.04280635712913614,0.898933499711859,945773.7937174066,1129096.7511027984,1391341.2200731735,0,24,0 +m_62,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,911297.6405793307,1160216.3567938558,34476.153138075875,104639.29781812006,0.06408027962299037,1,945773.7937174066,1264855.654611976,1391341.2200731735,0,24,0 +m_63,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,4119.042272896068,2121.2578050588213,744.0012190818505,466.93366291517106,0.05756860573655283,1,4863.043491977919,2588.1914679739925,5349.347841175711,0,24,0 +m_63,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,4119.042272896068,4119.992555093383,744.0012190818505,615.8713883283201,0.9992383174984288,1,4863.043491977919,4735.863943421703,5349.347841175711,0,24,0 +m_63,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,4119.042272896068,4001.44933132101,744.0012190818505,298.8399211263997,0.8888279226046809,1,4863.043491977919,4300.28925244741,5349.347841175711,0,24,0 +m_63,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1478.4460255699946,1681.229950717797,106.41086952457168,512.6943289436332,0.7132732968964204,1,1584.8568950945662,2193.9242796614303,2413.3167076275736,0,24,0 +m_63,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,1478.4460255699946,868.5045666422749,106.41086952457168,197.49570859294192,0.02731739623270823,0.6009827171195811,1584.8568950945662,1066.0002752352168,2413.3167076275736,0,24,0 +m_63,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1478.4460255699946,1112.2905388408014,106.41086952457168,323.0451634096707,0.32258156621236983,1,1584.8568950945662,1435.3357022504722,2413.3167076275736,0,24,0 +m_63,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1742.927245695786,1250.6269765455565,613.7229533575128,303.29761941455354,0.499492303046872,1,2356.650199053299,1553.92459596011,2592.315218958629,0,24,0 +m_63,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1742.927245695786,1710.1533718005835,613.7229533575128,645.8158548550598,0.9715587802794619,1,2356.650199053299,2355.969226655643,2592.315218958629,0,24,0 +m_63,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1742.927245695786,979.3297278653995,613.7229533575128,131.05884946402122,0.2853478543283157,1,2356.650199053299,1110.3885773294207,2592.315218958629,0,24,0 +m_63,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,749.6106308195243,992.3767509627895,221.38111542346917,458.63824605841904,0.6478679790265749,1,970.9917462429935,1451.0149970212085,1596.1164967233294,0,24,0 +m_63,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,749.6106308195243,750.1940070402321,221.38111542346917,336.2655792159276,0.9988779832787359,1,970.9917462429935,1086.4595862561596,1596.1164967233294,0,24,0 +m_63,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,749.6106308195243,978.2679594639098,221.38111542346917,254.33949478304095,0.5147606664510728,1,970.9917462429935,1232.6074542469507,1596.1164967233294,0,24,0 +m_63,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,27771.73432432993,24138.421390940457,4709.851621751921,2189.225075812946,0.5065831403618887,1,32481.58594608185,26327.646466753402,47134.312966768484,0,24,0 +m_63,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,27771.73432432993,24666.162980885067,4709.851621751921,2462.1338324819076,0.5760396073481429,1,32481.58594608185,27128.296813366975,47134.312966768484,0,24,0 +m_63,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,27771.73432432993,32550.639036423134,4709.851621751921,10298.73638791185,0.6856814951015551,1,32481.58594608185,42849.37542433498,47134.312966768484,0,24,0 +m_63,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,8294.309829846356,8993.213252556829,858.4094154979115,907.5293177624311,0.5881790725100936,1,9152.719245344268,9900.74257031926,13237.356598412318,0,24,0 +m_63,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,8294.309829846356,7915.909951804431,858.4094154979115,822.0384357332125,0.7567620026031101,1,9152.719245344268,8737.948387537645,13237.356598412318,0,24,0 +m_63,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,8294.309829846356,11118.752993278593,858.4094154979115,915.2075507326039,0.04820569798858094,0.9159082617830379,9152.719245344268,12033.960544011197,13237.356598412318,0,24,0 +m_63,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2856.7048475947613,4154.103859475001,542.2156488389448,214.88606579735887,0.0641716393917069,1,3398.920496433706,4368.98992527236,5838.289777194746,0,24,0 +m_63,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,2856.7048475947613,4724.335317060279,542.2156488389448,583.200844025854,0.041091701248054426,0.8218340249610885,3398.920496433706,5307.536161086133,5838.289777194746,0,24,0 +m_63,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2856.7048475947613,3722.1953117017647,542.2156488389448,225.4894482431557,0.18602653067098188,1,3398.920496433706,3947.68475994492,5838.289777194746,0,24,0 +m_63,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,2138.7943755926544,3159.439501357201,363.4549994285209,148.77207149896893,0.03721978040377487,0.7816153884792723,2502.249375021175,3308.2115728561703,4638.943917611466,0,24,0 +m_63,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,2138.7943755926544,3558.5503998023214,363.4549994285209,327.63913537118736,0.015961595957596206,0.3671167070247127,2502.249375021175,3886.189535173509,4638.943917611466,0,24,0 +m_63,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,2138.7943755926544,3847.887408084654,363.4549994285209,369.3343351984964,0.008039537085550386,0.19294889005320925,2502.249375021175,4217.22174328315,4638.943917611466,0,24,0 +m_64,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1784.5499331911153,1725.9970833121702,186.45855594491564,109.98624041050141,0.795023672061084,1,1971.008489136031,1835.9833237226717,2508.901889568768,0,24,0 +m_64,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1784.5499331911153,2038.0908702579904,186.45855594491564,207.74251959462933,0.38741197217375034,1,1971.008489136031,2245.83338985262,2508.901889568768,0,24,0 +m_64,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1784.5499331911153,2140.865152802283,186.45855594491564,139.95474680568822,0.16592623699951387,1,1971.008489136031,2280.819899607971,2508.901889568768,0,24,0 +m_64,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,844.7979261896141,1232.67872018608,74.42524749838012,265.1312363543883,0.2103999006039518,1,919.2231736879943,1497.8099565404682,1647.5909521945152,0,24,0 +m_64,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,844.7979261896141,840.8115890576039,74.42524749838012,115.95078683685372,0.9775847035667466,1,919.2231736879943,956.7623758944576,1647.5909521945152,0,24,0 +m_64,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,844.7979261896141,1044.183991170634,74.42524749838012,201.02635383554937,0.38631723439847926,1,919.2231736879943,1245.2103450061834,1647.5909521945152,0,24,0 +m_64,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1296.3503287956537,677.8466191592211,656.5514143191607,182.67492001927423,0.40893626168226416,1,1952.9017431148145,860.5215391784952,2148.191917426296,0,24,0 +m_64,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1296.3503287956537,767.3755852092115,656.5514143191607,197.4415193678932,0.47722317457983454,1,1952.9017431148145,964.8171045771047,2148.191917426296,0,24,0 +m_64,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1296.3503287956537,974.1583832783647,656.5514143191607,143.59546054369065,0.6545988483956193,1,1952.9017431148145,1117.7538438220554,2148.191917426296,0,24,0 +m_64,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,613.8984432679271,701.215388915961,203.0080676763367,95.92671080270468,0.7113370351098003,1,816.9065109442638,797.1420997186656,1228.6940627656024,0,24,0 +m_64,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,613.8984432679271,494.096298415548,203.0080676763367,91.01279005830249,0.6109905959107714,1,816.9065109442638,585.1090884738505,1228.6940627656024,0,24,0 +m_64,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,613.8984432679271,919.047178992861,203.0080676763367,197.9474235213231,0.31034705746680863,1,816.9065109442638,1116.994602514184,1228.6940627656024,0,24,0 +m_64,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6529.2174902471115,5259.394561526678,1210.1742985955702,228.30956501812275,0.3467911658241281,1,7739.391788842682,5487.7041265448015,8513.330967726952,0,24,0 +m_64,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,6529.2174902471115,5141.542004333152,1210.1742985955702,296.08816776889887,0.310891971429743,1,7739.391788842682,5437.630172102051,8513.330967726952,0,24,0 +m_64,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6529.2174902471115,5456.592046179264,1210.1742985955702,446.3631084885701,0.4358623453586524,1,7739.391788842682,5902.955154667834,8513.330967726952,0,24,0 +m_64,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5390.205684907195,5812.92171441212,140.10620081760564,426.5217397687462,0.38237382794254604,1,5530.311885724801,6239.443454180867,6863.387799598954,0,24,0 +m_64,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5390.205684907195,4840.273150927038,140.10620081760564,375.47665618711477,0.21638956203152782,1,5530.311885724801,5215.749807114153,6863.387799598954,0,24,0 +m_64,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5390.205684907195,5085.538651027726,140.10620081760564,286.2519958969182,0.36980825509814186,1,5530.311885724801,5371.790646924644,6863.387799598954,0,24,0 +m_64,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,7136.435739764695,7962.779054877851,886.9563181954921,990.5227147186706,0.5483413754829098,1,8023.392057960187,8953.30176959652,9848.631946556174,0,24,0 +m_64,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,7136.435739764695,5675.1096359755975,886.9563181954921,889.5884170345802,0.2717210754570821,1,8023.392057960187,6564.698053010177,9848.631946556174,0,24,0 +m_64,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,7136.435739764695,6279.0705081828855,886.9563181954921,487.77928055962235,0.4223106272703838,1,8023.392057960187,6766.849788742508,9848.631946556174,0,24,0 +m_64,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6365.76448478505,7897.806639160023,747.4761443222375,586.8313628169027,0.13972308094527822,1,7113.2406291072875,8484.638001976926,9333.101802174619,0,24,0 +m_64,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,6365.76448478505,6450.7030034383115,747.4761443222375,997.599731995028,0.9471231124294852,1,7113.2406291072875,7448.30273543334,9333.101802174619,0,24,0 +m_64,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6365.76448478505,7874.290535561655,747.4761443222375,427.2087369556209,0.11807158357120541,1,7113.2406291072875,8301.499272517276,9333.101802174619,0,24,0 +m_65,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,87.82893569770141,125.94440878084373,8.731813067197042,23.187296301348102,0.17211691965949044,1,96.56074876489845,149.13170508219184,164.04487559041104,0,24,0 +m_65,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,87.82893569770141,112.62158419344931,8.731813067197042,16.719520162689477,0.22793226749144968,1,96.56074876489845,129.34110435613877,164.04487559041104,0,24,0 +m_65,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,87.82893569770141,98.85429757923357,8.731813067197042,17.12747186240859,0.5834950242593664,1,96.56074876489845,115.98176944164217,164.04487559041104,0,24,0 +m_65,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,74.3527828791224,110.17794239976044,9.143034616706322,36.77905545318241,0.3833834934669097,1,83.49581749582872,146.95699785294283,161.65269763823713,0,24,0 +m_65,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,74.3527828791224,72.2893548503733,9.143034616706322,11.246742648035026,0.889737847800064,1,83.49581749582872,83.53609749840832,161.65269763823713,0,24,0 +m_65,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,74.3527828791224,80.43184914480436,9.143034616706322,15.515740145884267,0.7442830791516564,1,83.49581749582872,95.94758929068863,161.65269763823713,0,24,0 +m_65,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,61.50921678158582,67.70236043692731,10.873677147945884,6.486444608368781,0.6404012693876089,1,72.3828939295317,74.18880504529609,193.9688326120978,0,24,0 +m_65,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,61.50921678158582,137.25076571198773,10.873677147945884,39.084536662646634,0.12571325761113294,1,72.3828939295317,176.33530237463435,193.9688326120978,0,24,0 +m_65,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,61.50921678158582,87.36155676265338,10.873677147945884,22.525370991893205,0.3351661269168472,1,72.3828939295317,109.88692775454658,193.9688326120978,0,24,0 +m_65,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,70.21289390855102,90.42182844947514,12.567753019350837,12.028230536744841,0.27594613835880083,1,82.78064692790186,102.45005898621999,112.695064884842,0,24,0 +m_65,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,70.21289390855102,76.3767772828802,12.567753019350837,10.730766575604417,0.7184043005784917,1,82.78064692790186,87.10754385848462,112.695064884842,0,24,0 +m_65,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,70.21289390855102,60.25745540741734,12.567753019350837,4.905711365550786,0.4924146237811411,1,82.78064692790186,65.16316677296813,112.695064884842,0,24,0 +m_65,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1831.7990599248974,1694.3458893871557,297.8103103476725,157.77698958860552,0.6946312934781527,1,2129.60937027257,1852.1228789757613,2342.570307299827,0,24,0 +m_65,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1831.7990599248974,1519.823433539521,297.8103103476725,178.29072767158536,0.3944551351095702,1,2129.60937027257,1698.1141612111062,2342.570307299827,0,24,0 +m_65,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1831.7990599248974,1818.144656689393,297.8103103476725,217.14675154643848,0.9712436574188339,1,2129.60937027257,2035.2914082358316,2342.570307299827,0,24,0 +m_65,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1919.4679006240701,1696.9875861949454,271.5592584909488,243.25673421524837,0.5554779755374363,1,2191.027159115019,1940.2443204101937,2450.3609664215555,0,24,0 +m_65,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1919.4679006240701,2026.4426095477006,271.5592584909488,201.15826901734934,0.7586430637275228,1,2191.027159115019,2227.60087856505,2450.3609664215555,0,24,0 +m_65,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1919.4679006240701,1636.987052730133,271.5592584909488,511.0533499114443,0.6392136697043692,1,2191.027159115019,2148.040402641577,2450.3609664215555,0,24,0 +m_65,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1789.1368780662747,1876.8504289214854,125.35524588689218,261.2072518440311,0.7706607062780617,1,1914.4921239531668,2138.0576807655166,2351.8634488420685,0,24,0 +m_65,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1789.1368780662747,1541.7908890635167,125.35524588689218,224.6216908510308,0.36498614348127,1,1914.4921239531668,1766.4125799145475,2351.8634488420685,0,24,0 +m_65,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1789.1368780662747,1280.3291555070618,125.35524588689218,230.14593262416452,0.08942764787091481,1,1914.4921239531668,1510.4750881312264,2351.8634488420685,0,24,0 +m_65,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2003.7789126851078,2125.2175778445726,100.5764489418551,338.54422652193153,0.7429254473934538,1,2104.355361626963,2463.7618043665043,2710.1379848031547,0,24,0 +m_65,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2003.7789126851078,1974.373441536459,100.5764489418551,285.30450281841445,0.9256195218534099,1,2104.355361626963,2259.6779443548735,2710.1379848031547,0,24,0 +m_65,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2003.7789126851078,1705.8298936102226,100.5764489418551,165.35469906445067,0.1610977470798736,1,2104.355361626963,1871.1845926746732,2710.1379848031547,0,24,0 +m_66,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1412.2647002970136,1130.7292300638062,156.74035156108582,104.91888163353643,0.1778404772726162,1,1569.0050518580995,1235.6481116973425,2461.741784025205,0,24,0 +m_66,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1412.2647002970136,1843.81380320873,156.74035156108582,394.13327317781966,0.3452971152869597,1,1569.0050518580995,2237.9470763865497,2461.741784025205,0,24,0 +m_66,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1412.2647002970136,1855.5141121618371,156.74035156108582,290.54585239867805,0.2184174239229737,1,1569.0050518580995,2146.0599645605153,2461.741784025205,0,24,0 +m_66,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,695.4609106403511,1065.9212691633747,67.67769875357844,228.36837433507407,0.17193608236052269,1,763.1386093939295,1294.2896434984489,1425.9117988477735,0,24,0 +m_66,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,695.4609106403511,953.7533984865814,67.67769875357844,96.69306145554775,0.05655247488274934,1,763.1386093939295,1050.4464599421292,1425.9117988477735,0,24,0 +m_66,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,695.4609106403511,1135.4774697103003,67.67769875357844,160.8059837876755,0.041057554533909635,0.9443237542799217,763.1386093939295,1296.2834534979759,1425.9117988477735,0,24,0 +m_66,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,944.7832053219098,687.9135501293243,368.36216405552665,148.05326091152864,0.5446627154203136,1,1313.1453693774365,835.9668110408529,1585.6303725698697,0,24,0 +m_66,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,944.7832053219098,829.7471106553866,368.36216405552665,191.50783896693946,0.7909930873036367,1,1313.1453693774365,1021.254949622326,1585.6303725698697,0,24,0 +m_66,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,944.7832053219098,1229.1416750791248,368.36216405552665,212.34048180257497,0.5265746075901644,1,1313.1453693774365,1441.4821568816997,1585.6303725698697,0,24,0 +m_66,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,700.7857837159185,816.0817756717695,218.5592760870946,147.8603153835613,0.6748298114894458,1,919.3450598030131,963.9420910553308,1862.8224264526873,0,24,0 +m_66,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,700.7857837159185,595.8020880328432,218.5592760870946,119.15808532586041,0.6872585158149878,1,919.3450598030131,714.9601733587036,1862.8224264526873,0,24,0 +m_66,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,700.7857837159185,1385.9488105591615,218.5592760870946,307.526122579645,0.104338735821589,1,919.3450598030131,1693.4749331388066,1862.8224264526873,0,24,0 +m_66,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5220.552698897576,4249.661046128693,843.3552458213373,134.74398489551137,0.3047846188966473,1,6063.907944718913,4384.405031024204,6670.2987391908055,0,24,0 +m_66,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5220.552698897576,3862.7020294222766,843.3552458213373,379.86465623075384,0.1858545209809379,1,6063.907944718913,4242.566685653031,6670.2987391908055,0,24,0 +m_66,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5220.552698897576,4402.082799266989,843.3552458213373,400.34208112760433,0.40914524468620905,1,6063.907944718913,4802.424880394594,6670.2987391908055,0,24,0 +m_66,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,4151.407218192035,4506.041373041249,220.7166844567231,567.3496072576004,0.5798967941754916,1,4372.123902648757,5073.390980298849,5688.470994934868,0,24,0 +m_66,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,4151.407218192035,3703.560967970422,220.7166844567231,236.89070762489965,0.1968546249441875,1,4372.123902648757,3940.451675595322,5688.470994934868,0,24,0 +m_66,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,4151.407218192035,4620.559297165518,220.7166844567231,550.7779709570889,0.4567380402466904,1,4372.123902648757,5171.3372681226065,5688.470994934868,0,24,0 +m_66,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6043.594493860634,7118.386703888918,821.141448222232,1074.7568593060098,0.446513025627303,1,6864.735942082866,8193.143563194928,9012.457919514422,0,24,0 +m_66,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,6043.594493860634,4736.601227517196,821.141448222232,909.4663593094572,0.311454055150044,1,6864.735942082866,5646.0675868266535,9012.457919514422,0,24,0 +m_66,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6043.594493860634,5596.4323537711725,821.141448222232,586.6989051113414,0.6681070604457159,1,6864.735942082866,6183.131258882514,9012.457919514422,0,24,0 +m_66,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,4688.560133729121,6678.030834827453,546.0154586116898,762.3235087162976,0.06266329436502646,1,5234.5755923408105,7440.3543435437505,8184.389777898126,0,24,0 +m_66,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,4688.560133729121,4424.259158911602,546.0154586116898,664.1756818819499,0.7650796019200219,1,5234.5755923408105,5088.434840793552,8184.389777898126,0,24,0 +m_66,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,4688.560133729121,6373.053133671725,546.0154586116898,425.0857537333041,0.036550947021919876,0.877222728526077,5234.5755923408105,6798.138887405029,8184.389777898126,0,24,0 +m_67,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,915.5565266024303,824.4061213817597,145.25653011500953,129.29471314978068,0.6509814884675573,1,1060.8130567174398,953.7008345315404,1288.3652018030664,0,24,0 +m_67,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,915.5565266024303,899.5429717791606,145.25653011500953,107.13705293766117,0.9315645615712619,1,1060.8130567174398,1006.6800247168217,1288.3652018030664,0,24,0 +m_67,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,915.5565266024303,1086.1307118289246,145.25653011500953,85.11038071931733,0.34668584546383835,1,1060.8130567174398,1171.241092548242,1288.3652018030664,0,24,0 +m_67,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,469.8270779661186,530.1988577436127,48.487243039112734,76.50540602632654,0.5228345836196573,1,518.3143210052314,606.7042637699393,817.9382844443413,0,24,0 +m_67,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,469.8270779661186,622.5886076706154,48.487243039112734,113.09831985865235,0.25568825876651385,1,518.3143210052314,735.6869275292677,817.9382844443413,0,24,0 +m_67,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,469.8270779661186,663.3483930515607,48.487243039112734,80.23186553420413,0.07192362943396545,1,518.3143210052314,743.5802585857648,817.9382844443413,0,24,0 +m_67,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,499.27300846807753,461.3733059232892,122.38052433788152,52.79373714774228,0.7865809272087301,1,621.653532805959,514.1670430710315,720.8360215446048,0,24,0 +m_67,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,499.27300846807753,472.32845026359007,122.38052433788152,114.17400321121788,0.8761127575906751,1,621.653532805959,586.5024534748079,720.8360215446048,0,24,0 +m_67,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,499.27300846807753,593.9560232315065,122.38052433788152,61.349450899952345,0.5151813370810794,1,621.653532805959,655.3054741314588,720.8360215446048,0,24,0 +m_67,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,384.65137963543384,383.170873959578,109.09527297023884,35.47628849207205,0.9902173852583918,1,493.7466526056727,418.64716245165005,609.276085945123,0,24,0 +m_67,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,384.65137963543384,315.17165647802574,109.09527297023884,20.672470367394265,0.5632597415280394,1,493.7466526056727,335.84412684542,609.276085945123,0,24,0 +m_67,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,384.65137963543384,484.3286923935097,109.09527297023884,69.558658465693,0.4663007393440948,1,493.7466526056727,553.8873508592027,609.276085945123,0,24,0 +m_67,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,361.4769054097859,394.3773798247734,108.26056998429472,96.07618290415857,0.8248335050167004,1,469.7374753940806,490.45356272893196,949.0059177179602,0,24,0 +m_67,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,361.4769054097859,487.1122199257199,108.26056998429472,159.25436442846362,0.5307851187123054,1,469.7374753940806,646.3665843541835,949.0059177179602,0,24,0 +m_67,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,361.4769054097859,572.7986337063395,108.26056998429472,289.9340187645333,0.5187831953310285,1,469.7374753940806,862.7326524708728,949.0059177179602,0,24,0 +m_67,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,737.8354071599811,1914.9278097664157,287.8014055469501,315.23310954530695,0.020357348159720366,0.46821900767356844,1025.636812706931,2230.160919311723,3098.0304572548835,0,24,0 +m_67,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,737.8354071599811,2567.342096247896,287.8014055469501,249.04922852927058,7.586704975168109e-4,0.01820809194040346,1025.636812706931,2816.3913247771666,3098.0304572548835,0,24,0 +m_67,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,737.8354071599811,1063.0796294472707,287.8014055469501,244.83558173693694,0.41003591084370294,1,1025.636812706931,1307.9152111842077,3098.0304572548835,0,24,0 +m_67,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,400.8655003794621,607.1388766762487,97.11198493555541,106.51195018993366,0.18315624145731849,1,497.97748531501753,713.6508268661823,1074.795835541937,0,24,0 +m_67,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,400.8655003794621,828.6740626723621,97.11198493555541,137.5760026182013,0.031708839121728054,0.6975944606780172,497.97748531501753,966.2500652905634,1074.795835541937,0,24,0 +m_67,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,400.8655003794621,791.0703998062899,97.11198493555541,186.0167234136529,0.10227529550965477,1,497.97748531501753,977.0871232199428,1074.795835541937,0,24,0 +m_67,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,772.5530415852671,649.4311680804556,402.7400480909105,393.5682802419706,0.8313263623920587,1,1175.2930896761777,1042.9994483224261,1292.8223986437956,0,24,0 +m_67,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,772.5530415852671,684.8237128790627,402.7400480909105,287.0798595525641,0.8631216549559946,1,1175.2930896761777,971.9035724316268,1292.8223986437956,0,24,0 +m_67,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,772.5530415852671,375.9259814482795,402.7400480909105,93.63553677903066,0.37741608439321767,1,1175.2930896761777,469.56151822731016,1292.8223986437956,0,24,0 +m_68,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,175.88898513024054,187.10473620075555,50.57142935437055,12.12711986730864,0.8387550354190041,1,226.46041448461108,199.2318560680642,260.33262275357765,0,24,0 +m_68,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,175.88898513024054,179.17162125760234,50.57142935437055,48.06330431410075,0.9635269985611227,1,226.46041448461108,227.2349255717031,260.33262275357765,0,24,0 +m_68,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,175.88898513024054,215.3446462614213,50.57142935437055,21.32137442364929,0.5020369900422381,1,226.46041448461108,236.66602068507058,260.33262275357765,0,24,0 +m_68,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,166.15857604840284,210.8097882284126,7.899546580548829,21.782632062243085,0.10000844771104203,1,174.05812262895165,232.5924202906557,278.7541883052257,0,24,0 +m_68,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,166.15857604840284,181.6456305653009,7.899546580548829,9.228600694117992,0.2318415528241419,1,174.05812262895165,190.8742312594189,278.7541883052257,0,24,0 +m_68,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,166.15857604840284,240.4144103892254,7.899546580548829,12.998488070070664,0.0011178599028079355,0.025710777764582516,174.05812262895165,253.41289845929606,278.7541883052257,0,24,0 +m_68,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,232.09232504108763,233.96102948023207,27.83168071732963,13.866743530005857,0.9540494122619559,1,259.92400575841725,247.82777301023793,286.27849145511345,0,24,0 +m_68,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,232.09232504108763,207.111300673471,27.83168071732963,16.175875830412313,0.4653312674705967,1,259.92400575841725,223.2871765038833,286.27849145511345,0,24,0 +m_68,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,232.09232504108763,241.89917248893812,27.83168071732963,18.354001561165,0.7769902255930778,1,259.92400575841725,260.2531740501031,286.27849145511345,0,24,0 +m_68,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,216.68366112664066,197.4079114380109,18.354333977785934,27.370075525879443,0.5739962680483013,1,235.03799510442659,224.77798696389033,269.27357597429443,0,24,0 +m_68,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,216.68366112664066,169.35928369074173,18.354333977785934,18.15763203429285,0.10051927243103193,1,235.03799510442659,187.51691572503458,269.27357597429443,0,24,0 +m_68,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,216.68366112664066,225.7180917606261,18.354333977785934,19.076068216005176,0.7407664258514212,1,235.03799510442659,244.79415997663128,269.27357597429443,0,24,0 +m_68,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1426.2529480152073,1174.6507186662493,116.4309613623059,134.27561029088625,0.18784380245241208,1,1542.6839093775131,1308.9263289571356,1696.9523003152647,0,24,0 +m_68,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1426.2529480152073,1441.6829709348735,116.4309613623059,95.70817351109523,0.92055654526695,1,1542.6839093775131,1537.3911444459688,1696.9523003152647,0,24,0 +m_68,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1426.2529480152073,1300.1196034381915,116.4309613623059,100.3736705521025,0.4314500872473064,1,1542.6839093775131,1400.493273990294,1696.9523003152647,0,24,0 +m_68,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1278.2002101207167,1062.4437583574381,198.18850412298667,108.84127068001133,0.3687324983715918,1,1476.3887142437034,1171.2850290374495,1624.027585668074,0,24,0 +m_68,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1278.2002101207167,1108.6346522508074,198.18850412298667,68.2694042143693,0.4486167171393529,1,1476.3887142437034,1176.9040564651768,1624.027585668074,0,24,0 +m_68,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1278.2002101207167,1350.1631379238197,198.18850412298667,100.44639826257405,0.7549796357539711,1,1476.3887142437034,1450.6095361863938,1624.027585668074,0,24,0 +m_68,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,596.0870145939413,782.8944435752147,78.19331596465737,86.58969288529212,0.140740221239757,1,674.2803305585986,869.4841364605069,958.108193772313,0,24,0 +m_68,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,596.0870145939413,798.4270766078433,78.19331596465737,72.58037227607764,0.08727530297676643,1,674.2803305585986,871.0074488839209,958.108193772313,0,24,0 +m_68,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,596.0870145939413,706.9645082120363,78.19331596465737,58.72588819126304,0.28530860317786605,1,674.2803305585986,765.6903964032994,958.108193772313,0,24,0 +m_68,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,615.8359185894908,782.1670070908723,73.05920331425853,74.52279782560576,0.14207723160016067,1,688.8951219037493,856.689804916478,1273.9239436755215,0,24,0 +m_68,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,615.8359185894908,1086.5704923513117,73.05920331425853,71.54218371734423,9.758984623303328e-4,0.023421563095927987,688.8951219037493,1158.112676068656,1273.9239436755215,0,24,0 +m_68,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,615.8359185894908,975.2362850410317,73.05920331425853,75.05781055605144,0.006432024702735912,0.14150454346019006,688.8951219037493,1050.294095597083,1273.9239436755215,0,24,0 +m_69,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,78.96936044816908,56.2553487922828,33.46306601298369,15.341928332178082,0.5612085550032018,1,112.43242646115277,71.59727712446089,133.67498022070188,5,24,20.833333333333336 +m_69,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,78.96936044816908,90.36469828439644,33.46306601298369,31.15801100715072,0.80896612369617,1,112.43242646115277,121.52270929154716,133.67498022070188,5,24,20.833333333333336 +m_69,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,78.96936044816908,15.891302265775675,33.46306601298369,9.651729215887178,0.13403067515804082,1,112.43242646115277,25.54303148166285,133.67498022070188,5,24,20.833333333333336 +m_69,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,58.538229360375034,84.5888098283365,11.232882541712966,23.333548920372355,0.34704744553510636,1,69.771111902088,107.92235874870885,120.74435024063986,0,24,0 +m_69,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,58.538229360375034,80.64763409160426,11.232882541712966,14.351511627905335,0.25451151059106997,1,69.771111902088,94.9991457195096,120.74435024063986,0,24,0 +m_69,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,58.538229360375034,91.32342717160049,11.232882541712966,18.444163956253924,0.16627662197260082,1,69.771111902088,109.76759112785442,120.74435024063986,0,24,0 +m_69,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,82.89710700480718,80.83038747206528,14.853335011152263,9.738494161473223,0.9105780983453021,1,97.75044201595945,90.56888163353851,316.86012556864364,0,24,0 +m_69,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,82.89710700480718,208.06077985951654,14.853335011152263,79.99387974834131,0.19424946237663326,1,97.75044201595945,288.05465960785784,316.86012556864364,0,24,0 +m_69,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,82.89710700480718,115.92543665029764,14.853335011152263,41.800778390784366,0.48373314654694277,1,97.75044201595945,157.726215041082,316.86012556864364,0,24,0 +m_69,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,101.73138829665541,65.6795073695141,24.430764887187454,5.778670757368594,0.21739219746049201,1,126.16215318384286,71.45817812688269,138.77836850222715,0,24,0 +m_69,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,101.73138829665541,51.02476095772062,24.430764887187454,9.78315308214109,0.10891717046420955,1,126.16215318384286,60.807914039861714,138.77836850222715,0,24,0 +m_69,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,101.73138829665541,68.2624496069734,24.430764887187454,16.02006749169589,0.28896863247028426,1,126.16215318384286,84.2825170986693,138.77836850222715,0,24,0 +m_69,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,223.15432786449992,252.8237183050789,33.22313976431354,23.369424231814573,0.4837572031762243,1,256.37746762881346,276.19314253689345,428.43674478124,0,24,0 +m_69,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,223.15432786449992,245.21299996798953,33.22313976431354,34.07640732682536,0.6529381166037462,1,256.37746762881346,279.2894072948149,428.43674478124,0,24,0 +m_69,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,223.15432786449992,346.4385722348562,33.22313976431354,43.04937756627103,0.048410459218510074,1,256.37746762881346,389.48794980112723,428.43674478124,0,24,0 +m_69,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,147.21030102641845,168.92187376958648,18.831086251714016,44.65989469123285,0.6682590903902429,1,166.04138727813248,213.58176846081932,277.3895903202352,0,24,0 +m_69,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,147.21030102641845,211.05090144583613,18.831086251714016,41.12145339074131,0.20090775325963067,1,166.04138727813248,252.17235483657743,277.3895903202352,0,24,0 +m_69,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,147.21030102641845,172.19717860995513,18.831086251714016,10.590490700773119,0.2813356552070525,1,166.04138727813248,182.78766931072826,277.3895903202352,0,24,0 +m_69,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,109.21365838361572,136.9762888109044,23.795593672271973,32.87415422898545,0.5109338005562656,1,133.00925205588769,169.85044303988985,212.0147895389814,0,24,0 +m_69,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,109.21365838361572,163.59941462652262,23.795593672271973,29.14130313618774,0.18008976511467373,1,133.00925205588769,192.74071776271035,212.0147895389814,0,24,0 +m_69,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,109.21365838361572,130.47158329350577,23.795593672271973,21.747843425342257,0.5246292526318973,1,133.00925205588769,152.21942671884804,212.0147895389814,0,24,0 +m_69,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,93.53234569214308,128.05818892633906,21.348341367353658,30.397234577252433,0.37697768925233177,1,114.88068705949674,158.45542350359148,212.4742858753423,0,24,0 +m_69,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,93.53234569214308,163.90529323282556,21.348341367353658,29.253148472031057,0.08334955973157193,1,114.88068705949674,193.1584417048566,212.4742858753423,0,24,0 +m_69,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,93.53234569214308,118.98203018945418,21.348341367353658,20.16642862717695,0.40653794127485887,1,114.88068705949674,139.14845881663112,212.4742858753423,0,24,0 +m_70,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,1287.8187829790709,272.1543786640603,273.6567907185959,73.17668488600293,0.018370564478667185,0.3674112895733437,1561.4755736976667,345.3310635500632,1717.6231310674336,0,24,0 +m_70,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1287.8187829790709,719.3806889425662,273.6567907185959,98.54618381660268,0.10764709672923081,1,1561.4755736976667,817.9268727591689,1717.6231310674336,0,24,0 +m_70,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1287.8187829790709,867.5626293996404,273.6567907185959,204.5737349852108,0.2546019200617781,1,1561.4755736976667,1072.1363643848513,1717.6231310674336,0,24,0 +m_70,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,1053.7713334035723,592.4977886560471,114.45991791816047,139.73638862133356,0.02948765174560849,0.5085711920046887,1168.2312513217328,732.2341772773807,1285.0543764539061,0,23,0 +m_70,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1053.7713334035723,745.0125187942036,114.45991791816047,212.09200944296785,0.24566266741994933,1,1168.2312513217328,957.1045282371715,1285.0543764539061,0,23,0 +m_70,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,1053.7713334035723,441.72999505145174,114.45991791816047,84.49339632588779,0.0018855685373599712,0.04525364489663931,1168.2312513217328,526.2233913773396,1285.0543764539061,0,23,0 +m_70,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1545.8952408635428,1205.4762591131237,285.25614419356754,339.425705088525,0.4623512909658035,1,1831.1513850571102,1544.9019642016488,2014.2665235628215,0,24,0 +m_70,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1545.8952408635428,1090.254991496686,285.25614419356754,268.82039196170746,0.2786661332085311,1,1831.1513850571102,1359.0753834583934,2014.2665235628215,0,24,0 +m_70,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1545.8952408635428,762.7716884519183,285.25614419356754,225.02743133549257,0.06308355706350939,1,1831.1513850571102,987.7991197874109,2014.2665235628215,0,24,0 +m_70,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,761.179367641068,1026.1583106573162,98.28519061006357,192.2271355817407,0.2576486347539612,1,859.4645582511315,1218.3854462390568,2509.0447135594236,0,24,0 +m_70,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,761.179367641068,1776.6580013273858,98.28519061006357,504.2917382720901,0.10102867545034726,1,859.4645582511315,2280.949739599476,2509.0447135594236,0,24,0 +m_70,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,761.179367641068,700.4690364496175,98.28519061006357,173.33025903454765,0.7686453842772984,1,859.4645582511315,873.7992954841652,2509.0447135594236,0,24,0 +m_70,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,782673.5029735971,924174.0095969618,60654.9259239231,41687.361933831555,0.08720307753803433,1,843328.4288975203,965861.3715307934,1179730.383585556,0,24,0 +m_70,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,782673.5029735971,927002.3245256043,60654.9259239231,36591.85389409177,0.07505573222101207,1,843328.4288975203,963594.178419696,1179730.383585556,0,24,0 +m_70,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,782673.5029735971,1008566.4243329093,60654.9259239231,63915.74256305041,0.028253955111371597,0.5085711920046887,843328.4288975203,1072482.1668959598,1179730.383585556,0,24,0 +m_70,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,513919.16374162235,586899.1708031615,44939.59522412903,38880.105651885875,0.24808806157634378,1,558858.7589657514,625779.2764550473,826930.01864752,0,24,0 +m_70,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,513919.16374162235,523931.22308002063,44939.59522412903,39505.96587688217,0.8705024759226709,1,558858.7589657514,563437.1889569028,826930.01864752,0,24,0 +m_70,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,513919.16374162235,697679.1725518533,44939.59522412903,54075.389854982954,0.026548847033746107,0.504428093641176,558858.7589657514,751754.5624068363,826930.01864752,0,24,0 +m_70,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,369123.52293533116,428429.96472206566,58623.543138354245,30625.57622536052,0.39762174650161586,1,427747.0660736854,459055.54094742617,565260.1623645215,0,24,0 +m_70,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,369123.52293533116,395252.3852866531,58623.543138354245,69659.54234752285,0.7801475426722491,1,427747.0660736854,464911.927634176,565260.1623645215,0,24,0 +m_70,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,369123.52293533116,482406.2839981659,58623.543138354245,31466.59087867182,0.12872219992569242,1,427747.0660736854,513872.8748768377,565260.1623645215,0,24,0 +m_70,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,258075.7105503754,424308.9263689304,33198.413983301376,32621.954294656367,0.00508513519714111,0.11695810953424553,291274.1245336768,456930.8806635867,736861.4962613268,0,24,0 +m_70,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,258075.7105503754,437975.1764986733,33198.413983301376,40398.05698099493,0.006675195383461961,0.14685429843616316,291274.1245336768,478373.2334796682,736861.4962613268,0,24,0 +m_70,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,258075.7105503754,581301.1986772447,33198.413983301376,88572.88883305238,0.012907223344357456,0.2710516902315066,291274.1245336768,669874.0875102971,736861.4962613268,0,24,0 +m_71,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,499.2222044164429,292.70796982538735,159.31570841435484,37.80428774917061,0.2692714876439098,1,658.5379128307977,330.51225757455796,724.3917041138776,0,24,0 +m_71,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,499.2222044164429,254.31398638312848,159.31570841435484,27.944850186731394,0.2004898628687578,1,658.5379128307977,282.25883656985985,724.3917041138776,0,24,0 +m_71,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,499.2222044164429,439.3427559471184,159.31570841435484,49.31196224997067,0.734907513767526,1,658.5379128307977,488.6547181970891,724.3917041138776,0,24,0 +m_71,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,168.24207082530216,168.3507658536189,29.273101114060356,24.274437547945862,0.9977775552855612,1,197.51517193936252,192.62520340156476,217.2666891332988,0,24,0 +m_71,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,168.24207082530216,142.14415730188966,29.273101114060356,11.358624182227622,0.4354708704687541,1,197.51517193936252,153.5027814841173,217.2666891332988,0,24,0 +m_71,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,168.24207082530216,136.8969576091661,29.273101114060356,17.969802336572137,0.38721400304750353,1,197.51517193936252,154.86675994573824,217.2666891332988,0,24,0 +m_71,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,161.42864013408035,125.24024604535403,38.83329677869409,14.053558391775951,0.42062361057910386,1,200.26193691277444,139.29380443712998,220.2881306040519,0,24,0 +m_71,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,161.42864013408035,159.91087425602421,38.83329677869409,31.708428105232503,0.9766191966056494,1,200.26193691277444,191.61930236125673,220.2881306040519,0,24,0 +m_71,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,161.42864013408035,127.59231545354926,38.83329677869409,11.248402276854566,0.44331652701373875,1,200.26193691277444,138.84071773040384,220.2881306040519,0,24,0 +m_71,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,131.47736122215045,118.78442371803064,18.812179957294028,5.55053309808372,0.5478201421797799,1,150.28954117944448,124.33495681611436,165.31849529738895,0,24,0 +m_71,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,131.47736122215045,120.61695657447342,18.812179957294028,6.950332594239862,0.6109937372887401,1,150.28954117944448,127.56728916871329,165.31849529738895,0,24,0 +m_71,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,131.47736122215045,120.15792731696713,18.812179957294028,11.65017674071981,0.6250333265701482,1,150.28954117944448,131.80810405768693,165.31849529738895,0,24,0 +m_71,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2374.2728786293014,2633.243546299308,128.423389505072,180.11382162580827,0.2716529863045164,1,2502.6962681343734,2813.3573679251163,3596.3415713269083,0,24,0 +m_71,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2374.2728786293014,2679.6054660942327,128.423389505072,158.6694375894345,0.16689294844887967,1,2502.6962681343734,2838.274903683667,3596.3415713269083,0,24,0 +m_71,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,2374.2728786293014,3118.569186470334,128.423389505072,150.83224200867343,0.003907659819322167,0.09378383566373202,2502.6962681343734,3269.4014284790073,3596.3415713269083,0,24,0 +m_71,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2147.6154464917763,2056.0125680051506,184.36888554810469,52.93143659754255,0.6503755130353144,1,2331.984332039881,2108.944004602693,2922.4784517735857,0,24,0 +m_71,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2147.6154464917763,2447.1673185595173,184.36888554810469,209.6312739619239,0.3088811375434908,1,2331.984332039881,2656.798592521441,2922.4784517735857,0,24,0 +m_71,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2147.6154464917763,2344.2249506290177,184.36888554810469,127.53105508031375,0.4035433674685248,1,2331.984332039881,2471.7560057093315,2922.4784517735857,0,24,0 +m_71,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2717.345902716852,2959.6321798608637,149.68739548525824,225.91468255529645,0.3954170908094775,1,2867.03329820211,3185.5468624161604,3504.1015486577767,0,24,0 +m_71,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2717.345902716852,2828.531113883452,149.68739548525824,248.4969210914806,0.7112597287787243,1,2867.03329820211,3077.0280349749323,3504.1015486577767,0,24,0 +m_71,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2717.345902716852,2553.9230492057573,149.68739548525824,137.14954842173844,0.4396971384920413,1,2867.03329820211,2691.0725976274957,3504.1015486577767,0,24,0 +m_71,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3004.2024881525895,4167.522455673152,196.27300355723474,452.7244003043213,0.051481024936036617,1,3200.4754917098244,4620.246855977473,5082.271541575221,0,24,0 +m_71,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,3004.2024881525895,4211.043297482026,196.27300355723474,383.8230049126315,0.02492690679947285,0.5733188563878756,3200.4754917098244,4594.866302394657,5082.271541575221,0,24,0 +m_71,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3004.2024881525895,4142.280447182302,196.27300355723474,446.6235546380889,0.053115456227905936,1,3200.4754917098244,4588.9040018203905,5082.271541575221,0,24,0 +m_72,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,224.19809380208912,154.28709433400726,55.70944547442985,25.901718811643395,0.3006815577560726,1,279.90753927651895,180.18881314565067,323.05135943483566,0,24,0 +m_72,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,224.19809380208912,121.21648850561199,55.70944547442985,16.92027756687602,0.14037459088543874,1,279.90753927651895,138.136766072488,323.05135943483566,0,24,0 +m_72,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,224.19809380208912,247.20815171884271,55.70944547442985,46.474902312826025,0.7589592743937921,1,279.90753927651895,293.68305403166875,323.05135943483566,0,24,0 +m_72,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,154.30284514237644,121.98409403358062,36.906141399236986,18.766554430853887,0.4592120053123211,1,191.20898654161343,140.7506484644345,210.32988519577478,0,24,0 +m_72,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,154.30284514237644,92.11181082113994,36.906141399236986,12.602900422033334,0.1606837553041385,1,191.20898654161343,104.71471124317327,210.32988519577478,0,24,0 +m_72,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,154.30284514237644,83.22344948441801,36.906141399236986,7.876658170347639,0.11349051023236834,1,191.20898654161343,91.10010765476565,210.32988519577478,0,24,0 +m_72,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,100.92285155092736,80.99889302799234,27.882744658975327,15.784567180943437,0.5553971354567719,1,128.8055962099027,96.78346020893578,149.06832289528836,0,24,0 +m_72,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,100.92285155092736,55.9084714050045,27.882744658975327,15.413950866748419,0.20560018768086719,1,128.8055962099027,71.32242227175291,149.06832289528836,0,24,0 +m_72,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,100.92285155092736,114.14447228980352,27.882744658975327,21.372184887731347,0.7165655156778592,1,128.8055962099027,135.51665717753485,149.06832289528836,0,24,0 +m_72,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,96.13121274223809,87.73752532487856,13.997748142591036,12.96728312190159,0.6707480987366619,1,110.12896088482913,100.70480844678015,176.7225299729455,0,24,0 +m_72,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,96.13121274223809,95.81339230920034,13.997748142591036,17.157130750719713,0.9888638335649582,1,110.12896088482913,112.97052305992005,176.7225299729455,0,24,0 +m_72,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,96.13121274223809,134.35338159851977,13.997748142591036,26.303463831430662,0.23786965377423208,1,110.12896088482913,160.65684542995044,176.7225299729455,0,24,0 +m_72,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,279.1508889906329,230.22588177776532,27.87764715085642,23.773711169021844,0.21207582148130413,1,307.0285361414893,253.99959294678717,413.3722276960636,0,24,0 +m_72,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,279.1508889906329,293.6396036377724,27.87764715085642,47.53062637691368,0.7991809163885718,1,307.0285361414893,341.17023001468607,413.3722276960636,0,24,0 +m_72,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,279.1508889906329,313.7997670939688,27.87764715085642,61.993167175179906,0.6260292665489965,1,307.0285361414893,375.7929342691487,413.3722276960636,0,24,0 +m_72,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,308.13689831179255,400.7000306629894,48.74576699102877,32.29290449709405,0.14911512098652924,1,356.88266530282135,432.99293516008345,591.4257524492755,0,24,0 +m_72,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,308.13689831179255,485.42292198089245,48.74576699102877,52.23685297299427,0.03257319590130056,0.7491835057299129,356.88266530282135,537.6597749538868,591.4257524492755,0,24,0 +m_72,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,308.13689831179255,447.60322657907096,48.74576699102877,76.16307708677931,0.15932792760107548,1,356.88266530282135,523.7663036658503,591.4257524492755,0,24,0 +m_72,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,400.8957323197124,549.3609772667938,47.01565764889891,77.720529967976,0.1397598026257746,1,447.91138996861133,627.0815072347698,689.7896579582468,0,24,0 +m_72,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,400.8957323197124,439.33935633529603,47.01565764889891,83.43300095921677,0.6987678043622405,1,447.91138996861133,522.7723572945129,689.7896579582468,0,24,0 +m_72,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,400.8957323197124,430.0745093819147,47.01565764889891,71.828791710024,0.7420745199008808,1,447.91138996861133,501.9033010919387,689.7896579582468,0,24,0 +m_72,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,490.807523353751,563.6907052072163,31.75080086381418,36.7260128397836,0.16481705595517915,1,522.5583242175652,600.4167180469999,858.9734665707706,0,24,0 +m_72,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,490.807523353751,719.4244821749712,31.75080086381418,61.460487434820166,0.01182947355078974,0.28390736521895377,522.5583242175652,780.8849696097914,858.9734665707706,0,24,0 +m_72,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,490.807523353751,455.2061118297305,31.75080086381418,40.613710143703386,0.5064275670231885,1,522.5583242175652,495.8198219734339,858.9734665707706,0,24,0 +m_73,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,194.76065323140625,163.99995611547726,28.59018171671545,13.571848687049986,0.37002283526644747,1,223.3508349481217,177.57180480252725,245.68591844293388,0,24,0 +m_73,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,194.76065323140625,184.25976328798353,28.59018171671545,35.933732080484575,0.824295742885021,1,223.3508349481217,220.19349536846812,245.68591844293388,0,24,0 +m_73,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,194.76065323140625,141.4029941482079,28.59018171671545,20.189706032709516,0.16841608128775812,1,223.3508349481217,161.59270018091743,245.68591844293388,0,24,0 +m_73,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,101.67698352669939,91.84134821233084,4.250473734675465,14.108741800924381,0.5296809286022566,1,105.92745726137485,105.95009001325522,116.54509901458076,2,24,8.333333333333332 +m_73,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,101.67698352669939,74.69618365162852,4.250473734675465,4.157567239382424,0.0010796377082625196,0.025911304998300473,105.92745726137485,78.85375089101095,116.54509901458076,2,24,8.333333333333332 +m_73,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,101.67698352669939,92.91712795492548,4.250473734675465,12.932675322739723,0.5434519948898777,1,105.92745726137485,105.8498032776652,116.54509901458076,2,24,8.333333333333332 +m_73,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,84.45526851335163,84.45550453544897,8.46468462607908,7.584299276068983,0.9999839054673823,1,92.9199531394307,92.03980381151796,174.83049568333976,3,24,12.5 +m_73,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,84.45526851335163,115.3936626680932,8.46468462607908,43.5431515894884,0.5213777162289649,1,92.9199531394307,158.9368142575816,174.83049568333976,3,24,12.5 +m_73,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,84.45526851335163,80.57514257669146,8.46468462607908,14.05367944245564,0.8190017466343854,1,92.9199531394307,94.62882201914711,174.83049568333976,3,24,12.5 +m_73,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,78.64120835950264,73.41390126980797,7.3736346384763545,4.350199087031565,0.5618242014003356,1,86.014842997979,77.76410035683953,94.6163272977769,9,24,37.5 +m_73,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,78.64120835950264,69.75888648756529,7.3736346384763545,3.4813873510111355,0.3195316899942023,1,86.014842997979,73.24027383857643,94.6163272977769,9,24,37.5 +m_73,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,78.64120835950264,60.784257573081476,7.3736346384763545,3.3458438409389717,0.07256685200895832,1,86.014842997979,64.13010141402044,94.6163272977769,9,24,37.5 +m_73,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1929.533635665975,1844.134354192025,133.7284721718379,88.01282310120621,0.6071667076330963,1,2063.262107837813,1932.1471772932314,2665.7361768143046,0,24,0 +m_73,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1929.533635665975,1908.761990160484,133.7284721718379,163.52550623837465,0.9236884348564525,1,2063.262107837813,2072.287496398859,2665.7361768143046,0,24,0 +m_73,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1929.533635665975,2231.0620998019162,133.7284721718379,192.3344245747239,0.2304333447057879,1,2063.262107837813,2423.39652437664,2665.7361768143046,0,24,0 +m_73,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1683.916481401971,1882.3392343143046,68.87722377564079,59.01796535223951,0.05416901403213244,1,1752.7937051776116,1941.3571996665441,2350.707704527008,0,24,0 +m_73,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1683.916481401971,1897.09398343017,68.87722377564079,122.95191596823125,0.1695025236716029,1,1752.7937051776116,2020.0458993984014,2350.707704527008,0,24,0 +m_73,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,1683.916481401971,2016.5621531135644,68.87722377564079,120.44485100189733,0.04351826038537585,1,1752.7937051776116,2137.0070041154618,2350.707704527008,0,24,0 +m_73,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1727.1723925307936,1777.5146142215679,56.859941731981586,55.08104236026216,0.5391223338036837,1,1784.032334262775,1832.59565658183,2037.014117887638,0,24,0 +m_73,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1727.1723925307936,1791.6859715485364,56.859941731981586,60.14504471295251,0.4538192652552636,1,1784.032334262775,1851.831016261489,2037.014117887638,0,24,0 +m_73,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1727.1723925307936,1695.282662689368,56.859941731981586,20.253385322198266,0.6155011949586326,1,1784.032334262775,1715.5360480115662,2037.014117887638,0,24,0 +m_73,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1710.8868039225827,1817.3654344809977,44.1684720031025,56.13708568045041,0.1685648787379967,1,1755.0552759256852,1873.502520161448,2418.2163337552847,0,24,0 +m_73,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1710.8868039225827,1741.7251934549317,44.1684720031025,48.08892522109229,0.6469256062351656,1,1755.0552759256852,1789.814118676024,2418.2163337552847,0,24,0 +m_73,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1710.8868039225827,2041.7612003617555,44.1684720031025,156.61728487032136,0.08996724269905237,1,1755.0552759256852,2198.378485232077,2418.2163337552847,0,24,0 +m_74,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,248.74137171022352,266.71180287008127,13.098576473801355,7.699128178929652,0.27769600523561383,1,261.8399481840249,274.4109310490109,308.35332470121324,0,24,0 +m_74,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,248.74137171022352,237.9512630175572,13.098576473801355,28.567337745493795,0.7415106841837276,1,261.8399481840249,266.518600763051,308.35332470121324,0,24,0 +m_74,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,248.74137171022352,253.93635393336137,13.098576473801355,26.384850340468798,0.8648591435385331,1,261.8399481840249,280.3212042738302,308.35332470121324,0,24,0 +m_74,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,171.27157496819638,241.26068357900732,13.558072267957394,33.64713049985863,0.09765384789844174,1,184.82964723615376,274.90781407886595,302.3985954867526,0,24,0 +m_74,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,171.27157496819638,175.01347976548368,13.558072267957394,12.82351450951922,0.8451123088856258,1,184.82964723615376,187.8369942750029,302.3985954867526,0,24,0 +m_74,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,171.27157496819638,228.59757512100242,13.558072267957394,16.577931156452202,0.02396514859809818,0.5751635663543564,184.82964723615376,245.17550627745462,302.3985954867526,0,24,0 +m_74,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,236.99732148815616,207.46551682942209,74.5193152199253,24.26610688868911,0.7222288318196682,1,311.5166367080815,231.7316237181112,342.6683003788896,0,24,0 +m_74,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,236.99732148815616,184.67368172330043,74.5193152199253,41.21592753547159,0.5606601774845184,1,311.5166367080815,225.88960925877203,342.6683003788896,0,24,0 +m_74,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,236.99732148815616,234.82887290854052,74.5193152199253,18.70537520795259,0.9786905679572608,1,311.5166367080815,253.5342481164931,342.6683003788896,0,24,0 +m_74,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,158.21676846284709,166.7116911321855,28.180775691084932,4.509981479744039,0.7800954104306673,1,186.39754415393202,171.22167261192953,228.72830920543322,0,24,0 +m_74,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,158.21676846284709,115.61843935425428,28.180775691084932,9.414893390875807,0.21232177847164294,1,186.39754415393202,125.03333274513008,228.72830920543322,0,24,0 +m_74,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,158.21676846284709,189.98618044870426,28.180775691084932,17.948646101689555,0.37341235193975447,1,186.39754415393202,207.9348265503938,228.72830920543322,0,24,0 +m_74,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1248.8175020786064,1045.146902837256,184.0652702151626,35.598286092589255,0.32362324334097325,1,1432.882772293769,1080.7451889298452,1576.171049523146,0,24,0 +m_74,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1248.8175020786064,900.842417890709,184.0652702151626,77.05076072353252,0.12661532551256385,1,1432.882772293769,977.8931786142416,1576.171049523146,0,24,0 +m_74,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1248.8175020786064,1153.6289174011624,184.0652702151626,144.65850942535636,0.693335157898441,1,1432.882772293769,1298.2874268265189,1576.171049523146,0,24,0 +m_74,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1020.7131815647399,1056.520030798436,73.38850452345004,31.838088118605754,0.6683157329747087,1,1094.10168608819,1088.3581189170418,1203.511854697009,0,24,0 +m_74,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1020.7131815647399,841.114968989906,73.38850452345004,45.03662437163828,0.06923377329593751,1,1094.10168608819,886.1515933615442,1203.511854697009,0,24,0 +m_74,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1020.7131815647399,940.9100050905397,73.38850452345004,85.63687509615703,0.4957281139963142,1,1094.10168608819,1026.5468801866966,1203.511854697009,0,24,0 +m_74,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1132.137598379313,906.1206371614178,113.41010955420668,76.73327941019512,0.13404381563283527,1,1245.5477079335196,982.8539165716129,1370.1024787268716,0,24,0 +m_74,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1132.137598379313,970.2290249324566,113.41010955420668,267.4564938526916,0.595312264430085,1,1245.5477079335196,1237.6855187851481,1370.1024787268716,0,24,0 +m_74,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1132.137598379313,931.3439657612444,113.41010955420668,53.83252808708927,0.1528864233174313,1,1245.5477079335196,985.1764938483336,1370.1024787268716,0,24,0 +m_74,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1068.4447009417866,908.8193101959879,93.15541902815689,43.65486559971756,0.16412390699112978,1,1161.6001199699435,952.4741757957055,1277.760131966938,0,24,0 +m_74,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1068.4447009417866,926.7798120276473,93.15541902815689,61.15563952887566,0.23680820290450422,1,1161.6001199699435,987.9354515565229,1277.760131966938,0,24,0 +m_74,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1068.4447009417866,983.8425737072652,93.15541902815689,88.41721668569006,0.5249939494666687,1,1161.6001199699435,1072.2597903929552,1277.760131966938,0,24,0 +m_75,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,148.32865529425163,162.906769397906,7.520240472596825,4.4024822208348615,0.14090627288419988,1,155.84889576684844,167.30925161874086,195.08904419804534,0,24,0 +m_75,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,148.32865529425163,155.04195755580136,7.520240472596825,5.450452239383259,0.4913696762648585,1,155.84889576684844,160.4924097951846,195.08904419804534,0,24,0 +m_75,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,148.32865529425163,166.11661358815482,7.520240472596825,11.237062955522745,0.22317472334569832,1,155.84889576684844,177.35367654367758,195.08904419804534,0,24,0 +m_75,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,110.02540318311323,150.36551101890268,11.586396713027918,18.33031343435559,0.09793670877396937,1,121.61179989614115,168.69582445325827,185.56540689858411,0,24,0 +m_75,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,110.02540318311323,139.46581353017464,11.586396713027918,7.577198654161309,0.06371421768254625,1,121.61179989614115,147.04301218433596,185.56540689858411,0,24,0 +m_75,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,110.02540318311323,135.46971474915603,11.586396713027918,2.7177583751024432,0.08008619223785753,1,121.61179989614115,138.18747312425847,185.56540689858411,0,24,0 +m_75,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,108.88006883358833,141.06967963429213,4.898694064452642,9.52991381489279,0.0187178661290166,0.427180382866655,113.77876289804097,150.5995934491849,177.1807482793918,0,24,0 +m_75,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,108.88006883358833,120.17002371038365,4.898694064452642,8.802962555564507,0.30356315846916276,1,113.77876289804097,128.97298626594815,177.1807482793918,0,24,0 +m_75,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,108.88006883358833,148.88675663984301,4.898694064452642,12.186650886876768,0.02034598173232472,0.42726561637881916,113.77876289804097,161.0734075267198,177.1807482793918,0,24,0 +m_75,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,101.193417409009,131.41290170724224,2.1878822306687256,10.672719212815954,0.03594553691941464,0.7189107383882929,103.38129963967772,142.0856209200582,159.95903250868992,0,24,0 +m_75,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,101.193417409009,121.76914465570074,2.1878822306687256,5.096079144898296,0.00811186208697843,0.19468469008748235,103.38129963967772,126.86522380059904,159.95903250868992,0,24,0 +m_75,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,101.193417409009,135.3391840852548,2.1878822306687256,10.078118195372376,0.018573060124637174,0.427180382866655,103.38129963967772,145.41730228062718,159.95903250868992,0,24,0 +m_75,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,9753.938051835177,10003.6727726558,463.93564115168675,259.1570763507745,0.6511823212149256,1,10217.873692986865,10262.829849006575,12849.247029547605,0,24,0 +m_75,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,9753.938051835177,9680.59597285589,463.93564115168675,520.2806612271518,0.9183143782067255,1,10217.873692986865,10200.876634083043,12849.247029547605,0,24,0 +m_75,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,9753.938051835177,10991.821869256446,463.93564115168675,689.3117939686496,0.17137369392369006,1,10217.873692986865,11681.133663225095,12849.247029547605,0,24,0 +m_75,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,8653.628407645267,10456.979664668586,262.3526151903484,1122.557978367123,0.17279712255221769,1,8915.981022835615,11579.53764303571,12737.491407339283,0,24,0 +m_75,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,8653.628407645267,9030.895839887888,262.3526151903484,467.2108089689047,0.5016862484586118,1,8915.981022835615,9498.106648856792,12737.491407339283,0,24,0 +m_75,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,8653.628407645267,9940.436060726654,262.3526151903484,635.9852464428257,0.10580078903943213,1,8915.981022835615,10576.42130716948,12737.491407339283,0,24,0 +m_75,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,7995.201063351163,9698.550406350789,317.33999731029365,660.835032403307,0.05216856723261589,0.939034210187086,8312.541060661457,10359.385438754096,11395.323982629507,0,24,0 +m_75,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,7995.201063351163,9165.854320180695,317.33999731029365,507.12405984936873,0.08437244634763226,1,8312.541060661457,9672.978380030065,11395.323982629507,0,24,0 +m_75,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,7995.201063351163,9358.448193117689,317.33999731029365,473.6314211884722,0.04127037265600239,0.7841370804640454,8312.541060661457,9832.079614306162,11395.323982629507,0,24,0 +m_75,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,8195.704907369402,9244.639611162916,322.91069469986985,393.8885331328462,0.06752022282762213,1,8518.61560206927,9638.528144295762,10879.454474050146,0,24,0 +m_75,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,8195.704907369402,7972.572027134306,322.91069469986985,196.55299175384152,0.5708145224186614,1,8518.61560206927,8169.125018888148,10879.454474050146,0,24,0 +m_75,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,8195.704907369402,9015.518645947817,322.91069469986985,874.8945122795875,0.41144753833587255,1,8518.61560206927,9890.413158227404,10879.454474050146,0,24,0 +m_76,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,39.07783753694922,73.8463873394048,7.655816771954628,18.104005243309604,0.12227684263937866,1,46.733654308903844,91.9503925827144,101.14543184098585,0,24,0 +m_76,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,39.07783753694922,58.68077237333231,7.655816771954628,12.39061325399861,0.21489880698915967,1,46.733654308903844,71.07138562733093,101.14543184098585,0,24,0 +m_76,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,39.07783753694922,38.0332649375083,7.655816771954628,7.403118865027502,0.9240600331482526,1,46.733654308903844,45.4363838025358,101.14543184098585,0,24,0 +m_76,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,42.54152345579989,119.06296105955913,9.642609287096713,74.73766149183723,0.3550615117846415,1,52.1841327428966,193.80062255139637,213.18068480653602,0,24,0 +m_76,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,42.54152345579989,85.59597944829977,9.642609287096713,20.020141337662473,0.0927147140003741,1,52.1841327428966,105.61612078596224,213.18068480653602,0,24,0 +m_76,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,42.54152345579989,61.48615112553326,9.642609287096713,14.81977436227575,0.3131285820620887,1,52.1841327428966,76.305925487809,213.18068480653602,0,24,0 +m_76,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,88.40944193178245,47.19066014481918,20.019161947314608,14.468979102638016,0.1356595470605711,1,108.42860387909707,61.65963924745719,119.27146426700678,0,24,0 +m_76,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,88.40944193178245,25.072615779048192,20.019161947314608,10.306753148987982,0.03074213650855345,0.7378112762052828,108.42860387909707,35.37936892803617,119.27146426700678,0,24,0 +m_76,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,88.40944193178245,40.719196381858204,20.019161947314608,10.546849574505194,0.07850975853686745,1,108.42860387909707,51.2660459563634,119.27146426700678,0,24,0 +m_76,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,54.484574340672744,64.87750740335757,17.746730912494964,15.075459975759337,0.6666847514042336,1,72.2313052531677,79.9529673791169,87.9482641170286,0,24,0 +m_76,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,54.484574340672744,41.78900913487054,17.746730912494964,11.390709972277442,0.5660769067133911,1,72.2313052531677,53.17971910714798,87.9482641170286,0,24,0 +m_76,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,54.484574340672744,45.14771529684239,17.746730912494964,10.308688478822544,0.6638328802518774,1,72.2313052531677,55.45640377566494,87.9482641170286,0,24,0 +m_76,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,170.59477506636338,164.9949726232054,47.932560967315894,16.765144537376784,0.9156710112136082,1,218.52733603367926,181.76011716058218,305.58556011749033,0,24,0 +m_76,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,170.59477506636338,205.069272822308,47.932560967315894,72.73578182995591,0.7018602781481791,1,218.52733603367926,277.8050546522639,305.58556011749033,0,24,0 +m_76,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,170.59477506636338,190.89606084523405,47.932560967315894,53.654502569388804,0.7836374954199741,1,218.52733603367926,244.55056341462284,305.58556011749033,0,24,0 +m_76,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,135.95692000315353,188.3052821616234,20.25825122428021,27.683083097788273,0.1607556734381366,1,156.21517122743373,215.9883652594117,332.1642345162882,0,24,0 +m_76,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,135.95692000315353,193.57010126169843,20.25825122428021,40.10059835120398,0.23844217208690022,1,156.21517122743373,233.6706996129024,332.1642345162882,0,24,0 +m_76,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,135.95692000315353,237.4663383180732,20.25825122428021,64.50114760582518,0.18410476281686952,1,156.21517122743373,301.9674859238984,332.1642345162882,0,24,0 +m_76,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,138.37643855007204,225.60952307248522,25.568656450029287,29.32324320964424,0.04929299916778431,1,163.94509500010133,254.93276628212945,280.4260429103424,0,24,0 +m_76,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,138.37643855007204,188.54532904145017,25.568656450029287,32.69770639706526,0.25616383639021223,1,163.94509500010133,221.24303543851545,280.4260429103424,0,24,0 +m_76,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,138.37643855007204,146.73757346733896,25.568656450029287,21.78437913466131,0.8085896814060914,1,163.94509500010133,168.52195260200028,280.4260429103424,0,24,0 +m_76,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,181.8259570369428,154.4838326206148,35.82514098609522,40.95366394145622,0.6263827041177769,1,217.65109802303803,195.43749656207103,290.91560813381483,0,24,0 +m_76,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,181.8259570369428,152.54156941422937,35.82514098609522,28.222415042905162,0.5360176343897867,1,217.65109802303803,180.76398445713454,290.91560813381483,0,24,0 +m_76,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,181.8259570369428,238.70673829741554,35.82514098609522,25.761996369688806,0.2292508128304003,1,217.65109802303803,264.46873466710434,290.91560813381483,0,24,0 +m_77,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,607.1892721654009,661.8324607492589,37.8713701711065,39.02096604170599,0.3413701012219522,1,645.0606423365074,700.8534267909648,911.439259438957,0,24,0 +m_77,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,607.1892721654009,635.1973476107291,37.8713701711065,12.75955623665564,0.5152142507154556,1,645.0606423365074,647.9569038473848,911.439259438957,0,24,0 +m_77,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,607.1892721654009,754.6976037459239,37.8713701711065,73.88354119858249,0.11689459019644022,1,645.0606423365074,828.5811449445064,911.439259438957,0,24,0 +m_77,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,597.3351903711382,730.5324790605114,31.562596877127433,15.886484463834067,0.0063383516184857555,0.15212043884365814,628.8977872482657,746.4189635243455,821.0608598767801,0,24,0 +m_77,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,597.3351903711382,659.3251400075447,31.562596877127433,31.416299991143028,0.19410353504178665,1,628.8977872482657,690.7414399986877,821.0608598767801,0,24,0 +m_77,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,597.3351903711382,654.3862348700395,31.562596877127433,35.26860388289481,0.25612547146183,1,628.8977872482657,689.6548387529343,821.0608598767801,0,24,0 +m_77,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,612.0235250440827,629.6166230948753,26.59146177291989,37.449065081586895,0.7109985570642818,1,638.6149868170025,667.0656881764622,844.4367210907914,0,24,0 +m_77,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,612.0235250440827,710.4174360552867,26.59146177291989,57.25231039088725,0.17312449984356312,1,638.6149868170025,767.6697464461739,844.4367210907914,0,24,0 +m_77,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,612.0235250440827,694.644571890351,26.59146177291989,50.05993802241919,0.18564845267198368,1,638.6149868170025,744.7045099127702,844.4367210907914,0,24,0 +m_77,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,598.5025834222519,715.2088307439365,40.82491167966805,26.24934727407282,0.04700356731152215,1,639.3274951019199,741.4581780180093,878.3355675242246,0,24,0 +m_77,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,598.5025834222519,667.7054979591287,40.82491167966805,42.37932698522853,0.2699137803278626,1,639.3274951019199,710.0848249443573,878.3355675242246,0,24,0 +m_77,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,598.5025834222519,716.6660003822324,40.82491167966805,81.82087918524448,0.23599360092058497,1,639.3274951019199,798.4868795674769,878.3355675242246,0,24,0 +m_77,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,17181.93758258304,15477.74973700597,922.3232463942702,864.474230328872,0.2074823848946426,1,18104.26082897731,16342.223967334841,19950.107099719782,0,24,0 +m_77,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,17181.93758258304,16764.184381653497,922.3232463942702,915.4526976887184,0.7544737603723817,1,18104.26082897731,17679.637079342214,19950.107099719782,0,24,0 +m_77,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,17181.93758258304,16657.97542058085,922.3232463942702,1478.4855791644027,0.7709832423378488,1,18104.26082897731,18136.460999745254,19950.107099719782,0,24,0 +m_77,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,15222.381974888109,16354.261597895029,1149.3035430879931,1135.6115926941377,0.4995625876583142,1,16371.685517976102,17489.873190589165,21469.513713172877,0,24,0 +m_77,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,15222.381974888109,16476.490991073173,1149.3035430879931,718.3902776132896,0.3806552918110646,1,16371.685517976102,17194.881268686462,21469.513713172877,0,24,0 +m_77,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,15222.381974888109,17670.197862279892,1149.3035430879931,1847.5418769681735,0.2918308183071617,1,16371.685517976102,19517.739739248067,21469.513713172877,0,24,0 +m_77,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,14180.619541235512,16977.454295702308,206.55614428125517,1108.1813275438892,0.052615593103632764,1,14387.175685516768,18085.6356232462,22811.745205779625,0,24,0 +m_77,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,14180.619541235512,18104.555799480175,206.55614428125517,1566.4974073810154,0.05397426175532027,1,14387.175685516768,19671.05320686119,22811.745205779625,0,24,0 +m_77,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,14180.619541235512,18558.776198101732,206.55614428125517,2179.1739889706514,0.10091745323187917,1,14387.175685516768,20737.950187072383,22811.745205779625,0,24,0 +m_77,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,15066.853658787537,19552.04141596353,685.8598402334379,1860.1869788454142,0.062040729192790425,1,15752.713499020974,21412.228394808943,23553.451234289838,0,24,0 +m_77,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,15066.853658787537,15408.742327782991,685.8598402334379,436.7079823065878,0.6845864126787151,1,15752.713499020974,15845.450310089578,23553.451234289838,0,24,0 +m_77,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,15066.853658787537,18355.120436847625,685.8598402334379,1763.037497749877,0.12916597539621422,1,15752.713499020974,20118.1579345975,23553.451234289838,0,24,0 +m_78,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,229.55080185990076,64.89351547063492,166.7827392317347,1.7515890003547698,0.37941934385537357,1,396.3335410916354,66.6451044709897,753.2852607232626,0,24,0 +m_78,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,229.55080185990076,374.0511737276547,166.7827392317347,310.75360874803846,0.693439542970667,1,396.3335410916354,684.8047824756932,753.2852607232626,0,24,0 +m_78,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,229.55080185990076,63.40477842413303,166.7827392317347,0.6463560689283486,0.3755447522781637,1,396.3335410916354,64.05113449306138,753.2852607232626,0,24,0 +m_78,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,63.346969528619866,324.6156105043382,1.0781994931607,261.20749514134985,0.3631168950680715,1,64.42516902178056,585.823105645688,644.4054162102568,0,24,0 +m_78,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,63.346969528619866,64.65208104042583,1.0781994931607,1.0235707310185693,0.40066785432316665,1,64.42516902178056,65.6756517714444,644.4054162102568,0,24,0 +m_78,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,63.346969528619866,64.30420463114022,1.0781994931607,0.9486228689080823,0.5203808154968027,1,64.42516902178056,65.25282750004831,644.4054162102568,0,24,0 +m_78,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,65.27125361129964,62.16279960331607,1.3810591915143624,0.4983565593317606,0.08736959428058107,1,66.65231280281401,62.66115616264783,430.2985468389849,0,24,0 +m_78,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,65.27125361129964,227.6816729400898,1.3810591915143624,163.4988241862601,0.3767763406571942,1,66.65231280281401,391.1804971263499,430.2985468389849,0,24,0 +m_78,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,65.27125361129964,62.96462415288913,1.3810591915143624,0.6224349532664674,0.18209208995746648,1,66.65231280281401,63.5870591061556,430.2985468389849,0,24,0 +m_78,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,62.8704966822211,66.2658396516872,1.4286530474566532,2.470488765311661,0.26904771116933085,1,64.29914972967775,68.73632841699886,75.60996125869875,0,24,0 +m_78,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,62.8704966822211,62.1621624475353,1.4286530474566532,1.223096168812046,0.7157802850932733,1,64.29914972967775,63.38525861634735,75.60996125869875,0,24,0 +m_78,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,62.8704966822211,61.716761972874224,1.4286530474566532,1.2626171439759604,0.5608575043233566,1,64.29914972967775,62.97937911685018,75.60996125869875,0,24,0 +m_78,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,100.47766545845039,97.5701210175047,1.5461273199857568,0.6582777809667041,0.12875668026177353,1,102.02379277843615,98.2283987984714,114.07560694035863,0,24,0 +m_78,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,100.47766545845039,98.26689687625691,1.5461273199857568,0.4524100173326376,0.2202506568033049,1,102.02379277843615,98.71930689358955,114.07560694035863,0,24,0 +m_78,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,100.47766545845039,101.18615525120647,1.5461273199857568,2.5189419673013638,0.8163691232317356,1,102.02379277843615,103.70509721850783,114.07560694035863,0,24,0 +m_78,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,102.79528155880061,102.90622988864389,2.7961741290747173,2.4627757282309743,0.9768408105728618,1,105.59145568787532,105.36900561687487,116.15060125666287,0,24,0 +m_78,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,102.79528155880061,101.73088822771894,2.7961741290747173,2.7662791355347354,0.7921945400957451,1,105.59145568787532,104.49716736325367,116.15060125666287,0,24,0 +m_78,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,102.79528155880061,101.93640335565952,2.7961741290747173,2.22921379346344,0.8152820398944065,1,105.59145568787532,104.16561714912297,116.15060125666287,0,24,0 +m_78,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,98.55734383950625,100.36855446297128,1.3236705511925042,1.8883364818119135,0.45248327711281533,1,99.88101439069875,102.2568909447832,112.48258003926152,0,24,0 +m_78,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,98.55734383950625,99.38552640793094,1.3236705511925042,1.1753759583372165,0.6500617186873971,1,99.88101439069875,100.56090236626815,112.48258003926152,0,24,0 +m_78,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,98.55734383950625,98.93459222955947,1.3236705511925042,1.0436983858635998,0.8276597597786464,1,99.88101439069875,99.97829061542308,112.48258003926152,0,24,0 +m_78,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,100.49015468400951,103.79022345361179,1.3688753376790428,1.6216918656988408,0.15184857141410413,1,101.85903002168855,105.41191531931062,115.9531068512417,0,24,0 +m_78,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,100.49015468400951,100.90004949813401,1.3688753376790428,3.209847049196528,0.9099059847334008,1,101.85903002168855,104.10989654733054,115.9531068512417,0,24,0 +m_78,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,100.49015468400951,102.14136299128619,1.3688753376790428,2.702072055818078,0.601685681780534,1,101.85903002168855,104.84343504710426,115.9531068512417,0,24,0 +m_79,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,136.09893195858092,145.86046085693738,6.1559164492465674,2.028652575972353,0.19393042502456015,1,142.2548484078275,147.88911343290974,175.411996529625,0,24,0 +m_79,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,136.09893195858092,138.96758284977062,6.1559164492465674,2.891158333406799,0.6885226658527086,1,142.2548484078275,141.85874118317741,175.411996529625,0,24,0 +m_79,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,136.09893195858092,152.28800611154776,6.1559164492465674,7.1774452790204,0.12109431557206303,1,142.2548484078275,159.46545139056815,175.411996529625,0,24,0 +m_79,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,115.0844034525808,123.01813716003178,2.152213664238878,4.176479527059791,0.13238940939040963,1,117.23661711681967,127.19461668709158,143.84738987266036,0,24,0 +m_79,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,115.0844034525808,119.4588227558703,2.152213664238878,4.586914290425274,0.4161493642352204,1,117.23661711681967,124.04573704629557,143.84738987266036,0,24,0 +m_79,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,115.0844034525808,125.71052823648107,2.152213664238878,5.059826193210164,0.09609511064563138,1,117.23661711681967,130.77035442969122,143.84738987266036,0,24,0 +m_79,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,128.8243674230666,107.4746588814869,15.345759341781458,2.110384321414778,0.23774158702437598,1,144.17012676484805,109.58504320290169,158.58713944133288,0,24,0 +m_79,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,128.8243674230666,126.93028483893438,15.345759341781458,11.47629160267224,0.9238841718831052,1,144.17012676484805,138.40657644160663,158.58713944133288,0,24,0 +m_79,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,128.8243674230666,108.54982371416966,15.345759341781458,1.250936599203696,0.257419225018686,1,144.17012676484805,109.80076031337336,158.58713944133288,0,24,0 +m_79,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,109.95671552102958,113.98407733435042,5.464244983955764,4.762601399497952,0.5928371371289956,1,115.42096050498535,118.74667873384837,130.62134660723322,0,24,0 +m_79,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,109.95671552102958,105.78226005848981,5.464244983955764,4.445526165156346,0.5694578054125097,1,115.42096050498535,110.22778622364616,130.62134660723322,0,24,0 +m_79,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,109.95671552102958,110.52948047599553,5.464244983955764,2.636052527014393,0.9279472863442482,1,115.42096050498535,113.16553300300993,130.62134660723322,0,24,0 +m_79,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,265.16216253369726,263.5555397560333,4.915774644308353,9.377751445057566,0.8833660060486264,1,270.0779371780056,272.93329120109087,323.68616983088384,0,24,0 +m_79,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,265.16216253369726,264.7133720062381,4.915774644308353,2.732430447244108,0.93840272164038,1,270.0779371780056,267.4458024534822,323.68616983088384,0,24,0 +m_79,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,265.16216253369726,279.36012977508767,4.915774644308353,14.900024616624854,0.3999735599151061,1,270.0779371780056,294.26015439171255,323.68616983088384,0,24,0 +m_79,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,262.45427409314215,271.82972553952146,9.500952101765945,6.373577386680596,0.4342841660211503,1,271.9552261949081,278.20330292620207,306.0236332188223,0,24,0 +m_79,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,262.45427409314215,263.6681280969986,9.500952101765945,4.762913536873467,0.9121207885023586,1,271.9552261949081,268.43104163387204,306.0236332188223,0,24,0 +m_79,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,262.45427409314215,265.6287897709445,9.500952101765945,6.35151179594683,0.7876562515931619,1,271.9552261949081,271.9803015668913,306.0236332188223,0,24,0 +m_79,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,240.87337315832247,248.8615238737326,3.958802596366331,5.003968423221385,0.24054331389595804,1,244.8321757546888,253.865492296954,279.2520415266494,0,24,0 +m_79,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,240.87337315832247,245.44189376752206,3.958802596366331,3.507435942482686,0.408242793628666,1,244.8321757546888,248.94932971000475,279.2520415266494,0,24,0 +m_79,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,240.87337315832247,246.44155671766458,3.958802596366331,3.4190733964922155,0.31265364861337347,1,244.8321757546888,249.8606301141568,279.2520415266494,0,24,0 +m_79,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,243.54938966397899,253.5126194228069,2.4108377240581493,2.9926817535219716,0.027745258726047328,0.6658862094251359,245.96022738803714,256.5053011763289,282.1558312939618,0,24,0 +m_79,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,243.54938966397899,246.89326499585582,2.4108377240581493,6.967125247210056,0.6656341908992611,1,245.96022738803714,253.86039024306586,282.1558312939618,0,24,0 +m_79,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,243.54938966397899,249.26545053194602,2.4108377240581493,7.230985914541593,0.4812275441058471,1,245.96022738803714,256.4964364464876,282.1558312939618,0,24,0 +m_80,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,54.222126009134534,55.19682448321747,5.197182507313685,1.962014629278702,0.8674266561872928,1,59.41930851644822,57.15883911249617,81.31342860278467,0,24,0 +m_80,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,54.222126009134534,50.4084484657105,5.197182507313685,1.495498534103458,0.5143362102605165,1,59.41930851644822,51.903946999813954,81.31342860278467,0,24,0 +m_80,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,54.222126009134534,64.91740604881215,5.197182507313685,9.003892680992076,0.3344151753637788,1,59.41930851644822,73.921298729804235,81.31342860278467,0,24,0 +m_80,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,47.50816131333528,55.00845459137131,1.0437073978332585,2.161306084107385,0.016099879724034264,0.38639711337682237,48.55186871116854,57.1697606754787,62.886736743026574,0,24,0 +m_80,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,47.50816131333528,47.94879849152035,1.0437073978332585,1.26420294419584,0.7937519804041565,1,48.55186871116854,49.21300143571619,62.886736743026574,0,24,0 +m_80,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,47.50816131333528,50.10479633192675,1.0437073978332585,1.6433553475968286,0.21702046455135915,1,48.55186871116854,51.74815167952358,62.886736743026574,0,24,0 +m_80,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,49.79770295664674,46.7987228571543,1.2062399601896334,1.4153804909505427,0.14135515881279567,1,51.00394291683637,48.21410334810484,59.297411594408835,0,24,0 +m_80,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,49.79770295664674,46.83518723779339,1.2062399601896334,1.7138593235218482,0.19933835089257176,1,51.00394291683637,48.54904656131524,59.297411594408835,0,24,0 +m_80,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,49.79770295664674,50.436227151198764,1.2062399601896334,3.4705106619001684,0.8675957741366959,1,51.00394291683637,53.906737813098935,59.297411594408835,0,24,0 +m_80,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,52.85511393128503,51.19074861078904,4.069464220841183,2.063410098398778,0.7277827752210723,1,56.924578152126216,53.25415870918782,62.61703596733884,0,24,0 +m_80,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,52.85511393128503,51.10532220562529,4.069464220841183,3.8631043743144486,0.7624483086070233,1,56.924578152126216,54.96842657993974,62.61703596733884,0,24,0 +m_80,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,52.85511393128503,49.95717598289519,4.069464220841183,2.2932507861881235,0.5563517868360266,1,56.924578152126216,52.25042676908331,62.61703596733884,0,24,0 +m_80,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,125.86971456698815,125.8618338841878,4.109876571137474,2.551034503854758,0.9987383424733681,1,129.9795911381256,128.41286838804257,152.58886736890165,0,24,0 +m_80,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,125.86971456698815,124.83906240645186,4.109876571137474,4.953796726882033,0.8760808009977357,1,129.9795911381256,129.7928591333339,152.58886736890165,0,24,0 +m_80,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,125.86971456698815,134.37238129658624,4.109876571137474,4.344770856960703,0.18563504004392756,1,129.9795911381256,138.71715215354695,152.58886736890165,0,24,0 +m_80,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,132.88471926631746,137.6520561892521,5.537390804048632,6.339181787047456,0.58383959632001,1,138.4221100703661,143.99123797629957,164.02396421418115,0,24,0 +m_80,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,132.88471926631746,143.12703032961565,5.537390804048632,5.985664410549022,0.2378069088196837,1,138.4221100703661,149.11269474016467,164.02396421418115,0,24,0 +m_80,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,132.88471926631746,133.37199239644167,5.537390804048632,2.561225478716601,0.9385639610920216,1,138.4221100703661,135.93321787515828,164.02396421418115,0,24,0 +m_80,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,138.05533092624532,146.59968531149357,6.216624982431891,4.541496253780132,0.29537602657323386,1,144.2719559086772,151.1411815652737,166.2552997218011,0,24,0 +m_80,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,138.05533092624532,134.52616317993278,6.216624982431891,3.8852481963977232,0.6425312362245562,1,144.2719559086772,138.4114113763305,166.2552997218011,0,24,0 +m_80,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,138.05533092624532,142.92365329699268,6.216624982431891,4.240791228695619,0.5341432457451853,1,144.2719559086772,147.1644445256883,166.2552997218011,0,24,0 +m_80,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,145.91831693350866,162.9580757139473,5.856099056910434,5.9713851996891485,0.06896301374802863,1,151.7744159904191,168.92946091363643,189.74014449776917,0,24,0 +m_80,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,145.91831693350866,141.55582779490413,5.856099056910434,3.87597343562314,0.5504349162494104,1,151.7744159904191,145.43180123052727,189.74014449776917,0,24,0 +m_80,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,145.91831693350866,162.80143934579775,5.856099056910434,9.689601106719676,0.17323724175648517,1,151.7744159904191,172.4910404525174,189.74014449776917,0,24,0 +m_81,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1458.9173011281637,1331.2927900435116,150.94363437177657,118.09616802284017,0.5242015878169417,1,1609.8609354999403,1449.3889580663517,3364.1931712004343,0,24,0 +m_81,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1458.9173011281637,2495.2561663483907,150.94363437177657,563.1012620156404,0.12831158720386773,1,1609.8609354999403,3058.357428364031,3364.1931712004343,0,24,0 +m_81,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1458.9173011281637,1444.078746497433,150.94363437177657,81.95748090217556,0.9338480128346245,1,1609.8609354999403,1526.0362273996086,3364.1931712004343,0,24,0 +m_81,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,414.496548283176,653.7405278247923,52.97166550570133,104.2853727150661,0.07779923349692963,1,467.46821378887734,758.0259005398584,833.8284905938443,0,24,0 +m_81,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,414.496548283176,474.0277634849307,52.97166550570133,97.11942875561387,0.6056249003717857,1,467.46821378887734,571.1471922405445,833.8284905938443,0,24,0 +m_81,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,414.496548283176,576.3184399178122,52.97166550570133,83.42178553764232,0.13805698277576126,1,467.46821378887734,659.7402254554545,833.8284905938443,0,24,0 +m_81,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,449.7440386741406,382.1854085189345,185.5959818386941,58.384863109899264,0.7431394712467418,1,635.3400205128347,440.5702716288337,698.8740225641183,0,24,0 +m_81,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,449.7440386741406,404.6728245417356,185.5959818386941,147.50036305326557,0.8541885901443255,1,635.3400205128347,552.1731875950012,698.8740225641183,0,24,0 +m_81,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,449.7440386741406,502.1502019752894,185.5959818386941,34.949546882326395,0.7942842209359293,1,635.3400205128347,537.0997488576159,698.8740225641183,0,24,0 +m_81,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,261.347965154705,255.44003811756954,68.4359137390703,23.540435140787235,0.9381378768433248,1,329.7838788937753,278.98047325835677,459.4204613389905,0,24,0 +m_81,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,261.347965154705,194.0786707992143,68.4359137390703,25.345180268013713,0.3981897275218951,1,329.7838788937753,219.42385106722801,459.4204613389905,0,24,0 +m_81,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,261.347965154705,363.2729869293011,68.4359137390703,54.38197792432658,0.2768980018127065,1,329.7838788937753,417.6549648536277,459.4204613389905,0,24,0 +m_81,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,9445.259149577016,7529.973244824174,1060.6298320810727,324.9888201100197,0.135572514566622,1,10505.888981658089,7854.962064934193,11556.477879823899,0,24,0 +m_81,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,9445.259149577016,7390.977186073711,1060.6298320810727,399.4030006910441,0.11683351722555195,1,10505.888981658089,7790.380186764755,11556.477879823899,0,24,0 +m_81,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,9445.259149577016,7507.640262812561,1060.6298320810727,835.84039389952,0.1834790655407608,1,10505.888981658089,8343.480656712081,11556.477879823899,0,24,0 +m_81,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,8521.753117668031,6012.44350599407,374.6557179559137,191.26722444928737,4.449743437513621e-4,0.01023440990628133,8896.408835623944,6203.7107304433575,9786.04971918634,0,24,0 +m_81,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,8521.753117668031,6624.151953092283,374.6557179559137,407.5218397089155,0.006526449190836885,0.1305289838167377,8896.408835623944,7031.673792801199,9786.04971918634,0,24,0 +m_81,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,8521.753117668031,6540.112074627463,374.6557179559137,281.8682128492208,0.00206728977333205,0.043413085239973045,8896.408835623944,6821.980287476684,9786.04971918634,0,24,0 +m_81,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,8979.148599273423,6596.929963179095,334.47362095667904,335.44668958391634,5.149694726975727e-4,0.011329328399346599,9313.622220230103,6932.3766527630105,10244.984442253115,0,24,0 +m_81,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,8979.148599273423,6986.812556207087,334.47362095667904,511.3708379378002,0.01041792191167865,0.19794051632189433,9313.622220230103,7498.183394144888,10244.984442253115,0,24,0 +m_81,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,8979.148599273423,5974.167067539434,334.47362095667904,194.81935363283847,5.26275578595493e-5,0.0012630613886291833,9313.622220230103,6168.9864211722725,10244.984442253115,0,24,0 +m_81,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,7540.877985370558,6260.475637234449,405.7580027358975,442.5695476106947,0.058974869165736306,1,7946.635988106455,6703.045184845144,8741.2995869171,0,24,0 +m_81,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,7540.877985370558,7130.289482479089,405.7580027358975,206.63232520096915,0.39549792756210056,1,7946.635988106455,7336.921807680058,8741.2995869171,0,24,0 +m_81,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,7540.877985370558,6465.606481073294,405.7580027358975,384.65928561046314,0.08345135061934325,1,7946.635988106455,6850.265766683758,8741.2995869171,0,24,0 +m_82,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,7767.503126167148,5325.899408582503,1553.0036496291218,944.7518189893949,0.22251470630320427,1,9320.50677579627,6270.651227571898,10252.557453375897,0,24,0 +m_82,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,7767.503126167148,6041.708986196922,1553.0036496291218,600.5699947355271,0.34581928583185145,1,9320.50677579627,6642.278980932449,10252.557453375897,0,24,0 +m_82,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,7767.503126167148,4238.226821171917,1553.0036496291218,617.2497511532157,0.08568403411808588,1,9320.50677579627,4855.476572325133,10252.557453375897,0,24,0 +m_82,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,5901.959480872984,6547.26772791548,379.1511391577789,736.7249309331455,0.46002308806590786,1,6281.110620030763,7283.992658848625,8012.391924733488,0,24,0 +m_82,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,5901.959480872984,5430.7980155436635,379.1511391577789,348.6981856642908,0.38203808099992265,1,6281.110620030763,5779.496201207954,8012.391924733488,0,24,0 +m_82,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,5901.959480872984,4605.313170156286,379.1511391577789,254.325329441478,0.019960048320171512,0.45908111136394475,6281.110620030763,4859.638499597764,8012.391924733488,0,24,0 +m_82,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,11263.780275552652,7175.715990872219,3245.36950959722,619.6751778236279,0.2793508505328331,1,14509.149785149872,7795.391168695846,15960.064763664861,0,24,0 +m_82,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,11263.780275552652,6711.161327331242,3245.36950959722,1051.9490690019038,0.24148785866428382,1,14509.149785149872,7763.110396333146,15960.064763664861,0,24,0 +m_82,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,11263.780275552652,5529.801311764739,3245.36950959722,723.1017515928497,0.15318096507847492,1,14509.149785149872,6252.9030633575885,15960.064763664861,0,24,0 +m_82,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,5107.556668860965,6972.245441806576,487.73998169621524,318.6509991848608,0.014747150504198229,0.3539316121007575,5595.29665055718,7290.896440991437,8019.986085090582,0,24,0 +m_82,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,5107.556668860965,5875.5331898674185,487.73998169621524,477.4618560297199,0.29012549564748724,1,5595.29665055718,6352.995045897138,8019.986085090582,0,24,0 +m_82,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,5107.556668860965,6521.887849323294,487.73998169621524,484.8741693330931,0.07030775443156462,1,5595.29665055718,7006.762018656387,8019.986085090582,0,24,0 +m_82,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,83725.26771891712,83235.14758122317,14228.559815781657,11583.047482259897,0.9792349801472932,1,97953.82753469878,94818.19506348306,176410.76350147603,0,24,0 +m_82,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,83725.26771891712,97711.06249351343,14228.559815781657,9708.958892105162,0.4381810358166601,1,97953.82753469878,107420.02138561859,176410.76350147603,0,24,0 +m_82,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,83725.26771891712,122591.1234927811,14228.559815781657,37782.297872197094,0.3707107418558924,1,97953.82753469878,160373.4213649782,176410.76350147603,0,24,0 +m_82,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,87315.25067000066,194636.53444727827,13465.145853155334,39370.68828425219,0.04087260070350426,0.8991972154770936,100780.396523156,234007.22273153046,257407.94500468354,0,24,0 +m_82,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,87315.25067000066,139751.01244555466,13465.145853155334,20527.978103832476,0.062718735155603,1,100780.396523156,160278.99054938715,257407.94500468354,0,24,0 +m_82,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,87315.25067000066,83895.50943599254,13465.145853155334,8068.923417938428,0.832881974740344,1,100780.396523156,91964.43285393096,257407.94500468354,0,24,0 +m_82,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,112267.5825168915,114229.4351355467,39829.72227532762,14648.727168404952,0.9645526188072201,1,152097.30479221913,128878.16230395164,444130.16820647917,0,24,0 +m_82,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,112267.5825168915,280686.7677945544,39829.72227532762,123067.93057497208,0.240386977722501,1,152097.30479221913,403754.6983695265,444130.16820647917,0,24,0 +m_82,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,112267.5825168915,112142.4402485937,39829.72227532762,18495.364853988154,0.9978051346287026,1,152097.30479221913,130637.80510258186,444130.16820647917,0,24,0 +m_82,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,180330.65339424144,204720.9282997571,42015.94977651779,23020.163442523513,0.6248518071808822,1,222346.60317075922,227741.0917422806,373383.580383476,0,24,0 +m_82,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,180330.65339424144,293715.7648951298,42015.94977651779,43136.659026037414,0.08911274077236653,1,222346.60317075922,336852.4239211672,373383.580383476,0,24,0 +m_82,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,180330.65339424144,272085.7502494205,42015.94977651779,67353.86828101214,0.27963973697980016,1,222346.60317075922,339439.6185304327,373383.580383476,0,24,0 +m_83,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,319.7046506096342,341.7897470758166,49.02446546447622,21.744258549293235,0.6958938877117269,1,368.72911607411044,363.53400562510984,564.6051594576311,0,24,0 +m_83,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,319.7046506096342,477.40366877959724,49.02446546447622,35.873748909158245,0.03295148868022925,0.7578842396452727,368.72911607411044,513.2774176887555,564.6051594576311,0,24,0 +m_83,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,319.7046506096342,424.37207935715145,49.02446546447622,30.444197368485074,0.11344254594002051,1,368.72911607411044,454.8162767256365,564.6051594576311,0,24,0 +m_83,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,159.73421242690517,230.67328681844106,29.421679324543327,14.369813129958962,0.06559539057599743,1,189.1558917514485,245.04309994840003,531.5025702780978,0,24,0 +m_83,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,159.73421242690517,390.3170174044967,29.421679324543327,92.86713739377397,0.05579376136947622,1,189.1558917514485,483.1841547982707,531.5025702780978,0,24,0 +m_83,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,159.73421242690517,273.3153880939625,29.421679324543327,57.012016221161765,0.11718887546417114,1,189.1558917514485,330.3274043151243,531.5025702780978,0,24,0 +m_83,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,286.8118571485732,243.46566645022338,129.47989798349096,21.310401708316725,0.75691623405795,1,416.29175513206417,264.7760681585401,457.92093064527063,0,24,0 +m_83,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,286.8118571485732,283.35094614137296,129.47989798349096,69.0306181167121,0.9819345604406815,1,416.29175513206417,352.38156425808506,457.92093064527063,0,24,0 +m_83,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,286.8118571485732,308.3716112254849,129.47989798349096,55.39336603764986,0.8838346293963262,1,416.29175513206417,363.76497726313477,457.92093064527063,0,24,0 +m_83,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,98.01831453553807,182.8319579579749,22.959529607159162,16.661979548680062,0.018305589853226164,0.4393341564774279,120.97784414269722,199.49393750665496,225.1209132839267,0,24,0 +m_83,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,98.01831453553807,137.9130670820475,22.959529607159162,13.64256874554292,0.18102220213961193,1,120.97784414269722,151.5556358275904,225.1209132839267,0,24,0 +m_83,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,98.01831453553807,178.17755349273278,22.959529607159162,26.477822219927845,0.0480151064320628,1,120.97784414269722,204.65537571266063,225.1209132839267,0,24,0 +m_83,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1928.654338711422,1830.2480837596272,294.008012730954,180.23543994485107,0.782370049137201,1,2222.662351442376,2010.4835237044783,2461.9756494156013,0,24,0 +m_83,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1928.654338711422,2074.007062022949,294.008012730954,104.59642731553065,0.657171121080417,1,2222.662351442376,2178.6034893384794,2461.9756494156013,0,24,0 +m_83,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1928.654338711422,2000.0845018778195,294.008012730954,238.07517940909085,0.8541772786900794,1,2222.662351442376,2238.15968128691,2461.9756494156013,0,24,0 +m_83,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2521.5821357960617,2319.275237980529,373.55776924585786,217.09874896793625,0.6520599160526219,1,2895.1399050419195,2536.3739869484652,3606.571511227272,0,24,0 +m_83,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2521.5821357960617,2967.2057699686193,373.55776924585786,311.49560387435474,0.3818109917385907,1,2895.1399050419195,3278.701373842974,3606.571511227272,0,24,0 +m_83,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,2521.5821357960617,1463.9917860165222,373.55776924585786,192.40407422129354,0.03792733338744621,0.8344013345238166,2895.1399050419195,1656.3958602378157,3606.571511227272,0,24,0 +m_83,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2329.479413444333,1665.0373370747352,550.5707064947953,125.18723231474094,0.28755587237373603,1,2880.0501199391283,1790.224569389476,3168.0551319330416,0,24,0 +m_83,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2329.479413444333,2191.6429488928543,550.5707064947953,307.52701599857073,0.8325666933380926,1,2880.0501199391283,2499.169964891425,3168.0551319330416,0,24,0 +m_83,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2329.479413444333,1743.45216735061,550.5707064947953,348.1301149476239,0.3932344490898777,1,2880.0501199391283,2091.5822822982336,3168.0551319330416,0,24,0 +m_83,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1812.4793707702274,1700.7401151424301,407.3504402646862,222.6352688105282,0.8160363155465743,1,2219.8298110349137,1923.3753839529584,3469.5237288399303,0,24,0 +m_83,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1812.4793707702274,2734.2142295854674,407.3504402646862,419.89825117810545,0.14623299510207552,1,2219.8298110349137,3154.112480763573,3469.5237288399303,0,24,0 +m_83,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1812.4793707702274,1731.6569629821886,407.3504402646862,337.26128865171273,0.8816781686407014,1,2219.8298110349137,2068.9182516339015,3469.5237288399303,0,24,0 +m_84,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,9807.420358442967,10051.783054371404,4843.7217295217515,1096.6399752869452,0.9629052123517567,1,14651.14208796472,11148.42302965835,20724.654485774183,0,24,0 +m_84,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,9807.420358442967,12375.304425474409,4843.7217295217515,6465.290561593028,0.7580444899107313,1,14651.14208796472,18840.594987067438,20724.654485774183,0,24,0 +m_84,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,9807.420358442967,12594.213248202863,4843.7217295217515,3988.9207165457165,0.6683919324731774,1,14651.14208796472,16583.13396474858,20724.654485774183,0,24,0 +m_84,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,562.292579486503,1876.4808655955426,81.27331064762268,610.2365755228343,0.08399996225807774,1,643.5658901341257,2486.717441118377,2735.389185230215,0,24,0 +m_84,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,562.292579486503,511.6428858994674,81.27331064762268,88.89819105742909,0.6830809837896771,1,643.5658901341257,600.5410769568965,2735.389185230215,0,24,0 +m_84,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,562.292579486503,1259.0333499966468,81.27331064762268,362.09602010061604,0.11394413399784754,1,643.5658901341257,1621.1293700972628,2735.389185230215,0,24,0 +m_84,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1734.5601178275288,439.57751104705005,1105.720455485062,156.76511340515168,0.3084049259384964,1,2840.2805733125906,596.3426244522018,3124.30863064385,0,24,0 +m_84,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1734.5601178275288,429.9751697748902,1105.720455485062,158.72392779379635,0.3053342705622358,1,2840.2805733125906,588.6990975686865,3124.30863064385,0,24,0 +m_84,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1734.5601178275288,570.1926404620473,1105.720455485062,125.30411405863161,0.3530855130154059,1,2840.2805733125906,695.4967545206789,3124.30863064385,0,24,0 +m_84,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,434.5650550234931,498.22956046599074,138.2699598944567,108.26428105863044,0.7263456032795517,1,572.8350149179498,606.4938415246212,1025.1922050753813,0,24,0 +m_84,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,434.5650550234931,297.25940521769974,138.2699598944567,59.055437985351226,0.3997397153159756,1,572.8350149179498,356.31484320305094,1025.1922050753813,0,24,0 +m_84,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,434.5650550234931,732.7966080238764,138.2699598944567,199.1963056810156,0.25164772699694893,1,572.8350149179498,931.992913704892,1025.1922050753813,0,24,0 +m_84,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2091807.4870880158,2408856.9656015867,172063.90288127508,217387.47601803875,0.2807975542468366,1,2263871.3899692907,2626244.4416196253,3686247.5054059345,0,24,0 +m_84,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2091807.4870880158,2391735.2680982924,172063.90288127508,202135.48689835626,0.2855545907185258,1,2263871.3899692907,2593870.7549966485,3686247.5054059345,0,24,0 +m_84,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,2091807.4870880158,3127215.0375841986,172063.90288127508,223919.05823937783,0.004834169946488598,0.11602007871572634,2263871.3899692907,3351134.0958235767,3686247.5054059345,0,24,0 +m_84,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,414853.8934497313,666691.0471194226,145359.11651901342,143488.67469718194,0.24578551260911485,1,560213.0099687447,810179.7218166045,993916.7463137924,0,24,0 +m_84,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,414853.8934497313,286821.4803318923,145359.11651901342,75965.36676471336,0.45882004339203586,1,560213.0099687447,362786.8470966057,993916.7463137924,0,24,0 +m_84,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,414853.8934497313,750804.5339857378,145359.11651901342,152756.1444813462,0.14227271920620072,1,560213.0099687447,903560.678467084,993916.7463137924,0,24,0 +m_84,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,15754.750123365417,31753.003085088178,3810.1189355762835,3314.302408674798,0.010254105090239623,0.23584441707551132,19564.869058941702,35067.30549376298,50450.848247973154,0,24,0 +m_84,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,15754.750123365417,17430.326100672995,3810.1189355762835,2572.409791165925,0.7241309067373805,1,19564.869058941702,20002.735891838922,50450.848247973154,0,24,0 +m_84,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,15754.750123365417,37803.26244206832,3810.1189355762835,8061.145056089085,0.04205848346376924,0.9252866362029233,19564.869058941702,45864.40749815741,50450.848247973154,0,24,0 +m_84,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,9833.502392298877,12408.401553963236,1004.0789776783865,1020.7024729733977,0.10232930788272351,1,10837.581369977263,13429.104026936635,14772.014429630299,0,24,0 +m_84,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,9833.502392298877,10047.6093605823,1004.0789776783865,698.8075909817431,0.8649696070124844,1,10837.581369977263,10746.416951564044,14772.014429630299,0,24,0 +m_84,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,9833.502392298877,9943.190173087283,1004.0789776783865,1110.3797552069152,0.943050459167965,1,10837.581369977263,11053.569928294199,14772.014429630299,0,24,0 +m_85,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,50.25814193787295,63.75321754351509,4.99638000726153,1.9563365033938283,0.051456728822099555,1,55.25452194513448,65.70955404690892,99.81440458768417,0,24,0 +m_85,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,50.25814193787295,56.9564945184585,4.99638000726153,8.42901234113405,0.5137469047204553,1,55.25452194513448,65.38550685959255,99.81440458768417,0,24,0 +m_85,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,50.25814193787295,79.31460596814705,4.99638000726153,11.425761838838547,0.05375059274172163,1,55.25452194513448,90.7403678069856,99.81440458768417,0,24,0 +m_85,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,41.383975932095495,44.44291662874228,1.227112838554013,2.508776464593104,0.308374840125633,1,42.61108877064951,46.951693093335386,70.35650311887709,0,24,0 +m_85,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,41.383975932095495,51.618618551682,1.227112838554013,7.237115645020163,0.2189916410223513,1,42.61108877064951,58.85573419670216,70.35650311887709,0,24,0 +m_85,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,41.383975932095495,55.21033302891667,1.227112838554013,8.750124351880672,0.17620199235019524,1,42.61108877064951,63.960457380797344,70.35650311887709,0,24,0 +m_85,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,47.405647205874274,43.71094894767554,2.8013767462564423,2.740513614492796,0.37083986412598835,1,50.20702395213072,46.45146256216834,56.45612777568407,0,24,0 +m_85,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,47.405647205874274,45.368820315870664,2.8013767462564423,5.954932207478488,0.7679616526374704,1,50.20702395213072,51.32375252334915,56.45612777568407,0,24,0 +m_85,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,47.405647205874274,41.095634700746444,2.8013767462564423,1.3080361942566243,0.08966384916503957,1,50.20702395213072,42.40367089500307,56.45612777568407,0,24,0 +m_85,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,42.4088060383901,46.738210946860896,2.6339619358896953,4.70139896846527,0.44588724595554163,1,45.04276797427979,51.439609915326166,56.58357090685879,0,24,0 +m_85,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,42.4088060383901,43.185550885197976,2.6339619358896953,3.041214608978588,0.8512005823898302,1,45.04276797427979,46.22676549417656,56.58357090685879,0,24,0 +m_85,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,42.4088060383901,38.61139562054814,2.6339619358896953,1.9298667821692284,0.2797152337844531,1,45.04276797427979,40.541262402717365,56.58357090685879,0,24,0 +m_85,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1290.5036601316474,1483.1824627909245,101.28415180242543,64.92659445956765,0.14563522978045573,1,1391.7878119340728,1548.1090572504922,2325.1918891095766,0,24,0 +m_85,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1290.5036601316474,1530.1834537400648,101.28415180242543,78.85458087191698,0.09320507636843116,1,1391.7878119340728,1609.0380346119819,2325.1918891095766,0,24,0 +m_85,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1290.5036601316474,1853.1587631960635,101.28415180242543,260.6520450853695,0.08739963512919675,1,1391.7878119340728,2113.810808281433,2325.1918891095766,0,24,0 +m_85,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,664.203282239165,911.0709204459462,82.01569892594517,92.08414622461677,0.07352640763858913,1,746.2189811651101,1003.155066670563,1103.4705733376193,0,24,0 +m_85,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,664.203282239165,673.3005188326133,82.01569892594517,69.06937412887207,0.9341087060400686,1,746.2189811651101,742.3698929614853,1103.4705733376193,0,24,0 +m_85,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,664.203282239165,797.9937524819981,82.01569892594517,71.30788989922458,0.24700160490648246,1,746.2189811651101,869.3016423812227,1103.4705733376193,0,24,0 +m_85,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,381.04398548029735,400.19861847670063,11.072679330866846,8.883997953399861,0.20835813888047316,1,392.1166648111642,409.0826164301005,503.99561200789606,0,24,0 +m_85,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,381.04398548029735,412.9016435171184,11.072679330866846,18.931785556893715,0.1841276188884157,1,392.1166648111642,431.8334290740121,503.99561200789606,0,24,0 +m_85,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,381.04398548029735,442.7019440216128,11.072679330866846,15.47588507647446,0.010073336781264668,0.24176008275035205,392.1166648111642,458.1778290980873,503.99561200789606,0,24,0 +m_85,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,385.8715169071063,412.47883226072537,13.806584195577056,15.251556683884187,0.2252495025137596,1,399.67810110268334,427.73038894460956,470.5034278390705,0,24,0 +m_85,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,385.8715169071063,406.6873245648944,13.806584195577056,13.943785450387448,0.31373070792734054,1,399.67810110268334,420.6311100152819,470.5034278390705,0,24,0 +m_85,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,385.8715169071063,392.6384540846114,13.806584195577056,19.17316112509431,0.7809887875858381,1,399.67810110268334,411.8116152097057,470.5034278390705,0,24,0 +m_86,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1537.280639553939,1358.917036266137,161.57359820951646,82.07200564196422,0.3629529941631315,1,1698.8542377634553,1440.9890419081014,1868.739661539801,0,24,0 +m_86,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1537.280639553939,1106.4478736233252,161.57359820951646,171.33683356319034,0.10068335710944692,1,1698.8542377634553,1277.7847071865156,1868.739661539801,0,24,0 +m_86,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1537.280639553939,1031.5304726669206,161.57359820951646,153.59221855686417,0.050214526420020875,1,1698.8542377634553,1185.1226912237848,1868.739661539801,0,24,0 +m_86,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,899.5523644790958,814.1752079581987,78.6487751004289,78.7712121854844,0.46080474347661327,1,978.2011395795247,892.9464201436831,1379.4563177712798,0,24,0 +m_86,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,899.5523644790958,1118.0945601122892,78.6487751004289,135.9566378616014,0.20153120879045,1,978.2011395795247,1254.0511979738906,1379.4563177712798,0,24,0 +m_86,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,899.5523644790958,853.7167281701054,78.6487751004289,107.78525089058547,0.7389696602576168,1,978.2011395795247,961.5019790606909,1379.4563177712798,0,24,0 +m_86,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,851.6485383916953,1023.4767775331366,138.99691959235219,105.72100791909611,0.3544556348880374,1,990.6454579840474,1129.1977854522327,1485.0264178488299,0,24,0 +m_86,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,851.6485383916953,1251.438629430068,138.99691959235219,98.58538679614101,0.050341628597116383,1,990.6454579840474,1350.024016226209,1485.0264178488299,0,24,0 +m_86,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,851.6485383916953,896.9493835205088,138.99691959235219,64.57053311008747,0.7780230272974432,1,990.6454579840474,961.5199166305963,1485.0264178488299,0,24,0 +m_86,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1002.6445024002205,883.8078912918543,147.76764900651452,71.80597736722343,0.49735964611672423,1,1150.4121514067351,955.6138686590778,1265.4533665474087,0,24,0 +m_86,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1002.6445024002205,1043.9418133430775,147.76764900651452,94.85612019427774,0.8207747687608737,1,1150.4121514067351,1138.7979335373552,1265.4533665474087,0,24,0 +m_86,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1002.6445024002205,728.7256194388224,147.76764900651452,73.63736607393963,0.1486605489248891,1,1150.4121514067351,802.362985512762,1265.4533665474087,0,24,0 +m_86,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,23734.370934539536,18893.518600463074,1907.6557881676029,1639.9209575387958,0.08387339927300246,1,25642.026722707138,20533.439558001868,37606.21932790922,0,24,0 +m_86,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,23734.370934539536,20186.661613989214,1907.6557881676029,1798.2118515041518,0.20586944232816476,1,25642.026722707138,21984.873465493365,37606.21932790922,0,24,0 +m_86,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,23734.370934539536,29024.2507970887,1907.6557881676029,5163.221319192401,0.37174049327805647,1,25642.026722707138,34187.472116281104,37606.21932790922,0,24,0 +m_86,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,20082.392095537383,18961.37121081097,1981.9208477668153,2491.1875126455116,0.7323998230242609,1,22064.312943304198,21452.55872345648,31962.296830553583,0,24,0 +m_86,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,20082.392095537383,22954.446830850713,1981.9208477668153,2129.670580854757,0.34693182799725775,1,22064.312943304198,25084.11741170547,31962.296830553583,0,24,0 +m_86,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,20082.392095537383,25703.791725591826,1981.9208477668153,3352.8417567296137,0.18640736517027676,1,22064.312943304198,29056.63348232144,31962.296830553583,0,24,0 +m_86,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,12061.268311501992,13999.65076073196,1519.0355720136577,1097.588668127083,0.3276862511516498,1,13580.30388351565,15097.239428859044,22235.671071212128,0,24,0 +m_86,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,12061.268311501992,17326.608692210873,1519.0355720136577,2887.637736163788,0.1473852806074535,1,13580.30388351565,20214.24642837466,22235.671071212128,0,24,0 +m_86,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,12061.268311501992,13194.881116659282,1519.0355720136577,941.9302078222715,0.5429100892413463,1,13580.30388351565,14136.811324481554,22235.671071212128,0,24,0 +m_86,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6245.085755978491,7691.335392434932,761.5987833058188,751.8152186461723,0.20634325641326223,1,7006.68453928431,8443.150611081104,11443.505886127952,0,24,0 +m_86,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,6245.085755978491,9981.945078734649,761.5987833058188,421.2420904725812,0.002799998466504023,0.06719996319609656,7006.68453928431,10403.187169207229,11443.505886127952,0,24,0 +m_86,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6245.085755978491,8189.289655519432,761.5987833058188,507.5438240315734,0.0636059954088688,1,7006.68453928431,8696.833479551005,11443.505886127952,0,24,0 +m_87,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,284.49809794690213,373.3215210805471,36.506135395254375,45.10992457926518,0.16054340517446733,1,321.0042333421565,418.43144565981225,478.3425023425437,0,24,0 +m_87,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,284.49809794690213,287.1900683050499,36.506135395254375,32.892119013213076,0.9575628670981142,1,321.0042333421565,320.082187318263,478.3425023425437,0,24,0 +m_87,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,284.49809794690213,404.26227018092146,36.506135395254375,30.594550130481892,0.0350841939696896,0.7718522673331711,321.0042333421565,434.85682031140334,478.3425023425437,0,24,0 +m_87,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,233.54789951871354,305.01445903080895,16.255934747639095,37.67740019685298,0.12637677930390187,1,249.80383426635262,342.69185922766195,376.96104515042816,0,24,0 +m_87,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,233.54789951871354,304.70406888423906,16.255934747639095,16.891175075381312,0.012583027742913037,0.3019926658299129,249.80383426635262,321.59524395962035,376.96104515042816,0,24,0 +m_87,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,233.54789951871354,269.249298000791,16.255934747639095,19.32338745497815,0.18864781253380025,1,249.80383426635262,288.57268545576915,376.96104515042816,0,24,0 +m_87,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,247.53209525400527,275.3093048839986,28.99022601881599,26.06810686032798,0.49506481666110325,1,276.5223212728213,301.3774117443266,385.1180513314314,0,24,0 +m_87,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,247.53209525400527,327.7147332931339,28.99022601881599,22.392586099076414,0.06214543081006326,1,276.5223212728213,350.10731939221034,385.1180513314314,0,24,0 +m_87,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,247.53209525400527,293.60045413814,28.99022601881599,16.190033370687892,0.21179223102890204,1,276.5223212728213,309.7904875088279,385.1180513314314,0,24,0 +m_87,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,289.8012081128336,279.8705593304188,32.42772636782549,53.89750922118649,0.878479636870077,1,322.22893448065906,333.7680685516053,426.54171640726884,0,24,0 +m_87,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,289.8012081128336,366.2085741881999,32.42772636782549,21.556622545680778,0.08941599245573531,1,322.22893448065906,387.7651967338807,426.54171640726884,0,24,0 +m_87,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,289.8012081128336,312.3989168772932,32.42772636782549,31.063849863554427,0.6271743789280463,1,322.22893448065906,343.4627667408476,426.54171640726884,0,24,0 +m_87,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,36598.77059076293,43133.15283007709,2465.823511825212,2185.271889376576,0.07587828590721073,1,39064.59410258814,45318.424719453666,58138.9855646462,0,24,0 +m_87,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,36598.77059076293,49317.45924616371,2465.823511825212,3536.1639944237477,0.016343345318993965,0.3758969423368612,39064.59410258814,52853.623240587454,58138.9855646462,0,24,0 +m_87,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,36598.77059076293,39013.423489404115,2465.823511825212,3197.9334648235576,0.5640094448553704,1,39064.59410258814,42211.356954227675,58138.9855646462,0,24,0 +m_87,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,37315.74340119801,33392.229581424275,1985.9127787698185,1824.2641609876941,0.17655190173098428,1,39301.656179967824,35216.49374241197,43231.82179796461,0,24,0 +m_87,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,37315.74340119801,32865.75543683814,1985.9127787698185,5310.653307574041,0.46071727896349157,1,39301.656179967824,38176.40874441218,43231.82179796461,0,24,0 +m_87,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,37315.74340119801,27617.020496387606,1985.9127787698185,4602.411094571917,0.09546847023067845,1,39301.656179967824,32219.431590959524,43231.82179796461,0,24,0 +m_87,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,24759.938144453186,28424.13819905551,4004.280021848227,1471.287858638969,0.42173101484819847,1,28764.218166301413,29895.42605769448,32884.96866346393,0,24,0 +m_87,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,24759.938144453186,23300.28626567406,4004.280021848227,2150.343849838319,0.7566834982761923,1,28764.218166301413,25450.63011551238,32884.96866346393,0,24,0 +m_87,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,24759.938144453186,24764.727202061746,4004.280021848227,908.3670060098527,0.9991104303847529,1,28764.218166301413,25673.094208071598,32884.96866346393,0,24,0 +m_87,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,19122.271903916942,18462.146090872353,2936.916169306036,2188.335139505996,0.8608563854212548,1,22059.188073222977,20650.481230378347,24265.106880545278,0,24,0 +m_87,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,19122.271903916942,18288.58316902436,2936.916169306036,1683.0927422999084,0.8116875846461797,1,22059.188073222977,19971.67591132427,24265.106880545278,0,24,0 +m_87,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,19122.271903916942,18802.65176375464,2936.916169306036,2984.982928843297,0.9406654044622063,1,22059.188073222977,21787.634692597934,24265.106880545278,0,24,0 +m_88,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,95.36830463653448,114.70224679072665,19.21850892016549,13.662805161257658,0.437450298243545,1,114.58681355669997,128.3650519519843,186.82928506086486,0,24,0 +m_88,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,95.36830463653448,96.12522054248602,19.21850892016549,28.974577521443784,0.9831429238755662,1,114.58681355669997,125.0997980639298,186.82928506086486,0,24,0 +m_88,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,95.36830463653448,147.80222872263678,19.21850892016549,22.042575878149453,0.10659155682936869,1,114.58681355669997,169.84480460078623,186.82928506086486,0,24,0 +m_88,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,65.96605268382268,109.3448743858892,5.758563756317681,13.349559211085916,0.021119982698233505,0.48575960205937063,71.72461644014037,122.69443359697512,154.8581376644582,0,24,0 +m_88,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,65.96605268382268,118.05698442027034,5.758563756317681,22.7231407292371,0.07083727992736853,1,71.72461644014037,140.78012514950746,154.8581376644582,0,24,0 +m_88,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,65.96605268382268,81.75947554124673,5.758563756317681,11.123045442477352,0.24514154858288884,1,71.72461644014037,92.88252098372408,154.8581376644582,0,24,0 +m_88,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,74.63233355855702,100.58945344080874,9.137166433872762,19.866914828608007,0.2741999576948374,1,83.76949999242979,120.45636826941674,132.50200509635843,0,24,0 +m_88,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,74.63233355855702,106.77266651584749,9.137166433872762,10.936982653707663,0.05514305039892251,1,83.76949999242979,117.70964916955515,132.50200509635843,0,24,0 +m_88,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,74.63233355855702,99.85723366166405,9.137166433872762,16.158223312788582,0.2125362632384607,1,83.76949999242979,116.01545697445263,132.50200509635843,0,24,0 +m_88,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,111.01681566749893,92.0692849405206,5.957187130969893,16.183496185967957,0.3120830306371671,1,116.97400279846883,108.25278112648856,135.05512438296265,0,24,0 +m_88,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,111.01681566749893,99.39780788169733,5.957187130969893,11.62546431752329,0.40196957122078125,1,116.97400279846883,111.02327219922063,135.05512438296265,0,24,0 +m_88,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,111.01681566749893,106.9861450942349,5.957187130969893,15.791240708458421,0.8187530801461378,1,116.97400279846883,122.77738580269332,135.05512438296265,0,24,0 +m_88,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1802.6391351292646,1975.9244940900257,108.41591941964292,48.39159757311933,0.18829165428284714,1,1911.0550545489075,2024.316091663145,2594.0147551917935,0,24,0 +m_88,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1802.6391351292646,2247.9232385249716,108.41591941964292,110.27199346756771,0.016405119787338975,0.3937228748961354,1911.0550545489075,2358.1952319925394,2594.0147551917935,0,24,0 +m_88,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1802.6391351292646,1805.2959873366626,108.41591941964292,162.43638330570414,0.9894518538352477,1,1911.0550545489075,1967.7323706423667,2594.0147551917935,0,24,0 +m_88,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1805.022981153884,1705.4032769755493,112.72362945280531,77.46969159313385,0.48520999268785225,1,1917.7466106066895,1782.872968568683,2109.5212716673586,0,24,0 +m_88,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1805.022981153884,1775.6039068590899,112.72362945280531,117.25714277844611,0.860087794561663,1,1917.7466106066895,1892.8610496375359,2109.5212716673586,0,24,0 +m_88,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1805.022981153884,1474.9118754684287,112.72362945280531,117.59202802711573,0.07025986840982677,1,1917.7466106066895,1592.5039034955444,2109.5212716673586,0,24,0 +m_88,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1179.37056356463,1452.7316474405125,127.89451933237842,122.2347506863654,0.15340165579353085,1,1307.2650828970084,1574.966398126878,1732.463037939566,0,24,0 +m_88,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1179.37056356463,1126.2202894637378,127.89451933237842,147.66526277208024,0.7912096384662106,1,1307.2650828970084,1273.885552235818,1732.463037939566,0,24,0 +m_88,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1179.37056356463,1375.918487181061,127.89451933237842,82.67867020309512,0.23061728761341688,1,1307.2650828970084,1458.5971573841562,1732.463037939566,0,24,0 +m_88,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1048.3386659324408,1014.261328430965,166.86569872703495,112.77283706606464,0.8694717337788889,1,1215.2043646594757,1127.0341654970296,1336.7248011254233,0,24,0 +m_88,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1048.3386659324408,1047.673543992573,166.86569872703495,111.76943867668619,0.9974320434776971,1,1215.2043646594757,1159.4429826692592,1336.7248011254233,0,24,0 +m_88,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1048.3386659324408,1016.9765406256465,166.86569872703495,132.44762519014614,0.8860389455242639,1,1215.2043646594757,1149.4241658157925,1336.7248011254233,0,24,0 +m_89,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,44343.62828894802,42182.36602658221,7139.39059847449,5198.248423741084,0.8131074681831097,1,51483.01888742251,47380.61445032329,101248.91385732123,0,24,0 +m_89,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,44343.62828894802,57988.95624837174,7139.39059847449,7098.672966147222,0.2087879748921613,1,51483.01888742251,65087.62921451896,101248.91385732123,0,24,0 +m_89,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,44343.62828894802,83951.50999466103,7139.39059847449,8092.957148358251,0.0051555109803408964,0.12373226352818151,51483.01888742251,92044.46714301928,101248.91385732123,0,24,0 +m_89,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,10542.092483765766,22293.042542582945,2068.40267131752,8350.712815173612,0.22417690207453367,1,12610.495155083285,30643.755357756556,33708.130893532216,0,23,0 +m_89,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,10542.092483765766,10082.385207907215,2068.40267131752,1380.6044213832593,0.8577424273150334,1,12610.495155083285,11462.989629290474,33708.130893532216,0,23,0 +m_89,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,10542.092483765766,10935.638143918166,2068.40267131752,1571.037705104894,0.8827952442687517,1,12610.495155083285,12506.67584902306,33708.130893532216,0,23,0 +m_89,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,24341.25906786465,10790.502943205689,12746.519688117112,2974.4365637582077,0.3536297224298782,1,37087.77875598176,13764.939506963896,40796.55663157994,0,24,0 +m_89,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,24341.25906786465,16243.698402973305,12746.519688117112,12384.390623266581,0.6607757398159377,1,37087.77875598176,28628.089026239886,40796.55663157994,0,24,0 +m_89,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,24341.25906786465,8368.675332463807,12746.519688117112,986.2856115581583,0.27890275895079225,1,37087.77875598176,9354.960944021965,40796.55663157994,0,24,0 +m_89,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,5453.602601951663,3740.066716698803,1102.8507421581069,564.4204110773111,0.21559667442479055,1,6556.45334410977,4304.487127776114,7212.098678520748,0,24,0 +m_89,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,5453.602601951663,3256.623112037426,1102.8507421581069,511.8507451341397,0.12339569328756876,1,6556.45334410977,3768.4738571715657,7212.098678520748,0,24,0 +m_89,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,5453.602601951663,5439.647139774152,1102.8507421581069,1047.9556018366313,0.9928863671127753,1,6556.45334410977,6487.602741610783,7212.098678520748,0,24,0 +m_89,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,261063.91404717226,155148.71008483903,64316.94512787667,20516.040347701746,0.16766629626463384,1,325380.85917504894,175664.75043254078,453469.99274553655,0,24,0 +m_89,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,261063.91404717226,184707.57100988773,64316.94512787667,22746.501876860082,0.3043102000591047,1,325380.85917504894,207454.0728867478,453469.99274553655,0,24,0 +m_89,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,261063.91404717226,295743.65626458946,64316.94512787667,116501.79168589828,0.8011579390228378,1,325380.85917504894,412245.4479504877,453469.99274553655,0,24,0 +m_89,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,111139.06279218901,141843.33668861393,14133.326681650136,24054.99256619077,0.3027901428508803,1,125272.38947383915,165898.3292548047,219835.52976703257,0,24,0 +m_89,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,111139.06279218901,177043.4718818113,14133.326681650136,22807.009724581927,0.03835742795047626,0.8822208428609539,125272.38947383915,199850.48160639324,219835.52976703257,0,24,0 +m_89,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,111139.06279218901,152798.26434141136,14133.326681650136,11042.345022821246,0.043997942773937836,0.9679547410266324,125272.38947383915,163840.6093642326,219835.52976703257,0,24,0 +m_89,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,68731.01767022567,105314.84673772214,12284.973237248538,16938.884636943305,0.11389810098477127,1,81015.99090747422,122253.73137466544,141942.48552976386,0,24,0 +m_89,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,68731.01767022567,109779.27412119646,12284.973237248538,18500.950852336435,0.09878185149191539,1,81015.99090747422,128280.2249735329,141942.48552976386,0,24,0 +m_89,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,68731.01767022567,109714.14750492919,12284.973237248538,19324.475703947024,0.10918533021323568,1,81015.99090747422,129038.62320887622,141942.48552976386,0,24,0 +m_89,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,64173.361133824874,80812.20535611142,9780.050581406758,6493.862872561926,0.19122543332228298,1,73953.41171523163,87306.06822867334,116496.21582565819,0,24,0 +m_89,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,64173.361133824874,91637.96781414576,9780.050581406758,14267.682936452584,0.14738147672494578,1,73953.41171523163,105905.65075059835,116496.21582565819,0,24,0 +m_89,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,64173.361133824874,89994.55261247186,9780.050581406758,13749.251957520255,0.1601832396527476,1,73953.41171523163,103743.80456999212,116496.21582565819,0,24,0 +m_90,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,104.38541732179313,89.66065141876214,38.2284956984276,9.41189768906371,0.7254124530928371,1,142.61391302022074,99.07254910782585,197.4017972871882,0,24,0 +m_90,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,104.38541732179313,82.54999152474423,38.2284956984276,22.56664301332404,0.638673114748054,1,142.61391302022074,105.11663453806827,197.4017972871882,0,24,0 +m_90,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,104.38541732179313,136.31981499092072,38.2284956984276,43.13636436106852,0.5930435582665203,1,142.61391302022074,179.45617935198925,197.4017972871882,0,24,0 +m_90,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,46.0733268975513,72.38773565129674,8.612336021984094,11.902217337050732,0.10647530380362666,1,54.68566291953539,84.28995298834747,154.97673680219162,0,24,0 +m_90,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,46.0733268975513,100.77641670154227,8.612336021984094,40.11152584590465,0.23533059149391145,1,54.68566291953539,140.88794254744693,154.97673680219162,0,24,0 +m_90,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,46.0733268975513,83.21058557662228,8.612336021984094,13.731887513903372,0.04965187496522284,1,54.68566291953539,96.94247309052565,154.97673680219162,0,24,0 +m_90,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,58.8916416506703,61.433938784628744,8.178222304005432,19.915589494131414,0.9095162264374459,1,67.06986395467574,81.34952827876016,124.67913153837664,0,24,0 +m_90,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,58.8916416506703,60.967707547484984,8.178222304005432,16.033271122687555,0.9119653236459788,1,67.06986395467574,77.00097867017254,124.67913153837664,0,24,0 +m_90,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,58.8916416506703,89.49124732308067,8.178222304005432,23.853417711807175,0.26956377527557757,1,67.06986395467574,113.34466503488784,124.67913153837664,0,24,0 +m_90,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,82.77341642135346,85.15108165175535,14.369231184613856,21.351381754108655,0.9285569540973766,1,97.14264760596731,106.502463405864,117.15270974645041,0,24,0 +m_90,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,82.77341642135346,85.59201743132633,14.369231184613856,11.11183437118563,0.8805573806391258,1,97.14264760596731,96.70385180251196,117.15270974645041,0,24,0 +m_90,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,82.77341642135346,77.35163844963543,14.369231184613856,16.102080917040112,0.8072815095063783,1,97.14264760596731,93.45371936667554,117.15270974645041,0,24,0 +m_90,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3984.0990373133245,3779.997647685739,331.30139665545624,182.63994276589182,0.6046236084719666,1,4315.400433968781,3962.637590451631,5608.298360650421,0,24,0 +m_90,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3984.0990373133245,4385.004366893598,331.30139665545624,460.47972519540656,0.4974695807901176,1,4315.400433968781,4845.484092089005,5608.298360650421,0,24,0 +m_90,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3984.0990373133245,4671.406194545647,331.30139665545624,427.0468605910989,0.23400550992151462,1,4315.400433968781,5098.453055136746,5608.298360650421,0,24,0 +m_90,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,2782.4689880787587,3734.4357608379387,180.15912710869307,255.90004171603525,0.014013376814676919,0.33632104355224607,2962.628115187452,3990.3358025539737,4389.369382809371,0,24,0 +m_90,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2782.4689880787587,3479.5422776662303,180.15912710869307,498.1939277842982,0.2341907770518552,1,2962.628115187452,3977.7362054505284,4389.369382809371,0,24,0 +m_90,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2782.4689880787587,3324.9511853484914,180.15912710869307,599.0900985310653,0.4197409169331466,1,2962.628115187452,3924.041283879557,4389.369382809371,0,24,0 +m_90,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2768.91347289136,2651.724653758106,235.1330437232913,263.75252000014314,0.747083697176756,1,3004.0465166146514,2915.477173758249,3588.8592248225164,0,24,0 +m_90,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2768.91347289136,2971.6714414528897,235.1330437232913,290.92785384030697,0.6001751301064573,1,3004.0465166146514,3262.5992952931965,3588.8592248225164,0,24,0 +m_90,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2768.91347289136,2817.29697114976,235.1330437232913,229.69960168474995,0.8859068972946593,1,3004.0465166146514,3046.9965728345096,3588.8592248225164,0,24,0 +m_90,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2141.365658987758,2195.0671939821896,266.1360898713706,173.83512232232223,0.8697483372262,1,2407.5017488591284,2368.9023163045117,2797.558405706179,0,24,0 +m_90,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2141.365658987758,2317.263545575466,266.1360898713706,225.97136870287852,0.6255837356271259,1,2407.5017488591284,2543.2349142783446,2797.558405706179,0,24,0 +m_90,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2141.365658987758,2155.358841851436,266.1360898713706,332.0370660840736,0.9744443439504545,1,2407.5017488591284,2487.3959079355095,2797.558405706179,0,24,0 +m_91,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,270.5184438210109,207.49338850313964,31.055191281096747,48.29714169017577,0.30344218709716064,1,301.5736351021077,255.79053019331542,405.0093479531317,0,24,0 +m_91,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,270.5184438210109,292.23433398344037,31.055191281096747,70.01760763763143,0.785183696597957,1,301.5736351021077,362.2519416210718,405.0093479531317,0,24,0 +m_91,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,270.5184438210109,278.94349614915154,31.055191281096747,89.24682017187723,0.9317796736431896,1,301.5736351021077,368.1903163210288,405.0093479531317,0,24,0 +m_91,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,283.6783378969789,417.30258876243954,37.722385980413016,68.67172264961762,0.12763920350593227,1,321.40072387739195,485.97431141205715,597.0068354567394,0,24,0 +m_91,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,283.6783378969789,498.3121120272289,37.722385980413016,44.421374751625024,0.004413868678021397,0.10151897959449213,321.40072387739195,542.733486778854,597.0068354567394,0,24,0 +m_91,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,283.6783378969789,406.6236319877928,37.722385980413016,49.57926345370285,0.0787423035688758,1,321.40072387739195,456.2028954414957,597.0068354567394,0,24,0 +m_91,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,338.6179168244462,408.9338972167626,18.253011980084345,40.63742904997787,0.15927707427862253,1,356.87092880453054,449.57132626674047,649.3926484396342,0,24,0 +m_91,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,338.6179168244462,515.9680730064224,18.253011980084345,74.38888012051773,0.07450971933623969,1,356.87092880453054,590.3569531269401,649.3926484396342,0,24,0 +m_91,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,338.6179168244462,386.6897715567526,18.253011980084345,39.42540010107222,0.3052259664081068,1,356.87092880453054,426.1151716578248,649.3926484396342,0,24,0 +m_91,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,285.0677067828484,471.83348842510617,72.99177856334263,55.05039107424174,0.07614748588318847,1,358.059485346191,526.8838794993479,579.5722674492828,0,24,0 +m_91,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,285.0677067828484,472.2885649062058,72.99177856334263,44.1817601948607,0.06572125567777048,1,358.059485346191,516.4703251010665,579.5722674492828,0,24,0 +m_91,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,285.0677067828484,356.0475412842422,72.99177856334263,15.734209792816909,0.3913347242292374,1,358.059485346191,371.7817510770591,579.5722674492828,0,24,0 +m_91,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,229247.0662341001,485223.0778252303,57352.67129134364,98223.89736104445,0.05430783265063162,0.9775409877113691,286599.7375254437,583446.9751862747,641791.6727049022,0,24,0 +m_91,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,229247.0662341001,518482.4081919198,57352.67129134364,58653.27210877662,0.00548922865034847,0.11527380165731788,286599.7375254437,577135.6803006964,641791.6727049022,0,24,0 +m_91,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,229247.0662341001,409946.09487217735,57352.67129134364,124373.72430829782,0.22837128885161753,1,286599.7375254437,534319.8191804752,641791.6727049022,0,24,0 +m_91,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,457821.38884922385,827214.8260038258,68060.69768475027,56300.1710881266,0.0020286658085758346,0.04868797940582003,525882.0865339742,883514.9970919524,1022060.5053883268,0,24,0 +m_91,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,457821.38884922385,846312.1598173633,68060.69768475027,82833.75417202462,0.004949820224187125,0.10889604493211676,525882.0865339742,929145.9139893879,1022060.5053883268,0,24,0 +m_91,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,457821.38884922385,726814.6290654321,68060.69768475027,90429.4346256343,0.04063449732099702,0.7720554490989434,525882.0865339742,817244.0636910665,1022060.5053883268,0,24,0 +m_91,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,743472.3139868695,778427.8373030736,41145.13175156376,61945.76512369817,0.6498863461752351,1,784617.4457384333,840373.6024267718,955283.4309878096,0,24,0 +m_91,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,743472.3139868695,779954.8160256551,41145.13175156376,88484.66669053532,0.7194740326426434,1,784617.4457384333,868439.4827161904,955283.4309878096,0,24,0 +m_91,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,743472.3139868695,785793.9436393253,41145.13175156376,47789.42370303839,0.5176756434263838,1,784617.4457384333,833583.3673423637,955283.4309878096,0,24,0 +m_91,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,724296.655045942,881299.24190878,80817.53908563973,82760.61616387719,0.2045532771275846,1,805114.1941315818,964059.8580726571,1130789.7326677844,0,24,0 +m_91,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,724296.655045942,973141.9726878626,80817.53908563973,47554.744496552565,0.028798793324778527,0.5759758664955705,805114.1941315818,1020696.7171844151,1130789.7326677844,0,24,0 +m_91,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,724296.655045942,899425.2432141167,80817.53908563973,128565.4228475055,0.2805022456773581,1,805114.1941315818,1027990.6660616222,1130789.7326677844,0,24,0 +m_92,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,54.01874019060251,55.757398577080274,10.33686682393411,11.282211451063331,0.9120300782493808,1,64.35560701453662,67.0396100281436,94.32236820363237,0,24,0 +m_92,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,54.01874019060251,61.48965274340851,10.33686682393411,15.60054124129197,0.6997642263745933,1,64.35560701453662,77.09019398470048,94.32236820363237,0,24,0 +m_92,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,54.01874019060251,61.53319260152816,10.33686682393411,24.214414856319436,0.7839371568103529,1,64.35560701453662,85.7476074578476,94.32236820363237,0,24,0 +m_92,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,71.2626900976105,42.35982488079452,6.3547521177130895,15.642565645629594,0.13320699928689517,1,77.61744221532359,58.002390526424115,157.89240285458524,0,24,0 +m_92,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,71.2626900976105,112.78491004163517,6.3547521177130895,30.753638007987767,0.23908842566108138,1,77.61744221532359,143.53854804962293,157.89240285458524,0,24,0 +m_92,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,71.2626900976105,35.53692335464495,6.3547521177130895,11.720146007200212,0.028892662961329217,0.6356385851492428,77.61744221532359,47.25706936184516,157.89240285458524,0,24,0 +m_92,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,91.42806372571346,55.404687304683584,16.424794016779632,21.811697030115866,0.2205064902918699,1,107.85285774249309,77.21638433479944,153.26396207829893,0,24,0 +m_92,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,91.42806372571346,112.70768438963394,16.424794016779632,26.62319022700144,0.5192853626511473,1,107.85285774249309,139.33087461663538,153.26396207829893,0,24,0 +m_92,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,91.42806372571346,90.18213031920205,16.424794016779632,25.104787720782323,0.9678550836120877,1,107.85285774249309,115.28691803998437,153.26396207829893,0,24,0 +m_92,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,126.94877083842833,84.50625891089692,29.30819700952086,18.88798880596714,0.262724963440755,1,156.2569678479492,103.39424771686406,238.60747902343329,0,24,0 +m_92,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,126.94877083842833,149.09858647995688,29.30819700952086,22.891090435603584,0.5679178369270683,1,156.2569678479492,171.98967691556047,238.60747902343329,0,24,0 +m_92,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,126.94877083842833,147.85165187204709,29.30819700952086,69.06423814925587,0.7889561845705201,1,156.2569678479492,216.91589002130297,238.60747902343329,0,24,0 +m_92,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,13173.493656070199,26309.016064117855,2907.938984858766,5548.785542489634,0.0713224286153709,1,16081.432640928964,31857.80160660749,41765.55397179201,0,24,0 +m_92,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,13173.493656070199,32424.79205147111,2907.938984858766,5543.893377430708,0.016317378306222718,0.3916170793493452,16081.432640928964,37968.68542890182,41765.55397179201,0,24,0 +m_92,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,13173.493656070199,16463.466772517524,2907.938984858766,3693.8840909863397,0.5008539152501944,1,16081.432640928964,20157.350863503863,41765.55397179201,0,24,0 +m_92,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,42780.18934791191,64181.8289420318,16975.038016716608,5409.282448801086,0.27487853065033974,1,59755.22736462852,69591.11139083288,127514.13715880665,0,24,0 +m_92,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,42780.18934791191,103144.217090364,16975.038016716608,12777.725781278392,0.01878447346250157,0.4320428896375361,59755.22736462852,115921.9428716424,127514.13715880665,0,24,0 +m_92,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,42780.18934791191,33789.23241911809,16975.038016716608,4455.831620292588,0.6277215065670441,1,59755.22736462852,38245.064039410674,127514.13715880665,0,24,0 +m_92,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,75716.19121033206,103413.81792500167,9586.372299952469,16170.852630173691,0.17829043421454252,1,85302.56351028453,119584.67055517535,163927.49805841435,0,24,0 +m_92,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,75716.19121033206,125134.3391950008,9586.372299952469,23890.659039921324,0.09909855526398627,1,85302.56351028453,149024.99823492212,163927.49805841435,0,24,0 +m_92,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,75716.19121033206,100319.92945650291,9586.372299952469,22461.227823255766,0.34838782820765546,1,85302.56351028453,122781.15727975869,163927.49805841435,0,24,0 +m_92,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,94593.87687362579,129472.15908374086,17288.032575397687,34115.41961209209,0.39050100335053806,1,111881.90944902349,163587.57869583296,245470.46444099265,0,24,0 +m_92,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,94593.87687362579,186276.05086246162,17288.032575397687,36878.91681116805,0.05860812491034667,1,111881.90944902349,223154.96767362967,245470.46444099265,0,24,0 +m_92,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,94593.87687362579,100714.84633636737,17288.032575397687,18432.99704201054,0.8135338175723593,1,111881.90944902349,119147.8433783779,245470.46444099265,0,24,0 +m_93,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,82.18938974393983,33.56399765162239,77.96563887092974,7.851520552618644,0.5678793240341597,1,160.15502861486956,41.41551820424103,443.8916957095372,0,24,0 +m_93,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,82.18938974393983,82.98297624968798,77.96563887092974,32.37462178242997,0.9928389476367766,1,160.15502861486956,115.35759803211795,443.8916957095372,0,24,0 +m_93,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,82.18938974393983,243.126278853886,77.96563887092974,160.41162633660235,0.3962829957689634,1,160.15502861486956,403.53790519048835,443.8916957095372,0,24,0 +m_93,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,64.11225039958765,117.85066174876881,36.30412302098442,61.08468635070663,0.47081353988465813,1,100.41637342057207,178.93534809947545,196.82888290942302,0,24,0 +m_93,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,64.11225039958765,88.06573577040749,36.30412302098442,47.19522590792797,0.696483020356302,1,100.41637342057207,135.26096167833546,196.82888290942302,0,24,0 +m_93,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,64.11225039958765,32.6051039143084,36.30412302098442,16.144429579313286,0.4541695042613686,1,100.41637342057207,48.74953349362168,196.82888290942302,0,24,0 +m_93,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,236.98549676744128,55.71517557926619,101.4501620591981,27.21197221939699,0.15036696620278742,1,338.4356588266394,82.92714779866319,372.2792247093034,0,24,0 +m_93,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,236.98549676744128,17.259888458677374,101.4501620591981,3.4510957033191274,0.0962336338032689,1,338.4356588266394,20.7109841619965,372.2792247093034,0,24,0 +m_93,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,236.98549676744128,150.20761569318478,101.4501620591981,97.35919243113423,0.5527735935768241,1,338.4356588266394,247.566808124319,372.2792247093034,0,24,0 +m_93,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,34.2642969985689,273.798464367416,27.16798308634431,181.17149781656792,0.24562146487498548,1,61.43228008491322,454.9699621839839,500.4669584023823,0,24,0 +m_93,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,34.2642969985689,50.937111095023184,27.16798308634431,33.63560185179057,0.708827171150323,1,61.43228008491322,84.57271294681375,500.4669584023823,0,24,0 +m_93,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,34.2642969985689,216.87390461455738,27.16798308634431,102.66354209640075,0.1390070240485239,1,61.43228008491322,319.53744671095814,500.4669584023823,0,24,0 +m_93,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,64.83609418598816,68.07804549869432,19.800379345310304,12.945340524377327,0.8941470337456487,1,84.63647353129846,81.02338602307165,187.56593325353703,0,24,0 +m_93,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,64.83609418598816,65.21874874157425,19.800379345310304,22.68045462773756,0.9901139244514603,1,84.63647353129846,87.8992033693118,187.56593325353703,0,24,0 +m_93,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,64.83609418598816,121.92897052761678,19.800379345310304,48.58551424832596,0.31454897443616753,1,84.63647353129846,170.51448477594275,187.56593325353703,0,24,0 +m_93,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,66.44262619543163,73.30488590646907,17.616324020438586,16.013438359115487,0.7790957008748401,1,84.05895021587021,89.31832426558455,99.5661245391504,0,24,0 +m_93,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,66.44262619543163,64.81467936978991,17.616324020438586,25.699979302164984,0.9594914998043798,1,84.05895021587021,90.51465867195489,99.5661245391504,0,24,0 +m_93,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,66.44262619543163,42.68121120923448,17.616324020438586,24.5799600887365,0.4520702057830809,1,84.05895021587021,67.26117129797098,99.5661245391504,0,24,0 +m_93,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,45.5802909052258,90.96290019513373,11.839144014251962,27.949444182834224,0.18016429656222238,1,57.419434919477766,118.91234437796795,150.49175650825433,0,24,0 +m_93,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,45.5802909052258,61.2420574968402,11.839144014251962,15.684933302032873,0.4453326448710835,1,57.419434919477766,76.92699079887306,150.49175650825433,0,24,0 +m_93,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,45.5802909052258,103.76936159702822,11.839144014251962,33.04132613774842,0.14633238927401676,1,57.419434919477766,136.81068773477665,150.49175650825433,0,24,0 +m_93,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,74.66086218948179,136.6120471557466,15.371479528281878,45.70429694435239,0.24538065833206582,1,90.03234171776367,182.316344100099,241.8155343909742,0,24,0 +m_93,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,74.66086218948179,171.84861863091027,15.371479528281878,47.98368536088444,0.101878003110162,1,90.03234171776367,219.8323039917947,241.8155343909742,0,24,0 +m_93,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,74.66086218948179,120.34608389527418,15.371479528281878,18.01412261042205,0.08326619071246878,1,90.03234171776367,138.36020650569623,241.8155343909742,0,24,0 +m_94,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,742.4765295769716,406.95583572796926,239.82282139457666,39.918170622219435,0.23615030805396087,1,982.2993509715483,446.87400635018867,1167.222901821168,0,24,0 +m_94,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,742.4765295769716,403.09316167992137,239.82282139457666,127.35975247779014,0.25660080908858973,1,982.2993509715483,530.4529141577115,1167.222901821168,0,24,0 +m_94,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,742.4765295769716,968.0153285974043,239.82282139457666,93.0964003309303,0.4192879554192347,1,982.2993509715483,1061.1117289283345,1167.222901821168,0,24,0 +m_94,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,294.78535160368045,434.0964492523889,36.50884000678513,81.60636034566086,0.1635927211303372,1,331.2941916104656,515.7028095980497,567.2730905578547,0,24,0 +m_94,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,294.78535160368045,281.71740136800986,36.50884000678513,51.996115184484474,0.8416301465154358,1,331.2941916104656,333.71351655249435,567.2730905578547,0,24,0 +m_94,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,294.78535160368045,276.0004244574416,36.50884000678513,23.09429317454,0.6745750745611306,1,331.2941916104656,299.0947176319816,567.2730905578547,0,24,0 +m_94,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,462.79551764146515,356.6652504575642,60.72395456786439,80.73028939787706,0.3215750233549601,1,523.5194722093296,437.39553985544126,629.7183467598281,0,24,0 +m_94,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,462.79551764146515,386.5678389258483,60.72395456786439,111.6547985220364,0.5700088925605755,1,523.5194722093296,498.2226374478847,629.7183467598281,0,24,0 +m_94,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,462.79551764146515,430.6932136256215,60.72395456786439,141.778010701495,0.8412873787007356,1,523.5194722093296,572.4712243271165,629.7183467598281,0,24,0 +m_94,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,347.6986105145094,405.89090935203706,57.415017951173766,53.851442334591404,0.479159254775148,1,405.1136284656832,459.74235168662847,675.2640406353847,0,24,0 +m_94,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,347.6986105145094,428.19879677577916,57.415017951173766,114.57304212027499,0.5491614363156986,1,405.1136284656832,542.7718388960542,675.2640406353847,0,24,0 +m_94,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,347.6986105145094,530.45727371528,57.415017951173766,83.41912686234244,0.10664965024698964,1,405.1136284656832,613.8764005776225,675.2640406353847,0,24,0 +m_94,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,5788.555293205857,7656.0245322883375,326.00193592165215,520.2862802243387,0.01513274672681588,0.25725669435586995,6114.557229127509,8176.310812512676,10373.792213453706,0,24,0 +m_94,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5788.555293205857,7111.644921310973,326.00193592165215,524.0618936245693,0.0629218586868259,1,6114.557229127509,7635.706814935542,10373.792213453706,0,24,0 +m_94,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,5788.555293205857,8930.249363045677,326.00193592165215,500.4708310031458,6.052807764521859e-4,0.012710896305495904,6114.557229127509,9430.720194048823,10373.792213453706,0,24,0 +m_94,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3695.4163100041114,4520.49671813466,241.42487242695174,321.87123333769694,0.06962391961124632,1,3936.8411824310633,4842.367951472357,6086.31584943463,0,24,0 +m_94,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3695.4163100041114,3743.5838839654302,241.42487242695174,128.71917584453968,0.8648340231229096,1,3936.8411824310633,3872.30305980997,6086.31584943463,0,24,0 +m_94,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,3695.4163100041114,5377.706628801239,241.42487242695174,155.3077797756972,2.9562559531237333e-4,0.0067993886921845865,3936.8411824310633,5533.014408576936,6086.31584943463,0,24,0 +m_94,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,3073.969513289624,4308.559268236164,165.64235649234777,144.8735483349975,2.3943569455390113e-4,0.005746456669293627,3239.611869781972,4453.432816571161,4898.776098228278,0,24,0 +m_94,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3073.969513289624,3210.345595021294,165.64235649234777,246.4259127009346,0.6572140486800667,1,3239.611869781972,3456.7715077222283,4898.776098228278,0,24,0 +m_94,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,3073.969513289624,4060.2274926521636,165.64235649234777,110.2719965249172,8.663385805242294e-4,0.017326771610484588,3239.611869781972,4170.499489177081,4898.776098228278,0,24,0 +m_94,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,2521.321340016667,3103.7879869552175,72.36684315595276,141.19396343004783,0.007117255569825107,0.135227855826677,2593.6881831726196,3244.9819503852655,3569.4801454237922,0,24,0 +m_94,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,2521.321340016667,2845.873871040755,72.36684315595276,72.51942987515096,0.010023270209625432,0.18041886377325778,2593.6881831726196,2918.393300915906,3569.4801454237922,0,24,0 +m_94,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,2521.321340016667,3039.1751222608427,72.36684315595276,67.96659725194856,3.970986902299316e-4,0.008736171185058495,2593.6881831726196,3107.1417195127915,3569.4801454237922,0,24,0 +m_97,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,243.8821830174072,116.88436380754271,68.82043204807117,9.596365433496773,0.13892052410037148,1,312.70261506547837,126.48072924103948,381.1456194274577,0,24,0 +m_97,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,243.8821830174072,256.47440531462115,68.82043204807117,64.11311505317225,0.896541406635435,1,312.70261506547837,320.5875203677934,381.1456194274577,0,24,0 +m_97,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,243.8821830174072,263.31787943070884,68.82043204807117,83.1781382306163,0.8611397393818065,1,312.70261506547837,346.49601766132514,381.1456194274577,0,24,0 +m_97,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,75.16000097668704,111.21677369104307,9.53632409387356,12.902594439240879,0.050587475445037174,1,84.6963250705606,124.11936813028396,172.08847530543463,0,24,0 +m_97,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,75.16000097668704,120.29176785901855,9.53632409387356,10.726105811545864,0.010599031460999817,0.2543767550639956,84.6963250705606,131.01787367056443,172.08847530543463,0,24,0 +m_97,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,75.16000097668704,129.23256914533536,9.53632409387356,27.21149931415063,0.10821695663298307,1,84.6963250705606,156.444068459486,172.08847530543463,0,24,0 +m_97,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,88.65323973882525,129.61898535134435,15.19957977413323,15.90339420521249,0.09562528268488406,1,103.85281951295848,145.52237955655684,229.4901701274807,0,24,0 +m_97,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,88.65323973882525,168.19515525208755,15.19957977413323,40.43227213653124,0.12367322236590997,1,103.85281951295848,208.6274273886188,229.4901701274807,0,24,0 +m_97,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,88.65323973882525,154.81102050991126,15.19957977413323,34.20465310981912,0.12149336535940242,1,103.85281951295848,189.01567361973036,229.4901701274807,0,24,0 +m_97,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,79.44971561377609,71.49311429065261,15.112049812857602,5.551326816658046,0.641787624136066,1,94.5617654266337,77.04444110731066,118.77545780513486,0,24,0 +m_97,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,79.44971561377609,56.08069106449982,15.112049812857602,4.966618968063215,0.20332234608769423,1,94.5617654266337,61.04731003256303,118.77545780513486,0,24,0 +m_97,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,79.44971561377609,96.31046875152818,15.112049812857602,11.667220162230777,0.4031245067509368,1,94.5617654266337,107.97768891375895,118.77545780513486,0,24,0 +m_97,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,158.54028310382807,138.848586588974,36.43878682961163,31.101413533120688,0.6899233462257766,1,194.9790699334397,169.95000012209468,392.8929561189861,0,24,0 +m_97,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,158.54028310382807,247.03363877985518,36.43878682961163,110.14177587376852,0.4741277740032942,1,194.9790699334397,357.1754146536237,392.8929561189861,0,24,0 +m_97,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,158.54028310382807,145.85190632828161,36.43878682961163,40.06483091122119,0.8195293942104889,1,194.9790699334397,185.91673723950282,392.8929561189861,0,24,0 +m_97,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,103.88139588397615,143.05530851726823,18.90195609817099,65.98162661125441,0.5895247925978242,1,122.78335198214714,209.03693512852266,229.94062864137493,0,24,0 +m_97,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,103.88139588397615,122.42744228465448,18.90195609817099,29.706250372046874,0.6118831985492581,1,122.78335198214714,152.13369265670136,229.94062864137493,0,24,0 +m_97,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,103.88139588397615,86.1119787144265,18.90195609817099,15.091360394186275,0.48023149360076445,1,122.78335198214714,101.20333910861277,229.94062864137493,0,24,0 +m_97,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,142.38458126721986,110.61995037775387,41.666550010911735,45.90996376742048,0.619636977238387,1,184.0511312781316,156.52991414517436,238.65532785188077,0,24,0 +m_97,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,142.38458126721986,147.16308477377575,41.666550010911735,69.79630418247947,0.9545368804950733,1,184.0511312781316,216.95938895625522,238.65532785188077,0,24,0 +m_97,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,142.38458126721986,64.67018016180741,41.666550010911735,9.303975884347476,0.12305536026542115,1,184.0511312781316,73.97415604615489,238.65532785188077,0,24,0 +m_97,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,42.37178439720435,77.20571541631985,16.836480380605856,30.845559672665708,0.3515483966179766,1,59.20826477781021,108.05127508898556,143.3703373965107,0,24,0 +m_97,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,42.37178439720435,100.28270360927085,16.836480380605856,30.053966751193414,0.1319418065260559,1,59.20826477781021,130.33667036046427,143.3703373965107,0,24,0 +m_97,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,42.37178439720435,104.74312963947695,16.836480380605856,18.564993546137227,0.032271056731781184,0.7422343048309672,59.20826477781021,123.30812318561418,143.3703373965107,0,24,0 +m_98,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,2664.5190429494905,3220.3055163465137,521.5345880998374,475.05510916782185,0.45187569767807756,1,3186.053631049328,3695.3606255143354,5910.666492414543,0,24,0 +m_98,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,2664.5190429494905,4326.744407616286,521.5345880998374,1046.5887673060258,0.19681362906962568,1,3186.053631049328,5373.333174922312,5910.666492414543,0,24,0 +m_98,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,2664.5190429494905,3444.7167079457918,521.5345880998374,500.3648292170779,0.3090888828594744,1,3186.053631049328,3945.0815371628696,5910.666492414543,0,24,0 +m_98,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1724.000575268397,1936.1940919308297,189.11469575816338,443.15767630341537,0.6733811784553312,1,1913.1152710265603,2379.351768234245,2617.2869450576695,0,24,0 +m_98,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1724.000575268397,1298.3585410777514,189.11469575816338,115.24419945084848,0.08967634055481652,1,1913.1152710265603,1413.6027405286,2617.2869450576695,0,24,0 +m_98,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1724.000575268397,1890.2603641069538,189.11469575816338,361.69488735588635,0.6950651706521302,1,1913.1152710265603,2251.9552514628404,2617.2869450576695,0,24,0 +m_98,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,2621.145687680179,1344.2058387280904,1530.4056291246839,223.4554968848048,0.4536284744462231,1,4151.551316804863,1567.661335612895,4566.70644848535,0,24,0 +m_98,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,2621.145687680179,2251.2822175136544,1530.4056291246839,1186.6249286216737,0.8535792395417525,1,4151.551316804863,3437.907146135328,4566.70644848535,0,24,0 +m_98,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,2621.145687680179,1656.577914356626,1530.4056291246839,166.65508184023165,0.5641821039341958,1,4151.551316804863,1823.2329961968576,4566.70644848535,0,24,0 +m_98,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,1321.2949146990686,1174.5656958452143,431.09233064565666,96.34424918967008,0.7549866625466166,1,1752.3872453447252,1270.9099450348845,2204.7779466615953,0,24,0 +m_98,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,1321.2949146990686,794.4053018605607,431.09233064565666,130.60659786247956,0.2975928228855786,1,1752.3872453447252,925.0118997230403,2204.7779466615953,0,24,0 +m_98,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,1321.2949146990686,1703.8152425647377,431.09233064565666,300.5283453094398,0.48897333563419165,1,1752.3872453447252,2004.3435878741775,2204.7779466615953,0,24,0 +m_98,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,96360.09401886453,76681.3936362911,6166.802974972647,2578.5284383651856,0.02271156513855304,0.49965443304816687,102526.89699383717,79259.9220746563,112779.5866932209,0,24,0 +m_98,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,96360.09401886453,79066.75748069266,6166.802974972647,5174.904836667518,0.058049578906696715,1,102526.89699383717,84241.66231736017,112779.5866932209,0,24,0 +m_98,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,96360.09401886453,80401.88589005418,6166.802974972647,9311.938448516554,0.18804413261049746,1,102526.89699383717,89713.82433857073,112779.5866932209,0,24,0 +m_98,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,66837.37176624076,58126.574819632086,12862.895890833614,6574.572541463872,0.564417432385312,1,79700.26765707438,64701.14736109596,87670.29442278182,0,24,0 +m_98,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,66837.37176624076,48805.638194657164,12862.895890833614,6259.32396527908,0.24657441447531148,1,79700.26765707438,55064.96215993624,87670.29442278182,0,24,0 +m_98,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,66837.37176624076,59686.911949661524,12862.895890833614,6385.014731311183,0.633139334038046,1,79700.26765707438,66071.92668097271,87670.29442278182,0,24,0 +m_98,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,24376.98461298013,31448.04877401319,3233.9952180922737,5795.422807947367,0.31838660590590523,1,27610.979831072404,37243.471581960555,47067.69675480581,0,24,0 +m_98,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,24376.98461298013,35223.82831047657,3233.9952180922737,7564.986921165068,0.23022773607609626,1,27610.979831072404,42788.81523164164,47067.69675480581,0,24,0 +m_98,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,24376.98461298013,25160.600006225315,3233.9952180922737,2424.622740915475,0.8504591740750834,1,27610.979831072404,27585.22274714079,47067.69675480581,0,24,0 +m_98,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,23354.026662177774,21418.054820247547,1695.0913344743365,3045.1935050864276,0.594078774924508,1,25049.11799665211,24463.248325333974,27554.02979631732,0,24,0 +m_98,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,23354.026662177774,16121.954336389772,1695.0913344743365,1675.7219425884127,0.012589631582067667,0.28956152638755633,25049.11799665211,17797.676278978186,27554.02979631732,0,24,0 +m_98,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,23354.026662177774,15097.099244436142,1695.0913344743365,1213.1544695434725,0.003257264592353173,0.07817435021647616,25049.11799665211,16310.253713979615,27554.02979631732,0,24,0 +m_99,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,32909.743656614686,37816.08074110297,6307.369614418833,6288.63378544023,0.5953119100271685,1,39217.11327103352,44104.7145265432,81087.54158529852,0,24,0 +m_99,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,32909.743656614686,33577.07757523173,6307.369614418833,5614.177992247679,0.9388264960148155,1,39217.11327103352,39191.255567479406,81087.54158529852,0,24,0 +m_99,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,32909.743656614686,67243.95673823822,6307.369614418833,6471.9901574877,0.004279247378126919,0.09842268969691913,39217.11327103352,73715.94689572592,81087.54158529852,0,24,0 +m_99,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,12016.135471725433,19469.586859823154,2080.1876810497697,7470.24975286318,0.3749853888961295,1,14096.323152775203,26939.836612686333,29633.820273954967,0,23,0 +m_99,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,12016.135471725433,8970.957972730388,2080.1876810497697,2458.288324204681,0.3708910409295779,1,14096.323152775203,11429.246296935069,29633.820273954967,0,23,0 +m_99,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,12016.135471725433,12427.874055920149,2080.1876810497697,3006.613041085955,0.9128344468296181,1,14096.323152775203,15434.487097006104,29633.820273954967,0,23,0 +m_99,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,16624.59590642571,11834.622112215406,3389.6703031692446,3002.5992148157925,0.31916780071184686,1,20014.266209594956,14837.221327031199,22015.692830554453,0,24,0 +m_99,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,16624.59590642571,13692.404237460516,3389.6703031692446,5990.640237900314,0.6842323741392901,1,20014.266209594956,19683.04447536083,22015.692830554453,0,24,0 +m_99,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,16624.59590642571,9961.582371630948,3389.6703031692446,1970.502959474622,0.13590884437833586,1,20014.266209594956,11932.085331105569,22015.692830554453,0,24,0 +m_99,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,13473.54115415771,9162.567390557588,2372.2083673757033,841.4480182635278,0.14736207151656697,1,15845.749521533413,10004.015408821115,19266.522505611985,0,24,0 +m_99,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,13473.54115415771,13984.596438544128,2372.2083673757033,1444.7984697627571,0.8594051141781525,1,15845.749521533413,15429.394908306884,19266.522505611985,0,24,0 +m_99,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,13473.54115415771,14527.178169880368,2372.2083673757033,2987.8422897668884,0.7887302783823164,1,15845.749521533413,17515.020459647258,19266.522505611985,0,24,0 +m_99,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,116006.80211035845,110577.89593762589,5346.308682835039,5614.802942532683,0.4997857563868644,1,121353.11079319348,116192.69888015857,154904.51921993794,0,24,0 +m_99,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,116006.80211035845,130559.12116215088,5346.308682835039,8928.734583151148,0.19877786763689415,1,121353.11079319348,139487.85574530205,154904.51921993794,0,24,0 +m_99,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,116006.80211035845,126400.13143425225,5346.308682835039,14422.158765691309,0.5230603221340392,1,121353.11079319348,140822.29019994356,154904.51921993794,0,24,0 +m_99,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,103461.50641620978,105442.86392069749,3897.1931608957584,5996.397999918852,0.7882952107008633,1,107358.69957710554,111439.26192061635,147196.32859567553,0,24,0 +m_99,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,103461.50641620978,130140.72612866144,3897.1931608957584,3674.1180492253957,5.582788833569093e-4,0.013398693200565822,107358.69957710554,133814.84417788684,147196.32859567553,0,24,0 +m_99,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,103461.50641620978,111920.41859248975,3897.1931608957584,9407.550720726356,0.4348763560015628,1,107358.69957710554,121327.9693132161,147196.32859567553,0,24,0 +m_99,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,69063.35246662365,72394.27992969478,7229.104082093173,2578.4151283312153,0.6788756368160122,1,76292.45654871681,74972.69505802599,111005.77089775425,0,24,0 +m_99,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,69063.35246662365,94273.00578686866,7229.104082093173,6641.331392907926,0.028131109867951868,0.5907533072269893,76292.45654871681,100914.33717977659,111005.77089775425,0,24,0 +m_99,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,69063.35246662365,72048.14112429817,7229.104082093173,2715.2050187689006,0.7116694363194362,1,76292.45654871681,74763.34614306707,111005.77089775425,0,24,0 +m_99,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,49612.48263442616,60362.602021140774,8392.03755569669,4865.207207004766,0.29989219517893234,1,58004.52019012285,65227.80922814554,101229.42163352465,0,24,0 +m_99,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,49612.48263442616,85054.19547405248,8392.03755569669,6972.5514655153665,0.00912289963018978,0.20070379186417517,58004.52019012285,92026.74693956785,101229.42163352465,0,24,0 +m_99,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,49612.48263442616,60124.820154947025,8392.03755569669,4113.565303958237,0.2964291326003636,1,58004.52019012285,64238.385458905264,101229.42163352465,0,24,0 +m_100,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,77.92037301857388,144.2800038529973,38.92569447048645,25.47835193980079,0.19611513726195814,1,116.84606748906033,169.7583557927981,186.73419137207793,0,24,0 +m_100,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,77.92037301857388,76.55106738325836,38.92569447048645,28.24215650931904,0.9780158459997712,1,116.84606748906033,104.7932238925774,186.73419137207793,0,24,0 +m_100,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,77.92037301857388,84.70974728002761,38.92569447048645,21.031142998968946,0.8828759855107007,1,116.84606748906033,105.74089027899656,186.73419137207793,0,24,0 +m_100,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,83.48486613860484,45.0918346510506,28.082056048471387,18.23877477205017,0.2825240092259468,1,111.56692218707623,63.33060942310077,122.72361440578386,0,24,0 +m_100,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,83.48486613860484,67.41912510246748,28.082056048471387,15.728297385870675,0.6313539728855557,1,111.56692218707623,83.14742248833815,122.72361440578386,0,24,0 +m_100,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,83.48486613860484,68.75877684669878,28.082056048471387,19.078662945202648,0.6748964985216227,1,111.56692218707623,87.83743979190143,122.72361440578386,0,24,0 +m_100,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,88.39690434263368,28.88293742130715,50.54491688709364,7.218030987796665,0.3061707596148275,1,138.9418212297273,36.100968409103814,152.83600335270006,0,24,0 +m_100,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,88.39690434263368,91.85255531634046,50.54491688709364,36.921080228408556,0.9574492181228793,1,138.9418212297273,128.77363554474903,152.83600335270006,0,24,0 +m_100,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,88.39690434263368,81.85562580697791,50.54491688709364,33.20981547241904,0.9168489224333113,1,138.9418212297273,115.06544127939695,152.83600335270006,0,24,0 +m_100,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,44.58166891160943,73.80641838836198,14.476930226293128,19.54258608342865,0.26114249457280764,1,59.058599137902554,93.34900447179062,102.68390491896969,0,24,0 +m_100,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,44.58166891160943,38.04559923384818,14.476930226293128,13.325419098271455,0.7476400689089457,1,59.058599137902554,51.37101833211963,102.68390491896969,0,24,0 +m_100,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,44.58166891160943,48.60012391105911,14.476930226293128,13.983535927675373,0.8462869001335619,1,59.058599137902554,62.58365983873448,102.68390491896969,0,24,0 +m_100,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3954.7303490425847,3386.73488337726,233.98965842981897,213.41747764976003,0.10339368531170845,1,4188.720007472404,3600.1523610270197,4863.706922456715,0,24,0 +m_100,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3954.7303490425847,3360.8961369725475,233.98965842981897,212.06887211094465,0.08973974745555882,1,4188.720007472404,3572.965009083492,4863.706922456715,0,24,0 +m_100,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3954.7303490425847,4245.556389427144,233.98965842981897,175.99535826077852,0.3457437051284534,1,4188.720007472404,4421.551747687922,4863.706922456715,0,24,0 +m_100,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,2858.9107605398826,2163.891935419818,453.3030072162122,265.9819079533856,0.22224953020141794,1,3312.213767756095,2429.8738433732033,4034.3222633356813,0,24,0 +m_100,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,2858.9107605398826,3149.7795578701225,453.3030072162122,454.7887023289891,0.6602307116438246,1,3312.213767756095,3604.5682601991116,4034.3222633356813,0,24,0 +m_100,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2858.9107605398826,3276.94455656688,453.3030072162122,390.6211373746483,0.5010657053322414,1,3312.213767756095,3667.565693941528,4034.3222633356813,0,24,0 +m_100,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1994.1315982841727,2383.8363521686238,223.05953150683064,100.14953241044645,0.1553935147501643,1,2217.1911297910033,2483.9858845790704,3180.7840332783994,0,24,0 +m_100,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1994.1315982841727,2508.947937121364,223.05953150683064,382.67391131354464,0.27843722314213337,1,2217.1911297910033,2891.6218484349083,3180.7840332783994,0,24,0 +m_100,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1994.1315982841727,2162.9342365534153,223.05953150683064,236.51519767412125,0.614941106472408,1,2217.1911297910033,2399.4494342275366,3180.7840332783994,0,24,0 +m_100,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1543.2839395802719,1881.7047373903101,96.04388884080014,183.56122735292143,0.14326096811028735,1,1639.327828421072,2065.2659647432315,2572.0940901690756,0,24,0 +m_100,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1543.2839395802719,2191.4086590083916,96.04388884080014,146.85869569076795,0.005359656080961223,0.12863174594306936,1639.327828421072,2338.2673546991596,2572.0940901690756,0,24,0 +m_100,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1543.2839395802719,1889.9224238066731,96.04388884080014,162.38547608251977,0.10293009615040699,1,1639.327828421072,2052.307899889193,2572.0940901690756,0,24,0 +m_101,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,43.83211659228358,33.87847241439712,9.121749100186845,3.636769425564881,0.35505111052116084,1,52.95386569247043,37.515241839962,75.7956649779732,0,24,0 +m_101,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,43.83211659228358,36.52722170396811,9.121749100186845,2.768493295513679,0.4799038280957384,1,52.95386569247043,39.29571499948179,75.7956649779732,0,24,0 +m_101,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,43.83211659228358,57.58466011565536,9.121749100186845,11.320489864320267,0.36912351288348855,1,52.95386569247043,68.90514997997563,75.7956649779732,0,24,0 +m_101,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,40.7642207143318,31.934332531183323,4.613306812582908,2.5830784128223523,0.13415989216678784,1,45.377527526914704,34.517410944005675,49.91528027960618,0,24,0 +m_101,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,40.7642207143318,32.54724029145878,4.613306812582908,3.0799726738081477,0.1737251363356895,1,45.377527526914704,35.62721296526693,49.91528027960618,0,24,0 +m_101,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,40.7642207143318,34.1422078027504,4.613306812582908,1.7978044686576853,0.22607937200110195,1,45.377527526914704,35.94001227140809,49.91528027960618,0,24,0 +m_101,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,33.63511686481217,33.66652348943988,1.052158974057878,4.2066089538367875,0.9944713469201258,1,34.68727583887004,37.87313244327667,43.59811403196208,0,24,0 +m_101,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,33.63511686481217,30.420915190428474,1.052158974057878,5.530302686155269,0.5966218730359825,1,34.68727583887004,35.95121787658374,43.59811403196208,0,24,0 +m_101,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,33.63511686481217,36.34175316305656,1.052158974057878,3.2928959569089695,0.4634456243182299,1,34.68727583887004,39.63464911996553,43.59811403196208,0,24,0 +m_101,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,31.276034215973343,37.408264400319915,3.0617096583941548,2.6787661595146575,0.16799220535374956,1,34.3377438743675,40.087030559834574,48.085130006511164,0,24,0 +m_101,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,31.276034215973343,36.064854343726495,3.0617096583941548,4.882225695580191,0.4296997182497557,1,34.3377438743675,40.947080039306684,48.085130006511164,0,24,0 +m_101,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,31.276034215973343,40.33305225871945,3.0617096583941548,3.3807022926543375,0.07833852998278097,1,34.3377438743675,43.71375455137378,48.085130006511164,0,24,0 +m_101,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,111.92128774556616,80.96105829842328,34.71252787140652,35.16789437636426,0.5449943906275947,1,146.6338156169727,116.12895267478754,593.301095956001,0,24,0 +m_101,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,111.92128774556616,299.55010735745105,34.71252787140652,239.81452532982257,0.47240358236445373,1,146.6338156169727,539.3646326872736,593.301095956001,0,24,0 +m_101,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,111.92128774556616,137.42510980511258,34.71252787140652,69.54879946568369,0.7519863508736255,1,146.6338156169727,206.97390927079627,593.301095956001,0,24,0 +m_101,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,108.71556938598117,127.4062937601338,36.410561821616334,75.3828560232299,0.8295217056005271,1,145.1261312075975,202.7891497833637,223.0680647617001,0,24,0 +m_101,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,108.71556938598117,64.11911170139676,36.410561821616334,15.6960559532804,0.2988383834405706,1,145.1261312075975,79.81516765467717,223.0680647617001,0,24,0 +m_101,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,108.71556938598117,76.87198823412781,36.410561821616334,27.439492075206516,0.5020009731712396,1,145.1261312075975,104.31148030933433,223.0680647617001,0,24,0 +m_101,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,89.45721650219787,59.18214874314934,35.77422918922799,6.643850268714809,0.44096072535836517,1,125.23144569142585,65.82599901186416,243.81197150027086,0,24,0 +m_101,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,89.45721650219787,61.822973174514054,35.77422918922799,13.520582236106998,0.4954871932304986,1,125.23144569142585,75.34355541062105,243.81197150027086,0,24,0 +m_101,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,89.45721650219787,177.46418155704689,35.77422918922799,44.18306526138115,0.15396329348465151,1,125.23144569142585,221.64724681842804,243.81197150027086,0,24,0 +m_101,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,130.468422036268,98.2593299774582,46.93387950439591,32.90629605978571,0.5879542087917206,1,177.40230154066393,131.1656260372439,352.3800534392682,0,24,0 +m_101,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,130.468422036268,218.52097397930686,46.93387950439591,86.51700480860919,0.3980765651126339,1,177.40230154066393,305.037978787916,352.3800534392682,0,24,0 +m_101,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,130.468422036268,210.8781227162689,46.93387950439591,109.46738041033852,0.5219552075901329,1,177.40230154066393,320.3455031266074,352.3800534392682,0,24,0 +m_102,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,117.56246753969309,101.99343195522809,12.196342998233341,6.032849046199993,0.2967291523596202,1,129.75881053792642,108.02628100142809,148.9187033250874,0,24,0 +m_102,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,117.56246753969309,110.53403641101383,12.196342998233341,8.376615604352965,0.6485529133965671,1,129.75881053792642,118.9106520153668,148.9187033250874,0,24,0 +m_102,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,117.56246753969309,121.02193730573819,12.196342998233341,14.358702080704893,0.8583850178983693,1,129.75881053792642,135.38063938644308,148.9187033250874,0,24,0 +m_102,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,97.85010255448059,118.82627111633904,4.448428323822632,11.576251688531631,0.13827916391711745,1,102.29853087830321,130.40252280487067,143.44277508535774,0,24,0 +m_102,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,97.85010255448059,93.25094816325654,4.448428323822632,2.223555864497924,0.3844267493687468,1,102.29853087830321,95.47450402775446,143.44277508535774,0,24,0 +m_102,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,97.85010255448059,97.60227836709888,4.448428323822632,5.179756323970831,0.9717762910855392,1,102.29853087830321,102.78203469106971,143.44277508535774,0,24,0 +m_102,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,98.08079513171121,198.62070607290957,5.018924866241231,101.40408673601637,0.36730565184111486,1,103.09971999795245,300.02479280892595,330.02727208981855,0,24,0 +m_102,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,98.08079513171121,113.1221281368419,5.018924866241231,9.969950373036532,0.22720370491684524,1,103.09971999795245,123.09207850987843,330.02727208981855,0,24,0 +m_102,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,98.08079513171121,107.99418140136767,5.018924866241231,6.457709479076887,0.2568929178068384,1,103.09971999795245,114.45189088044455,330.02727208981855,0,24,0 +m_102,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,95.42663227533711,144.33221368155577,10.339649470103877,22.023283938932437,0.08423056331413455,1,105.76628174544099,166.35549762048822,182.99104738253706,0,24,0 +m_102,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,95.42663227533711,134.58291203871087,10.339649470103877,24.17295124625208,0.1817916241491492,1,105.76628174544099,158.75586328496294,182.99104738253706,0,24,0 +m_102,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,95.42663227533711,119.34391012833643,10.339649470103877,10.277014752751661,0.1357664422267408,1,105.76628174544099,129.6209248810881,182.99104738253706,0,24,0 +m_102,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,569.8354932592428,553.0500244809425,6.4521854679650295,11.38884647310932,0.23602029792122534,1,576.2876787272078,564.4388709540518,649.0755056939395,0,24,0 +m_102,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,569.8354932592428,552.1156176861215,6.4521854679650295,15.28640618254398,0.322360006268647,1,576.2876787272078,567.4020238686654,649.0755056939395,0,24,0 +m_102,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,569.8354932592428,567.3710698868681,6.4521854679650295,22.697571653076846,0.9203370163775308,1,576.2876787272078,590.0686415399449,649.0755056939395,0,24,0 +m_102,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,615.3314289346068,627.9351654598702,14.049345912325316,11.97651189412664,0.5106758543673684,1,629.3807748469321,639.9116773539968,750.1357716261039,0,24,0 +m_102,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,615.3314289346068,651.4997089456816,14.049345912325316,30.44190162350363,0.3162728110090693,1,629.3807748469321,681.9416105691853,750.1357716261039,0,24,0 +m_102,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,615.3314289346068,564.5831817227038,14.049345912325316,7.668325073313151,0.013765935482339411,0.3303824515761459,629.3807748469321,572.2515067960169,750.1357716261039,0,24,0 +m_102,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,605.5695154459156,590.4332382446894,35.080552169078466,24.271077183623014,0.7309876048304119,1,640.6500676149941,614.7043154283124,733.4403672818077,0,24,0 +m_102,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,605.5695154459156,603.5992271699416,35.080552169078466,23.300735922659623,0.9637417876632808,1,640.6500676149941,626.8999630926013,733.4403672818077,0,24,0 +m_102,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,605.5695154459156,631.5883236720986,35.080552169078466,35.17564658409012,0.6118674847674914,1,640.6500676149941,666.7639702561887,733.4403672818077,0,24,0 +m_102,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,569.3868516791151,559.357600463355,26.819353282850926,23.074169991458124,0.7827193549283328,1,596.206204961966,582.4317704548131,674.446528045879,0,24,0 +m_102,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,569.3868516791151,597.095034370726,26.819353282850926,16.0381729437093,0.400590811407723,1,596.206204961966,613.1332073144354,674.446528045879,0,24,0 +m_102,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,569.3868516791151,549.2818975378932,26.819353282850926,19.847217491103233,0.5613219768587401,1,596.206204961966,569.1291150289965,674.446528045879,0,24,0 +m_103,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,38183.9620333328,17795.271159175652,18675.054376734017,6751.652749982816,0.35123657233736766,1,56859.01641006682,24546.923909158468,68011.59399060585,0,24,0 +m_103,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,38183.9620333328,19546.5683155044,18675.054376734017,10080.217868867547,0.41233081117865095,1,56859.01641006682,29626.786184371944,68011.59399060585,0,24,0 +m_103,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,38183.9620333328,50134.93622855008,18675.054376734017,11693.785581091584,0.6046133695577609,1,56859.01641006682,61828.72180964167,68011.59399060585,0,24,0 +m_103,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,5643.5454412025265,8232.58655921649,1122.5851419843111,2959.997131732965,0.4427870790189503,1,6766.130583186838,11192.583690949456,15773.586575638996,0,23,0 +m_103,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,5643.5454412025265,8573.111709437737,1122.5851419843111,5766.512450234076,0.6424299355700349,1,6766.130583186838,14339.624159671814,15773.586575638996,0,23,0 +m_103,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,5643.5454412025265,4368.721984314944,1122.5851419843111,1154.598613224606,0.44695948661692453,1,6766.130583186838,5523.32059753955,15773.586575638996,0,23,0 +m_103,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,14421.496803450878,3807.339313394162,7943.455480826661,1455.2161329378268,0.2549027442788304,1,22364.95228427754,5262.5554463319895,24601.447512705297,0,24,0 +m_103,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,14421.496803450878,4359.365428481809,7943.455480826661,2890.6772604793186,0.2869267799550439,1,22364.95228427754,7250.042688961128,24601.447512705297,0,24,0 +m_103,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,14421.496803450878,4193.0878007692545,7943.455480826661,1595.074472505964,0.2705917172210319,1,22364.95228427754,5788.1622732752185,24601.447512705297,0,24,0 +m_103,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,5328.634617598269,3483.725717627265,2029.0373843144002,406.3130800596038,0.41949707830824284,1,7357.67200191267,3890.0387976868687,8115.414156424757,0,24,0 +m_103,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,5328.634617598269,5705.587955855278,2029.0373843144002,1672.0612772581367,0.8894423177651793,1,7357.67200191267,7377.649233113414,8115.414156424757,0,24,0 +m_103,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,5328.634617598269,3891.61600598935,2029.0373843144002,1310.524965236859,0.5704833045659605,1,7357.67200191267,5202.140971226209,8115.414156424757,0,24,0 +m_103,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,853941.778194888,865663.0032482671,61727.102194714986,73150.84966172016,0.9050282020170008,1,915668.880389603,938813.8529099873,1199618.233308985,0,24,0 +m_103,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,853941.778194888,685681.4950039181,61727.102194714986,101367.46050390849,0.19287091671689813,1,915668.880389603,787048.9555078265,1199618.233308985,0,24,0 +m_103,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,853941.778194888,1048777.0530467131,61727.102194714986,41784.97723418215,0.028640197650140482,0.6014441506529501,915668.880389603,1090562.0302808953,1199618.233308985,0,24,0 +m_103,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,765336.4244533308,826149.2807170689,68354.4053708883,60457.25207062119,0.5204478376377044,1,833690.8298242191,886606.5327876902,1062535.3673255574,0,24,0 +m_103,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,765336.4244533308,725778.3784098548,68354.4053708883,82123.12806922347,0.7191844785494816,1,833690.8298242191,807901.5064790783,1062535.3673255574,0,24,0 +m_103,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,765336.4244533308,882239.9883270881,68354.4053708883,83701.25469614583,0.30573123689301795,1,833690.8298242191,965941.243023234,1062535.3673255574,0,24,0 +m_103,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,777523.3317061171,835405.9422669389,21433.927319209717,26524.463794594976,0.1218267244505931,1,798957.2590253268,861930.4060615338,948123.4466676873,0,24,0 +m_103,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,777523.3317061171,798988.9545617953,21433.927319209717,38307.03812423989,0.638199375172186,1,798957.2590253268,837295.9926860352,948123.4466676873,0,24,0 +m_103,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,777523.3317061171,785753.2505554985,21433.927319209717,23193.184822970838,0.7997208564224756,1,798957.2590253268,808946.4353784694,948123.4466676873,0,24,0 +m_103,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,656386.6079991342,796513.5010650818,18956.774766306207,28049.82985426148,0.002664219931095612,0.06127705841519907,675343.3827654404,824563.3309193433,916577.6213075466,0,24,0 +m_103,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,656386.6079991342,804005.564219014,18956.774766306207,29246.81878784644,0.0024434481560469488,0.05864275574512677,675343.3827654404,833252.3830068605,916577.6213075466,0,24,0 +m_103,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,656386.6079991342,747193.4263599765,18956.774766306207,28515.435966881956,0.0271566985597301,0.5974473683140622,675343.3827654404,775708.8623268584,916577.6213075466,0,24,0 +m_104,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,37433.00742808753,17853.339979055196,18307.776667962677,6417.643346412838,0.3593148932265546,1,55740.78409605021,24270.983325468034,66674.026671826,0,24,0 +m_104,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,37433.00742808753,21241.72554336292,18307.776667962677,9305.485691621308,0.46040905039274727,1,55740.78409605021,30547.21123498423,66674.026671826,0,24,0 +m_104,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,37433.00742808753,49148.94474836683,18307.776667962677,11463.806771474983,0.6046133695577606,1,55740.78409605021,60612.75151984181,66674.026671826,0,24,0 +m_104,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,5054.0355383011565,8070.678300866373,1385.8933493961717,2901.783594969881,0.378725438527154,1,6439.928887697328,10972.461895836255,15463.371321656954,0,23,0 +m_104,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,5054.0355383011565,8404.506426574102,1385.8933493961717,5653.10386584131,0.5925422633799221,1,6439.928887697328,14057.610292415411,15463.371321656954,0,23,0 +m_104,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,5054.0355383011565,4282.803401788238,1385.8933493961717,1131.891405809778,0.6759652960626232,1,6439.928887697328,5414.694807598016,15463.371321656954,0,23,0 +m_104,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,14137.872767013083,3732.4613060090514,7787.233492399158,1426.5967545793708,0.2549027442788307,1,21925.10625941224,5159.058060588422,24117.61688535347,0,24,0 +m_104,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,14137.872767013083,4273.630859041173,7787.233492399158,2833.827020602698,0.286926779955044,1,21925.10625941224,7107.457879643871,24117.61688535347,0,24,0 +m_104,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,14137.872767013083,4110.623372603402,7787.233492399158,1563.7045345254091,0.2705917172210319,1,21925.10625941224,5674.327907128811,24117.61688535347,0,24,0 +m_104,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,5223.837669019135,3415.2121393668476,1989.1328043068156,398.3222204841677,0.41949707830824334,1,7212.970473325951,3813.5343598510153,7955.810298948683,0,24,0 +m_104,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,5223.837669019135,5593.377558533461,1989.1328043068156,1639.1772586926147,0.8894423177651795,1,7212.970473325951,7232.554817226075,7955.810298948683,0,24,0 +m_104,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,5223.837669019135,3884.9325676999597,1989.1328043068156,1247.4838770792835,0.5865658335996953,1,7212.970473325951,5132.416444779243,7955.810298948683,0,24,0 +m_104,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,853933.294184607,865663.0032482671,61728.221635565416,73150.84966172016,0.9049605368523563,1,915661.5158201724,938813.8529099873,1199618.233308985,0,24,0 +m_104,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,853933.294184607,685681.4950039181,61728.221635565416,101367.46050390849,0.1928926852720599,1,915661.5158201724,787048.9555078265,1199618.233308985,0,24,0 +m_104,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,853933.294184607,1048777.0530467131,61728.221635565416,41784.97723418215,0.028636656277328528,0.6013697818238991,915661.5158201724,1090562.0302808953,1199618.233308985,0,24,0 +m_104,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,765336.4244533308,826149.2807170689,68354.4053708883,60457.25207062119,0.5204478376377044,1,833690.8298242191,886606.5327876902,1062535.3673255574,0,24,0 +m_104,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,765336.4244533308,725778.3784098548,68354.4053708883,82123.12806922347,0.7191844785494816,1,833690.8298242191,807901.5064790783,1062535.3673255574,0,24,0 +m_104,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,765336.4244533308,882239.9883270881,68354.4053708883,83701.25469614583,0.30573123689301795,1,833690.8298242191,965941.243023234,1062535.3673255574,0,24,0 +m_104,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,777523.3317061171,835405.9422669389,21433.927319209717,26524.463794594976,0.1218267244505931,1,798957.2590253268,861930.4060615338,948123.4466676873,0,24,0 +m_104,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,777523.3317061171,798988.9545617953,21433.927319209717,38307.03812423989,0.638199375172186,1,798957.2590253268,837295.9926860352,948123.4466676873,0,24,0 +m_104,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,777523.3317061171,785753.2505554985,21433.927319209717,23193.184822970838,0.7997208564224756,1,798957.2590253268,808946.4353784694,948123.4466676873,0,24,0 +m_104,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,656386.6079991342,796503.5285748892,18956.774766306207,28046.139324481723,0.0026634842973652846,0.06126013883940155,675343.3827654404,824549.6678993709,916577.6213075466,0,24,0 +m_104,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,656386.6079991342,804005.564219014,18956.774766306207,29246.81878784644,0.0024434481560469488,0.05864275574512677,675343.3827654404,833252.3830068605,916577.6213075466,0,24,0 +m_104,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,656386.6079991342,747193.4263599765,18956.774766306207,28515.435966881956,0.0271566985597301,0.5974473683140622,675343.3827654404,775708.8623268584,916577.6213075466,0,24,0 +m_105,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,44.48888068524934,52.43739243674535,6.305384280334683,3.0641898386960102,0.30118383169608964,1,50.79426496558403,55.50158227544136,61.051740502985496,0,24,0 +m_105,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,44.48888068524934,45.61601577613055,6.305384280334683,4.405386573370143,0.8873908885467889,1,50.79426496558403,50.0214023495007,61.051740502985496,0,24,0 +m_105,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,44.48888068524934,50.517764997583285,6.305384280334683,2.9270779829205678,0.4208166084221664,1,50.79426496558403,53.44484298050385,61.051740502985496,0,24,0 +m_105,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,49.5511172956052,51.65443754349678,1.6023066525443381,3.1130374129129126,0.5657739674392143,1,51.15342394814954,54.76747495640969,63.67785716367643,0,24,0 +m_105,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,49.5511172956052,52.16120456009073,1.6023066525443381,5.698638228021012,0.6752661553058793,1,51.15342394814954,57.85984278811174,63.67785716367643,0,24,0 +m_105,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,49.5511172956052,53.45065440013684,1.6023066525443381,4.4383066577508155,0.43883106580404596,1,51.15342394814954,57.888961057887656,63.67785716367643,0,24,0 +m_105,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,53.67071736142427,46.07381605483698,1.6993401147696903,1.891664178454754,0.01526204163041661,0.3662889991299986,55.37005747619396,47.965480233291736,60.90706322381337,0,24,0 +m_105,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,53.67071736142427,41.02389067614976,1.6993401147696903,4.003492884432899,0.030604683842797478,0.703907728384342,55.37005747619396,45.02738356058266,60.90706322381337,0,24,0 +m_105,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,53.67071736142427,44.877803810706304,1.6993401147696903,4.969902240637519,0.14406694273612955,1,55.37005747619396,49.84770605134382,60.90706322381337,0,24,0 +m_105,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,50.79723336807032,49.65107702567092,7.053814220762816,4.79594399000102,0.8967372358365564,1,57.85104758883314,54.44702101567194,63.63615234771646,0,24,0 +m_105,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,50.79723336807032,47.510157710032814,7.053814220762816,4.645237141965368,0.708474057417902,1,57.85104758883314,52.15539485199818,63.63615234771646,0,24,0 +m_105,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,50.79723336807032,50.64809087363046,7.053814220762816,4.107766418670155,0.9859650194584662,1,57.85104758883314,54.75585729230061,63.63615234771646,0,24,0 +m_105,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,89.95654413215318,140.80068887444753,26.773877862453027,28.536158930888476,0.2230896291804881,1,116.73042199460622,169.336847805336,193.01131168865004,0,24,0 +m_105,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,89.95654413215318,95.45552687499072,26.773877862453027,11.465559050150304,0.8557789381001376,1,116.73042199460622,106.92108592514103,193.01131168865004,0,24,0 +m_105,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,89.95654413215318,147.578180658873,26.773877862453027,27.88664814899064,0.16698993542390628,1,116.73042199460622,175.46482880786365,193.01131168865004,0,24,0 +m_105,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,113.32963109450672,116.9831299850431,20.220426777668322,30.077522125656298,0.9219749805845482,1,133.55005787217505,147.0606521106994,172.47275602664837,0,24,0 +m_105,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,113.32963109450672,90.94007296196432,20.220426777668322,13.01681823888547,0.37741181160528825,1,133.55005787217505,103.95689120084978,172.47275602664837,0,24,0 +m_105,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,113.32963109450672,124.94316432844609,20.220426777668322,31.850250241234242,0.7656461653978719,1,133.55005787217505,156.79341456968032,172.47275602664837,0,24,0 +m_105,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,103.81884196253857,115.02740610312057,19.358316199349048,17.619759626596327,0.6776637413888198,1,123.17715816188762,132.6471657297169,172.10871105885403,0,24,0 +m_105,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,103.81884196253857,123.47865265488824,19.358316199349048,32.98381194406998,0.6209785244385511,1,123.17715816188762,156.4624645989582,172.10871105885403,0,24,0 +m_105,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,103.81884196253857,112.56812021293928,19.358316199349048,24.683638567041026,0.7863117637526166,1,123.17715816188762,137.2517587799803,172.10871105885403,0,24,0 +m_105,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,124.85055234194422,141.87588542606468,23.74591584015222,31.29363998466131,0.6745773902146845,1,148.59646818209643,173.169525410726,190.48647795179863,0,24,0 +m_105,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,124.85055234194422,82.60712243491076,23.74591584015222,15.997367730350541,0.1751054687812005,1,148.59646818209643,98.60449016526131,190.48647795179863,0,24,0 +m_105,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,124.85055234194422,72.38575194506232,23.74591584015222,6.352870867431074,0.07905651949901163,1,148.59646818209643,78.7386228124934,190.48647795179863,0,24,0 +m_106,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,242.37081784359805,261.6265793010397,34.96604699074921,9.57667000104803,0.6199394342305823,1,277.33686483434724,271.2032493020878,305.07055131778196,0,24,0 +m_106,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,242.37081784359805,239.84353020484772,34.96604699074921,16.817285296372795,0.9502466497495933,1,277.33686483434724,256.6608155012205,305.07055131778196,0,24,0 +m_106,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,242.37081784359805,253.51170257979373,34.96604699074921,8.575918095850827,0.7708395519625375,1,277.33686483434724,262.0876206756446,305.07055131778196,0,24,0 +m_106,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,163.8251652207895,195.81674867497333,9.51776322233526,2.245932147917645,0.019009776445053278,0.4182150817911721,173.34292844312475,198.06268082289097,217.86894890518008,0,24,0 +m_106,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,163.8251652207895,171.19986823176984,9.51776322233526,9.164260475803454,0.5890305104629667,1,173.34292844312475,180.3641287075733,217.86894890518008,0,24,0 +m_106,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,163.8251652207895,180.4673055763937,9.51776322233526,6.940604732988131,0.19083312664490246,1,173.34292844312475,187.40791030938183,217.86894890518008,0,24,0 +m_106,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,187.72866104474357,173.28110878486214,19.52241650115663,8.006795939497053,0.5221295444601284,1,207.25107754590022,181.28790472435918,227.97618530049024,1,24,4.166666666666666 +m_106,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,187.72866104474357,163.96368825473195,19.52241650115663,23.04976632636614,0.4546930260405503,1,207.25107754590022,187.01345458109807,227.97618530049024,1,24,4.166666666666666 +m_106,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,187.72866104474357,186.22396566089586,19.52241650115663,9.916070720091858,0.9474427169114134,1,207.25107754590022,196.1400363809877,227.97618530049024,1,24,4.166666666666666 +m_106,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,149.81706398084205,154.8168318629324,5.360647094973979,10.858388482663392,0.6917151085890697,1,155.17771107581603,165.6752203455958,188.03972419505249,1,24,4.166666666666666 +m_106,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,149.81706398084205,155.1120071874732,5.360647094973979,7.25830001684026,0.5722333635844017,1,155.17771107581603,162.37030720431346,188.03972419505249,1,24,4.166666666666666 +m_106,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,149.81706398084205,164.07096193126415,5.360647094973979,6.874241882419906,0.13705400557024772,1,155.17771107581603,170.94520381368406,188.03972419505249,1,24,4.166666666666666 +m_106,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3386.8925656611377,3538.5872101506407,131.9761013273769,76.69230046679503,0.3493164318432227,1,3518.8686669885146,3615.279510617436,4387.345116995949,0,24,0 +m_106,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3386.8925656611377,3515.7625356572407,131.9761013273769,73.82196935368961,0.4193397445767716,1,3518.8686669885146,3589.58450501093,4387.345116995949,0,24,0 +m_106,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3386.8925656611377,3732.3932283339896,131.9761013273769,256.10233257141834,0.26705024545156075,1,3518.8686669885146,3988.4955609054077,4387.345116995949,0,24,0 +m_106,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3142.0307590794428,3269.793882437594,122.65714274649028,74.3425905599447,0.39831813295007445,1,3264.687901825933,3344.136472997539,3942.614268793971,0,24,0 +m_106,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3142.0307590794428,3458.373537076909,122.65714274649028,125.82125273579159,0.1020189935585345,1,3264.687901825933,3584.1947898127005,3942.614268793971,0,24,0 +m_106,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,3142.0307590794428,3080.163812601301,122.65714274649028,86.47751045397412,0.6898283458303673,1,3264.687901825933,3166.641323055275,3942.614268793971,0,24,0 +m_106,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,3048.2746230712073,3287.7095207315865,94.45766819026072,95.6531070571885,0.10524437911645056,1,3142.732291261468,3383.362627788775,4140.07821218277,0,24,0 +m_106,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,3048.2746230712073,3602.177297874595,94.45766819026072,161.53016774610413,0.017989011428632008,0.4137472628585362,3142.732291261468,3763.707465620699,4140.07821218277,0,24,0 +m_106,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,3048.2746230712073,3331.23102038816,94.45766819026072,58.01841831265024,0.03305625497001147,0.6611250994002293,3142.732291261468,3389.24943870081,4140.07821218277,0,24,0 +m_106,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,2791.14294318225,3207.581004681559,88.36063606348887,52.927184824831464,0.0035528097932636714,0.08526743503832812,2879.503579245739,3260.5081895063904,3948.9989116248203,0,24,0 +m_106,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,2791.14294318225,3298.6941394992346,88.36063606348887,156.07442938576804,0.022416305248363414,0.4707424102156317,2879.503579245739,3454.7685688850024,3948.9989116248203,0,24,0 +m_106,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,2791.14294318225,3334.2572365239,88.36063606348887,255.74177404411842,0.09013990875172093,1,2879.503579245739,3589.999010568018,3948.9989116248203,0,24,0 +m_107,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,709.7323516050236,701.7584238044392,79.95670323260008,44.511764543989564,0.9332372050886949,1,789.6890548376236,746.2701883484287,1006.259353359433,0,24,0 +m_107,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,709.7323516050236,801.4514770705441,79.95670323260008,113.32975325621307,0.5258125055693272,1,789.6890548376236,914.7812303267572,1006.259353359433,0,24,0 +m_107,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,709.7323516050236,772.1371926327015,79.95670323260008,99.820663198171,0.6373942984996219,1,789.6890548376236,871.9578558308725,1006.259353359433,0,24,0 +m_107,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,374.072621588788,485.7861188387827,31.620660501719627,75.7676735271549,0.21767109609689209,1,405.69328209050764,561.5537923659376,617.7091716025315,0,24,0 +m_107,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,374.072621588788,352.61968295175757,31.620660501719627,49.941716471339966,0.7255649818397358,1,405.69328209050764,402.56139942309755,617.7091716025315,0,24,0 +m_107,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,374.072621588788,407.9698690048897,31.620660501719627,56.271774294717204,0.6139435693149583,1,405.69328209050764,464.2416432996069,617.7091716025315,0,24,0 +m_107,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,696.9365653924843,360.7227584989879,395.55403255459765,67.8115126940729,0.44684128797228356,1,1092.490597947082,428.5342711930608,1201.7396577417903,0,24,0 +m_107,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,696.9365653924843,412.76947838132986,395.55403255459765,154.5581640267084,0.5320013264389831,1,1092.490597947082,567.3276424080383,1201.7396577417903,0,24,0 +m_107,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,696.9365653924843,377.80157593063285,395.55403255459765,37.21467007200273,0.46610854400106705,1,1092.490597947082,415.01624600263557,1201.7396577417903,0,24,0 +m_107,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,222.01180748199775,274.8697674256525,60.93701870098342,21.295402097151598,0.45028051067272995,1,282.9488261829812,296.16516952280415,390.3385923791999,0,24,0 +m_107,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,222.01180748199775,173.14019482241065,60.93701870098342,23.064676037581794,0.486084855976361,1,282.9488261829812,196.20487085999244,390.3385923791999,0,24,0 +m_107,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,222.01180748199775,305.61295062804277,60.93701870098342,49.24031517122983,0.3165199343355447,1,282.9488261829812,354.8532657992726,390.3385923791999,0,24,0 +m_107,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,18134.541593068476,15583.168449591263,1240.3054645539994,911.5268918069975,0.13111673045986616,1,19374.847057622475,16494.69534139826,21312.331763384725,0,24,0 +m_107,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,18134.541593068476,16135.857380745101,1240.3054645539994,732.2508698296208,0.20218637661366387,1,19374.847057622475,16868.10825057472,21312.331763384725,0,24,0 +m_107,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,18134.541593068476,16297.591380953829,1240.3054645539994,1352.5668073409877,0.34061434647204325,1,19374.847057622475,17650.158188294816,21312.331763384725,0,24,0 +m_107,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,12323.844257895526,10664.628039957248,2013.9564244013764,703.295162929406,0.465317611740653,1,14337.800682296902,11367.923202886654,15771.580750526593,0,24,0 +m_107,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,12323.844257895526,10003.116616644445,2013.9564244013764,811.9198291625238,0.3227989851909876,1,14337.800682296902,10815.036445806969,15771.580750526593,0,24,0 +m_107,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,12323.844257895526,10597.987477246306,2013.9564244013764,585.4701047688154,0.44287482427532837,1,14337.800682296902,11183.457582015122,15771.580750526593,0,24,0 +m_107,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,5883.783335525771,7097.513527655217,454.4545681055833,271.7759019403319,0.05043538088972694,1,6338.237903631354,7369.289429595549,8531.983382663107,0,24,0 +m_107,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,5883.783335525771,6960.651474247517,454.4545681055833,795.6970554462171,0.27391783451744833,1,6338.237903631354,7756.348529693734,8531.983382663107,0,24,0 +m_107,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,5883.783335525771,6666.940812548071,454.4545681055833,260.3479265373007,0.17337250554328743,1,6338.237903631354,6927.288739085372,8531.983382663107,0,24,0 +m_107,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,4330.453784028004,5231.320676990992,145.75796551983885,379.7661797065449,0.0656541975653998,1,4476.211749547842,5611.086856697537,6172.195542367291,0,24,0 +m_107,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,4330.453784028004,4375.753572852026,145.75796551983885,258.56702057277846,0.8825327654085006,1,4476.211749547842,4634.320593424804,6172.195542367291,0,24,0 +m_107,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,4330.453784028004,4411.1074187132,145.75796551983885,409.70433271621295,0.8587374392513266,1,4476.211749547842,4820.811751429413,6172.195542367291,0,24,0 +m_108,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,304.76931137951135,310.54254888407496,81.09130867244677,29.069639051121897,0.9491507539819769,1,385.8606200519581,339.61218793519686,424.44668205715396,0,24,0 +m_108,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,304.76931137951135,280.5765628571813,81.09130867244677,52.16038112171566,0.8090545925283312,1,385.8606200519581,332.73694397889693,424.44668205715396,0,24,0 +m_108,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,304.76931137951135,320.9622706804746,81.09130867244677,32.17359713178328,0.8597028966639498,1,385.8606200519581,353.13586781225786,424.44668205715396,0,24,0 +m_108,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,147.290577999341,127.4945264964549,19.463827897081728,10.734988627107674,0.39983502610943944,1,166.75440589642272,138.22951512356258,183.429846486065,0,24,0 +m_108,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,147.290577999341,62.11391171849686,19.463827897081728,9.828987509599044,0.005253987465053225,0.12609569916127739,166.75440589642272,71.9428992280959,183.429846486065,0,24,0 +m_108,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,147.290577999341,141.05173108057187,19.463827897081728,20.000816310753276,0.8276129000976755,1,166.75440589642272,161.05254739132513,183.429846486065,0,24,0 +m_108,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,137.71404956433514,99.88469418428464,35.65034857279615,11.641237536940192,0.36071898559016274,1,173.36439813713127,111.52593172122484,190.70083795084443,1,24,4.166666666666666 +m_108,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,137.71404956433514,36.0350823380658,35.65034857279615,19.260445096947464,0.04498421975246475,1,173.36439813713127,55.29552743501326,190.70083795084443,1,24,4.166666666666666 +m_108,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,137.71404956433514,75.93987286743075,35.65034857279615,11.498284012513608,0.1620443359814443,1,173.36439813713127,87.43815687994436,190.70083795084443,1,24,4.166666666666666 +m_108,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,100.4664893584531,85.23186505047792,12.774853407226981,18.183004410309163,0.5111452643681287,1,113.24134276568009,103.41486946078709,124.5654770422481,0,24,0 +m_108,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,100.4664893584531,80.75689154220191,12.774853407226981,22.751760530738487,0.4725193265679869,1,113.24134276568009,103.50865207294041,124.5654770422481,0,24,0 +m_108,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,100.4664893584531,72.54872394822895,12.774853407226981,10.16083161516149,0.12521613523007688,1,113.24134276568009,82.70955556339044,124.5654770422481,0,24,0 +m_108,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,317.6105123370091,469.6800472296446,59.704226918553324,145.07983627861574,0.3663319250042816,1,377.3147392555624,614.7598835082604,676.2358718590865,0,24,0 +m_108,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,317.6105123370091,336.8265845406727,59.704226918553324,97.30828346049354,0.8703629284695404,1,377.3147392555624,434.13486800116624,676.2358718590865,0,24,0 +m_108,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,317.6105123370091,489.00030487062725,59.704226918553324,102.02553798785695,0.18484380215615415,1,377.3147392555624,591.0258428584842,676.2358718590865,0,24,0 +m_108,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,439.0473932520628,534.7574759939412,87.67731802440326,106.59574658218222,0.5043942659519522,1,526.7247112764661,641.3532225761234,705.4885448337358,0,24,0 +m_108,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,439.0473932520628,377.34984506495937,87.67731802440326,57.85126968934603,0.5719594724926556,1,526.7247112764661,435.2011147543054,705.4885448337358,0,24,0 +m_108,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,439.0473932520628,312.81255278059876,87.67731802440326,72.6822281610636,0.29448808549416555,1,526.7247112764661,385.4947809416624,705.4885448337358,0,24,0 +m_108,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,304.323723836296,227.87648315465017,75.42561072527938,34.499959990991265,0.38732878019221195,1,379.7493345615754,262.3764431456414,510.6880715397065,0,24,0 +m_108,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,304.323723836296,360.6713257455561,75.42561072527938,103.5905574723589,0.6703467800293645,1,379.7493345615754,464.261883217915,510.6880715397065,0,24,0 +m_108,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,304.323723836296,313.03836950432856,75.42561072527938,84.77801806127383,0.9403187359570158,1,379.7493345615754,397.8163875656024,510.6880715397065,0,24,0 +m_108,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,219.8603821991507,153.33277490178924,82.47912537467366,38.612247169204686,0.4885043646831261,1,302.33950757382433,191.94502207099393,496.5531573448342,0,24,0 +m_108,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,219.8603821991507,383.26894394059923,82.47912537467366,68.14301728197727,0.15873733591045075,1,302.33950757382433,451.4119612225765,496.5531573448342,0,24,0 +m_108,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,219.8603821991507,206.9236285528066,82.47912537467366,58.91464073305172,0.9012314452122865,1,302.33950757382433,265.8382692858583,496.5531573448342,0,24,0 +m_109,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,28.693733564626175,78.27622560928788,9.376686347505984,9.212950441918899,0.004537626057878747,0.10436539933121118,38.07041991213216,87.48917605120678,127.83599832921661,0,24,0 +m_109,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,28.693733564626175,94.83119048122639,9.376686347505984,21.383353454425066,0.026123179136063504,0.52246358272127,38.07041991213216,116.21454393565145,127.83599832921661,0,24,0 +m_109,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,28.693733564626175,65.9495303782303,9.376686347505984,16.06060952372987,0.08079263152420549,1,38.07041991213216,82.01013990196017,127.83599832921661,0,24,0 +m_109,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,82.10830402830325,94.92178597041597,9.074015443593144,7.4416974861702405,0.3014473274188934,1,91.18231947189639,102.36348345658621,187.26006295141897,0,24,0 +m_109,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,82.10830402830325,145.68492494282714,9.074015443593144,24.55149592209919,0.049059895088730245,0.8830781115971444,91.18231947189639,170.23642086492632,187.26006295141897,0,24,0 +m_109,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,82.10830402830325,114.451640220172,9.074015443593144,13.887810009270053,0.08447018272501171,1,91.18231947189639,128.33945022944204,187.26006295141897,0,24,0 +m_109,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,99.79753214803992,86.1690686276392,7.8368315946095235,15.49262314432442,0.4572248059298024,1,107.63436374264944,101.66169177196363,183.74204384290312,0,24,0 +m_109,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,99.79753214803992,134.52651513481044,7.8368315946095235,21.548271788172876,0.1898395466344814,1,107.63436374264944,156.07478692298332,183.74204384290312,0,24,0 +m_109,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,99.79753214803992,154.153026713493,7.8368315946095235,12.885194961873463,0.0069216263890896695,0.15227578055997273,107.63436374264944,167.03822167536646,183.74204384290312,0,24,0 +m_109,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,115.26780159034894,101.33450696061367,16.876269432187403,6.986272181259448,0.4777616946236213,1,132.14407102253634,108.32077914187312,174.30023204209235,0,24,0 +m_109,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,115.26780159034894,144.37935479548662,16.876269432187403,14.075401606415516,0.22061064586266685,1,132.14407102253634,158.45475640190213,174.30023204209235,0,24,0 +m_109,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,115.26780159034894,122.65696256190834,16.876269432187403,16.81215019493638,0.7635713265468416,1,132.14407102253634,139.4691127568447,174.30023204209235,0,24,0 +m_109,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,956.9044131587275,982.0577607405977,105.70331597276385,60.209806617600385,0.8413960384388539,1,1062.6077291314914,1042.267567358198,1317.2120338957104,0,24,0 +m_109,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,956.9044131587275,952.6506756175954,105.70331597276385,94.41319057906506,0.9766544123156378,1,1062.6077291314914,1047.0638661966605,1317.2120338957104,0,24,0 +m_109,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,956.9044131587275,1076.1553063470374,105.70331597276385,121.31017901269927,0.4759638038688606,1,1062.6077291314914,1197.4654853597367,1317.2120338957104,0,24,0 +m_109,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1075.5597803910264,1307.5900284703562,82.83755233377164,102.12071027528425,0.10938694224232279,1,1158.397332724798,1409.7107387456404,1952.4209066517105,0,24,0 +m_109,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,1075.5597803910264,1655.7922038879678,82.83755233377164,119.13589306813232,0.0031740251213632905,0.07617660291271897,1158.397332724798,1774.9280969561003,1952.4209066517105,0,24,0 +m_109,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,1075.5597803910264,1530.8762835307864,82.83755233377164,125.1998699422962,0.014786693575974738,0.3105205650954695,1158.397332724798,1656.0761534730825,1952.4209066517105,0,24,0 +m_109,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1695.861336972824,1747.2400455219538,63.779538727328905,179.61139106784037,0.7961875345628069,1,1759.6408757001527,1926.851436589794,2382.5033273547724,0,24,0 +m_109,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1695.861336972824,1414.0492863536904,63.779538727328905,161.76242305381567,0.1522700446705359,1,1759.6408757001527,1575.811709407506,2382.5033273547724,0,24,0 +m_109,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1695.861336972824,1861.684253118835,63.779538727328905,304.22786265823066,0.6147909119822912,1,1759.6408757001527,2165.9121157770655,2382.5033273547724,0,24,0 +m_109,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1760.6737631139824,2068.1280419892596,231.5502632211366,191.13128614805848,0.3308049691203486,1,1992.224026335119,2259.259328137318,3210.4689915389054,0,24,0 +m_109,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1760.6737631139824,1933.237055228743,231.5502632211366,231.33232871618603,0.609536789463216,1,1992.224026335119,2164.569383944929,3210.4689915389054,0,24,0 +m_109,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,1760.6737631139824,2637.779679809268,231.5502632211366,280.8284943170093,0.03753198905518197,0.7131077920484574,1992.224026335119,2918.6081741262774,3210.4689915389054,0,24,0 +m_110,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,803.0077798452246,780.9913497282062,157.5872318286452,26.68275284748821,0.8967496248495963,1,960.5950116738697,807.6741025756944,1143.1924535958585,0,24,0 +m_110,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,803.0077798452246,867.8668548071931,157.5872318286452,171.39901209813263,0.786878298229952,1,960.5950116738697,1039.2658669053258,1143.1924535958585,0,24,0 +m_110,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,803.0077798452246,921.7432686193224,157.5872318286452,65.0847056344281,0.5152390500106306,1,960.5950116738697,986.8279742537505,1143.1924535958585,0,24,0 +m_110,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,279.95384215221173,536.341533615747,29.092523707974905,69.43152432802026,0.01213059703097666,0.26687313468148655,309.04636586018665,605.7730579437673,666.3503637381441,0,24,0 +m_110,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,279.95384215221173,425.2334905070888,29.092523707974905,68.9584663974706,0.09507856744303426,1,309.04636586018665,494.1919569045594,666.3503637381441,0,24,0 +m_110,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,279.95384215221173,491.6130856109202,29.092523707974905,21.47797376693067,2.227722926460415e-4,0.005346535023504996,309.04636586018665,513.0910593778509,666.3503637381441,0,24,0 +m_110,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,407.13277716960454,356.2465030061606,159.41151803095573,34.68968539296332,0.7693977851357497,1,566.5442952005603,390.9361883991239,623.1987247206164,0,24,0 +m_110,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,407.13277716960454,326.9011231466667,159.41151803095573,54.01999829799809,0.6540647449144408,1,566.5442952005603,380.9211214446648,623.1987247206164,0,24,0 +m_110,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,407.13277716960454,474.8315079872311,159.41151803095573,41.955452548048534,0.6998916561821051,1,566.5442952005603,516.7869605352796,623.1987247206164,0,24,0 +m_110,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,246.94010350613598,291.8140231005119,42.21046137158135,33.16208003364842,0.4273821780232647,1,289.15056487771733,324.9761031341603,435.85508314507786,0,24,0 +m_110,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,246.94010350613598,202.4516466644459,42.21046137158135,13.959397666021605,0.36402561428304003,1,289.15056487771733,216.4110443304675,435.85508314507786,0,24,0 +m_110,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,246.94010350613598,357.7967413321389,42.21046137158135,38.435152436113704,0.08542357840064914,1,289.15056487771733,396.2318937682526,435.85508314507786,0,24,0 +m_110,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,3836.947745696641,2210.8057094401347,607.6429152205377,192.7424217468386,0.043463351419697926,0.8692670283939585,4444.590660917179,2403.5481311869735,4889.049727008897,0,24,0 +m_110,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,3836.947745696641,2451.4022869502323,607.6429152205377,136.17962658937998,0.07176346246702846,1,4444.590660917179,2587.5819135396123,4889.049727008897,0,24,0 +m_110,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,3836.947745696641,2044.8137744029673,607.6429152205377,188.48061646258634,0.030735641647650993,0.6454484746006709,4444.590660917179,2233.2943908655534,4889.049727008897,0,24,0 +m_110,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,4225.880915172431,3500.381744092133,226.8797444479429,244.20826259693402,0.05471052121528344,1,4452.760659620374,3744.590006689067,4898.036725582412,0,24,0 +m_110,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,4225.880915172431,3690.402859514037,226.8797444479429,265.288836717868,0.15676784175314726,1,4452.760659620374,3955.691696231905,4898.036725582412,0,24,0 +m_110,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,4225.880915172431,2546.045434207997,226.8797444479429,286.01995882655257,0.0011160214108340933,0.025668492449184146,4452.760659620374,2832.0653930345497,4898.036725582412,0,24,0 +m_110,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6196.556547397691,6450.223303986008,792.5311049415176,954.2888104808588,0.8422070846407036,1,6989.087652339209,7404.512114466867,8144.963325913554,0,24,0 +m_110,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,6196.556547397691,4922.782189994779,792.5311049415176,788.4283641708453,0.2810848122292729,1,6989.087652339209,5711.210554165625,8144.963325913554,0,24,0 +m_110,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6196.556547397691,4713.238914259191,792.5311049415176,959.0431638251998,0.2616360579763814,1,6989.087652339209,5672.28207808439,8144.963325913554,0,24,0 +m_110,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6405.278640912654,9126.596584719167,1032.0987172419457,1782.6597775937075,0.2229415062984895,1,7437.377358154599,10909.256362312875,12000.181998544163,0,24,0 +m_110,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,6405.278640912654,7784.864263026788,1032.0987172419457,1807.173557834154,0.5261468045802867,1,7437.377358154599,9592.037820860942,12000.181998544163,0,24,0 +m_110,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,6405.278640912654,9436.409839736109,1032.0987172419457,1343.9493347056225,0.10593927160454465,1,7437.377358154599,10780.359174441732,12000.181998544163,0,24,0 +m_111,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,246.34953519871243,146.37654387412192,159.1810605006087,20.230749548435895,0.5660248677988312,1,405.5305956993211,166.6072934225578,476.79175733742113,0,24,0 +m_111,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,246.34953519871243,234.12450224081502,159.1810605006087,83.95059121783552,0.94799404451382,1,405.5305956993211,318.07509345865054,476.79175733742113,0,24,0 +m_111,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,246.34953519871243,291.4845736736721,159.1810605006087,141.96247845125615,0.8373589976107012,1,405.5305956993211,433.4470521249283,476.79175733742113,0,24,0 +m_111,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,121.79601265661636,228.13012974355274,22.53724621393847,55.07993083470662,0.11951741119215165,1,144.33325887055483,283.21006057825934,741.5047374148265,0,24,0 +m_111,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,121.79601265661636,493.0198385922093,22.53724621393847,181.0753772394512,0.09586151884731212,1,144.33325887055483,674.0952158316604,741.5047374148265,0,24,0 +m_111,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,121.79601265661636,309.68732743349517,22.53724621393847,112.85456797139486,0.15914741765320395,1,144.33325887055483,422.54189540489006,741.5047374148265,0,24,0 +m_111,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,145.09384909344632,423.7490932800137,25.07621204469378,98.14736903485324,0.03543273539562833,0.7795201787038233,170.1700611381401,521.896462314867,574.0861085463538,0,24,0 +m_111,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,145.09384909344632,209.5658814727154,25.07621204469378,38.02651121936357,0.2003084185124178,1,170.1700611381401,247.592392692079,574.0861085463538,0,24,0 +m_111,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,145.09384909344632,276.87411739737115,25.07621204469378,39.74918074974047,0.022621463748027038,0.5429151299526489,170.1700611381401,316.6232981471116,574.0861085463538,0,24,0 +m_111,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,184.84349394551683,245.10805089406398,20.461153725696917,30.690131553825495,0.13928013409986945,1,205.30464767121373,275.7981824478895,337.9428057078297,0,24,0 +m_111,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,184.84349394551683,257.70559629028753,20.461153725696917,18.061381866793955,0.02685340625538939,0.6176283438739559,205.30464767121373,275.7669781570815,337.9428057078297,0,24,0 +m_111,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,184.84349394551683,272.2287209270111,20.461153725696917,34.99201153465218,0.06382144758956186,1,205.30464767121373,307.2207324616633,337.9428057078297,0,24,0 +m_111,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,22702.281093711128,21672.92218677292,1396.7990954645627,2111.8497178175567,0.6941939872364786,1,24099.08018917569,23784.771904590478,26528.806952171897,0,24,0 +m_111,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,22702.281093711128,22845.145011071807,1396.7990954645627,1271.9522181753696,0.9412232268530686,1,24099.08018917569,24117.097229247178,26528.806952171897,0,24,0 +m_111,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,22702.281093711128,20714.760393022498,1396.7990954645627,2605.879189660058,0.5212106817060415,1,24099.08018917569,23320.639582682554,26528.806952171897,0,24,0 +m_111,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,43720.1326879251,46074.002944674816,5854.994382049509,3276.422162991783,0.7349407948208322,1,49575.12706997461,49350.4251076666,54532.63977697207,0,24,0 +m_111,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,43720.1326879251,43009.782400329204,5854.994382049509,3105.43237887996,0.9174178989110342,1,49575.12706997461,46115.214779209164,54532.63977697207,0,24,0 +m_111,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,43720.1326879251,37543.75523365795,5854.994382049509,4236.94901568156,0.41468183310157614,1,49575.12706997461,41780.704249339506,54532.63977697207,0,24,0 +m_111,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,56106.61072558939,45294.22683563709,3323.720332945065,4639.815859991648,0.09046817690152013,1,59430.33105853445,49934.04269562874,65373.3641643879,0,24,0 +m_111,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,56106.61072558939,51853.859987293006,3323.720332945065,5946.665916550576,0.5501732919278262,1,59430.33105853445,57800.52590384358,65373.3641643879,0,24,0 +m_111,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,56106.61072558939,46946.543094772576,3323.720332945065,6122.679598036644,0.22631486844670498,1,59430.33105853445,53069.22269280922,65373.3641643879,0,24,0 +m_111,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,66689.05961878091,54135.055811726874,10251.091117349044,4973.187018083076,0.3058568618189829,1,76940.15073612996,59108.24282980995,84634.16580974296,0,24,0 +m_111,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,66689.05961878091,63411.85357210963,10251.091117349044,9085.300902825298,0.8158110948881917,1,76940.15073612996,72497.15447493493,84634.16580974296,0,24,0 +m_111,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,66689.05961878091,54163.93874036365,10251.091117349044,6807.29388457466,0.33624207431048864,1,76940.15073612996,60971.23262493831,84634.16580974296,0,24,0 +m_112,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,852.8399339333798,1656.0986307477676,146.38245740412296,570.7833087909055,0.22465409324414568,1,999.2223913375028,2226.881939538673,2576.474793738089,0,24,0 +m_112,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,852.8399339333798,1245.361025509341,146.38245740412296,324.34918461490037,0.3070515778511594,1,999.2223913375028,1569.7102101242415,2576.474793738089,0,24,0 +m_112,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,852.8399339333798,2170.7199140740413,146.38245740412296,171.52989841513056,2.4755991661059705e-4,0.005941437998654329,999.2223913375028,2342.2498124891717,2576.474793738089,0,24,0 +m_112,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,311.1792135019354,1570.7067673564452,47.59696940692736,376.8522324072916,0.0201348563276224,0.40269712655244805,358.7761829088628,1947.5589997637367,2142.3148997401104,0,24,0 +m_112,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,311.1792135019354,555.7354251894772,47.59696940692736,76.82446057945324,0.025817449775639534,0.44061183269232734,358.7761829088628,632.5598857689304,2142.3148997401104,0,24,0 +m_112,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,311.1792135019354,972.5722516847377,47.59696940692736,142.04071993025713,0.0043050180100407285,0.09471039622089603,358.7761829088628,1114.6129716149949,2142.3148997401104,0,24,0 +m_112,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,684.4018700084052,1715.6120636281876,277.90714401344087,354.4704708165252,0.048277481645427674,0.6758847430359874,962.3090140218461,2070.082534444713,2547.7107665078447,0,24,0 +m_112,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,684.4018700084052,811.8763867368177,277.90714401344087,73.44586579629106,0.6776849026942231,1,962.3090140218461,885.3222525331088,2547.7107665078447,0,24,0 +m_112,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,684.4018700084052,1948.460430208932,277.90714401344087,367.6402666163812,0.023283972913092144,0.44061183269232734,962.3090140218461,2316.100696825313,2547.7107665078447,0,24,0 +m_112,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,426.591426110135,1789.34996465981,112.55012389174729,338.8310311910702,0.008596640183037482,0.1805294438437871,539.1415500018823,2128.18099585088,2855.2492500727885,0,24,0 +m_112,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,426.591426110135,816.7757349915466,112.55012389174729,153.02596283701192,0.07125084382480965,0.9262609697225254,539.1415500018823,969.8016978285585,2855.2492500727885,0,24,0 +m_112,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,426.591426110135,2074.9631853517244,112.55012389174729,520.7179510780827,0.02404665650572175,0.44061183269232734,539.1415500018823,2595.6811364298073,2855.2492500727885,0,24,0 +m_112,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,284066.7372462544,170376.5246830435,87182.17337534636,19007.342804421747,0.25403178231603496,1,371248.91062160075,189383.86748746526,408373.80168376083,0,24,0 +m_112,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,284066.7372462544,176946.3498474148,87182.17337534636,13458.427670254194,0.27651812575118523,1,371248.91062160075,190404.777517669,408373.80168376083,0,24,0 +m_112,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,284066.7372462544,235088.75069101126,87182.17337534636,34545.93889918016,0.6187098902709336,1,371248.91062160075,269634.6895901914,408373.80168376083,0,24,0 +m_112,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,351518.5860881546,219730.84159179757,88922.78209468091,84536.8560068912,0.3080657365263272,1,440441.3681828355,304267.69759868877,507059.10379649885,0,24,0 +m_112,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,351518.5860881546,340557.4395658557,88922.78209468091,68383.93276848785,0.9242159670219755,1,440441.3681828355,408941.37233434356,507059.10379649885,0,24,0 +m_112,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,351518.5860881546,358732.4126443057,88922.78209468091,102230.40898887503,0.9586080012859719,1,440441.3681828355,460962.8216331807,507059.10379649885,0,24,0 +m_112,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,49795.27330558879,244513.34073149657,43597.69541217024,61990.7209431917,0.03029014972263636,0.45435224583954537,93392.96871775902,306504.06167468824,364887.2958966118,0,24,0 +m_112,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,49795.27330558879,208095.32960635843,43597.69541217024,101748.5353090404,0.1971505530088317,1,93392.96871775902,309843.8649153988,364887.2958966118,0,24,0 +m_112,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,49795.27330558879,301156.8744358467,43597.69541217024,30558.849106527643,0.0011013471431236244,0.025330984291843363,93392.96871775902,331715.7235423743,364887.2958966118,0,24,0 +m_112,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,6086.038398766024,95508.17449048873,657.5402643854702,88211.58530825871,0.3572366507262689,1,6743.578663151495,183719.75979874743,202091.73577862218,0,24,0 +m_112,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,6086.038398766024,9205.176905055909,657.5402643854702,1870.1217734372576,0.16495399915418357,1,6743.578663151495,11075.298678493167,202091.73577862218,0,24,0 +m_112,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,6086.038398766024,10304.498843029784,657.5402643854702,1320.869902975948,0.023190096457490914,0.44061183269232734,6743.578663151495,11625.368746005732,202091.73577862218,0,24,0 +m_120,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,85.88848601308547,80.58341331352315,35.96985941958828,15.694229146310809,0.8972727726693039,1,121.85834543267376,96.27764245983396,134.04417997594115,0,24,0 +m_120,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,85.88848601308547,52.179874420945126,35.96985941958828,11.965031619185869,0.4155064219833676,1,121.85834543267376,64.14490604013099,134.04417997594115,0,24,0 +m_120,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,85.88848601308547,71.58390487529333,35.96985941958828,12.605535569239523,0.7228801326243544,1,121.85834543267376,84.18944044453285,134.04417997594115,0,24,0 +m_120,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,63.80686168157371,75.74650067499844,10.108075375557293,12.971745651246374,0.4854360058588447,1,73.914937057131,88.71824632624482,97.59007095886932,0,24,0 +m_120,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,63.80686168157371,64.36790338395505,10.108075375557293,11.693972770195646,0.9717748562917135,1,73.914937057131,76.0618761541507,97.59007095886932,0,24,0 +m_120,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,63.80686168157371,67.15979324794867,10.108075375557293,9.448739180154476,0.8134490615563221,1,73.914937057131,76.60853242810315,97.59007095886932,0,24,0 +m_120,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,70.6955407612669,69.21941294245177,2.410017254157901,12.967443431454623,0.9149731120972008,1,73.1055580154248,82.1868563739064,90.40554201129704,0,24,0 +m_120,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,70.6955407612669,54.45095971112744,2.410017254157901,13.551411419190902,0.2996875201184008,1,73.1055580154248,68.00237113031834,90.40554201129704,0,24,0 +m_120,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,70.6955407612669,47.98286955475928,2.410017254157901,13.17848551386205,0.1471139933505683,1,73.1055580154248,61.16135506862133,90.40554201129704,0,24,0 +m_120,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,56.77751951238643,78.7913484080974,9.754973016946249,12.014855954276957,0.18891883082666977,1,66.53249252933267,90.80620436237436,99.8868247986118,0,24,0 +m_120,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,56.77751951238643,60.01564741497742,9.754973016946249,6.229753495887999,0.7877485534637335,1,66.53249252933267,66.24540091086543,99.8868247986118,0,24,0 +m_120,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,56.77751951238643,60.40350786301176,9.754973016946249,10.16846672491483,0.8027417688377957,1,66.53249252933267,70.57197458792659,99.8868247986118,0,24,0 +m_120,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,239.6956828866481,164.11173105137274,43.00866145265956,26.369907419715894,0.17113475117776047,1,282.7043443393076,190.48163847108864,310.9747787732384,0,24,0 +m_120,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,239.6956828866481,216.11897046012677,43.00866145265956,17.157750259082068,0.6273291462716525,1,282.7043443393076,233.27672071920884,310.9747787732384,0,24,0 +m_120,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,239.6956828866481,249.82015608892078,43.00866145265956,30.96014207034747,0.8526859480483935,1,282.7043443393076,280.7802981592682,310.9747787732384,0,24,0 +m_120,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,191.84406991084705,216.99645858312368,43.83602397033555,27.3498326186205,0.6388733938105209,1,235.68009388118261,244.34629120174418,268.78092032191864,0,24,0 +m_120,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,191.84406991084705,138.28189978460256,43.83602397033555,27.954795887898634,0.3313619248115871,1,235.68009388118261,166.23669567250118,268.78092032191864,0,24,0 +m_120,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,191.84406991084705,160.9544218119676,43.83602397033555,18.626940915061535,0.5380676384855392,1,235.68009388118261,179.58136272702913,268.78092032191864,0,24,0 +m_120,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,184.61476947057716,183.533092119829,22.388478865268038,33.592654227458155,0.9792276307423791,1,207.0032483358452,217.12574634728716,293.16084426194305,0,24,0 +m_120,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,184.61476947057716,227.1417002707802,22.388478865268038,39.36815814916802,0.3754479679794932,1,207.0032483358452,266.5098584199482,293.16084426194305,0,24,0 +m_120,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,184.61476947057716,132.79557983576598,22.388478865268038,16.244313275613482,0.09335227834624547,1,207.0032483358452,149.03989311137946,293.16084426194305,0,24,0 +m_120,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,232.93832449773902,220.47520325604322,15.405458393162315,39.03879573770747,0.7757295037791009,1,248.34378289090134,259.5139989937507,354.56947142304676,0,24,0 +m_120,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,232.93832449773902,253.19943007707855,15.405458393162315,69.13645303478211,0.7853176569971685,1,248.34378289090134,322.33588311186065,354.56947142304676,0,24,0 +m_120,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,232.93832449773902,212.93738947308694,15.405458393162315,36.90065372002202,0.6329722061035372,1,248.34378289090134,249.83804319310894,354.56947142304676,0,24,0 +m_121,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,65.21821887517287,69.53833488934588,17.62274707207538,12.755753690477864,0.8477870124202405,1,82.84096594724825,82.29408857982374,102.39890602985774,0,24,0 +m_121,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,65.21821887517287,80.26875038825192,17.62274707207538,12.821164184346014,0.5102386763587133,1,82.84096594724825,93.08991457259793,102.39890602985774,0,24,0 +m_121,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,65.21821887517287,63.42262397723436,17.62274707207538,10.210835587561663,0.9323844155788252,1,82.84096594724825,73.63345956479603,102.39890602985774,0,24,0 +m_121,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,64.93482240962831,63.105820696853336,24.254840750346407,23.429160810672474,0.9578162886168332,1,89.18966315997471,86.53498150752581,98.1086294759722,0,24,0 +m_121,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,64.93482240962831,61.4854445094714,24.254840750346407,10.037884617417696,0.8993332900464017,1,89.18966315997471,71.5233291268891,98.1086294759722,0,24,0 +m_121,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,64.93482240962831,58.86852404859882,24.254840750346407,9.618434222061891,0.8232673131133053,1,89.18966315997471,68.48695827066071,98.1086294759722,0,24,0 +m_121,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,74.00031513509738,49.25650831637655,4.122576308970496,10.260165572321148,0.06296680796501042,1,78.122891444067875,59.516673888697696,85.93518058847467,0,24,0 +m_121,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,74.00031513509738,52.93107163339471,4.122576308970496,14.347544396802078,0.22132816146282008,1,78.122891444067875,67.27861603019679,85.93518058847467,0,24,0 +m_121,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,74.00031513509738,38.99493889269521,4.122576308970496,7.249399886970702,0.003232201325729453,0.07757283181750688,78.122891444067875,46.24433877966591,85.93518058847467,0,24,0 +m_121,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,55.88566907011774,89.61390973641419,7.730736252868524,16.929992111715457,0.11330013582334922,1,63.61640532298627,106.54390184812965,117.19829203294262,0,24,0 +m_121,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,55.88566907011774,56.45449874562376,7.730736252868524,7.210992472822886,0.9583029653096882,1,63.61640532298627,63.66549121844665,117.19829203294262,0,24,0 +m_121,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,55.88566907011774,72.16616606769566,7.730736252868524,15.871328937954589,0.38648166109407084,1,63.61640532298627,88.03749500565024,117.19829203294262,0,24,0 +m_121,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,1533.1103657664225,1353.2733032869312,682.8772244435252,211.5660583431699,0.8098457513359103,1,2215.9875902099475,1564.8393616301012,2437.5863492309422,0,24,0 +m_121,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,1533.1103657664225,1243.1711177855518,682.8772244435252,235.21062801903452,0.7016327133007619,1,2215.9875902099475,1478.3817458045864,2437.5863492309422,0,24,0 +m_121,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,1533.1103657664225,1761.02147813173,682.8772244435252,229.04581131466665,0.7622094092429053,1,2215.9875902099475,1990.0672894463967,2437.5863492309422,0,24,0 +m_121,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,356.8455840460558,435.13190882440864,154.9667482103202,81.1345965695397,0.6670384989577067,1,511.812332256376,516.2665053939484,567.8931559333432,0,24,0 +m_121,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,356.8455840460558,143.78114768070392,154.9667482103202,24.117495745189075,0.2298296658986675,1,511.812332256376,167.898643425893,567.8931559333432,0,24,0 +m_121,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,356.8455840460558,341.43274815156644,154.9667482103202,80.55799349584288,0.9319849788037394,1,511.812332256376,421.9907416474093,567.8931559333432,0,24,0 +m_121,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,241.3213959830799,184.87701279683523,46.06274126379117,63.85878158993035,0.49145889237168994,1,287.3841372468711,248.73579438676558,345.0798558757516,0,24,0 +m_121,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,241.3213959830799,228.95718668867045,46.06274126379117,84.75177319837643,0.9012846248251606,1,287.3841372468711,313.7089598870469,345.0798558757516,0,24,0 +m_121,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,241.3213959830799,154.76762695708166,46.06274126379117,24.61490708928219,0.13783317542951262,1,287.3841372468711,179.38253404636384,345.0798558757516,0,24,0 +m_121,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,226.42114305345407,219.6127948392913,33.459458506198885,46.387833103983496,0.9078350505980478,1,259.880601559653,266.0006279432748,292.60069073760235,0,24,0 +m_121,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,226.42114305345407,210.6940249569261,33.459458506198885,34.82069983368914,0.7513935839309442,1,259.880601559653,245.51472479061525,292.60069073760235,0,24,0 +m_121,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,226.42114305345407,136.3329818424258,33.459458506198885,14.622200356065328,0.04378121998582511,1,259.880601559653,150.95518219849112,292.60069073760235,0,24,0 +m_122,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,402.446246456714,242.78868989207558,93.48425236509856,42.5003038504612,0.17420418035597263,1,495.93049882181253,285.2889937425368,593.964145314189,0,24,0 +m_122,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,402.446246456714,486.70879132994924,93.48425236509856,46.31248527871909,0.45050659313826547,1,495.93049882181253,533.0212766086684,593.964145314189,0,24,0 +m_122,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,402.446246456714,454.94552522913955,93.48425236509856,85.02187960194127,0.6879448289277639,1,495.93049882181253,539.9674048310808,593.964145314189,0,24,0 +m_122,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,239.18088458876,270.5099108386576,22.27116486832287,61.00436864584534,0.6457952865728294,1,261.45204945708286,331.51427948450294,364.66570743295324,0,24,0 +m_122,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,239.18088458876,296.001003496852,22.27116486832287,25.7861403184869,0.12699892058894938,1,261.45204945708286,321.7871438153389,364.66570743295324,0,24,0 +m_122,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,239.18088458876,292.8795569559334,22.27116486832287,35.05571182853187,0.23017723559640113,1,261.45204945708286,327.9352687844653,364.66570743295324,0,24,0 +m_122,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,279.92626143888253,266.7564712312267,88.76006280717606,55.50553934146624,0.9034770784003934,1,368.6863242460586,322.262010572693,455.95942350543555,0,24,0 +m_122,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,279.92626143888253,280.2925349955694,88.76006280717606,45.608758730805484,0.997190965379941,1,368.6863242460586,325.9012937263749,455.95942350543555,0,24,0 +m_122,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,279.92626143888253,364.87758224194494,88.76006280717606,49.63098458117827,0.4336191933898019,1,368.6863242460586,414.5085668231232,455.95942350543555,0,24,0 +m_122,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,212.71806341276286,264.55696068220374,60.467462348200975,41.88853794684051,0.5025613751357219,1,273.18552576096386,306.44549862904427,456.6728769588148,0,24,0 +m_122,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,212.71806341276286,208.24261200151844,60.467462348200975,43.126622958782676,0.9535157288461866,1,273.18552576096386,251.36923496030113,456.6728769588148,0,24,0 +m_122,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,212.71806341276286,358.1155401655385,60.467462348200975,57.041620706111296,0.11517929935795648,1,273.18552576096386,415.1571608716498,456.6728769588148,0,24,0 +m_122,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,12390.455737275557,10001.248363353803,1784.8595212672717,371.3020826757656,0.24269059333866896,1,14175.315258542829,10372.550446029569,15592.846784397112,0,24,0 +m_122,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,12390.455737275557,9780.307584500606,1784.8595212672717,524.7288367079991,0.2113333380501137,1,14175.315258542829,10305.036421208606,15592.846784397112,0,24,0 +m_122,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,12390.455737275557,10366.100585914677,1784.8595212672717,753.9089604692597,0.33218777784243836,1,14175.315258542829,11120.009546383937,15592.846784397112,0,24,0 +m_122,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,9753.747613536536,10273.265654301415,270.1511161693212,672.6282617799426,0.4982152423531977,1,10023.898729705857,10945.893916081357,12040.483307689494,0,24,0 +m_122,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,9753.747613536536,9027.938948960313,270.1511161693212,904.1310911553427,0.4715217802532936,1,10023.898729705857,9932.070040115656,12040.483307689494,0,24,0 +m_122,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,9753.747613536536,9422.077463148607,270.1511161693212,896.6603556138438,0.7355244021138521,1,10023.898729705857,10318.73781876245,12040.483307689494,0,24,0 +m_122,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,11959.054449636922,14497.257003499193,1451.2868125364178,1729.78694822851,0.28799541754778185,1,13410.34126217334,16227.043951727703,17849.748346900473,0,24,0 +m_122,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,11959.054449636922,11575.615806018885,1451.2868125364178,1643.301661708648,0.8647061764835486,1,13410.34126217334,13218.917467727533,17849.748346900473,0,24,0 +m_122,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,11959.054449636922,11093.505353758674,1451.2868125364178,913.3037681355376,0.6266609475723726,1,13410.34126217334,12006.809121894212,17849.748346900473,0,24,0 +m_122,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,10996.969545575432,15351.44469987785,882.7556887761259,1889.4645656921496,0.07472689989149273,1,11879.725234351557,17240.90926557,18965.000192127,0,24,0 +m_122,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,10996.969545575432,12820.432552334643,882.7556887761259,2199.490820317954,0.46841574790582186,1,11879.725234351557,15019.923372652596,18965.000192127,0,24,0 +m_122,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,10996.969545575432,13824.32016175891,882.7556887761259,603.1957567837219,0.027133547355353886,0.6512051365284932,11879.725234351557,14427.515918542631,18965.000192127,0,24,0 +m_123,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,449.1976332776138,170.23418442935488,360.6977123937079,38.275284325479916,0.48385230973341564,1,809.8953456713217,208.5094687548348,890.884880238454,0,24,0 +m_123,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,449.1976332776138,94.56781955133602,360.6977123937079,15.028077032670653,0.38137735977992293,1,809.8953456713217,109.59589658400667,890.884880238454,0,24,0 +m_123,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,449.1976332776138,121.10419205466552,360.6977123937079,22.63337032029035,0.41494461538700245,1,809.8953456713217,143.73756237495587,890.884880238454,0,24,0 +m_123,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,132.69697966006234,270.594394918631,20.20021180856966,104.37690023485298,0.24749826147478496,1,152.897191468632,374.971295153484,412.4684246688324,0,24,0 +m_123,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,132.69697966006234,241.6879656518074,20.20021180856966,100.68228775290194,0.3336510497354217,1,152.897191468632,342.37025340470933,412.4684246688324,0,24,0 +m_123,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,132.69697966006234,184.0142929758277,20.20021180856966,11.117271290932068,0.057629210263798046,1,152.897191468632,195.13156426675977,412.4684246688324,0,24,0 +m_123,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,146.49153813784983,144.20522537143546,9.212241858892028,10.458750267666591,0.8733240503731992,1,155.70377999674184,154.66397563910206,283.6433539395536,0,24,0 +m_123,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,146.49153813784983,215.25187959167812,9.212241858892028,42.60571489882511,0.18377616454989856,1,155.70377999674184,257.85759449050323,283.6433539395536,0,24,0 +m_123,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,146.49153813784983,163.92946233478145,9.212241858892028,14.142317306818224,0.33075642888959467,1,155.70377999674184,178.07177964159968,283.6433539395536,0,24,0 +m_123,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,147.8550055811589,143.38988729472206,21.608779187098346,13.613585207683988,0.8662089344672539,1,169.46378476825726,157.00347250240605,189.40910901898607,0,24,0 +m_123,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,147.8550055811589,149.6742146709357,21.608779187098346,11.643267759337888,0.9432388079406764,1,169.46378476825726,161.31748243027357,189.40910901898607,0,24,0 +m_123,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,147.8550055811589,148.48814085768402,21.608779187098346,23.70195825048512,0.9846816293278182,1,169.46378476825726,172.19009910816914,189.40910901898607,0,24,0 +m_123,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,304.86585603148745,218.11803733198457,30.489782946877565,33.28486555736697,0.08378316572222108,1,335.355638978365,251.40290288935154,368.89120287620153,0,24,0 +m_123,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,304.86585603148745,273.7695403404658,30.489782946877565,32.52975056823793,0.5014714892830039,1,335.355638978365,306.29929090870377,368.89120287620153,0,24,0 +m_123,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,304.86585603148745,265.0539918493505,30.489782946877565,40.9757486805347,0.4552018899208774,1,335.355638978365,306.0297405298852,368.89120287620153,0,24,0 +m_123,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,261.16782414230795,246.20596839853695,32.89807659567065,45.22183326745081,0.7949908929791247,1,294.0659007379786,291.4278016659878,333.8826577612567,0,24,0 +m_123,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,261.16782414230795,279.19926564121215,32.89807659567065,22.320549299013095,0.6611250223721389,1,294.0659007379786,301.5198149402253,333.8826577612567,0,24,0 +m_123,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,261.16782414230795,254.2132641064911,32.89807659567065,49.3164247673786,0.9092715220192289,1,294.0659007379786,303.5296888738697,333.8826577612567,0,24,0 +m_123,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,154.13281223721808,177.3138188344072,34.085385822860964,33.62323914252781,0.6386991942923135,1,188.21819806007903,210.937057976935,240.19338851042977,0,24,0 +m_123,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,154.13281223721808,181.57286976659802,34.085385822860964,30.28342156743292,0.5608703346778565,1,188.21819806007903,211.85629133403094,240.19338851042977,0,24,0 +m_123,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,154.13281223721808,198.08214100081634,34.085385822860964,20.27548491775616,0.29944379823342165,1,188.21819806007903,218.3576259185725,240.19338851042977,0,24,0 +m_123,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,92.19915296117537,209.12993850776405,15.325111171239467,44.102216219448295,0.04504892705263391,1,107.52426413241484,253.23215472721233,303.0968992288255,0,24,0 +m_123,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,92.19915296117537,252.2698761029775,15.325111171239467,23.2727595595911,3.2292832860983866e-4,0.007750279886636128,107.52426413241484,275.5426356625686,303.0968992288255,0,24,0 +m_123,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,92.19915296117537,182.74607961490042,15.325111171239467,36.619367898857426,0.05820743987375596,1,107.52426413241484,219.36544751375786,303.0968992288255,0,24,0 diff --git a/runs/GC-MS analysis/p_values_cv.csv b/runs/GC-MS analysis/p_values_cv.csv new file mode 100644 index 0000000000000000000000000000000000000000..828ad63e6c71c4481a89dd3285584d79622c1881 --- /dev/null +++ b/runs/GC-MS analysis/p_values_cv.csv @@ -0,0 +1,685 @@ +met,alias1,alias2,p.signif,mean_cv1,mean_cv2,se_cv1,se_cv2,tissue,tissue2,p.value,adj.p.value,tot_val1,tot_val2,y.position,group1,group2,miss_comp_treat,percent_na_clust +m_1,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.45653967606948337,0.9791418742932401,0.07643708423294358,0.12792827089619413,fruit,fruit,1.9469956140625736e-5,1.1681973684375441e-4,0.5329767603024269,1.1070701451894343,1.2177771597083777,MoneyMaker,panK4-1,FALSE,0 +m_1,967514 MM WT,1017361 Sl10g086080 #2,*,0.45653967606948337,0.16343029752671995,0.07643708423294358,0.024965196783107615,fruit,fruit,0.006621136972256795,0.0249953397884818,0.5329767603024269,0.18839549430982755,1.2177771597083777,MoneyMaker,log2-1,FALSE,0 +m_1,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.45653967606948337,0.1610248719079469,0.07643708423294358,0.013725954555569903,fruit,fruit,0.00624883494712045,0.0249953397884818,0.5329767603024269,0.1747508264635168,1.2177771597083777,MoneyMaker,transp1-1,FALSE,0 +m_1,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.5118987430540033,0.1431379423886527,0.06961781456121166,0.01819945954330202,leaf,leaf,0.0010137608756075416,0.0050688043780377084,0.5815165576152149,0.16133740193195473,0.6426710843958221,MoneyMaker,panK4-1,FALSE,0 +m_1,967514 MM WT,1017361 Sl10g086080 #2,*,0.5118987430540033,0.2581579637202425,0.06961781456121166,0.017443742152493454,leaf,leaf,0.01667503875258011,0.03335007750516022,0.5815165576152149,0.27560170587273597,0.6426710843958221,MoneyMaker,log2-1,FALSE,0 +m_1,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5118987430540033,0.48233322358346226,0.06961781456121166,0.10191321677637592,leaf,leaf,0.7668724502626295,0.7668724502626295,0.5815165576152149,0.5842464403598382,0.6426710843958221,MoneyMaker,transp1-1,FALSE,0 +m_10,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.0805242582658268,0.14486063959112014,0.007804971283967862,0.029471546949854217,fruit,fruit,7.097851883460892e-4,0.004258711130076535,0.08832922954979466,0.17433218654097435,0.1917654051950718,MoneyMaker,panK4-1,FALSE,0 +m_10,967514 MM WT,1017361 Sl10g086080 #2,*,0.0805242582658268,0.024927138126432033,0.007804971283967862,0.006833851161893099,fruit,fruit,0.00263556460413317,0.01054225841653268,0.08832922954979466,0.03176098928832513,0.1917654051950718,MoneyMaker,log2-1,FALSE,0 +m_10,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.0805242582658268,0.019268941450431894,0.007804971283967862,0.002512880146319894,fruit,fruit,0.001131605639090078,0.005658028195450391,0.08832922954979466,0.021781821596751787,0.1917654051950718,MoneyMaker,transp1-1,FALSE,0 +m_10,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.035085671089461194,0.006147741141841056,0.0055882086214180384,9.11836611043941e-4,leaf,leaf,0.093594502453444,0.280783507360332,0.040673879710879234,0.0070595777528849974,0.04870995986651731,MoneyMaker,panK4-1,FALSE,0 +m_10,967514 MM WT,1017361 Sl10g086080 #2,ns,0.035085671089461194,0.03654859901047596,0.0055882086214180384,0.007733182686357951,leaf,leaf,0.930395133193272,0.930395133193272,0.040673879710879234,0.044281781696833916,0.04870995986651731,MoneyMaker,log2-1,FALSE,0 +m_10,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.035085671089461194,0.017892933381355832,0.0055882086214180384,0.004934930518523946,leaf,leaf,0.3099054472263231,0.6198108944526463,0.040673879710879234,0.02282786389987978,0.04870995986651731,MoneyMaker,transp1-1,FALSE,0 +m_100,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.25687910232007444,0.6522311086369391,0.0648801598666143,0.08505204976208397,fruit,fruit,2.0399013183459826e-5,1.2239407910075896e-4,0.3217592621866887,0.7372831583990231,0.8110114742389255,MoneyMaker,panK4-1,FALSE,0 +m_100,967514 MM WT,1017361 Sl10g086080 #2,ns,0.25687910232007444,0.3252922912685446,0.0648801598666143,0.05878861949723326,fruit,fruit,0.3698281672646262,1,0.3217592621866887,0.38408091076577783,0.8110114742389255,MoneyMaker,log2-1,FALSE,0 +m_100,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.25687910232007444,0.22731619425079252,0.0648801598666143,0.040030133217625254,fruit,fruit,0.6963725779161242,1,0.3217592621866887,0.2673463274684178,0.8110114742389255,MoneyMaker,transp1-1,FALSE,0 +m_100,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3987617957779114,0.246810500606513,0.04627900564354726,0.04600721500182524,leaf,leaf,0.05358360599055188,0.21433442396220753,0.44504080142145863,0.29281771560833825,0.48954488156360454,MoneyMaker,panK4-1,FALSE,0 +m_100,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3987617957779114,0.19351484044492284,0.04627900564354726,0.017345396471473946,leaf,leaf,0.011355885123891199,0.056779425619455995,0.44504080142145863,0.2108602369163968,0.48954488156360454,MoneyMaker,log2-1,FALSE,0 +m_100,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3987617957779114,0.3666769725936657,0.04627900564354726,0.036757106627436774,leaf,leaf,0.6720114320485886,1,0.44504080142145863,0.40343407922110247,0.48954488156360454,MoneyMaker,transp1-1,FALSE,0 +m_101,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.15664072828201778,0.06359354584723974,0.012107166368907275,0.01158711193010719,fruit,fruit,0.1431191814588738,0.42935754437662144,0.16874789465092505,0.07518065777734692,0.3061175798519532,MoneyMaker,panK4-1,FALSE,0 +m_101,967514 MM WT,1017361 Sl10g086080 #2,ns,0.15664072828201778,0.08523273522115303,0.012107166368907275,0.008132206971399304,fruit,fruit,0.2567414832872514,0.4997387988045853,0.16874789465092505,0.09336494219255234,0.3061175798519532,MoneyMaker,log2-1,FALSE,0 +m_101,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.15664072828201778,0.22911942478983902,0.012107166368907275,0.049169284166482086,fruit,fruit,0.24986939940229266,0.4997387988045853,0.16874789465092505,0.2782887089563211,0.3061175798519532,MoneyMaker,transp1-1,FALSE,0 +m_101,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.14771252394477113,0.3068342970333679,0.0226586364148427,0.040343317814948154,leaf,leaf,0.016103479112949,0.064413916451796,0.17037116035961383,0.34717761484831605,0.9111003453838407,MoneyMaker,panK4-1,FALSE,0 +m_101,967514 MM WT,1017361 Sl10g086080 #2,*,0.14771252394477113,0.7467077866848769,0.0226586364148427,0.08156525457315997,leaf,leaf,8.11179313326702e-10,4.867075879960212e-9,0.17037116035961383,0.8282730412580369,0.9111003453838407,MoneyMaker,log2-1,FALSE,0 +m_101,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.14771252394477113,0.38024184552328855,0.0226586364148427,0.05960261117480966,leaf,leaf,9.095447605671164e-4,0.004547723802835582,0.17037116035961383,0.4398444566980982,0.9111003453838407,MoneyMaker,transp1-1,FALSE,0 +m_102,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.08929127030519496,0.28391809192792306,0.02480049558605569,0.04212488046086195,fruit,fruit,6.348248905828028e-7,3.808949343496817e-6,0.11409176589125064,0.326042972388785,0.3586472696276635,MoneyMaker,panK4-1,FALSE,0 +m_102,967514 MM WT,1017361 Sl10g086080 #2,ns,0.08929127030519496,0.14468562426172965,0.02480049558605569,0.022167628635408193,fruit,fruit,0.06879978679663772,0.3439989339831886,0.11409176589125064,0.16685325289713784,0.3586472696276635,MoneyMaker,log2-1,FALSE,0 +m_102,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.08929127030519496,0.09629336444888789,0.02480049558605569,0.012176110833557933,fruit,fruit,0.8117326407476815,1,0.11409176589125064,0.10846947528244583,0.3586472696276635,MoneyMaker,transp1-1,FALSE,0 +m_102,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.04038008921459113,0.057053313829537114,0.0019286152176146438,0.007787785700962248,leaf,leaf,0.5716697203336512,1,0.042308704432205774,0.06484109953049937,0.0829248148264437,MoneyMaker,panK4-1,FALSE,0 +m_102,967514 MM WT,1017361 Sl10g086080 #2,ns,0.04038008921459113,0.06538165924725164,0.0019286152176146438,0.010004536049515355,leaf,leaf,0.3983513087724131,1,0.042308704432205774,0.075386195296767,0.0829248148264437,MoneyMaker,log2-1,FALSE,0 +m_102,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.04038008921459113,0.057831663262842795,0.0019286152176146438,0.013700557734252779,leaf,leaf,0.5539799891254524,1,0.042308704432205774,0.07153222099709558,0.0829248148264437,MoneyMaker,transp1-1,FALSE,0 +m_103,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.8768698641873345,0.7374503674900517,0.11077123425161084,0.09499840036823116,fruit,fruit,0.46353509117777414,1,0.9876410984389453,0.8324487678582828,1.499313677348855,MoneyMaker,panK4-1,FALSE,0 +m_103,967514 MM WT,1017361 Sl10g086080 #2,ns,0.8768698641873345,0.6425559975697666,0.11077123425161084,0.10729022017416165,fruit,fruit,0.22263728851237763,1,0.9876410984389453,0.7498462177439282,1.499313677348855,MoneyMaker,log2-1,FALSE,0 +m_103,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.8768698641873345,1.0367754156727542,0.11077123425161084,0.3262370182807501,fruit,fruit,0.40132544010017845,1,0.9876410984389453,1.3630124339535044,1.499313677348855,MoneyMaker,transp1-1,FALSE,0 +m_103,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.10304291239606435,0.03319787877500315,0.01707881978576525,0.004927489840685267,leaf,leaf,0.7122772380297843,1,0.1201217321818296,0.03812536861568842,0.1878865799448044,MoneyMaker,panK4-1,FALSE,0 +m_103,967514 MM WT,1017361 Sl10g086080 #2,ns,0.10304291239606435,0.0758958150714673,0.01707881978576525,0.006800059307792395,leaf,leaf,0.8858802508067956,1,0.1201217321818296,0.0826958743792597,0.1878865799448044,MoneyMaker,log2-1,FALSE,0 +m_103,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.10304291239606435,0.14831684707465173,0.01707881978576525,0.02248913469335226,leaf,leaf,0.8109058444504904,1,0.1201217321818296,0.170805981768004,0.1878865799448044,MoneyMaker,transp1-1,FALSE,0 +m_104,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.8935424602760907,0.7468586294561204,0.109208772539315,0.09743893599536753,fruit,fruit,0.4479113684169299,1,1.0027512328154058,0.8442975654514879,1.497298196427496,MoneyMaker,panK4-1,FALSE,0 +m_104,967514 MM WT,1017361 Sl10g086080 #2,ns,0.8935424602760907,0.6873568062381621,0.109208772539315,0.12093544248326206,fruit,fruit,0.28890587815333957,1,1.0027512328154058,0.8082922487214241,1.497298196427496,MoneyMaker,log2-1,FALSE,0 +m_104,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.8935424602760907,1.0330618553110646,0.109208772539315,0.32811832325938617,fruit,fruit,0.4701396420704823,1,1.0027512328154058,1.361180178570451,1.497298196427496,MoneyMaker,transp1-1,FALSE,0 +m_104,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.10303906540507507,0.033202680156771525,0.017078772223442125,0.004928272467262395,leaf,leaf,0.7165875679719762,1,0.12011783762851719,0.03813095262403392,0.1878865799448044,MoneyMaker,panK4-1,FALSE,0 +m_104,967514 MM WT,1017361 Sl10g086080 #2,ns,0.10303906540507507,0.0758958150714673,0.017078772223442125,0.006800059307792395,leaf,leaf,0.887661912924726,1,0.12011783762851719,0.0826958743792597,0.1878865799448044,MoneyMaker,log2-1,FALSE,0 +m_104,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.10303906540507507,0.14831684707465173,0.017078772223442125,0.02248913469335226,leaf,leaf,0.8137793255702348,1,0.12011783762851719,0.170805981768004,0.1878865799448044,MoneyMaker,transp1-1,FALSE,0 +m_105,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.0745879708916856,0.05487605737494245,0.012587431049426896,0.009266704351240714,fruit,fruit,0.551094026243345,1,0.08717540194111251,0.06414276172618316,0.12101229073221387,MoneyMaker,panK4-1,FALSE,0 +m_105,967514 MM WT,1017361 Sl10g086080 #2,ns,0.0745879708916856,0.096095475952538,0.012587431049426896,0.013915697440383682,fruit,fruit,0.515718230218256,1,0.08717540194111251,0.11001117339292169,0.12101229073221387,MoneyMaker,log2-1,FALSE,0 +m_105,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.0745879708916856,0.06891660201174014,0.012587431049426896,0.013151930954810744,fruit,fruit,0.8633544339114229,1,0.08717540194111251,0.0820685329665509,0.12101229073221387,MoneyMaker,transp1-1,FALSE,0 +m_105,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.13379374177941727,0.11396410927967948,0.0180321888188538,0.0030266403210912505,leaf,leaf,0.5487364126414378,1,0.15182593059827107,0.11699074960077073,0.3484728805395014,MoneyMaker,panK4-1,FALSE,0 +m_105,967514 MM WT,1017361 Sl10g086080 #2,ns,0.13379374177941727,0.16735508042165906,0.0180321888188538,0.03316296378410899,leaf,leaf,0.313531665738134,1,0.15182593059827107,0.20051804420576805,0.3484728805395014,MoneyMaker,log2-1,FALSE,0 +m_105,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.13379374177941727,0.2698220726711238,0.0180321888188538,0.046971455092059265,leaf,leaf,3.404536212168396e-4,0.0020427217273010375,0.15182593059827107,0.31679352776318304,0.3484728805395014,MoneyMaker,transp1-1,FALSE,0 +m_106,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.20698496423054813,0.22258903040187264,0.03358019880001883,0.038037202491570214,fruit,fruit,0.7090409647169325,1,0.24056516303056696,0.26062623289344283,0.28668885618278717,MoneyMaker,panK4-1,FALSE,2.083333333333333 +m_106,967514 MM WT,1017361 Sl10g086080 #2,ns,0.20698496423054813,0.1890586090950077,0.03358019880001883,0.047037363914473364,fruit,fruit,0.6683044089452286,1,0.24056516303056696,0.23609597300948107,0.28668885618278717,MoneyMaker,log2-1,FALSE,2.083333333333333 +m_106,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.20698496423054813,0.18292663914621693,0.03358019880001883,0.04039154581658332,fruit,fruit,0.5658651163304683,1,0.24056516303056696,0.22331818496280026,0.28668885618278717,MoneyMaker,transp1-1,FALSE,2.083333333333333 +m_106,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.07724842342443715,0.04047474240788477,0.01133759587022265,0.00935618117059445,leaf,leaf,0.38235469914289033,1,0.0885860192946598,0.04983092357847922,0.09819199097259783,MoneyMaker,panK4-1,FALSE,0 +m_106,967514 MM WT,1017361 Sl10g086080 #2,ns,0.07724842342443715,0.03559402832958688,0.01133759587022265,0.005726331630193957,leaf,leaf,0.3235062556080489,1,0.0885860192946598,0.04132035995978084,0.09819199097259783,MoneyMaker,log2-1,FALSE,0 +m_106,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.07724842342443715,0.07649022391516268,0.01133759587022265,0.012775222423562622,leaf,leaf,0.9855129979501003,1,0.0885860192946598,0.0892654463387253,0.09819199097259783,MoneyMaker,transp1-1,FALSE,0 +m_107,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.4921184396027954,0.390608828872897,0.0587689648401054,0.0502155934770498,fruit,fruit,0.28979638909030175,1,0.5508874044429007,0.4408244223499468,0.717190365183342,MoneyMaker,panK4-1,FALSE,0 +m_107,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4921184396027954,0.5705458286356607,0.0587689648401054,0.08144541244010475,fruit,fruit,0.41121686419541637,1,0.5508874044429007,0.6519912410757654,0.717190365183342,MoneyMaker,log2-1,FALSE,0 +m_107,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4921184396027954,0.39497606388041395,0.0587689648401054,0.08588850015848597,fruit,fruit,0.31057090638618257,1,0.5508874044429007,0.48086456403889993,0.717190365183342,MoneyMaker,transp1-1,FALSE,0 +m_107,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6169682105235668,0.45750144191505115,0.06394793771196003,0.05371903190093396,leaf,leaf,0.10195705477689068,0.6117423286613441,0.6809161482355268,0.5112204738159851,0.7490077630590796,MoneyMaker,panK4-1,FALSE,0 +m_107,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6169682105235668,0.5181817729639296,0.06394793771196003,0.06585454315912254,leaf,leaf,0.30263053900984715,1,0.6809161482355268,0.5840363161230522,0.7490077630590796,MoneyMaker,log2-1,FALSE,0 +m_107,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6169682105235668,0.5319177186848376,0.06394793771196003,0.06227073958800243,leaf,leaf,0.3734437006002964,1,0.6809161482355268,0.5941884582728401,0.7490077630590796,MoneyMaker,transp1-1,FALSE,0 +m_108,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.4630049639268783,0.5735214679991293,0.0941686762781428,0.12517976473749678,fruit,fruit,0.40164018259081247,0.8032803651816249,0.5571736402050211,0.6987012327366261,1.0716322696411087,MoneyMaker,panK4-1,FALSE,1.0416666666666665 +m_108,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4630049639268783,0.8203767894325033,0.0941686762781428,0.15383436478668633,fruit,fruit,0.010868302467590565,0.06520981480554339,0.5571736402050211,0.9742111542191896,1.0716322696411087,MoneyMaker,log2-1,FALSE,1.0416666666666665 +m_108,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4630049639268783,0.6845435327462979,0.0941686762781428,0.1055652366884692,fruit,fruit,0.09987116533031802,0.3994846613212721,0.5571736402050211,0.790108769434767,1.0716322696411087,MoneyMaker,transp1-1,FALSE,1.0416666666666665 +m_108,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2701326755344045,0.5418909222560192,0.04106308118006153,0.05649721123115727,leaf,leaf,0.04646380235431223,0.23231901177156117,0.31119575671446603,0.5983881334871765,0.6582269468358941,MoneyMaker,panK4-1,FALSE,0 +m_108,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2701326755344045,0.05544121334536738,0.04106308118006153,0.008418030010608719,leaf,leaf,0.1101961959328355,0.3994846613212721,0.31119575671446603,0.06385924335597609,0.6582269468358941,MoneyMaker,log2-1,FALSE,0 +m_108,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2701326755344045,0.33535310062182594,0.04106308118006153,0.05214271988897909,leaf,leaf,0.6189384472379923,0.8032803651816249,0.31119575671446603,0.387495820510805,0.6582269468358941,MoneyMaker,transp1-1,FALSE,0 +m_109,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.4606723123719696,0.10987644715601266,0.09836785061649402,0.012697432989623472,fruit,fruit,5.570345702963065e-5,3.342207421777839e-4,0.5590401629884636,0.12257388014563614,0.61494417928731,MoneyMaker,panK4-1,FALSE,0 +m_109,967514 MM WT,1017361 Sl10g086080 #2,*,0.4606723123719696,0.17335259841915374,0.09836785061649402,0.04354298966022829,fruit,fruit,5.259230474004247e-4,0.0026296152370021237,0.5590401629884636,0.21689558807938203,0.61494417928731,MoneyMaker,log2-1,FALSE,0 +m_109,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4606723123719696,0.3128555544576871,0.09836785061649402,0.05501219187729971,fruit,fruit,0.05058137921528908,0.20232551686115632,0.5590401629884636,0.3678677463349868,0.61494417928731,MoneyMaker,transp1-1,FALSE,0 +m_109,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.304091621972263,0.3103969719479036,0.01967312975415971,0.035378929377156414,leaf,leaf,0.9307657829962859,1,0.3237647517264227,0.34577590132506003,0.4460315010167462,MoneyMaker,panK4-1,FALSE,0 +m_109,967514 MM WT,1017361 Sl10g086080 #2,ns,0.304091621972263,0.2745913988980013,0.01967312975415971,0.043086380781980974,leaf,leaf,0.684884606750855,1,0.3237647517264227,0.3176777796799823,0.4460315010167462,MoneyMaker,log2-1,FALSE,0 +m_109,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.304091621972263,0.35674319776296387,0.01967312975415971,0.04873998497953263,leaf,leaf,0.4705746103702554,1,0.3237647517264227,0.4054831827424965,0.4460315010167462,MoneyMaker,transp1-1,FALSE,0 +m_11,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.7708586695810169,0.60012915272734,0.09666431452944511,0.08288136269479088,fruit,fruit,0.33545363607744205,1,0.867522984110462,0.6830105154221309,1.0602856621365888,MoneyMaker,panK4-1,FALSE,0 +m_11,967514 MM WT,1017361 Sl10g086080 #2,ns,0.7708586695810169,0.8544766923659345,0.09666431452944511,0.10941936412187352,fruit,fruit,0.6345907002188986,1,0.867522984110462,0.963896056487808,1.0602856621365888,MoneyMaker,log2-1,FALSE,0 +m_11,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.7708586695810169,0.6475130490022062,0.09666431452944511,0.11054544906664171,fruit,fruit,0.48447261361460525,1,0.867522984110462,0.7580584980688478,1.0602856621365888,MoneyMaker,transp1-1,FALSE,0 +m_11,967514 MM WT,1015695 Sl10g074590 #30.1,ns,1.0747836366851873,0.5939718803308347,0.21219331498727165,0.061729952552783664,leaf,leaf,0.010690922809134943,0.06414553685480966,1.286976951672459,0.6557018328836184,1.415674646839705,MoneyMaker,panK4-1,FALSE,7.291666666666667 +m_11,967514 MM WT,1017361 Sl10g086080 #2,ns,1.0747836366851873,0.5992433392191372,0.21219331498727165,0.11985556861666671,leaf,leaf,0.011466897692672425,0.06414553685480966,1.286976951672459,0.7190989078358039,1.415674646839705,MoneyMaker,log2-1,FALSE,7.291666666666667 +m_11,967514 MM WT,1017363 Sl10g007190 #19.2,ns,1.0747836366851873,1.0420239773405227,0.21219331498727165,0.1306673752743685,leaf,leaf,0.8519899542636289,1,1.286976951672459,1.1726913526148912,1.415674646839705,MoneyMaker,transp1-1,FALSE,7.291666666666667 +m_110,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5284789044234743,0.42928490663172153,0.09164524879673623,0.05100103548568087,fruit,fruit,0.3381672800110138,0.6763345600220276,0.6201241532202105,0.4802859421174024,0.7377551665717281,MoneyMaker,panK4-1,FALSE,0 +m_110,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5284789044234743,0.5808804608436791,0.09164524879673623,0.08980605422152835,fruit,fruit,0.6103804301255089,0.6763345600220276,0.6201241532202105,0.6706865150652074,0.7377551665717281,MoneyMaker,log2-1,FALSE,0 +m_110,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5284789044234743,0.39391594833356813,0.09164524879673623,0.07994829385093791,fruit,fruit,0.19739525624617144,0.5921857687385144,0.6201241532202105,0.47386424218450607,0.7377551665717281,MoneyMaker,transp1-1,FALSE,0 +m_110,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.25697280523095867,0.5775833009039766,0.015309408552456558,0.06298847146828072,leaf,leaf,0.004242751894863217,0.021213759474316085,0.2722822137834152,0.6405717723722573,0.8301220573561608,MoneyMaker,panK4-1,FALSE,0 +m_110,967514 MM WT,1017361 Sl10g086080 #2,ns,0.25697280523095867,0.4622075895617972,0.015309408552456558,0.061871620618602,leaf,leaf,0.05445224704440055,0.2178089881776022,0.2722822137834152,0.5240792101803992,0.8301220573561608,MoneyMaker,log2-1,FALSE,0 +m_110,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.25697280523095867,0.6667921131421423,0.015309408552456558,0.08786430263618569,leaf,leaf,4.7897462781719625e-4,0.0028738477669031774,0.2722822137834152,0.754656415778328,0.8301220573561608,MoneyMaker,transp1-1,FALSE,0 +m_111,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3005535291100776,0.4177646585372515,0.038720490531965385,0.06656947666285912,fruit,fruit,0.2057801959684514,1,0.33927401964204296,0.4843341352001106,0.5327675487201217,MoneyMaker,panK4-1,FALSE,0 +m_111,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3005535291100776,0.378958334748091,0.038720490531965385,0.09301358710293682,fruit,fruit,0.39295708395611817,1,0.33927401964204296,0.4719719218510278,0.5327675487201217,MoneyMaker,log2-1,FALSE,0 +m_111,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3005535291100776,0.056924499876030585,0.038720490531965385,0.007673626185701484,fruit,fruit,0.012416682308299698,0.0745000938497982,0.33927401964204296,0.06459812606173207,0.5327675487201217,MoneyMaker,transp1-1,FALSE,0 +m_111,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.39745164578224845,0.32518890931268474,0.06578275228172656,0.07560211733654013,leaf,leaf,0.43054755566285297,1,0.46323439806397504,0.40079102664922484,0.5095578378703726,MoneyMaker,panK4-1,FALSE,0 +m_111,967514 MM WT,1017361 Sl10g086080 #2,ns,0.39745164578224845,0.37439136951559365,0.06578275228172656,0.0633804617129163,leaf,leaf,0.8002377636876651,1,0.46323439806397504,0.43777183122850993,0.5095578378703726,MoneyMaker,log2-1,FALSE,0 +m_111,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.39745164578224845,0.35976379956812854,0.06578275228172656,0.06156943795976119,leaf,leaf,0.6795481971985724,1,0.46323439806397504,0.42133323752788976,0.5095578378703726,MoneyMaker,transp1-1,FALSE,0 +m_112,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.42976367829851847,0.05366512629838931,0.04399102814054914,0.0071062994808380854,fruit,fruit,0.017863298977352678,0.08931649488676338,0.4737547064390676,0.060771425779227395,0.5211301770829744,MoneyMaker,panK4-1,FALSE,0 +m_112,967514 MM WT,1017361 Sl10g086080 #2,ns,0.42976367829851847,0.3160220271530918,0.04399102814054914,0.04954057137215796,fruit,fruit,0.4493960376475361,0.7331246711360941,0.4737547064390676,0.36556259852524975,0.5211301770829744,MoneyMaker,log2-1,FALSE,0 +m_112,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.42976367829851847,0.2936398012077573,0.04399102814054914,0.07999474381196363,fruit,fruit,0.36656233556804707,0.7331246711360941,0.4737547064390676,0.37363454501972093,0.5211301770829744,MoneyMaker,transp1-1,FALSE,0 +m_112,967514 MM WT,1015695 Sl10g074590 #30.1,*,1.0633531953648871,0.3576568907988443,0.17052603825965523,0.0607807147725962,leaf,leaf,7.430794177942278e-5,4.4584765067653666e-4,1.2338792336245423,0.4184376055714405,1.3572671569869967,MoneyMaker,panK4-1,FALSE,0 +m_112,967514 MM WT,1017361 Sl10g086080 #2,ns,1.0633531953648871,0.7534521960272081,0.17052603825965523,0.13412529970108822,leaf,leaf,0.04688197753604926,0.14064593260814778,1.2338792336245423,0.8875774957282964,1.3572671569869967,MoneyMaker,log2-1,FALSE,0 +m_112,967514 MM WT,1017363 Sl10g007190 #19.2,ns,1.0633531953648871,0.6893920260470846,0.17052603825965523,0.16095279168497248,leaf,leaf,0.018450603345675474,0.08931649488676338,1.2338792336245423,0.8503448177320571,1.3572671569869967,MoneyMaker,transp1-1,FALSE,0 +m_12,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6058468785662583,0.5471001487407213,0.0798179732667934,0.07189763031116363,fruit,fruit,0.7813323576142422,1,0.6856648518330517,0.6189977790518849,0.9806283225908159,MoneyMaker,panK4-1,FALSE,0 +m_12,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6058468785662583,0.7906193691103007,0.0798179732667934,0.10086092415407734,fruit,fruit,0.3860351350476453,1,0.6856648518330517,0.891480293264378,0.9806283225908159,MoneyMaker,log2-1,FALSE,0 +m_12,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6058468785662583,0.5657454069875123,0.0798179732667934,0.09531889762820242,fruit,fruit,0.8496497054010774,1,0.6856648518330517,0.6610643046157147,0.9806283225908159,MoneyMaker,transp1-1,FALSE,0 +m_12,967514 MM WT,1015695 Sl10g074590 #30.1,ns,1.223644494115569,0.6457384266772708,0.21455003317569266,0.06932981093652585,leaf,leaf,0.01085579264642893,0.06513475587857359,1.4381945272912617,0.7150682376137967,1.582013980020388,MoneyMaker,panK4-1,FALSE,0 +m_12,967514 MM WT,1017361 Sl10g086080 #2,ns,1.223644494115569,0.7147477110935923,0.21455003317569266,0.10367305651552833,leaf,leaf,0.02286041587365805,0.11430207936829026,1.4381945272912617,0.8184207676091206,1.582013980020388,MoneyMaker,log2-1,FALSE,0 +m_12,967514 MM WT,1017363 Sl10g007190 #19.2,ns,1.223644494115569,1.1214202645065192,0.21455003317569266,0.2877421441919711,leaf,leaf,0.6296483920844613,1,1.4381945272912617,1.4091624086984904,1.582013980020388,MoneyMaker,transp1-1,FALSE,0 +m_120,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.17209302785857455,0.06320114409750217,0.025373522706861378,0.01109824256246641,fruit,fruit,0.005340723145373311,0.026703615726866553,0.19746655056543594,0.07429938665996859,0.21721320562197954,MoneyMaker,panK4-1,FALSE,0 +m_120,967514 MM WT,1017361 Sl10g086080 #2,ns,0.17209302785857455,0.09365453193128,0.025373522706861378,0.009483872181384417,fruit,fruit,0.03717400368467279,0.11152201105401836,0.19746655056543594,0.10313840411266441,0.21721320562197954,MoneyMaker,log2-1,FALSE,0 +m_120,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.17209302785857455,0.16235149393855047,0.025373522706861378,0.027002937623198275,fruit,fruit,0.7864169973813676,1,0.19746655056543594,0.18935443156174875,0.21721320562197954,MoneyMaker,transp1-1,FALSE,0 +m_120,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.13202495620098226,0.13734479146152465,0.0061639728515965105,0.013313243890896179,leaf,leaf,0.882299342564848,1,0.13818892905257876,0.15065803535242084,0.33154253062855954,MoneyMaker,panK4-1,FALSE,0 +m_120,967514 MM WT,1017361 Sl10g086080 #2,*,0.13202495620098226,0.22841482745484265,0.0061639728515965105,0.04974938175660364,leaf,leaf,0.012186186493849447,0.04874474597539779,0.13818892905257876,0.2781642092114463,0.33154253062855954,MoneyMaker,log2-1,FALSE,0 +m_120,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.13202495620098226,0.2734888522861705,0.0061639728515965105,0.02791344828524727,leaf,leaf,5.553552474380369e-4,0.003332131484628221,0.13818892905257876,0.30140230057141776,0.33154253062855954,MoneyMaker,transp1-1,FALSE,0 +m_121,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.11002489793923534,0.23815787029596058,0.017067896634354825,0.03454940987908507,fruit,fruit,0.5077837198456296,1,0.12709279457359016,0.27270728017504564,0.30689082093187453,MoneyMaker,panK4-1,FALSE,0 +m_121,967514 MM WT,1017361 Sl10g086080 #2,ns,0.11002489793923534,0.17904468512588903,0.017067896634354825,0.03574197554270603,fruit,fruit,0.7203978087108278,1,0.12709279457359016,0.21478666066859506,0.30689082093187453,MoneyMaker,log2-1,FALSE,0 +m_121,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.11002489793923534,0.2339632495629703,0.017067896634354825,0.045028405829642904,fruit,fruit,0.5216512046860537,1,0.12709279457359016,0.27899165539261317,0.30689082093187453,MoneyMaker,transp1-1,FALSE,0 +m_121,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.8527159838208211,0.8634266878277927,0.19942510574467906,0.13651454908566654,leaf,leaf,0.9556461853879639,1,1.0521410895655001,0.9999412369134593,1.3688384920996082,MoneyMaker,panK4-1,FALSE,0 +m_121,967514 MM WT,1017361 Sl10g086080 #2,ns,0.8527159838208211,0.8942054341095061,0.19942510574467906,0.22233443532032016,leaf,leaf,0.8294981921618039,1,1.0521410895655001,1.1165398694298263,1.3688384920996082,MoneyMaker,log2-1,FALSE,0 +m_121,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.8527159838208211,1.063715402032793,0.19942510574467906,0.180683227148669,leaf,leaf,0.27919369299356067,1,1.0521410895655001,1.244398629181462,1.3688384920996082,MoneyMaker,transp1-1,FALSE,0 +m_122,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.2746660698882882,0.044181636358002624,0.04845132540333453,0.011060107776493227,fruit,fruit,3.642862870877056e-5,2.1857177225262337e-4,0.3231173952916227,0.055241744134495854,0.4467883426283963,MoneyMaker,panK4-1,FALSE,0 +m_122,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2746660698882882,0.34471508569188714,0.04845132540333453,0.061456134879382174,fruit,fruit,0.13775500318010944,0.4132650095403283,0.3231173952916227,0.4061712205712693,0.4467883426283963,MoneyMaker,log2-1,FALSE,0 +m_122,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2746660698882882,0.17380557298611893,0.04845132540333453,0.027029665706201075,fruit,fruit,0.0368264829624325,0.14730593184973,0.3231173952916227,0.20083523869232,0.4467883426283963,MoneyMaker,transp1-1,FALSE,0 +m_122,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.1014428059456466,0.2227370094412218,0.014499170532597314,0.010830981630946705,leaf,leaf,0.013744810462629322,0.06872405231314661,0.11594197647824392,0.2335679910721685,0.25692479017938535,MoneyMaker,panK4-1,FALSE,0 +m_122,967514 MM WT,1017361 Sl10g086080 #2,ns,0.1014428059456466,0.15684225737405078,0.014499170532597314,0.014956440000479515,leaf,leaf,0.23643591392343255,0.4328751768679667,0.11594197647824392,0.1717986973745303,0.25692479017938535,MoneyMaker,log2-1,FALSE,0 +m_122,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.1014428059456466,0.159358949554156,0.014499170532597314,0.028226221267061737,leaf,leaf,0.21643758843398336,0.4328751768679667,0.11594197647824392,0.18758517082121773,0.25692479017938535,MoneyMaker,transp1-1,FALSE,0 +m_123,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.5582780412538001,0.29500872899912406,0.16662550602606027,0.06605545184729604,fruit,fruit,0.015280010235859367,0.030560020471718734,0.7249035472798604,0.3610641808464201,0.7973939020078465,MoneyMaker,panK4-1,FALSE,0 +m_123,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5582780412538001,0.3785652192405685,0.16662550602606027,0.04985759462447054,fruit,fruit,0.08722785891972813,0.08722785891972813,0.7249035472798604,0.42842281386503905,0.7973939020078465,MoneyMaker,log2-1,FALSE,0 +m_123,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.5582780412538001,0.1679667191998866,0.16662550602606027,0.024187097065567088,fruit,fruit,7.26582569894035e-4,0.00435949541936421,0.7249035472798604,0.1921538162654537,0.7973939020078465,MoneyMaker,transp1-1,FALSE,0 +m_123,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.4838953564154649,0.1295032033967788,0.05739137945644874,0.019627437300333516,leaf,leaf,0.0017699054212051459,0.00884952710602573,0.5412867358719137,0.1491306406971123,0.5954154094591051,MoneyMaker,panK4-1,FALSE,0 +m_123,967514 MM WT,1017361 Sl10g086080 #2,*,0.4838953564154649,0.1734447056848702,0.05739137945644874,0.0403305006336972,leaf,leaf,0.005124692883382275,0.0204987715335291,0.5412867358719137,0.2137752063185674,0.5954154094591051,MoneyMaker,log2-1,FALSE,0 +m_123,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.4838953564154649,0.18062282243574695,0.05739137945644874,0.01136539914272077,leaf,leaf,0.006074188612894357,0.0204987715335291,0.5412867358719137,0.19198822157846773,0.5954154094591051,MoneyMaker,transp1-1,FALSE,0 +m_13,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.8734526188174414,0.8149994862700114,0.1211270581506842,0.09102428822502051,fruit,fruit,0.6917298481631892,1,0.9945796769681257,0.9060237744950319,1.1793940917036092,MoneyMaker,panK4-1,FALSE,0 +m_13,967514 MM WT,1017361 Sl10g086080 #2,ns,0.8734526188174414,0.9236450942868697,0.1211270581506842,0.1485313527164113,fruit,fruit,0.7333878350865599,1,0.9945796769681257,1.072176447003281,1.1793940917036092,MoneyMaker,log2-1,FALSE,0 +m_13,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.8734526188174414,0.8782774286911992,0.1211270581506842,0.1486794937044779,fruit,fruit,0.9738479091260454,1,0.9945796769681257,1.0269569223956772,1.1793940917036092,MoneyMaker,transp1-1,FALSE,0 +m_13,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5722878659561377,0.4237814031525643,0.06788552081517657,0.05737519844548371,leaf,leaf,0.3180792068358453,1,0.6401733867713142,0.481156601598048,0.7041907254484456,MoneyMaker,panK4-1,FALSE,0 +m_13,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5722878659561377,0.3742396179978301,0.06788552081517657,0.05146495476470503,leaf,leaf,0.1865441049396005,1,0.6401733867713142,0.42570457276253515,0.7041907254484456,MoneyMaker,log2-1,FALSE,0 +m_13,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5722878659561377,0.5416913881621748,0.06788552081517657,0.08474422307919803,leaf,leaf,0.835386628605556,1,0.6401733867713142,0.6264356112413728,0.7041907254484456,MoneyMaker,transp1-1,FALSE,0 +m_14,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.9004879892823983,0.5011496275175391,0.205097797643022,0.08140653677203269,fruit,fruit,0.004498675961284091,0.017994703845136364,1.1055857869254202,0.5825561642895718,1.2161443656179622,MoneyMaker,panK4-1,FALSE,0 +m_14,967514 MM WT,1017361 Sl10g086080 #2,*,0.9004879892823983,0.17044486654344765,0.205097797643022,0.02581108985447382,fruit,fruit,6.63737990471012e-6,3.9824279428260726e-5,1.1055857869254202,0.19625595639792148,1.2161443656179622,MoneyMaker,log2-1,FALSE,0 +m_14,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.9004879892823983,0.2835783938940922,0.205097797643022,0.050897775280899074,fruit,fruit,6.202668503502779e-5,3.1013342517513895e-4,1.1055857869254202,0.33447616917499123,1.2161443656179622,MoneyMaker,transp1-1,FALSE,0 +m_14,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2762967664224506,0.19429433138488417,0.04422525956724605,0.062370020558953146,leaf,leaf,0.5259024315713638,1,0.32052202598969665,0.2566643519438373,0.626002509705547,MoneyMaker,panK4-1,FALSE,0 +m_14,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2762967664224506,0.34276213860727606,0.04422525956724605,0.046153663586481423,leaf,leaf,0.6066598470052291,1,0.32052202598969665,0.3889158021937575,0.626002509705547,MoneyMaker,log2-1,FALSE,0 +m_14,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2762967664224506,0.4983878710794578,0.04422525956724605,0.07070531956194859,leaf,leaf,0.09409079247200887,0.2822723774160266,0.32052202598969665,0.5690931906414064,0.626002509705547,MoneyMaker,transp1-1,FALSE,0 +m_15,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2490359284871614,0.3290804491723123,0.051189495545734015,0.0548491589425325,fruit,fruit,0.1317978469006662,0.28702571612075073,0.3002254240328954,0.3839296081148448,0.4223225689263293,MoneyMaker,panK4-1,FALSE,0 +m_15,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2490359284871614,0.3097424777979322,0.051189495545734015,0.04805059042369383,fruit,fruit,0.2482838652066574,0.28702571612075073,0.3002254240328954,0.357793068221626,0.4223225689263293,MoneyMaker,log2-1,FALSE,0 +m_15,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2490359284871614,0.10911668421543495,0.051189495545734015,0.022121958481941963,fruit,fruit,0.01174659439239579,0.05873297196197895,0.3002254240328954,0.13123864269737692,0.4223225689263293,MoneyMaker,transp1-1,FALSE,0 +m_15,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.27275525777228543,0.13347170031805639,0.015750282549281406,0.01946425675052762,leaf,leaf,0.01208605348152007,0.05873297196197895,0.28850554032156683,0.152935957068584,0.31735609435372353,MoneyMaker,panK4-1,FALSE,0 +m_15,967514 MM WT,1017361 Sl10g086080 #2,ns,0.27275525777228543,0.1837749058975055,0.015750282549281406,0.03433570399544061,leaf,leaf,0.09567523870691691,0.28702571612075073,0.28850554032156683,0.21811060989294612,0.31735609435372353,MoneyMaker,log2-1,FALSE,0 +m_15,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.27275525777228543,0.11122108734360092,0.015750282549281406,0.017181166423516893,leaf,leaf,0.004348262367526394,0.026089574205158367,0.28850554032156683,0.1284022537671178,0.31735609435372353,MoneyMaker,transp1-1,FALSE,0 +m_16,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.629738625055206,0.4613169659918751,0.09139091296721015,0.06803622053913741,fruit,fruit,0.10926587142966697,0.5463293571483349,0.7211295380224161,0.5293531865310125,0.7932424918246578,MoneyMaker,panK4-1,FALSE,0 +m_16,967514 MM WT,1017361 Sl10g086080 #2,*,0.629738625055206,0.17124089224640954,0.09139091296721015,0.020041499361800347,fruit,fruit,1.37948759803783e-4,8.276925588226981e-4,0.7211295380224161,0.1912823916082099,0.7932424918246578,MoneyMaker,log2-1,FALSE,0 +m_16,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.629738625055206,0.5483382356580899,0.09139091296721015,0.06657432531391384,fruit,fruit,0.429359411803659,0.7896551664786785,0.7211295380224161,0.6149125609720038,0.7932424918246578,MoneyMaker,transp1-1,FALSE,0 +m_16,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.33260536041835986,0.4289771061108146,0.026169463810305604,0.06083472556414341,leaf,leaf,0.3507227252222943,0.7896551664786785,0.35877482422866547,0.489811831674958,0.66630592834701,MoneyMaker,panK4-1,FALSE,0 +m_16,967514 MM WT,1017361 Sl10g086080 #2,ns,0.33260536041835986,0.4738727489234156,0.026169463810305604,0.13185991321022977,leaf,leaf,0.17576403903938115,0.7030561561575246,0.35877482422866547,0.6057326621336454,0.66630592834701,MoneyMaker,log2-1,FALSE,0 +m_16,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.33260536041835986,0.216592667882417,0.026169463810305604,0.03776880336500578,leaf,leaf,0.26321838882622617,0.7896551664786785,0.35877482422866547,0.25436147124742275,0.66630592834701,MoneyMaker,transp1-1,FALSE,0 +m_17,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.9396949742785091,0.9763369698989393,0.11241810647098502,0.1425390815358609,fruit,fruit,0.8467810687488806,1,1.052113080749494,1.1188760514348002,1.5172212973641284,MoneyMaker,panK4-1,FALSE,0 +m_17,967514 MM WT,1017361 Sl10g086080 #2,ns,0.9396949742785091,1.1764107079895818,0.11241810647098502,0.20288138052326204,fruit,fruit,0.21912584173883376,1,1.052113080749494,1.379292088512844,1.5172212973641284,MoneyMaker,log2-1,FALSE,0 +m_17,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.9396949742785091,0.8747537060506192,0.11241810647098502,0.23139489717453718,fruit,fruit,0.732222575111271,1,1.052113080749494,1.1061486032251564,1.5172212973641284,MoneyMaker,transp1-1,FALSE,0 +m_17,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5317481004666126,0.3460521524275132,0.08417839165225834,0.02916223558783185,leaf,leaf,0.3321046579110325,1,0.615926492118871,0.37521438801534507,0.6775191413307581,MoneyMaker,panK4-1,FALSE,0 +m_17,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5317481004666126,0.4211903761022803,0.08417839165225834,0.04215808266880122,leaf,leaf,0.5611344946276803,1,0.615926492118871,0.4633484587710815,0.6775191413307581,MoneyMaker,log2-1,FALSE,0 +m_17,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5317481004666126,0.449355213558705,0.08417839165225834,0.05823248564123965,leaf,leaf,0.6644377455184884,1,0.615926492118871,0.5075876991999446,0.6775191413307581,MoneyMaker,transp1-1,FALSE,0 +m_18,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5025734696706072,0.34044087642050536,0.09198303123504581,0.025728380670000682,fruit,fruit,0.18785765944010788,0.6026697574575074,0.594556500905653,0.366169257090506,0.8250254359307924,MoneyMaker,panK4-1,FALSE,1.0416666666666665 +m_18,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5025734696706072,0.6768920996166217,0.09198303123504581,0.07313102395682597,fruit,fruit,0.15795330514699454,0.6026697574575074,0.594556500905653,0.7500231235734476,0.8250254359307924,MoneyMaker,log2-1,FALSE,1.0416666666666665 +m_18,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5025734696706072,0.4148165559306123,0.09198303123504581,0.13066052684214288,fruit,fruit,0.4702256297574833,0.6026697574575074,0.594556500905653,0.5454770827727552,0.8250254359307924,MoneyMaker,transp1-1,FALSE,1.0416666666666665 +m_18,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3128337113402008,0.5738930114398076,0.04704117739740757,0.09850789312341889,leaf,leaf,0.03907617236412743,0.23445703418476457,0.3598748887376084,0.6724009045632265,0.7396409950195493,MoneyMaker,panK4-1,FALSE,0 +m_18,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3128337113402008,0.4903990291109643,0.04704117739740757,0.10525558578253577,leaf,leaf,0.15066743936437685,0.6026697574575074,0.3598748887376084,0.5956546148935,0.7396409950195493,MoneyMaker,log2-1,FALSE,0 +m_18,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3128337113402008,0.5402650811705877,0.04704117739740757,0.05179740009670585,leaf,leaf,0.06930530258079169,0.3465265129039585,0.3598748887376084,0.59206248126729355,0.7396409950195493,MoneyMaker,transp1-1,FALSE,0 +m_19,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.1643996932896449,0.0871431691182367,0.025895012331302453,0.010272436153586478,fruit,fruit,0.12080320206905204,0.3624096062071561,0.19029470562094736,0.09741560527182318,0.28743240737230963,MoneyMaker,panK4-1,FALSE,25 +m_19,967514 MM WT,1017361 Sl10g086080 #2,ns,0.1643996932896449,0.19101904776328008,0.025895012331302453,0.02162993547859116,fruit,fruit,0.5845555099306067,0.5981601474827316,0.19029470562094736,0.21264898324187123,0.28743240737230963,MoneyMaker,log2-1,FALSE,25 +m_19,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.1643996932896449,0.2153781908176983,0.025895012331302453,0.045923997702583194,fruit,fruit,0.2990800737413658,0.5981601474827316,0.19029470562094736,0.2613021885202815,0.28743240737230963,MoneyMaker,transp1-1,FALSE,25 +m_19,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.1169602188866844,0.2017965938430261,0.024616017796622498,0.0384345908761712,leaf,leaf,0.09006208516342905,0.3602483406537162,0.1415762366833069,0.2402311847191973,0.3595783104922114,MoneyMaker,panK4-1,FALSE,0 +m_19,967514 MM WT,1017361 Sl10g086080 #2,*,0.1169602188866844,0.26912972465807966,0.024616017796622498,0.057759648516657935,leaf,leaf,0.004147574393598429,0.024885446361590575,0.1415762366833069,0.3268893731747376,0.3595783104922114,MoneyMaker,log2-1,FALSE,0 +m_19,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.1169602188866844,0.2285264388807713,0.024616017796622498,0.021338323539382444,leaf,leaf,0.028987664424934213,0.14493832212467106,0.1415762366833069,0.24986476242015374,0.3595783104922114,MoneyMaker,transp1-1,FALSE,0 +m_2,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.6600228857212979,1.318800934199407,0.11561238831477233,0.3722558143876277,fruit,fruit,0.008728035624471438,0.043640178122357196,0.7756352740360701,1.6910567485870347,1.9048044702489955,MoneyMaker,panK4-1,FALSE,0 +m_2,967514 MM WT,1017361 Sl10g086080 #2,*,0.6600228857212979,1.5411364298995283,0.11561238831477233,0.1905039975995583,fruit,fruit,8.314334414939606e-4,0.004988600648963763,0.7756352740360701,1.7316404274990866,1.9048044702489955,MoneyMaker,log2-1,FALSE,0 +m_2,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6600228857212979,0.3422883735251995,0.11561238831477233,0.06598720761643997,fruit,fruit,0.18117613349727005,0.569948342585205,0.7756352740360701,0.4082755811416394,1.9048044702489955,MoneyMaker,transp1-1,FALSE,0 +m_2,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5337909889959604,0.18393489441640135,0.11300493342692706,0.04265286862827441,leaf,leaf,0.14248708564630125,0.569948342585205,0.6467959224228875,0.22658776304467576,0.7114755146651763,MoneyMaker,panK4-1,FALSE,0 +m_2,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5337909889959604,0.41808527022643405,0.11300493342692706,0.062311774194842955,leaf,leaf,0.6205882057910876,0.6205882057910876,0.6467959224228875,0.480397044421277,0.7114755146651763,MoneyMaker,log2-1,FALSE,0 +m_2,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5337909889959604,0.2503951728016769,0.11300493342692706,0.0431997850000372,leaf,leaf,0.23123825063192893,0.569948342585205,0.6467959224228875,0.2935949578017141,0.7114755146651763,MoneyMaker,transp1-1,FALSE,0 +m_20,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.08902857002439829,0.4224915686091369,0.004546395157871708,0.06800984773784306,fruit,fruit,1.2356328480645962e-4,7.413797088387578e-4,0.09357496518227,0.49050141634697997,0.539551557981678,MoneyMaker,panK4-1,FALSE,0 +m_20,967514 MM WT,1017361 Sl10g086080 #2,ns,0.08902857002439829,0.19926264583356212,0.004546395157871708,0.04445357325666492,fruit,fruit,0.14381308206572055,0.693390011553592,0.09357496518227,0.24371621909022706,0.539551557981678,MoneyMaker,log2-1,FALSE,0 +m_20,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.08902857002439829,0.09775731973419141,0.004546395157871708,0.011019935180095197,fruit,fruit,0.9057513381586024,1,0.09357496518227,0.10877725491428661,0.539551557981678,MoneyMaker,transp1-1,FALSE,0 +m_20,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.4409712201762882,0.32923757105865664,0.06753579527798902,0.05425155225952389,leaf,leaf,0.13867800231071842,0.693390011553592,0.5085070154542772,0.3834891233181805,0.562603043951009,MoneyMaker,panK4-1,FALSE,0 +m_20,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4409712201762882,0.3980164320785645,0.06753579527798902,0.04574654116497095,leaf,leaf,0.5614720309576451,1,0.5085070154542772,0.4437629732435355,0.562603043951009,MoneyMaker,log2-1,FALSE,0 +m_20,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4409712201762882,0.44113466325159817,0.06753579527798902,0.0703226494311373,leaf,leaf,0.9982308381683955,1,0.5085070154542772,0.5114573126827354,0.562603043951009,MoneyMaker,transp1-1,FALSE,0 +m_21,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5483926543879996,0.4179329231668998,0.052641459481513046,0.07039974247315003,fruit,fruit,0.25936104080822303,1,0.6010341138695126,0.48833266564004985,0.7468172113076149,MoneyMaker,panK4-1,FALSE,0 +m_21,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5483926543879996,0.3474267547200141,0.052641459481513046,0.05346794487432778,fruit,fruit,0.08780994458951386,0.5268596675370831,0.6010341138695126,0.4008946995943419,0.7468172113076149,MoneyMaker,log2-1,FALSE,0 +m_21,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5483926543879996,0.5415959653873847,0.052641459481513046,0.13732877216499242,fruit,fruit,0.9525057600274769,1,0.6010341138695126,0.6789247375523771,0.7468172113076149,MoneyMaker,transp1-1,FALSE,0 +m_21,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.42311181020114463,0.3808392575681248,0.09421303707634755,0.07883814572619925,leaf,leaf,0.7114439722993527,1,0.5173248472774922,0.45967740329432405,0.5690573320052414,MoneyMaker,panK4-1,FALSE,0 +m_21,967514 MM WT,1017361 Sl10g086080 #2,ns,0.42311181020114463,0.3336481199202317,0.09421303707634755,0.07037179183793064,leaf,leaf,0.43599344804086604,1,0.5173248472774922,0.4040199117581623,0.5690573320052414,MoneyMaker,log2-1,FALSE,0 +m_21,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.42311181020114463,0.3287650663853273,0.09421303707634755,0.039009706950676154,leaf,leaf,0.4116987522490345,1,0.5173248472774922,0.3677747733360035,0.5690573320052414,MoneyMaker,transp1-1,FALSE,0 +m_22,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.47938695475377724,0.5092324087296431,0.05813897235972534,0.09873599335657698,fruit,fruit,0.7619444259317392,1,0.5375259271135026,0.6079684020862202,0.6687652422948422,MoneyMaker,panK4-1,FALSE,0 +m_22,967514 MM WT,1017361 Sl10g086080 #2,ns,0.47938695475377724,0.4549778129048102,0.05813897235972534,0.06084449873070844,fruit,fruit,0.8042658592555251,1,0.5375259271135026,0.5158223116355186,0.6687652422948422,MoneyMaker,log2-1,FALSE,0 +m_22,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.47938695475377724,0.4097578282886627,0.05813897235972534,0.09889337007245107,fruit,fruit,0.4816150984975536,1,0.5375259271135026,0.5086511983611137,0.6687652422948422,MoneyMaker,transp1-1,FALSE,0 +m_22,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3516842815561205,0.39283519471938366,0.04176887457611932,0.05390722338142223,leaf,leaf,0.6764496059581724,1,0.39345315613223986,0.4467424181008059,0.6668509328863385,MoneyMaker,panK4-1,FALSE,0 +m_22,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3516842815561205,0.5246258823320242,0.04176887457611932,0.0816022384737379,leaf,leaf,0.08850908248003284,0.4425454124001642,0.39345315613223986,0.6062281208057622,0.6668509328863385,MoneyMaker,log2-1,FALSE,0 +m_22,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3516842815561205,0.13341106383554885,0.04176887457611932,0.0057065342649278445,leaf,leaf,0.03455686058171657,0.20734116349029943,0.39345315613223986,0.1391175981004767,0.6668509328863385,MoneyMaker,transp1-1,FALSE,0 +m_23,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.04834187691561796,0.25406423386195565,0.012821269412167229,0.04937291622821263,fruit,fruit,5.247186821105621e-4,0.003148312092663373,0.06116314632778519,0.30343715009016825,0.3337808650991851,MoneyMaker,panK4-1,FALSE,0 +m_23,967514 MM WT,1017361 Sl10g086080 #2,ns,0.04834187691561796,0.1369732876917635,0.012821269412167229,0.013613200077058216,fruit,fruit,0.0975620005942135,0.31706707157736347,0.06116314632778519,0.15058648776882172,0.3337808650991851,MoneyMaker,log2-1,FALSE,0 +m_23,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.04834187691561796,0.1425654144009612,0.012821269412167229,0.03448882866257943,fruit,fruit,0.07926676789434087,0.31706707157736347,0.06116314632778519,0.17705424306354065,0.3337808650991851,MoneyMaker,transp1-1,FALSE,0 +m_23,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3055239299426363,0.3252416516752666,0.024690341367419412,0.050806841455152844,leaf,leaf,0.7046937897790106,1,0.3302142713100557,0.37604849313041944,0.5644749965484686,MoneyMaker,panK4-1,FALSE,0 +m_23,967514 MM WT,1017361 Sl10g086080 #2,*,0.3055239299426363,0.4728596978004485,0.024690341367419412,0.040299389970886536,leaf,leaf,0.003361159174301725,0.016805795871508624,0.3302142713100557,0.513159087771335,0.5644749965484686,MoneyMaker,log2-1,FALSE,0 +m_23,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3055239299426363,0.3263410207884416,0.024690341367419412,0.042188302398929255,leaf,leaf,0.6891173190005977,1,0.3302142713100557,0.36852932318737086,0.5644749965484686,MoneyMaker,transp1-1,FALSE,0 +m_24,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.37162059994791174,0.15449435847999946,0.0657989254049882,0.023743472232325646,fruit,fruit,0.004258829988699853,0.021294149943499267,0.43741952535289996,0.1782378307123251,0.48116147788818997,MoneyMaker,panK4-1,FALSE,0 +m_24,967514 MM WT,1017361 Sl10g086080 #2,ns,0.37162059994791174,0.3260685824715779,0.0657989254049882,0.05403181251767569,fruit,fruit,0.5140437479817026,1,0.43741952535289996,0.3801003949892536,0.48116147788818997,MoneyMaker,log2-1,FALSE,0 +m_24,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.37162059994791174,0.31697197307991615,0.0657989254049882,0.05594235492223838,fruit,fruit,0.43460766175175103,1,0.43741952535289996,0.3729143280021545,0.48116147788818997,MoneyMaker,transp1-1,FALSE,0 +m_24,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2168135927667602,0.37714402107266204,0.016720548227690587,0.03359610408527403,leaf,leaf,0.02845809448575572,0.11383237794302288,0.2335341409944508,0.41074012515793606,0.5385652177511806,MoneyMaker,panK4-1,FALSE,1.0416666666666665 +m_24,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2168135927667602,0.27607121709213206,0.016720548227690587,0.07008717863000878,leaf,leaf,0.39739943019041923,1,0.2335341409944508,0.34615839572214085,0.5385652177511806,MoneyMaker,log2-1,FALSE,1.0416666666666665 +m_24,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.2168135927667602,0.44892181866500835,0.016720548227690587,0.04068292474515577,leaf,leaf,0.0025063410219554796,0.015038046131732877,0.2335341409944508,0.48960474341016413,0.5385652177511806,MoneyMaker,transp1-1,FALSE,1.0416666666666665 +m_25,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.05379028842514187,0.10417086315071478,0.006229712863615579,0.020576962921624396,fruit,fruit,0.3121198828409018,0.6699692334066817,0.06002000128875745,0.12474782607233917,0.17516480073638124,MoneyMaker,panK4-1,FALSE,0 +m_25,967514 MM WT,1017361 Sl10g086080 #2,ns,0.05379028842514187,0.12376721913967803,0.006229712863615579,0.03547350880248672,fruit,fruit,0.16443392222293426,0.6577356888917371,0.06002000128875745,0.15924072794216476,0.17516480073638124,MoneyMaker,log2-1,FALSE,0 +m_25,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.05379028842514187,0.11274792196616373,0.006229712863615579,0.012280445367664905,fruit,fruit,0.23870083299912853,0.6699692334066817,0.06002000128875745,0.12502836733382863,0.17516480073638124,MoneyMaker,transp1-1,FALSE,0 +m_25,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.305900896251862,0.2123464410088714,0.04452763415894449,0.044669206409321996,leaf,leaf,0.06717123361520337,0.33585616807601687,0.3504285304108065,0.2570156474181934,0.3854713834518872,MoneyMaker,panK4-1,FALSE,0 +m_25,967514 MM WT,1017361 Sl10g086080 #2,ns,0.305900896251862,0.19550617439780676,0.04452763415894449,0.040284095626781785,leaf,leaf,0.032998322659380214,0.19798993595628128,0.3504285304108065,0.23579027002458855,0.3854713834518872,MoneyMaker,log2-1,FALSE,0 +m_25,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.305900896251862,0.2449050251869707,0.04452763415894449,0.04528805928773744,leaf,leaf,0.22332307780222724,0.6699692334066817,0.3504285304108065,0.29019308447470815,0.3854713834518872,MoneyMaker,transp1-1,FALSE,0 +m_26,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.31098959419942773,0.13045511520187847,0.08119206313145168,0.03340998404645218,fruit,fruit,0.004768740624089864,0.02861244374453918,0.3921816573308794,0.16386509924833065,0.43139982306396735,MoneyMaker,panK4-1,FALSE,0 +m_26,967514 MM WT,1017361 Sl10g086080 #2,ns,0.31098959419942773,0.25992855812381865,0.08119206313145168,0.03689692393454803,fruit,fruit,0.38775634217776966,1,0.3921816573308794,0.2968254820583667,0.43139982306396735,MoneyMaker,log2-1,FALSE,0 +m_26,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.31098959419942773,0.24495703138352454,0.08119206313145168,0.056785135244422434,fruit,fruit,0.2665138535213125,1,0.3921816573308794,0.30174216662794695,0.43139982306396735,MoneyMaker,transp1-1,FALSE,0 +m_26,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.10126618617420827,0.09677194340638026,0.01854276017995077,0.026943276889651535,leaf,leaf,0.9389258832384155,1,0.11980894635415903,0.1237152202960318,0.13608674232563497,MoneyMaker,panK4-1,FALSE,0 +m_26,967514 MM WT,1017361 Sl10g086080 #2,ns,0.10126618617420827,0.07992146879459967,0.01854276017995077,0.009584806980147803,leaf,leaf,0.7163000192236549,1,0.11980894635415903,0.08950627577474747,0.13608674232563497,MoneyMaker,log2-1,FALSE,0 +m_26,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.10126618617420827,0.08614789055853907,0.01854276017995077,0.004576584390875326,leaf,leaf,0.7967321486486096,1,0.11980894635415903,0.0907244749494144,0.13608674232563497,MoneyMaker,transp1-1,FALSE,0 +m_27,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.2929666544206788,0.14969098925167018,0.050592934380647506,0.03218782531776184,fruit,fruit,0.006630849853887154,0.03315424926943577,0.3435595888013263,0.18187881456943203,0.37791554768145896,MoneyMaker,panK4-1,FALSE,0 +m_27,967514 MM WT,1017361 Sl10g086080 #2,*,0.2929666544206788,0.1199887311047202,0.050592934380647506,0.00599577376979438,fruit,fruit,0.0014803837575251518,0.00888230254515091,0.3435595888013263,0.1259845048745146,0.37791554768145896,MoneyMaker,log2-1,FALSE,0 +m_27,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2929666544206788,0.28247649605988456,0.050592934380647506,0.026129474208678703,fruit,fruit,0.829576294978162,1,0.3435595888013263,0.3086059702685633,0.37791554768145896,MoneyMaker,transp1-1,FALSE,0 +m_27,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2111912922550016,0.0900729033215549,0.05370587853408401,0.013749003647080605,leaf,leaf,0.019116524243061393,0.07646609697224557,0.2648971707890856,0.10382190696863551,0.3112852567987767,MoneyMaker,panK4-1,FALSE,0 +m_27,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2111912922550016,0.24213267967443142,0.05370587853408401,0.040853917415365586,leaf,leaf,0.5270605161743557,1,0.2648971707890856,0.282986597089797,0.3112852567987767,MoneyMaker,log2-1,FALSE,0 +m_27,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2111912922550016,0.13225572607431324,0.05370587853408401,0.01545920707146153,leaf,leaf,0.11458978470627387,0.3437693541188216,0.2648971707890856,0.14771493314577477,0.3112852567987767,MoneyMaker,transp1-1,FALSE,0 +m_28,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2091912966241598,0.20406399970158676,0.056104433290994,0.04336789524165662,fruit,fruit,0.9442389240221265,1,0.2652957299151538,0.24743189494324339,0.3342829695627793,MoneyMaker,panK4-1,FALSE,0 +m_28,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2091912966241598,0.2610445306053677,0.056104433290994,0.042849078088068024,fruit,fruit,0.48163537082725283,1,0.2652957299151538,0.30389360869343574,0.3342829695627793,MoneyMaker,log2-1,FALSE,0 +m_28,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2091912966241598,0.07993366036665794,0.056104433290994,0.019334430553777027,fruit,fruit,0.08744174664652708,0.4372087332326354,0.2652957299151538,0.09926809092043497,0.3342829695627793,MoneyMaker,transp1-1,FALSE,0 +m_28,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3695354462411041,0.23284308298776368,0.052197365246865954,0.010387567096022215,leaf,leaf,0.07169578801214642,0.4301747280728785,0.4217328114879701,0.2432306500837859,0.542998901482012,MoneyMaker,panK4-1,FALSE,0 +m_28,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3695354462411041,0.3992757216109137,0.052197365246865954,0.09435964337273356,leaf,leaf,0.6854681655985443,1,0.4217328114879701,0.49363536498364724,0.542998901482012,MoneyMaker,log2-1,FALSE,0 +m_28,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3695354462411041,0.2504875338661811,0.052197365246865954,0.04555943897998394,leaf,leaf,0.11382744586203862,0.4553097834481545,0.4217328114879701,0.29604697284616505,0.542998901482012,MoneyMaker,transp1-1,FALSE,0 +m_29,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.4944353396015754,0.6934306795490441,0.10873323386421202,0.1306970125088167,fruit,fruit,0.2507941238300434,0.7523823714901302,0.6031685734657874,0.82412769205786085,1.2056291647338355,MoneyMaker,panK4-1,FALSE,0 +m_29,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4944353396015754,0.4837622935189364,0.10873323386421202,0.1335611353477103,fruit,fruit,0.9501935810189598,0.9501935810189598,0.6031685734657874,0.6173234288666467,1.2056291647338355,MoneyMaker,log2-1,FALSE,0 +m_29,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4944353396015754,0.8685917488487666,0.10873323386421202,0.22743476454562928,fruit,fruit,0.03667576700061302,0.22005460200367813,0.6031685734657874,1.0960265133943958,1.2056291647338355,MoneyMaker,transp1-1,FALSE,0 +m_29,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6885123769076202,0.4301848790374421,0.07354931720842094,0.054750603459541185,leaf,leaf,0.13964949655878828,0.5585979862351531,0.7620616941160412,0.4849354824969833,0.8382678635276454,MoneyMaker,panK4-1,FALSE,0 +m_29,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6885123769076202,0.3977630687261737,0.07354931720842094,0.07188620142676996,leaf,leaf,0.09839905776283807,0.49199528881419036,0.7620616941160412,0.46964927015294367,0.8382678635276454,MoneyMaker,log2-1,FALSE,0 +m_29,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6885123769076202,0.5440194224512024,0.07354931720842094,0.04819126147922801,leaf,leaf,0.4012621240138925,0.802524248027785,0.7620616941160412,0.5922106839304304,0.8382678635276454,MoneyMaker,transp1-1,FALSE,0 +m_3,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.4360287580506318,0.17974401069384163,0.03929358774033207,0.023979902212288216,fruit,fruit,0.00990657468366874,0.05943944810201243,0.4753223457909639,0.20372391290612984,0.5311771540616598,MoneyMaker,panK4-1,FALSE,0 +m_3,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4360287580506318,0.388567177516648,0.03929358774033207,0.09432114435758815,fruit,fruit,0.60870892785135855,1,0.4753223457909639,0.48288832187423614,0.5311771540616598,MoneyMaker,log2-1,FALSE,0 +m_3,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4360287580506318,0.343768839260841,0.03929358774033207,0.06560099894871707,fruit,fruit,0.32335700236341125,1,0.4753223457909639,0.4093698382095581,0.5311771540616598,MoneyMaker,transp1-1,FALSE,0 +m_3,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.49277725611594875,0.33701986661016786,0.07279734090330996,0.07742316487156138,leaf,leaf,0.10161895361960947,0.5080947680980473,0.5655745970192587,0.41444303148172923,0.6221320567211847,MoneyMaker,panK4-1,FALSE,0 +m_3,967514 MM WT,1017361 Sl10g086080 #2,ns,0.49277725611594875,0.4692511724592624,0.07279734090330996,0.049055553372101,leaf,leaf,0.7992771637031899,1,0.5655745970192587,0.5183067258313634,0.6221320567211847,MoneyMaker,log2-1,FALSE,0 +m_3,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.49277725611594875,0.45572288610062106,0.07279734090330996,0.06684642380836703,leaf,leaf,0.6890838642263817,1,0.5655745970192587,0.5225693099089881,0.6221320567211847,MoneyMaker,transp1-1,FALSE,0 +m_30,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.44144555720228945,0.18291277578061382,0.11805640484548129,0.018929401972172206,fruit,fruit,0.00194011080588618,0.009700554029430899,0.5595019620477707,0.20184217775278604,0.6154521582525478,MoneyMaker,panK4-1,FALSE,2.083333333333333 +m_30,967514 MM WT,1017361 Sl10g086080 #2,*,0.44144555720228945,0.15850968318912073,0.11805640484548129,0.024827671414705797,fruit,fruit,8.558152634785855e-4,0.005134891580871513,0.5595019620477707,0.18333735460382652,0.6154521582525478,MoneyMaker,log2-1,FALSE,2.083333333333333 +m_30,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.44144555720228945,0.3941219218576881,0.11805640484548129,0.08203754324620802,fruit,fruit,0.5302594787393656,0.5302594787393656,0.5595019620477707,0.47615946510389606,0.6154521582525478,MoneyMaker,transp1-1,FALSE,2.083333333333333 +m_30,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2028016160049509,0.07396035588610197,0.00946685107558266,0.006515269053676565,leaf,leaf,0.09577934127599048,0.28733802382797147,0.21226846708053354,0.08047562493977854,0.2334953137885869,MoneyMaker,panK4-1,FALSE,0 +m_30,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2028016160049509,0.09471496156673496,0.00946685107558266,0.016905007162601234,leaf,leaf,0.15875477520780806,0.3175095504156161,0.21226846708053354,0.1116199687293362,0.2334953137885869,MoneyMaker,log2-1,FALSE,0 +m_30,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2028016160049509,0.06098971928861817,0.00946685107558266,0.00530512854680282,leaf,leaf,0.06837468395543243,0.27349873582172973,0.21226846708053354,0.06629484783542099,0.2334953137885869,MoneyMaker,transp1-1,FALSE,0 +m_31,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.25531743671138624,0.29478966838344794,0.06372860024288365,0.0497929708970681,fruit,fruit,0.6481674174738721,1,0.3190460369542699,0.344582639280516,0.7716206008334457,MoneyMaker,panK4-1,FALSE,6.25 +m_31,967514 MM WT,1017361 Sl10g086080 #2,*,0.25531743671138624,0.5718066401529042,0.06372860024288365,0.12966663333204642,fruit,fruit,0.0011059100080952962,0.006635460048571778,0.3190460369542699,0.7014732734849506,0.7716206008334457,MoneyMaker,log2-1,FALSE,6.25 +m_31,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.25531743671138624,0.24692121734645947,0.06372860024288365,0.04384976856597372,fruit,fruit,0.9225140720197951,1,0.3190460369542699,0.29077098591243317,0.7716206008334457,MoneyMaker,transp1-1,FALSE,6.25 +m_31,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.1605914433623423,0.11102975370971858,0.047056985442067656,0.03303966888230331,leaf,leaf,0.5671719021476749,1,0.20764842880440995,0.14406942259202188,0.22841327168485095,MoneyMaker,panK4-1,FALSE,0 +m_31,967514 MM WT,1017361 Sl10g086080 #2,ns,0.1605914433623423,0.10581336050276857,0.047056985442067656,0.010250644864325968,leaf,leaf,0.5274098201320341,1,0.20764842880440995,0.11606400536709455,0.22841327168485095,MoneyMaker,log2-1,FALSE,0 +m_31,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.1605914433623423,0.12499004662848283,0.047056985442067656,0.022296119554835903,leaf,leaf,0.6805368343754752,1,0.20764842880440995,0.14728616618331875,0.22841327168485095,MoneyMaker,transp1-1,FALSE,0 +m_32,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.24423253089423666,0.2394704858717095,0.05702401073817718,0.013015173737646237,fruit,fruit,0.9449742961067049,1,0.30125654163241383,0.2524856596093557,0.33138219579565525,MoneyMaker,panK4-1,FALSE,0 +m_32,967514 MM WT,1017361 Sl10g086080 #2,ns,0.24423253089423666,0.22739640411883194,0.05702401073817718,0.036327658563403586,fruit,fruit,0.8073277317997822,1,0.30125654163241383,0.2637240626822355,0.33138219579565525,MoneyMaker,log2-1,FALSE,0 +m_32,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.24423253089423666,0.21253397287371428,0.05702401073817718,0.009737888940962268,fruit,fruit,0.6466457062268078,1,0.30125654163241383,0.22227186181467656,0.33138219579565525,MoneyMaker,transp1-1,FALSE,0 +m_32,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3246314778730885,0.2984740363869329,0.04426361091653911,0.06033656174163141,leaf,leaf,0.7050151007337679,1,0.3688950887896276,0.3588105981285643,0.47771073102248984,MoneyMaker,panK4-1,FALSE,0 +m_32,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3246314778730885,0.25128985360200357,0.04426361091653911,0.056303212482134685,leaf,leaf,0.29342937476670405,1,0.3688950887896276,0.3075930660841383,0.47771073102248984,MoneyMaker,log2-1,FALSE,0 +m_32,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3246314778730885,0.3632762357127735,0.04426361091653911,0.07100624703494451,leaf,leaf,0.576652271324711,1,0.3688950887896276,0.434282482747718,0.47771073102248984,MoneyMaker,transp1-1,FALSE,0 +m_33,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6571438816270889,0.7547671952372681,0.1921951964997751,0.08629819148797618,fruit,fruit,0.45968894776574953,1,0.849339078126864,0.8410653867252442,0.9342729859395505,MoneyMaker,panK4-1,FALSE,0 +m_33,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6571438816270889,0.5254021566712662,0.1921951964997751,0.08983530801957083,fruit,fruit,0.3206632807097493,1,0.849339078126864,0.6152374646908371,0.9342729859395505,MoneyMaker,log2-1,FALSE,0 +m_33,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6571438816270889,0.6001008911406716,0.1921951964997751,0.06376604100926786,fruit,fruit,0.6645284616061289,1,0.849339078126864,0.6638669321499394,0.9342729859395505,MoneyMaker,transp1-1,FALSE,0 +m_33,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3430549255093222,0.3501624274765841,0.05632082358421217,0.06930683692473483,leaf,leaf,0.9568228254339146,1,0.39937574909353435,0.41946926440131893,0.46141619084145086,MoneyMaker,panK4-1,FALSE,0 +m_33,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3430549255093222,0.2948941209551702,0.05632082358421217,0.04421775226234167,leaf,leaf,0.7141024844792712,1,0.39937574909353435,0.33911187321751185,0.46141619084145086,MoneyMaker,log2-1,FALSE,0 +m_33,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3430549255093222,0.2890210245122574,0.05632082358421217,0.03250582377281798,leaf,leaf,0.6811628732379347,1,0.39937574909353435,0.3215268482850754,0.46141619084145086,MoneyMaker,transp1-1,FALSE,0 +m_34,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.21183299737517589,0.17491987446715743,0.047861376915179686,0.02249834829760847,fruit,fruit,0.6407127396063156,1,0.2596943742903556,0.1974182227647659,0.31251434043430293,MoneyMaker,panK4-1,FALSE,0 +m_34,967514 MM WT,1017361 Sl10g086080 #2,ns,0.21183299737517589,0.13322053362839922,0.047861376915179686,0.016167616811433583,fruit,fruit,0.3241470822604189,1,0.2596943742903556,0.1493881504398328,0.31251434043430293,MoneyMaker,log2-1,FALSE,0 +m_34,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.21183299737517589,0.25128143160259103,0.047861376915179686,0.03282251424677523,fruit,fruit,0.6180653221061433,1,0.2596943742903556,0.28410394584936627,0.31251434043430293,MoneyMaker,transp1-1,FALSE,0 +m_34,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.30666736668820005,0.26290240124862524,0.06739665945806678,0.070219483690151685,leaf,leaf,0.5803889832207312,1,0.3740640261462668,0.3331218849387769,0.47201242633136054,MoneyMaker,panK4-1,FALSE,0 +m_34,967514 MM WT,1017361 Sl10g086080 #2,ns,0.30666736668820005,0.33810384496976004,0.06739665945806678,0.09099836078602223,leaf,leaf,0.690842905697785,1,0.3740640261462668,0.4291022057557823,0.47201242633136054,MoneyMaker,log2-1,FALSE,0 +m_34,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.30666736668820005,0.3108841416684508,0.06739665945806678,0.050049802217230835,leaf,leaf,0.9573849170803155,1,0.3740640261462668,0.3609339438856816,0.47201242633136054,MoneyMaker,transp1-1,FALSE,0 +m_35,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.4319102100142117,0.7047327527792455,0.12075427501882557,0.07671620330231729,fruit,fruit,0.04407740287498745,0.22038701437493727,0.5526644850330373,0.7814489560815628,0.8595938516897192,MoneyMaker,panK4-1,FALSE,0 +m_35,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4319102100142117,0.40655885334719905,0.12075427501882557,0.07084849186311493,fruit,fruit,0.8451284947430184,1,0.5526644850330373,0.47740734521031397,0.8595938516897192,MoneyMaker,log2-1,FALSE,0 +m_35,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4319102100142117,0.32974530979112493,0.12075427501882557,0.044299165366197754,fruit,fruit,0.4339690154113387,1,0.5526644850330373,0.3740444751573227,0.8595938516897192,MoneyMaker,transp1-1,FALSE,0 +m_35,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3548314009695578,0.6444486952972154,0.07644424115841894,0.11837897046337387,leaf,leaf,0.03346953622582384,0.20081721735494304,0.43127564212797675,0.7628276657605892,0.8391104323366483,MoneyMaker,panK4-1,FALSE,0 +m_35,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3548314009695578,0.5747152402682362,0.07644424115841894,0.13241622077334878,leaf,leaf,0.09966328430625093,0.39865313722500373,0.43127564212797675,0.707131461041585,0.8391104323366483,MoneyMaker,log2-1,FALSE,0 +m_35,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3548314009695578,0.3538627805638319,0.07644424115841894,0.03303471383484635,leaf,leaf,0.9940426906220694,1,0.43127564212797675,0.38689749439867827,0.8391104323366483,MoneyMaker,transp1-1,FALSE,0 +m_36,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.14985902213813979,0.09798648778864183,0.022666055994623763,0.009741213178321452,fruit,fruit,0.5872642702840958,1,0.17252507813276355,0.10772770096696328,0.24515458819661798,MoneyMaker,panK4-1,FALSE,0 +m_36,967514 MM WT,1017361 Sl10g086080 #2,ns,0.14985902213813979,0.18741267606742518,0.022666055994623763,0.03511222485877206,fruit,fruit,0.6939115089842112,1,0.17252507813276355,0.22252490092619723,0.24515458819661798,MoneyMaker,log2-1,FALSE,0 +m_36,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.14985902213813979,0.19446146621718882,0.022666055994623763,0.028406341234282033,fruit,fruit,0.6404226207074926,1,0.17252507813276355,0.22286780745147086,0.24515458819661798,MoneyMaker,transp1-1,FALSE,0 +m_36,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.29279427927331175,0.5342758180029443,0.061079592102093294,0.1082901891415782,leaf,leaf,0.01713363085857469,0.10280178515144814,0.35387387137540505,0.6425660071445225,0.7068226078589748,MoneyMaker,panK4-1,FALSE,0 +m_36,967514 MM WT,1017361 Sl10g086080 #2,ns,0.29279427927331175,0.48101678287066996,0.061079592102093294,0.12351233353438953,leaf,leaf,0.05734962078416759,0.28674810392083794,0.35387387137540505,0.6045291164050595,0.7068226078589748,MoneyMaker,log2-1,FALSE,0 +m_36,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.29279427927331175,0.2577682613069167,0.061079592102093294,0.046826375446680786,leaf,leaf,0.7135133155093738,1,0.35387387137540505,0.3045946367535975,0.7068226078589748,MoneyMaker,transp1-1,FALSE,0 +m_37,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.14075474871502291,0.10402263937149518,0.02102266952967072,0.010655569799830043,fruit,fruit,0.28589823920814705,0.5717964784162941,0.16177741824469363,0.11467820917132522,0.30017123556878184,MoneyMaker,panK4-1,FALSE,0 +m_37,967514 MM WT,1017361 Sl10g086080 #2,ns,0.14075474871502291,0.14908464450546643,0.02102266952967072,0.021594865892030857,fruit,fruit,0.8066114145845256,0.8066114145845256,0.16177741824469363,0.1706795103974973,0.30017123556878184,MoneyMaker,log2-1,FALSE,0 +m_37,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.14075474871502291,0.23947691310799152,0.02102266952967072,0.033406028318173756,fruit,fruit,0.007264105183577658,0.029056420734310633,0.16177741824469363,0.27288294142616526,0.30017123556878184,MoneyMaker,transp1-1,FALSE,0 +m_37,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.138122056421425,0.2655461238844004,0.008601545000762668,0.023152106872334596,leaf,leaf,9.024188090663902e-4,0.004512094045331951,0.14672360142218765,0.288698230756735,0.36874096778249166,MoneyMaker,panK4-1,FALSE,0 +m_37,967514 MM WT,1017361 Sl10g086080 #2,*,0.138122056421425,0.29401467047158986,0.008601545000762668,0.04120439114885712,leaf,leaf,1.057809887898127e-4,6.346859327388762e-4,0.14672360142218765,0.33521906162044696,0.36874096778249166,MoneyMaker,log2-1,FALSE,0 +m_37,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.138122056421425,0.07475795366531648,0.008601545000762668,0.0091990765600168,leaf,leaf,0.07189907915512304,0.21569723746536912,0.14672360142218765,0.08395703022533328,0.36874096778249166,MoneyMaker,transp1-1,FALSE,0 +m_38,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3169962691175314,0.519866044105356,0.07211107532236771,0.04946083364104712,fruit,fruit,0.0432611265357341,0.2513391758213873,0.38910734443989914,0.5693268777464031,0.6440605571321228,MoneyMaker,panK4-1,FALSE,0 +m_38,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3169962691175314,0.5213356201806386,0.07211107532236771,0.0641739772122003,fruit,fruit,0.04188986263689789,0.2513391758213873,0.38910734443989914,0.5855095973928389,0.6440605571321228,MoneyMaker,log2-1,FALSE,0 +m_38,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3169962691175314,0.3211148147526049,0.07211107532236771,0.02855547852168387,fruit,fruit,0.9658020210841606,0.9658020210841606,0.38910734443989914,0.3496702932742888,0.6440605571321228,MoneyMaker,transp1-1,FALSE,0 +m_38,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2922872090874294,0.39239121187479936,0.05785814040913977,0.0714204997210612,leaf,leaf,0.3028237212759818,0.6056474425519636,0.35014534949656917,0.46381171159586054,0.6122634044333353,MoneyMaker,panK4-1,FALSE,0 +m_38,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2922872090874294,0.46500963183575833,0.05785814040913977,0.09159346310363727,leaf,leaf,0.08174331223745622,0.3269732489498249,0.35014534949656917,0.5566030949393956,0.6122634044333353,MoneyMaker,log2-1,FALSE,0 +m_38,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2922872090874294,0.4348538266635929,0.05785814040913977,0.08204449990159286,leaf,leaf,0.14673824467992602,0.44021473403977807,0.35014534949656917,0.5168983265651858,0.6122634044333353,MoneyMaker,transp1-1,FALSE,0 +m_39,967514 MM WT,1015695 Sl10g074590 #30.1,*,1.400385168056376,0.8348488932201213,0.2508215902865504,0.10660290965968014,fruit,fruit,0.005596840832058486,0.02798420416029243,1.6512067583429264,0.9414518028798015,1.816327434177219,MoneyMaker,panK4-1,FALSE,0 +m_39,967514 MM WT,1017361 Sl10g086080 #2,*,1.400385168056376,0.690590979683197,0.2508215902865504,0.0743426215763322,fruit,fruit,8.299992922148509e-4,0.004979995753289106,1.6512067583429264,0.76493360125952925,1.816327434177219,MoneyMaker,log2-1,FALSE,0 +m_39,967514 MM WT,1017363 Sl10g007190 #19.2,ns,1.400385168056376,1.401987852812655,0.2508215902865504,0.23766584298059973,fruit,fruit,0.9931898896252598,1,1.6512067583429264,1.6396536957932548,1.816327434177219,MoneyMaker,transp1-1,FALSE,0 +m_39,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.11793666721291884,0.09543101192710904,0.018728417709704185,0.006059178886104328,leaf,leaf,0.9046109115247302,1,0.13666508492262303,0.10149019081321337,0.24004189134644224,MoneyMaker,panK4-1,FALSE,0 +m_39,967514 MM WT,1017361 Sl10g086080 #2,ns,0.11793666721291884,0.18959611874059829,0.018728417709704185,0.028623782483440097,leaf,leaf,0.7031697479853087,1,0.13666508492262303,0.2182199012240384,0.24004189134644224,MoneyMaker,log2-1,FALSE,0 +m_39,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.11793666721291884,0.1636201815045655,0.018728417709704185,0.02510914747038526,leaf,leaf,0.8078958503525461,1,0.13666508492262303,0.18872932897495076,0.24004189134644224,MoneyMaker,transp1-1,FALSE,0 +m_4,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.37530420913487955,0.3968473456479126,0.07745955964140118,0.04192094619615899,fruit,fruit,0.7864025223993334,1,0.4527637687762807,0.43876829184407157,0.685948480804672,MoneyMaker,panK4-1,FALSE,0 +m_4,967514 MM WT,1017361 Sl10g086080 #2,ns,0.37530420913487955,0.5391335271066939,0.07745955964140118,0.08445600089755324,fruit,fruit,0.04798249417226047,0.23991247086130235,0.4527637687762807,0.6235895280042472,0.685948480804672,MoneyMaker,log2-1,FALSE,0 +m_4,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.37530420913487955,0.28537556645896334,0.07745955964140118,0.04192762418848688,fruit,fruit,0.2639390426726261,1,0.4527637687762807,0.3273031906474502,0.685948480804672,MoneyMaker,transp1-1,FALSE,0 +m_4,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.27913624245781904,0.07623881621032531,0.055984104927374656,0.020930851674220454,leaf,leaf,0.01639578476631307,0.09837470859787842,0.3351203473851937,0.09716966788454577,0.413584914027267,MoneyMaker,panK4-1,FALSE,0 +m_4,967514 MM WT,1017361 Sl10g086080 #2,ns,0.27913624245781904,0.237617679070265,0.055984104927374656,0.028632274535489714,leaf,leaf,0.6022599596182279,1,0.3351203473851937,0.2662499536057547,0.413584914027267,MoneyMaker,log2-1,FALSE,0 +m_4,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.27913624245781904,0.31531694582909203,0.055984104927374656,0.06066933965024156,leaf,leaf,0.6494943798921253,1,0.3351203473851937,0.3759862854793336,0.413584914027267,MoneyMaker,transp1-1,FALSE,0 +m_40,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.36464502233075863,0.46214340381029084,0.06716134169324088,0.1416156252116816,fruit,fruit,0.3509903944990077,1,0.4318063640239995,0.6037590290219724,0.6921936525833918,MoneyMaker,panK4-1,FALSE,13.541666666666666 +m_40,967514 MM WT,1017361 Sl10g086080 #2,ns,0.36464502233075863,0.3506550994825259,0.06716134169324088,0.07084991393505997,fruit,fruit,0.8925764460875963,1,0.4318063640239995,0.42150501341758584,0.6921936525833918,MoneyMaker,log2-1,FALSE,13.541666666666666 +m_40,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.36464502233075863,0.5199701528800811,0.06716134169324088,0.1092968040139114,fruit,fruit,0.14274653792570813,0.8564792275542488,0.4318063640239995,0.6292669568939925,0.6921936525833918,MoneyMaker,transp1-1,FALSE,13.541666666666666 +m_40,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.07133696029138742,0.06450232727984108,0.004274212749506477,0.006750007453931483,leaf,leaf,0.9473901957717485,1,0.0756111730408939,0.07125233473377256,0.12849750677993205,MoneyMaker,panK4-1,FALSE,0 +m_40,967514 MM WT,1017361 Sl10g086080 #2,ns,0.07133696029138742,0.07875275327451306,0.004274212749506477,0.009321845344770574,leaf,leaf,0.9429245034940364,1,0.0756111730408939,0.08807459861928363,0.12849750677993205,MoneyMaker,log2-1,FALSE,0 +m_40,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.07133696029138742,0.09825528414951783,0.004274212749506477,0.018560631104965832,leaf,leaf,0.7950896253107467,1,0.0756111730408939,0.11681591525448366,0.12849750677993205,MoneyMaker,transp1-1,FALSE,0 +m_41,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.16394147904287457,0.12728111150213417,0.027328117906621617,0.022074522670992722,fruit,fruit,0.4769796590101161,1,0.1912695969494962,0.1493556341731269,0.2324258466790509,MoneyMaker,panK4-1,FALSE,0 +m_41,967514 MM WT,1017361 Sl10g086080 #2,ns,0.16394147904287457,0.1661948923314101,0.027328117906621617,0.04510133192227249,fruit,fruit,0.9649457975188453,1,0.1912695969494962,0.2112962242536826,0.2324258466790509,MoneyMaker,log2-1,FALSE,0 +m_41,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.16394147904287457,0.18125913688341047,0.027328117906621617,0.02711220649936679,fruit,fruit,0.7358575873896674,1,0.1912695969494962,0.20837134338277727,0.2324258466790509,MoneyMaker,transp1-1,FALSE,0 +m_41,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.18134784157973483,0.1184916256923851,0.04724566973715948,0.02824222758563101,leaf,leaf,0.2274225022479019,1,0.22859351131689432,0.1467338532780161,0.3260657430604078,MoneyMaker,panK4-1,FALSE,0 +m_41,967514 MM WT,1017361 Sl10g086080 #2,ns,0.18134784157973483,0.2414819309492023,0.04724566973715948,0.05494147183298657,leaf,leaf,0.24758450127527412,1,0.22859351131689432,0.29642340278218887,0.3260657430604078,MoneyMaker,log2-1,FALSE,0 +m_41,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.18134784157973483,0.15515366508710063,0.04724566973715948,0.01573026653397719,leaf,leaf,0.6104242780088738,1,0.22859351131689432,0.17088393162107782,0.3260657430604078,MoneyMaker,transp1-1,FALSE,0 +m_42,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.0266333284486893,0.04845063021371287,0.0021829368475349293,0.003227945485872101,fruit,fruit,0.14543129526254017,0.7271564763127009,0.028816265296224226,0.05167857569958497,0.16135163567050112,MoneyMaker,panK4-1,FALSE,0 +m_42,967514 MM WT,1017361 Sl10g086080 #2,*,0.0266333284486893,0.12289286222028765,0.0021829368475349293,0.02379044293471335,fruit,fruit,7.234981495331189e-7,4.340988897198713e-6,0.028816265296224226,0.146683305155001,0.16135163567050112,MoneyMaker,log2-1,FALSE,0 +m_42,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.0266333284486893,0.037761737557719985,0.0021829368475349293,0.0025077026868293795,fruit,fruit,0.45024537720877644,1,0.028816265296224226,0.040269440244549363,0.16135163567050112,MoneyMaker,transp1-1,FALSE,0 +m_42,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.049462519886395245,0.04801828393276764,0.002662248049748823,0.008551776299886028,leaf,leaf,0.9214806040909483,1,0.05212476793614407,0.05657006023265367,0.08721734379619152,MoneyMaker,panK4-1,FALSE,0 +m_42,967514 MM WT,1017361 Sl10g086080 #2,ns,0.049462519886395245,0.0675162774044684,0.002662248049748823,0.011772216955705699,leaf,leaf,0.225082177735771,0.900328710943084,0.05212476793614407,0.0792884943601741,0.08721734379619152,MoneyMaker,log2-1,FALSE,0 +m_42,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.049462519886395245,0.03622051160817409,0.002662248049748823,0.005881594698938163,leaf,leaf,0.3701589320161921,1,0.05212476793614407,0.04210210630711225,0.08721734379619152,MoneyMaker,transp1-1,FALSE,0 +m_43,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.9687725903294386,0.2822682093064568,0.2513101487985824,0.02519235357981594,fruit,fruit,8.126435143064186e-4,0.004875861085838511,1.2200827391280211,0.3074605628862727,1.3513561988285558,MoneyMaker,panK4-1,FALSE,4.166666666666666 +m_43,967514 MM WT,1017361 Sl10g086080 #2,ns,0.9687725903294386,1.0036113526881585,0.2513101487985824,0.2248942826105285,fruit,fruit,0.8476010553328173,1,1.2200827391280211,1.228505635298687,1.3513561988285558,MoneyMaker,log2-1,FALSE,4.166666666666666 +m_43,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.9687725903294386,0.5192733675040204,0.2513101487985824,0.10031695251163196,fruit,fruit,0.019371751537065343,0.09685875768532672,1.2200827391280211,0.6195903200156524,1.3513561988285558,MoneyMaker,transp1-1,FALSE,4.166666666666666 +m_43,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.16561247670379195,0.04653818547988694,0.03484482569411907,0.01008254559754459,leaf,leaf,0.5130304692138125,1,0.200457302397911,0.05662073107743153,0.2676402289809912,MoneyMaker,panK4-1,FALSE,0 +m_43,967514 MM WT,1017361 Sl10g086080 #2,ns,0.16561247670379195,0.1997039732469804,0.03484482569411907,0.04360532582664798,leaf,leaf,0.8508286778210872,1,0.200457302397911,0.24330929907362836,0.2676402289809912,MoneyMaker,log2-1,FALSE,0 +m_43,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.16561247670379195,0.2034659953425762,0.03484482569411907,0.03150275514559799,leaf,leaf,0.8346077461915641,1,0.200457302397911,0.2349687504881742,0.2676402289809912,MoneyMaker,transp1-1,FALSE,0 +m_44,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5418974088581695,0.7307579845109644,0.12172074827273283,0.08811024879840541,fruit,fruit,0.27085453877295435,0.6164424582874983,0.6636181571309023,0.8188682333093699,1.299254739936129,MoneyMaker,panK4-1,FALSE,0 +m_44,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5418974088581695,0.6802060014932264,0.12172074827273283,0.13947658950702221,fruit,fruit,0.417278703704145,0.6164424582874983,0.6636181571309023,0.8196825910002487,1.299254739936129,MoneyMaker,log2-1,FALSE,0 +m_44,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5418974088581695,0.9373391190128961,0.12172074827273283,0.24380155365631195,fruit,fruit,0.02675080189040687,0.1605048113424412,0.6636181571309023,1.181140672669208,1.299254739936129,MoneyMaker,transp1-1,FALSE,0 +m_44,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.7159354458418359,0.44929204506642556,0.08331388365086632,0.03871570797916583,leaf,leaf,0.12463798306163495,0.4985519322465398,0.7992493294927022,0.4880077530455914,0.8791742624419725,MoneyMaker,panK4-1,FALSE,0 +m_44,967514 MM WT,1017361 Sl10g086080 #2,ns,0.7159354458418359,0.3235500835698449,0.08331388365086632,0.02424795987720833,leaf,leaf,0.02783100475878982,0.1605048113424412,0.7992493294927022,0.34779804344705323,0.8791742624419725,MoneyMaker,log2-1,FALSE,0 +m_44,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.7159354458418359,0.49786553092014707,0.08331388365086632,0.042600828661748344,leaf,leaf,0.2054808194291661,0.6164424582874983,0.7992493294927022,0.5404663595818954,0.8791742624419725,MoneyMaker,transp1-1,FALSE,0 +m_45,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5519566494893826,0.7298887355134204,0.11435379229286843,0.096074359155390407,fruit,fruit,0.3399727005524916,0.7875561362351369,0.6663104417822511,0.8259630946688108,1.2482185365721212,MoneyMaker,panK4-1,FALSE,0 +m_45,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5519566494893826,0.6333938740422206,0.11435379229286843,0.15894921483722665,fruit,fruit,0.6598810370255819,0.7875561362351369,0.6663104417822511,0.7923430888794473,1.2482185365721212,MoneyMaker,log2-1,FALSE,0 +m_45,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5519566494893826,0.8916399494088346,0.11435379229286843,0.24310417474763907,fruit,fruit,0.075385070020972,0.37692535010486,0.6663104417822511,1.1347441241564737,1.2482185365721212,MoneyMaker,transp1-1,FALSE,0 +m_45,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.8953702963835762,0.6362521826906307,0.12014849364691282,0.06918101611771453,leaf,leaf,0.16909951950447735,0.6763980780179094,1.0155187900304892,0.7054331988083452,1.1170706690335381,MoneyMaker,panK4-1,FALSE,0 +m_45,967514 MM WT,1017361 Sl10g086080 #2,ns,0.8953702963835762,0.5291250581305441,0.12014849364691282,0.051811112337928206,leaf,leaf,0.056484250125652384,0.3389055007539143,1.0155187900304892,0.5809361704684723,1.1170706690335381,MoneyMaker,log2-1,FALSE,0 +m_45,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.8953702963835762,0.6856690267833284,0.12014849364691282,0.07089492249836091,leaf,leaf,0.26251871207837896,0.7875561362351369,1.0155187900304892,0.7565639492816894,1.1170706690335381,MoneyMaker,transp1-1,FALSE,0 +m_46,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.7852497268409664,0.706485258892824,0.08849430894667382,0.09747927758800783,fruit,fruit,0.6786542467795462,1,0.8737440357876403,0.8039645364808318,1.243118786396832,MoneyMaker,panK4-1,FALSE,0 +m_46,967514 MM WT,1017361 Sl10g086080 #2,ns,0.7852497268409664,0.8036874826606645,0.08849430894667382,0.11071121452415184,fruit,fruit,0.9226077806342681,1,0.8737440357876403,0.9143986971848164,1.243118786396832,MoneyMaker,log2-1,FALSE,0 +m_46,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.7852497268409664,0.9028159649971672,0.08849430894667382,0.22729202263631648,fruit,fruit,0.5372177538316139,1,0.8737440357876403,1.1301079876334836,1.243118786396832,MoneyMaker,transp1-1,FALSE,0 +m_46,967514 MM WT,1015695 Sl10g074590 #30.1,ns,1.083326004895171,0.9136765855337328,0.13113661401471416,0.11565564640288457,leaf,leaf,0.375324516938108,1,1.214462618909885,1.0293322319366174,1.382482519430166,MoneyMaker,panK4-1,FALSE,0 +m_46,967514 MM WT,1017361 Sl10g086080 #2,ns,1.083326004895171,0.837393587427082,0.13113661401471416,0.1263453153188215,leaf,leaf,0.20275498952489504,1,1.214462618909885,0.9637389027459036,1.382482519430166,MoneyMaker,log2-1,FALSE,0 +m_46,967514 MM WT,1017363 Sl10g007190 #19.2,ns,1.083326004895171,1.1415143812223465,0.13113661401471416,0.11528790916871344,leaf,leaf,0.7593587631951768,1,1.214462618909885,1.2568022903910598,1.382482519430166,MoneyMaker,transp1-1,FALSE,0 +m_47,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6696154407169976,0.6412820946320245,0.10022148917277146,0.10276018542768808,fruit,fruit,0.8719756215979656,1,0.7698369298897692,0.7440422800597125,1.0819245113402571,MoneyMaker,panK4-1,FALSE,0 +m_47,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6696154407169976,0.8484840498156829,0.10022148917277146,0.13508368776636898,fruit,fruit,0.3140749086184882,1,0.7698369298897692,0.983567737582052,1.0819245113402571,MoneyMaker,log2-1,FALSE,0 +m_47,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6696154407169976,0.6881817179859429,0.10022148917277146,0.12704175498155906,fruit,fruit,0.9158880866899022,1,0.7698369298897692,0.8152234729675019,1.0819245113402571,MoneyMaker,transp1-1,FALSE,0 +m_47,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.9114444321768727,0.5559334089315257,0.13802135522383854,0.11629910338183642,leaf,leaf,0.05210303558026759,0.26051517790133794,1.0494657874007112,0.6722325123133621,1.164837700779453,MoneyMaker,panK4-1,FALSE,0 +m_47,967514 MM WT,1017361 Sl10g086080 #2,ns,0.9114444321768727,0.5066213222684348,0.13802135522383854,0.09641220130177158,leaf,leaf,0.02871389156155169,0.17228334936931014,1.0494657874007112,0.6030335235702065,1.164837700779453,MoneyMaker,log2-1,FALSE,0 +m_47,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.9114444321768727,0.9034642712437231,0.13802135522383854,0.15547909310123417,leaf,leaf,0.9637887261139616,1,1.0494657874007112,1.0589433643449573,1.164837700779453,MoneyMaker,transp1-1,FALSE,0 +m_48,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.47459379221862114,0.3445620535178667,0.12479274154841696,0.058658147083887266,fruit,fruit,0.18340046024451528,0.7055235536530321,0.5993865337670381,0.40322020060175395,0.659325187143742,MoneyMaker,panK4-1,FALSE,0 +m_48,967514 MM WT,1017361 Sl10g086080 #2,ns,0.47459379221862114,0.4481802983979717,0.12479274154841696,0.07836049139442657,fruit,fruit,0.7831897237546712,0.7831897237546712,0.5993865337670381,0.5265407897923983,0.659325187143742,MoneyMaker,log2-1,FALSE,0 +m_48,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.47459379221862114,0.37796913304156843,0.12479274154841696,0.05199718564546749,fruit,fruit,0.3188548249389801,0.7055235536530321,0.5993865337670381,0.42996631868703594,0.659325187143742,MoneyMaker,transp1-1,FALSE,0 +m_48,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3634079444979527,0.20284968340892393,0.05084042609815484,0.01896839344317693,leaf,leaf,0.10368880213296257,0.6221328127977754,0.41424837059610753,0.22181807685210087,0.45567320765571834,MoneyMaker,panK4-1,FALSE,0 +m_48,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3634079444979527,0.23118026350545037,0.05084042609815484,0.042837686404873516,leaf,leaf,0.17638088841325802,0.7055235536530321,0.41424837059610753,0.2740179499103239,0.45567320765571834,MoneyMaker,log2-1,FALSE,0 +m_48,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3634079444979527,0.20867849827625332,0.05084042609815484,0.058328678615717174,leaf,leaf,0.11613890947689423,0.6221328127977754,0.41424837059610753,0.2670071768919705,0.45567320765571834,MoneyMaker,transp1-1,FALSE,0 +m_49,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.040559600299515816,0.04777521112009374,0.002348318602640565,0.002119529321124153,fruit,fruit,0.2499586647330394,1,0.04290791890215638,0.04989474044121789,0.05998408669279958,MoneyMaker,panK4-1,FALSE,0 +m_49,967514 MM WT,1017361 Sl10g086080 #2,ns,0.040559600299515816,0.04682517334316884,0.002348318602640565,0.007705814559376228,fruit,fruit,0.31615782953536953,1,0.04290791890215638,0.05453098790254507,0.05998408669279958,MoneyMaker,log2-1,FALSE,0 +m_49,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.040559600299515816,0.03659449220223477,0.002348318602640565,0.005422694084710715,fruit,fruit,0.5232150770694359,1,0.04290791890215638,0.042017186286945486,0.05998408669279958,MoneyMaker,transp1-1,FALSE,0 +m_49,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.025203036201602767,0.0297558545511677,0.005253788952907098,0.004286990834458698,leaf,leaf,0.46415542984996416,1,0.030456825154509867,0.0340428453856264,0.03744712992418905,MoneyMaker,panK4-1,FALSE,0 +m_49,967514 MM WT,1017361 Sl10g086080 #2,ns,0.025203036201602767,0.023027577869650137,0.005253788952907098,0.0013690514235296328,leaf,leaf,0.7253518677048669,1,0.030456825154509867,0.024396629293179768,0.03744712992418905,MoneyMaker,log2-1,FALSE,0 +m_49,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.025203036201602767,0.012336548750153243,0.005253788952907098,0.0017828100643051499,leaf,leaf,0.046200347701782135,0.2772020862106928,0.030456825154509867,0.014119358814458392,0.03744712992418905,MoneyMaker,transp1-1,FALSE,0 +m_5,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.30862544241068235,0.23611465604985993,0.060377369554334905,0.04939526958181575,fruit,fruit,0.4011309833899017,1,0.3690028119650173,0.28550992563167565,0.405903093161519,MoneyMaker,panK4-1,FALSE,0 +m_5,967514 MM WT,1017361 Sl10g086080 #2,ns,0.30862544241068235,0.17157087190549752,0.060377369554334905,0.02431005060999898,fruit,fruit,0.11924690569671645,0.7154814341802986,0.3690028119650173,0.1958809225154965,0.405903093161519,MoneyMaker,log2-1,FALSE,0 +m_5,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.30862544241068235,0.26959275520746007,0.060377369554334905,0.02772316980756183,fruit,fruit,0.6495686394841949,1,0.3690028119650173,0.2973159250150219,0.405903093161519,MoneyMaker,transp1-1,FALSE,0 +m_5,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5282695977127362,0.41767637264667257,0.08718884088310687,0.03881287596346898,leaf,leaf,0.20470581001450908,1,0.615458438595843,0.45648924861014156,0.6770042824554274,MoneyMaker,panK4-1,FALSE,0 +m_5,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5282695977127362,0.45887345380690503,0.08718884088310687,0.06530253125111093,leaf,leaf,0.42137451566983275,1,0.615458438595843,0.524175985058016,0.6770042824554274,MoneyMaker,log2-1,FALSE,0 +m_5,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5282695977127362,0.47637765042373176,0.08718884088310687,0.08926036447064235,leaf,leaf,0.5464803394511946,1,0.615458438595843,0.5656380148943742,0.6770042824554274,MoneyMaker,transp1-1,FALSE,0 +m_50,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.11847581412457914,0.154040642310707,0.01610076854923119,0.03536468262473253,fruit,fruit,0.5273547064191972,1,0.13457658267381034,0.18940532493543952,0.3174888430905504,MoneyMaker,panK4-1,FALSE,0 +m_50,967514 MM WT,1017361 Sl10g086080 #2,ns,0.11847581412457914,0.24215924952963053,0.01610076854923119,0.04646697146177889,fruit,fruit,0.035321492378700005,0.21192895427220004,0.13457658267381034,0.28862622099140944,0.3174888430905504,MoneyMaker,log2-1,FALSE,0 +m_50,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.11847581412457914,0.10199222344962551,0.01610076854923119,0.007668338726132748,fruit,fruit,0.7688208816422152,1,0.13457658267381034,0.10966056217575826,0.3174888430905504,MoneyMaker,transp1-1,FALSE,0 +m_50,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.4173607708929512,0.3295172090346818,0.05679418633405643,0.049768445903684434,leaf,leaf,0.1262429546764741,0.5049718187058964,0.4741549572270076,0.37928565493836625,0.558801143529241,MoneyMaker,panK4-1,FALSE,0 +m_50,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4173607708929512,0.31522736208072183,0.05679418633405643,0.03099287612999416,leaf,leaf,0.07788374966390635,0.3894187483195317,0.4741549572270076,0.346220238210716,0.558801143529241,MoneyMaker,log2-1,FALSE,0 +m_50,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4173607708929512,0.4643187448404458,0.05679418633405643,0.04368229473159147,leaf,leaf,0.40544762886866814,1,0.4741549572270076,0.5080010395720372,0.558801143529241,MoneyMaker,transp1-1,FALSE,0 +m_51,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.10998312469896565,0.06774116365061521,0.016699268538402073,0.006365132418590873,fruit,fruit,0.011357075907347617,0.0681424554440857,0.1266823932373677,0.07410629606920607,0.15452886234729798,MoneyMaker,panK4-1,FALSE,0 +m_51,967514 MM WT,1017361 Sl10g086080 #2,ns,0.10998312469896565,0.08460360176947065,0.016699268538402073,0.015391375001424673,fruit,fruit,0.11250984895558404,0.33752954686675213,0.1266823932373677,0.09999497677089533,0.15452886234729798,MoneyMaker,log2-1,FALSE,0 +m_51,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.10998312469896565,0.13022395215852256,0.016699268538402073,0.010256831793566507,fruit,fruit,0.20132153102801906,0.4026430620560381,0.1266823932373677,0.14048078395208907,0.15452886234729798,MoneyMaker,transp1-1,FALSE,0 +m_51,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.043688144510465196,0.07800443098629575,0.008724240530499831,0.01208526984568246,leaf,leaf,0.03554975814422659,0.17774879072113295,0.05241238504096503,0.09008970083197822,0.09909867091517605,MoneyMaker,panK4-1,FALSE,0 +m_51,967514 MM WT,1017361 Sl10g086080 #2,ns,0.043688144510465196,0.028065286161360913,0.008724240530499831,0.007622249711881727,leaf,leaf,0.3206574150228993,0.4026430620560381,0.05241238504096503,0.03568753587324264,0.09909867091517605,MoneyMaker,log2-1,FALSE,0 +m_51,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.043688144510465196,0.013985278543609963,0.008724240530499831,0.0027607443009383783,leaf,leaf,0.06576542936060133,0.2630617174424053,0.05241238504096503,0.01674602284454834,0.09909867091517605,MoneyMaker,transp1-1,FALSE,0 +m_52,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.023135576584632295,0.049006972155054326,0.004800602790625344,0.00869310614029258,fruit,fruit,0.09734795600895847,0.29204386802687543,0.02793617937525764,0.05770007829534691,0.10631855254873353,MoneyMaker,panK4-1,FALSE,0 +m_52,967514 MM WT,1017361 Sl10g086080 #2,*,0.023135576584632295,0.08321779360713351,0.004800602790625344,0.01343543598262424,fruit,fruit,5.183235985542668e-4,0.002779283267127721,0.02793617937525764,0.09665322958975775,0.10631855254873353,MoneyMaker,log2-1,FALSE,0 +m_52,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.023135576584632295,0.07913500675520628,0.004800602790625344,0.012446950943773323,fruit,fruit,0.0010283234510473358,0.004113293804189343,0.02793617937525764,0.0915819576989796,0.10631855254873353,MoneyMaker,transp1-1,FALSE,0 +m_52,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.0566546833298737,0.07186797647879503,0.0036427282792288445,0.008950142371692948,leaf,leaf,0.32047369422305655,0.6013136247949575,0.06029741160910255,0.08081811885048798,0.14988295735659699,MoneyMaker,panK4-1,FALSE,0 +m_52,967514 MM WT,1017361 Sl10g086080 #2,*,0.0566546833298737,0.11740354361793595,0.0036427282792288445,0.018853690342606755,leaf,leaf,4.632138778546202e-4,0.002779283267127721,0.06029741160910255,0.1362572339605427,0.14988295735659699,MoneyMaker,log2-1,FALSE,0 +m_52,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.0566546833298737,0.04079100810058443,0.0036427282792288445,0.0040807639339724535,leaf,leaf,0.30065681239747877,0.6013136247949575,0.06029741160910255,0.04487177203455689,0.14988295735659699,MoneyMaker,transp1-1,FALSE,0 +m_53,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2664320036451143,0.1106283001304504,0.039341259586503245,0.021717512079397365,fruit,fruit,0.009248212859700528,0.05548927715820317,0.3057732632316176,0.13234581220984776,0.33635058955477937,MoneyMaker,panK4-1,FALSE,0 +m_53,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2664320036451143,0.18561140776009127,0.039341259586503245,0.028774455239449513,fruit,fruit,0.1550103516806745,0.4650310550420235,0.3057732632316176,0.2143858629995408,0.33635058955477937,MoneyMaker,log2-1,FALSE,0 +m_53,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2664320036451143,0.20801208630585233,0.039341259586503245,0.047769630278026054,fruit,fruit,0.2991031549740344,0.4662196149846458,0.3057732632316176,0.2557817165838784,0.33635058955477937,MoneyMaker,transp1-1,FALSE,0 +m_53,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3188338841132848,0.2123653280739532,0.04293623940093923,0.03750218469713823,leaf,leaf,0.06495748963431783,0.2598299585372713,0.361770123514224,0.24986751277109143,0.39794713586564645,MoneyMaker,panK4-1,FALSE,0 +m_53,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3188338841132848,0.1901273063418087,0.04293623940093923,0.029084111637973302,leaf,leaf,0.028037229937183578,0.1401861496859179,0.361770123514224,0.219211417979782,0.39794713586564645,MoneyMaker,log2-1,FALSE,0 +m_53,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3188338841132848,0.25150121583955654,0.04293623940093923,0.05379815743994862,leaf,leaf,0.2331098074923229,0.4662196149846458,0.361770123514224,0.3052993732795052,0.39794713586564645,MoneyMaker,transp1-1,FALSE,0 +m_54,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2506373824992118,0.09361113660945841,0.03374452968015762,0.019151680753150258,fruit,fruit,0.04941153727081375,0.24705768635406877,0.2843819121793694,0.11276281736260867,0.3596726209558821,MoneyMaker,panK4-1,FALSE,0 +m_54,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2506373824992118,0.28178032073719456,0.03374452968015762,0.045194789222698185,fruit,fruit,0.6850974104805646,1,0.2843819121793694,0.32697510995989276,0.3596726209558821,MoneyMaker,log2-1,FALSE,0 +m_54,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2506373824992118,0.2176824271590084,0.03374452968015762,0.027489175912748774,fruit,fruit,0.6679069163851288,1,0.2843819121793694,0.24517160307175717,0.3596726209558821,MoneyMaker,transp1-1,FALSE,0 +m_54,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.48647220848946504,0.3539700370050672,0.06574861542960656,0.05395438106782738,leaf,leaf,0.09352416232230745,0.3740966492892298,0.5522208239190716,0.4079244180728946,0.6737884812221272,MoneyMaker,panK4-1,FALSE,0 +m_54,967514 MM WT,1017361 Sl10g086080 #2,ns,0.48647220848946504,0.29879053774521136,0.06574861542960656,0.07017165246085831,leaf,leaf,0.020835445100781554,0.12501267060468932,0.5522208239190716,0.3689621902060697,0.6737884812221272,MoneyMaker,log2-1,FALSE,0 +m_54,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.48647220848946504,0.5315205162121333,0.06574861542960656,0.08101446671707323,leaf,leaf,0.5582306351069152,1,0.5522208239190716,0.6125349829292065,0.6737884812221272,MoneyMaker,transp1-1,FALSE,0 +m_55,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.39830729977519136,0.24905458721273915,0.045891077110397804,0.03493347883677314,fruit,fruit,0.030773305706036,0.15386652853018,0.44419837688558916,0.2839880660495123,0.5520056613416339,MoneyMaker,panK4-1,FALSE,0 +m_55,967514 MM WT,1017361 Sl10g086080 #2,ns,0.39830729977519136,0.2408807199764703,0.045891077110397804,0.06511641375435995,fruit,fruit,0.023418424310992246,0.14051054586595346,0.44419837688558916,0.30599713373083026,0.5520056613416339,MoneyMaker,log2-1,FALSE,0 +m_55,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.39830729977519136,0.4418338623894704,0.045891077110397804,0.05998946610292398,fruit,fruit,0.5096833691781564,1,0.44419837688558916,0.5018233284923944,0.5520056613416339,MoneyMaker,transp1-1,FALSE,0 +m_55,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.21403489687260863,0.25128725383811806,0.03235353558130511,0.05343799930038551,leaf,leaf,0.5720849471821754,1,0.24638843245391373,0.30472525313850357,0.33519777845235393,MoneyMaker,panK4-1,FALSE,0 +m_55,967514 MM WT,1017361 Sl10g086080 #2,ns,0.21403489687260863,0.1390945659705468,0.03235353558130511,0.021053630682833446,leaf,leaf,0.26051959571139927,1,0.24638843245391373,0.16014819665338026,0.33519777845235393,MoneyMaker,log2-1,FALSE,0 +m_55,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.21403489687260863,0.2339877755317798,0.03235353558130511,0.03749121767892406,leaf,leaf,0.7616280382522448,1,0.24638843245391373,0.27147899321070385,0.33519777845235393,MoneyMaker,transp1-1,FALSE,0 +m_56,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.23443175897843804,0.2982199623419206,0.016927089524616492,0.06625649275995267,fruit,fruit,0.29646257820331434,0.7316419874860152,0.2513588485030545,0.36447645510187326,0.40092410061206063,MoneyMaker,panK4-1,FALSE,0 +m_56,967514 MM WT,1017361 Sl10g086080 #2,ns,0.23443175897843804,0.23567063677547692,0.016927089524616492,0.023407153276139455,fruit,fruit,0.9836336063402338,0.9836336063402338,0.2513588485030545,0.25907779005161635,0.40092410061206063,MoneyMaker,log2-1,FALSE,0 +m_56,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.23443175897843804,0.16302872617984673,0.016927089524616492,0.014292531268285804,fruit,fruit,0.2438806624953384,0.7316419874860152,0.2513588485030545,0.17732125744813254,0.40092410061206063,MoneyMaker,transp1-1,FALSE,0 +m_56,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.4001838301960352,0.2308793354223222,0.039079257764070584,0.031295953430427986,leaf,leaf,0.00920054767943841,0.04600273839719205,0.43926308796010577,0.2621752888527502,0.4831893967561164,MoneyMaker,panK4-1,FALSE,0 +m_56,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4001838301960352,0.2583141889364348,0.039079257764070584,0.07310004966016315,leaf,leaf,0.025958176098466186,0.10383270439386474,0.43926308796010577,0.33141423859659797,0.4831893967561164,MoneyMaker,log2-1,FALSE,0 +m_56,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.4001838301960352,0.1945969876878668,0.039079257764070584,0.031771914366898794,leaf,leaf,0.002137540786523815,0.01282524471914289,0.43926308796010577,0.2263689020547656,0.4831893967561164,MoneyMaker,transp1-1,FALSE,0 +m_57,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.40724476090884076,0.3161331602161225,0.08432525251825936,0.07583328531215829,fruit,fruit,0.3100291551023129,1,0.4915700134271001,0.39196644552828075,0.5407270147698101,MoneyMaker,panK4-1,FALSE,0 +m_57,967514 MM WT,1017361 Sl10g086080 #2,ns,0.40724476090884076,0.3074355858284116,0.08432525251825936,0.05581170251963955,fruit,fruit,0.267134575272963,1,0.4915700134271001,0.36324728834805114,0.5407270147698101,MoneyMaker,log2-1,FALSE,0 +m_57,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.40724476090884076,0.29237714819909305,0.08432525251825936,0.07382744262823975,fruit,fruit,0.20343051574934934,1,0.4915700134271001,0.3662045908273328,0.5407270147698101,MoneyMaker,transp1-1,FALSE,0 +m_57,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.19824557216643623,0.33507259265121436,0.044844766115421965,0.06690812261465429,leaf,leaf,0.13245204452392503,0.7947122671435503,0.2430903382818582,0.40198071526586865,0.44217878679245554,MoneyMaker,panK4-1,FALSE,0 +m_57,967514 MM WT,1017361 Sl10g086080 #2,ns,0.19824557216643623,0.2168106557439167,0.044844766115421965,0.043441536130308295,leaf,leaf,0.8344215435668336,1,0.2430903382818582,0.260252191874225,0.44217878679245554,MoneyMaker,log2-1,FALSE,0 +m_57,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.19824557216643623,0.16552636009187016,0.044844766115421965,0.03272154030581605,leaf,leaf,0.7128398538613314,1,0.2430903382818582,0.19824790039768622,0.44217878679245554,MoneyMaker,transp1-1,FALSE,0 +m_58,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.6093561072375596,0.28437135092608157,0.10030531968731639,0.06539106614314173,fruit,fruit,0.002441537174402915,0.007324611523208745,0.709661426924876,0.3497624170692233,0.7806275696173637,MoneyMaker,panK4-1,FALSE,0 +m_58,967514 MM WT,1017361 Sl10g086080 #2,*,0.6093561072375596,0.11706418163293107,0.10030531968731639,0.01718111385293733,fruit,fruit,3.0003685424760925e-5,1.8002211254856555e-4,0.709661426924876,0.1342452954858684,0.7806275696173637,MoneyMaker,log2-1,FALSE,0 +m_58,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.6093561072375596,0.24404056298668805,0.10030531968731639,0.05851714852693506,fruit,fruit,8.591486587811204e-4,0.0034365946351244815,0.709661426924876,0.3025577115136231,0.7806275696173637,MoneyMaker,transp1-1,FALSE,0 +m_58,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.8344788581083926,0.5197785282136609,0.10669925188460916,0.05387685992542565,leaf,leaf,0.0031731325187216606,0.007324611523208745,0.9411781099930018,0.5736553881390866,1.035295920992302,MoneyMaker,panK4-1,FALSE,0 +m_58,967514 MM WT,1017361 Sl10g086080 #2,*,0.8344788581083926,0.44595978117100854,0.10669925188460916,0.040137341999426784,leaf,leaf,4.6707575986785067e-4,0.0023353787993392536,0.9411781099930018,0.4860971231704353,1.035295920992302,MoneyMaker,log2-1,FALSE,0 +m_58,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.8344788581083926,0.5622008330743412,0.10669925188460916,0.05383345231974569,leaf,leaf,0.009117205067106136,0.009117205067106136,0.9411781099930018,0.6160342853940869,1.035295920992302,MoneyMaker,transp1-1,FALSE,0 +m_59,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5724501959945484,0.5742881953210113,0.09297519690988434,0.07026027694747715,fruit,fruit,0.9852941076610485,1,0.6654253929044327,0.6445484722684884,0.7862854790259303,MoneyMaker,panK4-1,FALSE,0 +m_59,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5724501959945484,0.6192594835868166,0.09297519690988434,0.0955454973458473,fruit,fruit,0.6395471787853816,1,0.6654253929044327,0.7148049809326639,0.7862854790259303,MoneyMaker,log2-1,FALSE,0 +m_59,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5724501959945484,0.48895189911080045,0.09297519690988434,0.09399867052930398,fruit,fruit,0.40584302188505994,1,0.6654253929044327,0.5829505696401044,0.7862854790259303,MoneyMaker,transp1-1,FALSE,0 +m_59,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3154112617060255,0.11803376584538111,0.06053686659051254,0.01667524224566684,leaf,leaf,0.056928011511954174,0.34156806907172504,0.37594812829653806,0.13470900809104797,0.4135429411261919,MoneyMaker,panK4-1,FALSE,0 +m_59,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3154112617060255,0.2190554628664354,0.06053686659051254,0.018447536746676076,leaf,leaf,0.3386008767847327,1,0.37594812829653806,0.23750299961311147,0.4135429411261919,MoneyMaker,log2-1,FALSE,0 +m_59,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3154112617060255,0.2694921555282011,0.06053686659051254,0.05590340688235268,leaf,leaf,0.645899730174125,1,0.37594812829653806,0.3253955624105538,0.4135429411261919,MoneyMaker,transp1-1,FALSE,0 +m_6,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5106134245640704,0.5261117740827783,0.07674859681875534,0.06298989473222381,fruit,fruit,0.9127130484229331,1,0.5873620213828258,0.5891016688150021,1.1579893543492783,MoneyMaker,panK4-1,FALSE,0 +m_6,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5106134245640704,0.8257553099397625,0.07674859681875534,0.22696228492321754,fruit,fruit,0.03370400164246136,0.20222400985476816,0.5873620213828258,1.0527175948629801,1.1579893543492783,MoneyMaker,log2-1,FALSE,0 +m_6,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5106134245640704,0.23443721176307591,0.07674859681875534,0.02581944636291661,fruit,fruit,0.059993903853492674,0.29996951926746335,0.5873620213828258,0.2602566581259925,1.1579893543492783,MoneyMaker,transp1-1,FALSE,0 +m_6,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.44643537952994683,0.39571920974495717,0.07546783378976846,0.05875684483769873,leaf,leaf,0.7201455086185451,1,0.5219032133197152,0.4544760545826559,0.5740935346516868,MoneyMaker,panK4-1,FALSE,0 +m_6,967514 MM WT,1017361 Sl10g086080 #2,ns,0.44643537952994683,0.43730793259773143,0.07546783378976846,0.07153599964149482,leaf,leaf,0.9485225846996486,1,0.5219032133197152,0.5088439322392262,0.5740935346516868,MoneyMaker,log2-1,FALSE,0 +m_6,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.44643537952994683,0.2210138408898492,0.07546783378976846,0.04461433021180785,leaf,leaf,0.12019751070739286,0.48079004282957144,0.5219032133197152,0.26562817110165704,0.5740935346516868,MoneyMaker,transp1-1,FALSE,0 +m_60,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.525399728766296,0.4198144326112145,0.04756373681007217,0.09529420501709136,fruit,fruit,0.19125734891474616,0.3825146978294923,0.5729634655763682,0.5151086376283058,0.6411664036805328,MoneyMaker,panK4-1,FALSE,0 +m_60,967514 MM WT,1017361 Sl10g086080 #2,ns,0.525399728766296,0.5347825154619268,0.04756373681007217,0.04809603333855749,fruit,fruit,0.9058690104785125,0.9058690104785125,0.5729634655763682,0.5828785488004843,0.6411664036805328,MoneyMaker,log2-1,FALSE,0 +m_60,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.525399728766296,0.21654460284055121,0.04756373681007217,0.057693750642714425,fruit,fruit,6.227302744237838e-4,0.0037363816465427026,0.5729634655763682,0.27423835348326564,0.6411664036805328,MoneyMaker,transp1-1,FALSE,0 +m_60,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.25330407937620636,0.4880669726779439,0.033433496024701276,0.04729673428529447,leaf,leaf,0.006353090604739685,0.02541236241895874,0.2867375754009076,0.5353637069632384,0.6614591405807472,MoneyMaker,panK4-1,FALSE,5.208333333333334 +m_60,967514 MM WT,1017361 Sl10g086080 #2,ns,0.25330407937620636,0.39204613285878565,0.033433496024701276,0.03961614598004397,leaf,leaf,0.08992309080430635,0.26976927241291904,0.2867375754009076,0.4316622788388296,0.6614591405807472,MoneyMaker,log2-1,FALSE,5.208333333333334 +m_60,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.25330407937620636,0.5489069980825458,0.033433496024701276,0.052419493354497027,leaf,leaf,9.520160368514922e-4,0.004760080184257461,0.2867375754009076,0.6013264914370429,0.6614591405807472,MoneyMaker,transp1-1,FALSE,5.208333333333334 +m_61,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.21822575208375328,0.1762309052362299,0.049334720949353275,0.025333607045472724,fruit,fruit,0.32897750288109406,1,0.26756047303310654,0.2015645122817026,0.33392050827447256,MoneyMaker,panK4-1,FALSE,0 +m_61,967514 MM WT,1017361 Sl10g086080 #2,ns,0.21822575208375328,0.28443315093083277,0.049334720949353275,0.019130947500505896,fruit,fruit,0.12928657801544607,0.7757194680926764,0.26756047303310654,0.3035640984313387,0.33392050827447256,MoneyMaker,log2-1,FALSE,0 +m_61,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.21822575208375328,0.2524089998582854,0.049334720949353275,0.03867900535738105,fruit,fruit,0.4252855779964104,1,0.26756047303310654,0.29108800521566647,0.33392050827447256,MoneyMaker,transp1-1,FALSE,0 +m_61,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.12070638484060096,0.16137400411877828,0.020971353843706096,0.02849640871225542,leaf,leaf,0.3441941532664208,1,0.14167773868430705,0.1898704128310337,0.2088574541141371,MoneyMaker,panK4-1,FALSE,0 +m_61,967514 MM WT,1017361 Sl10g086080 #2,ns,0.12070638484060096,0.09600340066561258,0.020971353843706096,0.02313929136559959,leaf,leaf,0.5632511036729263,1,0.14167773868430705,0.11914269203121217,0.2088574541141371,MoneyMaker,log2-1,FALSE,0 +m_61,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.12070638484060096,0.1358554457296615,0.020971353843706096,0.019486704847030273,leaf,leaf,0.7224004824354602,1,0.14167773868430705,0.15534215057669176,0.2088574541141371,MoneyMaker,transp1-1,FALSE,0 +m_62,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.593176121742765,0.8965139828522632,0.08051802871507051,0.11425965535908107,fruit,fruit,0.03160915661492618,0.1524584827340384,0.6736941504578355,1.0107736382113444,1.1896006927044047,MoneyMaker,panK4-1,FALSE,0 +m_62,967514 MM WT,1017361 Sl10g086080 #2,ns,0.593176121742765,0.8987422236872958,0.08051802871507051,0.16766028497386534,fruit,fruit,0.030491696546807678,0.1524584827340384,0.6736941504578355,1.0664025086611613,1.1896006927044047,MoneyMaker,log2-1,FALSE,0 +m_62,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.593176121742765,0.9414104201563096,0.08051802871507051,0.14004475502951283,fruit,fruit,0.014994558670132616,0.0899673520207957,0.6736941504578355,1.0814551751858223,1.1896006927044047,MoneyMaker,transp1-1,FALSE,0 +m_62,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.07755451827915072,0.13774586027857771,0.013774314370390785,0.024026332854960294,leaf,leaf,0.6546641968326081,1,0.0913288326495415,0.16177219313353802,0.22627203543172703,MoneyMaker,panK4-1,FALSE,0 +m_62,967514 MM WT,1017361 Sl10g086080 #2,ns,0.07755451827915072,0.15528950610360748,0.013774314370390785,0.05041234428887162,leaf,leaf,0.5640417238210702,1,0.0913288326495415,0.2057018503924791,0.22627203543172703,MoneyMaker,log2-1,FALSE,0 +m_62,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.07755451827915072,0.13896145348733213,0.013774314370390785,0.008471778580657285,leaf,leaf,0.6481843404278066,1,0.0913288326495415,0.14743323206798942,0.22627203543172703,MoneyMaker,transp1-1,FALSE,0 +m_63,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6516275647642971,0.3217680352451995,0.10210351015458252,0.035916718529194626,fruit,fruit,0.07077210678186764,0.4246326406912059,0.7537310749188796,0.3576847537743941,0.9495738782998272,MoneyMaker,panK4-1,FALSE,0 +m_63,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6516275647642971,0.7546772396509759,0.10210351015458252,0.1085717406215942,fruit,fruit,0.560229990592847,1,0.7537310749188796,0.8632489802725701,0.9495738782998272,MoneyMaker,log2-1,FALSE,0 +m_63,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6516275647642971,0.6589588671966862,0.10210351015458252,0.1947483127808918,fruit,fruit,0.9668257674288316,1,0.7537310749188796,0.853707179977578,0.9495738782998272,MoneyMaker,transp1-1,FALSE,0 +m_63,967514 MM WT,1015695 Sl10g074590 #30.1,ns,1.0391508603388002,0.859262347609179,0.11810258901512981,0.11390844474190033,leaf,leaf,0.3127319767797318,1,1.15725344935393,0.9731707923510793,1.272978794289323,MoneyMaker,panK4-1,FALSE,0 +m_63,967514 MM WT,1017361 Sl10g086080 #2,ns,1.0391508603388002,0.8211033917604329,0.11810258901512981,0.14208258170647717,leaf,leaf,0.22337579156985027,1,1.15725344935393,0.96318597346691,1.272978794289323,MoneyMaker,log2-1,FALSE,0 +m_63,967514 MM WT,1017363 Sl10g007190 #19.2,ns,1.0391508603388002,0.9528823387696523,0.11810258901512981,0.1148343992447094,leaf,leaf,0.62543235254058,1,1.15725344935393,1.0677167380143617,1.272978794289323,MoneyMaker,transp1-1,FALSE,0 +m_64,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.44703545523387667,0.44785362476860596,0.04951510563816074,0.046232672471016686,fruit,fruit,0.992580299565917,1,0.4965505608720374,0.49408629723962266,0.7603890833889636,MoneyMaker,panK4-1,FALSE,0 +m_64,967514 MM WT,1017361 Sl10g086080 #2,ns,0.44703545523387667,0.5793333065323844,0.04951510563816074,0.11192949654849162,fruit,fruit,0.14171578155129855,0.8502946893077913,0.4965505608720374,0.691262803080876,0.7603890833889636,MoneyMaker,log2-1,FALSE,0 +m_64,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.44703545523387667,0.3851382175517105,0.04951510563816074,0.1073588844386613,fruit,fruit,0.4840033152506986,1,0.4965505608720374,0.49249710199037183,0.7603890833889636,MoneyMaker,transp1-1,FALSE,0 +m_64,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.11009680418147079,0.20836418393546613,0.01873554162679937,0.013097219345959251,leaf,leaf,0.270220607118231,1,0.12883234580827016,0.22146140328142538,0.24360754360956793,MoneyMaker,panK4-1,FALSE,0 +m_64,967514 MM WT,1017361 Sl10g086080 #2,ns,0.11009680418147079,0.12352432000833641,0.01873554162679937,0.016640765209524858,leaf,leaf,0.8787293423873622,1,0.12883234580827016,0.14016508521786125,0.24360754360956793,MoneyMaker,log2-1,FALSE,0 +m_64,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.11009680418147079,0.19046658708742759,0.01873554162679937,0.0296952333170852,leaf,leaf,0.365168770220784,1,0.12883234580827016,0.2201618204045128,0.24360754360956793,MoneyMaker,transp1-1,FALSE,0 +m_65,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.1435184763068618,0.2521601203773707,0.02156902160924109,0.03349822152098324,fruit,fruit,0.003610292968462212,0.01805146484231106,0.1650874979161029,0.28565834189835393,0.3665295678720502,MoneyMaker,panK4-1,FALSE,0 +m_65,967514 MM WT,1017361 Sl10g086080 #2,*,0.1435184763068618,0.305903306136869,0.02156902160924109,0.0273053919286312,fruit,fruit,6.544540473492024e-5,3.9267242840952145e-4,0.1650874979161029,0.3332086980655002,0.3665295678720502,MoneyMaker,log2-1,FALSE,0 +m_65,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.1435184763068618,0.19322776630166297,0.02156902160924109,0.03235546183933218,fruit,fruit,0.15298508415793616,0.22081630230630545,0.1650874979161029,0.22558322814099516,0.3665295678720502,MoneyMaker,transp1-1,FALSE,0 +m_65,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.049551299819764263,0.10538329195615247,0.005635485697650852,0.016076509116586122,leaf,leaf,0.11040815115315272,0.22081630230630545,0.05518678551741511,0.12145980107273859,0.18365530184255607,MoneyMaker,panK4-1,FALSE,0 +m_65,967514 MM WT,1017361 Sl10g086080 #2,*,0.049551299819764263,0.15424830521688726,0.005635485697650852,0.0052300564836237845,leaf,leaf,0.004789831056751797,0.01915932422700719,0.05518678551741511,0.15947836170051105,0.18365530184255607,MoneyMaker,log2-1,FALSE,0 +m_65,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.049551299819764263,0.13796825554834735,0.005635485697650852,0.028991109763067232,leaf,leaf,0.01483786487215539,0.04451359461646617,0.05518678551741511,0.1669593653114146,0.18365530184255607,MoneyMaker,transp1-1,FALSE,0 +m_66,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.33382388510065614,0.22450723829354718,0.05420526842983809,0.02100836335305876,fruit,fruit,0.06861008137357703,0.27444032549430813,0.3880291535304942,0.24551560164660594,0.6061198614283252,MoneyMaker,panK4-1,FALSE,0 +m_66,967514 MM WT,1017361 Sl10g086080 #2,ns,0.33382388510065614,0.4658904232000851,0.05420526842983809,0.08512763264384687,fruit,fruit,0.030226571046895537,0.18135942628137322,0.3880291535304942,0.5510180558439319,0.6061198614283252,MoneyMaker,log2-1,FALSE,0 +m_66,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.33382388510065614,0.21219728782580824,0.05420526842983809,0.038940216811142014,fruit,fruit,0.04441643738662828,0.2220821869331414,0.3880291535304942,0.2511375046369503,0.6061198614283252,MoneyMaker,transp1-1,FALSE,0 +m_66,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.15590738985302932,0.26135268945626355,0.020383113788505394,0.014576409893238182,leaf,leaf,0.07830440151718669,0.27444032549430813,0.1762905036415347,0.2759290993495017,0.3035220092844519,MoneyMaker,panK4-1,FALSE,0 +m_66,967514 MM WT,1017361 Sl10g086080 #2,ns,0.15590738985302932,0.11397845738843299,0.020383113788505394,0.009461584362255804,leaf,leaf,0.47167820973687324,0.9433564194737465,0.1762905036415347,0.12344004175068879,0.3035220092844519,MoneyMaker,log2-1,FALSE,0 +m_66,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.15590738985302932,0.17043900244860577,0.020383113788505394,0.017004270254403347,leaf,leaf,0.8020784078516034,0.9433564194737465,0.1762905036415347,0.18744327270300912,0.3035220092844519,MoneyMaker,transp1-1,FALSE,0 +m_67,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.36943137511514357,0.32253876799652614,0.08134211598232942,0.05821264234513752,fruit,fruit,0.7116535606578981,1,0.450773491097473,0.38075141034166365,0.5177867020144457,MoneyMaker,panK4-1,FALSE,0 +m_67,967514 MM WT,1017361 Sl10g086080 #2,ns,0.36943137511514357,0.417021443492897,0.08134211598232942,0.053693740156598994,fruit,fruit,0.7075728674766946,1,0.450773491097473,0.470715183649496,0.5177867020144457,MoneyMaker,log2-1,FALSE,0 +m_67,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.36943137511514357,0.33894624102076465,0.08134211598232942,0.06490015608473816,fruit,fruit,0.8099400616716101,1,0.450773491097473,0.4038463971055028,0.5177867020144457,MoneyMaker,transp1-1,FALSE,0 +m_67,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.386157389734275,0.6559941929841226,0.026677859245957964,0.13952465901560931,leaf,leaf,0.04163488004051843,0.20817440020259215,0.41283524898023294,0.7955188519997319,0.9397609321822438,MoneyMaker,panK4-1,FALSE,0 +m_67,967514 MM WT,1017361 Sl10g086080 #2,ns,0.386157389734275,0.7026275337514513,0.026677859245957964,0.15170058641422485,leaf,leaf,0.01861400544317529,0.11168403265905175,0.41283524898023294,0.854328120165676,0.9397609321822438,MoneyMaker,log2-1,FALSE,0 +m_67,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.386157389734275,0.41372969006354177,0.026677859245957964,0.05073305773500361,leaf,leaf,0.8277815568654452,1,0.41283524898023294,0.46446274779854535,0.9397609321822438,MoneyMaker,transp1-1,FALSE,0 +m_68,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.1594118584712459,0.09423939729137432,0.010882129749404787,0.013431262418679873,fruit,fruit,0.06344172501787428,0.06344172501787428,0.17029398822065067,0.10767065971005418,0.18732338704271576,MoneyMaker,panK4-1,FALSE,0 +m_68,967514 MM WT,1017361 Sl10g086080 #2,ns,0.1594118584712459,0.0819325167340326,0.010882129749404787,0.016001788542156226,fruit,fruit,0.02957082943482147,0.05914165886964294,0.17029398822065067,0.09793430527618882,0.18732338704271576,MoneyMaker,log2-1,FALSE,0 +m_68,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.1594118584712459,0.054074934153901535,0.010882129749404787,0.005682777929743051,fruit,fruit,0.004381505734304113,0.01314451720291234,0.17029398822065067,0.05975771208364459,0.18732338704271576,MoneyMaker,transp1-1,FALSE,0 +m_68,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.44969935139010103,0.208422724325727,0.03421060876411794,0.013696532320084078,leaf,leaf,1.911961543861452e-7,1.1471769263168714e-6,0.48390996015421894,0.2221192566458111,0.5323009561696409,MoneyMaker,panK4-1,FALSE,0 +m_68,967514 MM WT,1017361 Sl10g086080 #2,*,0.44969935139010103,0.22908234232515212,0.03421060876411794,0.034868594018836796,leaf,leaf,8.179739640556453e-7,4.089869820278226e-6,0.48390996015421894,0.2639509363439889,0.5323009561696409,MoneyMaker,log2-1,FALSE,0 +m_68,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.44969935139010103,0.2766398556548896,0.03421060876411794,0.03640057235442744,leaf,leaf,2.7193938387333077e-5,1.0877575354933231e-4,0.48390996015421894,0.31304042800931703,0.5323009561696409,MoneyMaker,transp1-1,FALSE,0 +m_69,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.21365013024063353,0.18281028738090627,0.03300048650062573,0.018618806891712945,fruit,fruit,0.7633956589226254,0.9493843696111641,0.24665061674125927,0.2014290942726192,0.7759917890088545,MoneyMaker,panK4-1,FALSE,5.208333333333334 +m_69,967514 MM WT,1017361 Sl10g086080 #2,*,0.21365013024063353,0.569112611933187,0.03300048650062573,0.10452494133631061,fruit,fruit,0.0018003436572559053,0.009001718286279527,0.24665061674125927,0.6736375532694976,0.7759917890088545,MoneyMaker,log2-1,FALSE,5.208333333333334 +m_69,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.21365013024063353,0.5928501182837854,0.03300048650062573,0.11259696263335499,fruit,fruit,0.0010043272395938285,0.006025963437562971,0.24665061674125927,0.7054470809171404,0.7759917890088545,MoneyMaker,transp1-1,FALSE,5.208333333333334 +m_69,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3797583818834176,0.30502377372316214,0.05518941733376855,0.05489501311650043,leaf,leaf,0.46777605580169446,0.9493843696111641,0.4349477992171861,0.35991878683966255,0.6393404685197189,MoneyMaker,panK4-1,FALSE,0 +m_69,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3797583818834176,0.19858463162039747,0.05518941733376855,0.019241316775817523,leaf,leaf,0.08630302012020477,0.3452120804808191,0.4349477992171861,0.217825948396215,0.6393404685197189,MoneyMaker,log2-1,FALSE,0 +m_69,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3797583818834176,0.4833894145181525,0.05518941733376855,0.09782919322704649,leaf,leaf,0.3164614565370547,0.9493843696111641,0.4349477992171861,0.581218607745199,0.6393404685197189,MoneyMaker,transp1-1,FALSE,0 +m_7,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.46813360288427225,0.40911460260144367,0.0648682420402719,0.04919516237394486,fruit,fruit,0.6736584152978267,1,0.5330018449245442,0.45830976497538856,0.8711695231110532,MoneyMaker,panK4-1,FALSE,0 +m_7,967514 MM WT,1017361 Sl10g086080 #2,ns,0.46813360288427225,0.5065515535318751,0.0648682420402719,0.08873007798849349,fruit,fruit,0.7837544433254807,1,0.5330018449245442,0.5952816315203686,0.8711695231110532,MoneyMaker,log2-1,FALSE,0 +m_7,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.46813360288427225,0.6435605185204398,0.0648682420402719,0.14841177521688115,fruit,fruit,0.217224799562315,0.86889919824926,0.5330018449245442,0.791972293737321,0.8711695231110532,MoneyMaker,transp1-1,FALSE,0 +m_7,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.7109101325061914,0.3826061977611027,0.1320675471264305,0.08574355247489955,leaf,leaf,0.02607792057929511,0.13038960289647555,0.8429776796326219,0.4683497502360023,0.9272754475958842,MoneyMaker,panK4-1,FALSE,0 +m_7,967514 MM WT,1017361 Sl10g086080 #2,ns,0.7109101325061914,0.35371771932346674,0.1320675471264305,0.041032813530712996,leaf,leaf,0.016418903475947856,0.09851342085568714,0.8429776796326219,0.3947505328541797,0.9272754475958842,MoneyMaker,log2-1,FALSE,0 +m_7,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.7109101325061914,0.5550742661150568,0.1320675471264305,0.11682510190851189,leaf,leaf,0.2714122164510606,0.86889919824926,0.8429776796326219,0.6718993680235688,0.9272754475958842,MoneyMaker,transp1-1,FALSE,0 +m_70,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.2832076436294652,0.5539726445733993,0.037692142215127254,0.07611566495602172,fruit,fruit,0.0045336457898182605,0.027201874738909563,0.32089978584459244,0.6300883095294211,0.6930971404823633,MoneyMaker,panK4-1,FALSE,0 +m_70,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2832076436294652,0.42160762865241364,0.037692142215127254,0.06547934716670195,fruit,fruit,0.12256249322566819,0.5648088519961924,0.32089978584459244,0.4870869758191156,0.6930971404823633,MoneyMaker,log2-1,FALSE,0 +m_70,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2832076436294652,0.25457507224426923,0.037692142215127254,0.050188510518853494,fruit,fruit,0.7434252879307288,0.9880144136272728,0.32089978584459244,0.3047635827631227,0.6930971404823633,MoneyMaker,transp1-1,FALSE,0 +m_70,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.4524190037134414,0.36632129986181056,0.057840798840667895,0.06164162722081926,leaf,leaf,0.3293381378757576,0.9880144136272728,0.5102598025541093,0.42796292708262984,0.5612857828095202,MoneyMaker,panK4-1,FALSE,0 +m_70,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4524190037134414,0.3784698549922872,0.057840798840667895,0.07997464533655028,leaf,leaf,0.4009033248187662,0.9880144136272728,0.5102598025541093,0.4584445003288375,0.5612857828095202,MoneyMaker,log2-1,FALSE,0 +m_70,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4524190037134414,0.3101557241088895,0.057840798840667895,0.04844661891211425,leaf,leaf,0.11296177039923848,0.5648088519961924,0.5102598025541093,0.35860234302100374,0.5612857828095202,MoneyMaker,transp1-1,FALSE,0 +m_71,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.590012725546576,0.4139255926863827,0.15511519106505503,0.07622768835355112,fruit,fruit,0.20127846829093438,1,0.745127916611631,0.49015328103993383,0.8528072917209717,MoneyMaker,panK4-1,FALSE,0 +m_71,967514 MM WT,1017361 Sl10g086080 #2,ns,0.590012725546576,0.31667182001173344,0.15511519106505503,0.061979542644493464,fruit,fruit,0.05253655795315163,0.3152193477189098,0.745127916611631,0.3786513626562269,0.8528072917209717,MoneyMaker,log2-1,FALSE,0 +m_71,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.590012725546576,0.5976755084342305,0.15511519106505503,0.17760384767574375,fruit,fruit,0.9548752572140597,1,0.745127916611631,0.7752793561099742,0.8528072917209717,MoneyMaker,transp1-1,FALSE,0 +m_71,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.14471932468762938,0.2859085316054281,0.01566039853650534,0.044129850635153255,leaf,leaf,0.30257696843030996,1,0.1603797232241347,0.33003838224058135,0.3630422204646395,MoneyMaker,panK4-1,FALSE,0 +m_71,967514 MM WT,1017361 Sl10g086080 #2,ns,0.14471932468762938,0.23363084457292074,0.01566039853650534,0.05461844591560138,leaf,leaf,0.513358573969451,1,0.1603797232241347,0.2882492904885221,0.3630422204646395,MoneyMaker,log2-1,FALSE,0 +m_71,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.14471932468762938,0.25098466095225197,0.01566039853650534,0.037479719928764844,leaf,leaf,0.435573098610086,1,0.1603797232241347,0.28846438088101684,0.3630422204646395,MoneyMaker,transp1-1,FALSE,0 +m_72,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.39621567959678566,0.29642292742344073,0.049396383029352016,0.03142336473733805,fruit,fruit,0.17755457649488246,0.8671809019686824,0.4456120626261377,0.32784629216077876,0.5808671110439619,MoneyMaker,panK4-1,FALSE,0 +m_72,967514 MM WT,1017361 Sl10g086080 #2,ns,0.39621567959678566,0.28786049409334874,0.049396383029352016,0.04968203583062034,fruit,fruit,0.14453015032811373,0.8671809019686824,0.4456120626261377,0.3375425299239691,0.5808671110439619,MoneyMaker,log2-1,FALSE,0 +m_72,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.39621567959678566,0.44910143291100135,0.049396383029352016,0.07895957712896397,fruit,fruit,0.4687634499923513,0.8671809019686824,0.4456120626261377,0.5280610100399653,0.5808671110439619,MoneyMaker,transp1-1,FALSE,0 +m_72,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.25323483688323534,0.35613656167891644,0.027330761865444118,0.059185366389493246,leaf,leaf,0.16492978201203232,0.8671809019686824,0.2805655987486795,0.4153219280684097,0.4568541208752507,MoneyMaker,panK4-1,FALSE,0 +m_72,967514 MM WT,1017361 Sl10g086080 #2,ns,0.25323483688323534,0.3486031747198919,0.027330761865444118,0.051476537932890754,leaf,leaf,0.19682543593209803,0.8671809019686824,0.2805655987486795,0.40007971265278264,0.4568541208752507,MoneyMaker,log2-1,FALSE,0 +m_72,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.25323483688323534,0.1492463571888083,0.027330761865444118,0.040167867084769125,leaf,leaf,0.16068995155605265,0.8671809019686824,0.2805655987486795,0.18941422427357743,0.4568541208752507,MoneyMaker,transp1-1,FALSE,0 +m_73,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.41083858817158914,0.34892760046767735,0.09326304856684647,0.08061900973904654,fruit,fruit,0.41793408706500357,1,0.5041016367384357,0.4295466102067239,0.5608816882108922,MoneyMaker,panK4-1,FALSE,14.583333333333334 +m_73,967514 MM WT,1017361 Sl10g086080 #2,ns,0.41083858817158914,0.4479545630656048,0.09326304856684647,0.061937880762479025,fruit,fruit,0.6257130769624193,1,0.5041016367384357,0.5098924438280839,0.5608816882108922,MoneyMaker,log2-1,FALSE,14.583333333333334 +m_73,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.41083858817158914,0.34305871579064073,0.09326304856684647,0.054072018861607195,fruit,fruit,0.37584045147634226,1,0.5041016367384357,0.3971307346522479,0.5608816882108922,MoneyMaker,transp1-1,FALSE,14.583333333333334 +m_73,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.05760577033930864,0.02351437417430824,0.015026721872472225,0.003141744404745566,leaf,leaf,0.6540107301961953,1,0.07263249221178086,0.026656118579053804,0.1390649109914432,MoneyMaker,panK4-1,FALSE,0 +m_73,967514 MM WT,1017361 Sl10g086080 #2,ns,0.05760577033930864,0.044017910089381426,0.015026721872472225,0.003428508135227526,leaf,leaf,0.857969924360662,1,0.07263249221178086,0.047446418224608954,0.1390649109914432,MoneyMaker,log2-1,FALSE,0 +m_73,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.05760577033930864,0.10733819519223729,0.015026721872472225,0.019084451163620137,leaf,leaf,0.5142261742081067,1,0.07263249221178086,0.12642264635585743,0.1390649109914432,MoneyMaker,transp1-1,FALSE,0 +m_74,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2243638434764277,0.19326361575609963,0.013016649140612563,0.025889399736371416,fruit,fruit,0.3256900996915755,1,0.23738049261704028,0.21915301549247104,0.34849335988786573,MoneyMaker,panK4-1,FALSE,0 +m_74,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2243638434764277,0.27380703801297734,0.013016649140612563,0.04300510733962779,fruit,fruit,0.12376061872989029,0.6188030936494514,0.23738049261704028,0.31681214535260516,0.34849335988786573,MoneyMaker,log2-1,FALSE,0 +m_74,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.2243638434764277,0.11387325143562228,0.013016649140612563,0.021030998875094797,fruit,fruit,0.0015693646624472134,0.00941618797468328,0.23738049261704028,0.13490425031071707,0.34849335988786573,MoneyMaker,transp1-1,FALSE,0 +m_74,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.08508482809520776,0.08468367073041426,0.012558263268388006,0.0017828508292981253,leaf,leaf,0.9897807513066607,1,0.09764309136359577,0.08646652155971238,0.1277778324072687,MoneyMaker,panK4-1,FALSE,0 +m_74,967514 MM WT,1017361 Sl10g086080 #2,ns,0.08508482809520776,0.05760737468222367,0.012558263268388006,0.008500600683537207,leaf,leaf,0.38414849780990734,1,0.09764309136359577,0.06610797536576088,0.1277778324072687,MoneyMaker,log2-1,FALSE,0 +m_74,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.08508482809520776,0.09429081184482048,0.012558263268388006,0.02187085397996923,leaf,leaf,0.7690150748647913,1,0.09764309136359577,0.1161616658247897,0.1277778324072687,MoneyMaker,transp1-1,FALSE,0 +m_75,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.1622923342102598,0.08943389604892674,0.039609798529658666,0.011417404424681888,fruit,fruit,0.010264610013706491,0.06158766008223895,0.20190213273991847,0.10085130047360863,0.22209234601391034,MoneyMaker,panK4-1,FALSE,0 +m_75,967514 MM WT,1017361 Sl10g086080 #2,ns,0.1622923342102598,0.11984218918427336,0.039609798529658666,0.013380527174269475,fruit,fruit,0.11764330668050037,0.47057322672200147,0.20190213273991847,0.13322271635854283,0.22209234601391034,MoneyMaker,log2-1,FALSE,0 +m_75,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.1622923342102598,0.09561533430699826,0.039609798529658666,0.01407326455761384,fruit,fruit,0.017602240990979467,0.08801120495489734,0.20190213273991847,0.1096885988646121,0.22209234601391034,MoneyMaker,transp1-1,FALSE,0 +m_75,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.08583857356126118,0.05047715602629647,0.015628517635105522,0.006767332584448974,leaf,leaf,0.18897518427030152,0.5669255528109045,0.1014670911963667,0.05724448861074544,0.11161380031600338,MoneyMaker,panK4-1,FALSE,0 +m_75,967514 MM WT,1017361 Sl10g086080 #2,ns,0.08583857356126118,0.07668633106862283,0.015628517635105522,0.014291018434198886,leaf,leaf,0.7294445973517385,1,0.1014670911963667,0.09097734950282171,0.11161380031600338,MoneyMaker,log2-1,FALSE,0 +m_75,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.08583857356126118,0.08461790134457695,0.015628517635105522,0.012867973418728718,leaf,leaf,0.9631613145103615,1,0.1014670911963667,0.09748587476330567,0.11161380031600338,MoneyMaker,transp1-1,FALSE,0 +m_76,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3662666491289865,0.37422680729238567,0.06615307617913366,0.06077301107453478,fruit,fruit,0.8995747767595303,1,0.4324197253081201,0.4349998183669205,0.5910597824247982,MoneyMaker,panK4-1,FALSE,0 +m_76,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3662666491289865,0.47749888477620317,0.06615307617913366,0.05982819015543155,fruit,fruit,0.08737235470862142,0.4368617735431071,0.4324197253081201,0.5373270749316347,0.5910597824247982,MoneyMaker,log2-1,FALSE,0 +m_76,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3662666491289865,0.20840523852909465,0.06615307617913366,0.041835962521783926,fruit,fruit,0.01840938767689656,0.11045632606137935,0.4324197253081201,0.25024120105087855,0.5910597824247982,MoneyMaker,transp1-1,FALSE,0 +m_76,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.1462186734677538,0.16494562703145157,0.008539594077903726,0.023523915526751687,leaf,leaf,0.7667214955066158,1,0.15475826754565752,0.18846954255820325,0.26797177885283635,MoneyMaker,panK4-1,FALSE,0 +m_76,967514 MM WT,1017361 Sl10g086080 #2,ns,0.1462186734677538,0.11666845176337112,0.008539594077903726,0.025080938590384586,leaf,leaf,0.6401588211071414,1,0.15475826754565752,0.14174939035375572,0.26797177885283635,MoneyMaker,log2-1,FALSE,0 +m_76,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.1462186734677538,0.2131693841279575,0.008539594077903726,0.030441323920075515,leaf,leaf,0.29406806406300123,1,0.15475826754565752,0.243610708048033,0.26797177885283635,MoneyMaker,transp1-1,FALSE,0 +m_77,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.011544080584873747,0.06776339865499408,9.758541148345893e-4,0.006280654624696221,fruit,fruit,7.065008161077234e-4,0.00423900489664634,0.012519934699708336,0.0740440532796903,0.08144845860765933,MoneyMaker,panK4-1,FALSE,0 +m_77,967514 MM WT,1017361 Sl10g086080 #2,ns,0.011544080584873747,0.04495814274204775,9.758541148345893e-4,0.007479661909940624,fruit,fruit,0.029910420397961452,0.11964168159184581,0.012519934699708336,0.05243780465198837,0.08144845860765933,MoneyMaker,log2-1,FALSE,0 +m_77,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.011544080584873747,0.05784983788913367,9.758541148345893e-4,0.008050413937606337,fruit,fruit,0.003851084051259567,0.019255420256297836,0.012519934699708336,0.06590025182674,0.08144845860765933,MoneyMaker,transp1-1,FALSE,0 +m_77,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.07754476675232544,0.09663658391622848,0.01441087128539856,0.01789701134153847,leaf,leaf,0.1996506053704606,0.3993012107409212,0.091955638037724,0.11453359525776695,0.12598695478354366,MoneyMaker,panK4-1,FALSE,0 +m_77,967514 MM WT,1017361 Sl10g086080 #2,ns,0.07754476675232544,0.06417667666056859,0.01441087128539856,0.009783265479739733,leaf,leaf,0.3649433843861394,0.3993012107409212,0.091955638037724,0.07395994214030832,0.12598695478354366,MoneyMaker,log2-1,FALSE,0 +m_77,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.07754476675232544,0.04664892572103958,0.01441087128539856,0.007302752751886465,leaf,leaf,0.04323217898341906,0.12969653695025718,0.091955638037724,0.05395167847292605,0.12598695478354366,MoneyMaker,transp1-1,FALSE,0 +m_78,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6076812277355401,0.7534273342756587,0.19593757285797475,0.24036390031774704,fruit,fruit,0.3749990178666176,1,0.8036188005935149,0.9937912345934057,1.0931703580527463,MoneyMaker,panK4-1,FALSE,0 +m_78,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6076812277355401,0.8197193841588829,0.19593757285797475,0.08819098627050555,fruit,fruit,0.20089408276463397,1,0.8036188005935149,0.9079103704293885,1.0931703580527463,MoneyMaker,log2-1,FALSE,0 +m_78,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.6076812277355401,0.016513515975941712,0.19593757285797475,0.0024902979226318917,fruit,fruit,0.0012177377238541025,0.007306426343124615,0.8036188005935149,0.019003813898573606,1.0931703580527463,MoneyMaker,transp1-1,FALSE,0 +m_78,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.016624949765271915,0.0270307451582324,0.002611105466010444,0.0035021876903531036,leaf,leaf,0.949074754950716,1,0.01923605523128236,0.030532932848585506,0.03358622613344406,MoneyMaker,panK4-1,FALSE,0 +m_78,967514 MM WT,1017361 Sl10g086080 #2,ns,0.016624949765271915,0.015209236060939584,0.002611105466010444,0.001567925203284601,leaf,leaf,0.9930666770940773,1,0.01923605523128236,0.016777161264224186,0.03358622613344406,MoneyMaker,log2-1,FALSE,0 +m_78,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.016624949765271915,0.0136432226816816,0.002611105466010444,0.002937644127584863,leaf,leaf,0.9853979474273833,1,0.01923605523128236,0.016580866809266463,0.03358622613344406,MoneyMaker,transp1-1,FALSE,0 +m_79,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.09750138377968406,0.12959986748450067,0.00823046735554267,0.02207215978119635,fruit,fruit,0.10978065721503293,0.5489032860751646,0.10573185113522673,0.151672027265697,0.19707650269044677,MoneyMaker,panK4-1,FALSE,0 +m_79,967514 MM WT,1017361 Sl10g086080 #2,ns,0.09750138377968406,0.11024045788739541,0.00823046735554267,0.015453459185579383,fruit,fruit,0.5161084097589976,1,0.10573185113522673,0.12569391707297478,0.19707650269044677,MoneyMaker,log2-1,FALSE,0 +m_79,967514 MM WT,1017363 Sl10g007190 #19.2,*,0.09750138377968406,0.15386671011142358,0.00823046735554267,0.02529374687989163,fruit,fruit,0.007565554718617052,0.04539332831170231,0.10573185113522673,0.17916045699131522,0.19707650269044677,MoneyMaker,transp1-1,FALSE,0 +m_79,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.04957976948335031,0.03896226047469474,0.0018071571860800723,0.004122078460547799,leaf,leaf,0.5878540632639884,1,0.05138692666943038,0.043084338935242536,0.07046844939587303,MoneyMaker,panK4-1,FALSE,0 +m_79,967514 MM WT,1017361 Sl10g086080 #2,ns,0.04957976948335031,0.04085956789125967,0.0018071571860800723,8.770591489048068e-4,leaf,leaf,0.655919185254927,1,0.05138692666943038,0.041736627040164474,0.07046844939587303,MoneyMaker,log2-1,FALSE,0 +m_79,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.04957976948335031,0.05775593341152854,0.0018071571860800723,0.0063062933119924,leaf,leaf,0.6760472610909528,1,0.05138692666943038,0.06406222672352094,0.07046844939587303,MoneyMaker,transp1-1,FALSE,0 +m_8,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.7004533274929795,0.2440780278630908,0.13656827416620523,0.05359648153175154,fruit,fruit,0.0024241321145766553,0.014544792687459932,0.8370216016591847,0.29767450939484236,0.9207237618251033,MoneyMaker,panK4-1,FALSE,0 +m_8,967514 MM WT,1017361 Sl10g086080 #2,ns,0.7004533274929795,0.6377476144552021,0.13656827416620523,0.18523531866561882,fruit,fruit,0.6456982423016738,1,0.8370216016591847,0.8229829331208209,0.9207237618251033,MoneyMaker,log2-1,FALSE,0 +m_8,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.7004533274929795,0.4899255586688991,0.13656827416620523,0.12189116479947303,fruit,fruit,0.13109481306775772,0.6554740653387886,0.8370216016591847,0.6118167234683721,0.9207237618251033,MoneyMaker,transp1-1,FALSE,0 +m_8,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.25604168839757935,0.21228557918393287,0.0161476232638268,0.02787286721886992,leaf,leaf,0.7480739519403237,1,0.27218931166140614,0.2401584464028028,0.2994082428275468,MoneyMaker,panK4-1,FALSE,0 +m_8,967514 MM WT,1017361 Sl10g086080 #2,ns,0.25604168839757935,0.10368334854598177,0.0161476232638268,0.020615913987092466,leaf,leaf,0.26911143055459263,1,0.27218931166140614,0.12429926253307423,0.2994082428275468,MoneyMaker,log2-1,FALSE,0 +m_8,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.25604168839757935,0.1992473116922861,0.0161476232638268,0.0198890709714056,leaf,leaf,0.6769908718776807,1,0.27218931166140614,0.2191363826636917,0.2994082428275468,MoneyMaker,transp1-1,FALSE,0 +m_80,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.05833724964223802,0.0741151612617325,0.006082245619796372,0.010972374334949197,fruit,fruit,0.5104445909961188,1,0.06441949526203439,0.0850875355966817,0.17011909564988695,MoneyMaker,panK4-1,FALSE,0 +m_80,967514 MM WT,1017361 Sl10g086080 #2,ns,0.05833724964223802,0.04073471636295568,0.006082245619796372,0.003144925606623655,fruit,fruit,0.4632909952057742,1,0.06441949526203439,0.04387964196957933,0.17011909564988695,MoneyMaker,log2-1,FALSE,0 +m_80,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.05833724964223802,0.11720914248899222,0.006082245619796372,0.037444580829086804,fruit,fruit,0.01996839770865375,0.1198103862519225,0.06441949526203439,0.15465372331807903,0.17011909564988695,MoneyMaker,transp1-1,FALSE,0 +m_80,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.060708925739193065,0.10589836369056124,0.00807582872406741,0.01450992838820534,leaf,leaf,0.06768478775507011,0.3384239387753506,0.06878475446326048,0.12040829207876658,0.13244912128664324,MoneyMaker,panK4-1,FALSE,0 +m_80,967514 MM WT,1017361 Sl10g086080 #2,ns,0.060708925739193065,0.05950672324104667,0.00807582872406741,0.00921153248669461,leaf,leaf,0.9598217051415714,1,0.06878475446326048,0.06871825572774129,0.13244912128664324,MoneyMaker,log2-1,FALSE,0 +m_80,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.060708925739193065,0.08919619712730265,0.00807582872406741,0.017346415098587406,leaf,leaf,0.2394723943360138,0.9578895773440552,0.06878475446326048,0.10654261222589005,0.13244912128664324,MoneyMaker,transp1-1,FALSE,0 +m_81,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.709738865485851,0.6791078485980373,0.15118769087069422,0.08924008016362582,fruit,fruit,0.8339487607726159,1,0.8609265563565451,0.7683479287616631,1.2801949982262169,MoneyMaker,panK4-1,FALSE,0 +m_81,967514 MM WT,1017361 Sl10g086080 #2,ns,0.709738865485851,0.9719578715599918,0.15118769087069422,0.1918557631911143,fruit,fruit,0.08215805995271659,0.4929483597162996,0.8609265563565451,1.163813634751106,1.2801949982262169,MoneyMaker,log2-1,FALSE,0 +m_81,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.709738865485851,0.583063825583724,0.15118769087069422,0.12293017176606717,fruit,fruit,0.3894726254080493,1,0.8609265563565451,0.7059939973497912,1.2801949982262169,MoneyMaker,transp1-1,FALSE,0 +m_81,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.09153536900845285,0.09518953632492692,0.014656282508345938,0.01709198042005687,leaf,leaf,0.9800384125312736,1,0.1061916515167988,0.1122815167449838,0.12350966841948219,MoneyMaker,panK4-1,FALSE,0 +m_81,967514 MM WT,1017361 Sl10g086080 #2,ns,0.09153536900845285,0.044105562188889356,0.014656282508345938,0.006593424757878906,leaf,leaf,0.745634801960112,1,0.1061916515167988,0.05069898694676826,0.12350966841948219,MoneyMaker,log2-1,FALSE,0 +m_81,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.09153536900845285,0.0918935526960869,0.014656282508345938,0.01628115963916683,leaf,leaf,0.9980431380836465,1,0.1061916515167988,0.10817471233525373,0.12350966841948219,MoneyMaker,transp1-1,FALSE,0 +m_82,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.34510368563829846,0.12173555305227714,0.04927511145835152,0.025425181636687114,fruit,fruit,0.007468831886406339,0.0373441594320317,0.39437879709664997,0.14716073468896426,0.433816676806315,MoneyMaker,panK4-1,FALSE,0 +m_82,967514 MM WT,1017361 Sl10g086080 #2,*,0.34510368563829846,0.08493830593787279,0.04927511145835152,0.013161764371561963,fruit,fruit,0.0023401691932041628,0.014041015159224977,0.39437879709664997,0.09810007030943475,0.433816676806315,MoneyMaker,log2-1,FALSE,0 +m_82,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.34510368563829846,0.19046311459388435,0.04927511145835152,0.021967233622759864,fruit,fruit,0.0543789309508107,0.2175157238032428,0.39437879709664997,0.21243034821664422,0.433816676806315,MoneyMaker,transp1-1,FALSE,0 +m_82,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.35201581639164303,0.40488881534390375,0.06530350254541908,0.03984933489515089,leaf,leaf,0.49583127336238253,0.49583127336238253,0.4173193189370621,0.44473815023905466,0.6646146702736712,MoneyMaker,panK4-1,FALSE,0 +m_82,967514 MM WT,1017361 Sl10g086080 #2,ns,0.35201581639164303,0.49638520743930103,0.06530350254541908,0.04992620083986188,leaf,leaf,0.07112079374266726,0.2175157238032428,0.4173193189370621,0.5463114082791629,0.6646146702736712,MoneyMaker,log2-1,FALSE,0 +m_82,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.35201581639164303,0.4978756420452963,0.06530350254541908,0.10631951274895018,leaf,leaf,0.06844120416203651,0.2175157238032428,0.4173193189370621,0.6041951547942465,0.6646146702736712,MoneyMaker,transp1-1,FALSE,0 +m_83,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.4912204400968602,0.2516816486018037,0.05646250907662237,0.04182284463107452,fruit,fruit,4.43223682473298e-4,0.0026593420948397882,0.5476829491734826,0.2935044932328782,0.602451244090831,MoneyMaker,panK4-1,FALSE,0 +m_83,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4912204400968602,0.4540576881565696,0.05646250907662237,0.06999689333011457,fruit,fruit,0.5338875605426756,1,0.5476829491734826,0.5240545814866842,0.602451244090831,MoneyMaker,log2-1,FALSE,0 +m_83,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4912204400968602,0.33314897951053885,0.05646250907662237,0.048073661542905204,fruit,fruit,0.012951960196592636,0.06475980098296319,0.5476829491734826,0.38122264105344406,0.602451244090831,MoneyMaker,transp1-1,FALSE,0 +m_83,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.153802707206564,0.1467801278455172,0.011976877917795089,0.032681728905151274,leaf,leaf,0.9060516565618197,1,0.16577958512435909,0.17946185675066847,0.2009736864329768,MoneyMaker,panK4-1,FALSE,0 +m_83,967514 MM WT,1017361 Sl10g086080 #2,ns,0.153802707206564,0.17055842235700105,0.011976877917795089,0.012144928945705121,leaf,leaf,0.7784045670005318,1,0.16577958512435909,0.18270335130270618,0.2009736864329768,MoneyMaker,log2-1,FALSE,0 +m_83,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.153802707206564,0.1220868856257589,0.011976877917795089,0.018964820699427048,leaf,leaf,0.5950765866104362,1,0.16577958512435909,0.14105170632518593,0.2009736864329768,MoneyMaker,transp1-1,FALSE,0 +m_84,967514 MM WT,1015695 Sl10g074590 #30.1,ns,1.1997345058145645,1.2203955006653118,0.14819468714358464,0.13264986498015854,fruit,fruit,0.9351018223716914,1,1.3479291929581492,1.3530453656454704,1.726793360144326,MoneyMaker,panK4-1,FALSE,0 +m_84,967514 MM WT,1017361 Sl10g086080 #2,ns,1.1997345058145645,1.2427857746127478,0.14819468714358464,0.327026370973003,fruit,fruit,0.8653004259566631,1,1.3479291929581492,1.5698121455857508,1.726793360144326,MoneyMaker,log2-1,FALSE,0 +m_84,967514 MM WT,1017363 Sl10g007190 #19.2,ns,1.1997345058145645,1.1732213970942214,0.14819468714358464,0.2516373937857686,fruit,fruit,0.9167829630684579,1,1.3479291929581492,1.42485879087999,1.726793360144326,MoneyMaker,transp1-1,FALSE,0 +m_84,967514 MM WT,1015695 Sl10g074590 #30.1,ns,1.4770073697743935,1.4120468135403748,0.09774738588167343,0.1270173260486966,leaf,leaf,0.7980601222823567,1,1.574754755656067,1.5390641395890714,1.7456458855059547,MoneyMaker,panK4-1,FALSE,0 +m_84,967514 MM WT,1017361 Sl10g086080 #2,ns,1.4770073697743935,1.5269773148878847,0.09774738588167343,0.059973490117528665,leaf,leaf,0.8439284335360168,1,1.574754755656067,1.5869508050054133,1.7456458855059547,MoneyMaker,log2-1,FALSE,0 +m_84,967514 MM WT,1017363 Sl10g007190 #19.2,ns,1.4770073697743935,1.4416332090367918,0.09774738588167343,0.11432710348725718,leaf,leaf,0.8891377813438766,1,1.574754755656067,1.555960312524049,1.7456458855059547,MoneyMaker,transp1-1,FALSE,0 +m_85,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.09128954092199064,0.1685109395070799,0.007592809337281808,0.04466289574627734,fruit,fruit,0.4500606310159736,1,0.09888235025927244,0.21317383525335726,0.4144004826805044,MoneyMaker,panK4-1,FALSE,0 +m_85,967514 MM WT,1017361 Sl10g086080 #2,ns,0.09128954092199064,0.1241365408789836,0.007592809337281808,0.013016795602289024,fruit,fruit,0.7467886682099788,1,0.09888235025927244,0.13715333648127262,0.4144004826805044,MoneyMaker,log2-1,FALSE,0 +m_85,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.09128954092199064,0.3285704262942539,0.007592809337281808,0.04815728523347729,fruit,fruit,0.02677829714769215,0.1606697828861529,0.09888235025927244,0.3767277115277312,0.4144004826805044,MoneyMaker,transp1-1,FALSE,0 +m_85,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5737613387120818,0.6185020206636543,0.0874413645769462,0.0667346115187178,leaf,leaf,0.6603905533231866,1,0.661202703289028,0.6852366321823722,0.884494139009676,MoneyMaker,panK4-1,FALSE,0 +m_85,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5737613387120818,0.6191572090364365,0.0874413645769462,0.11054013576122518,leaf,leaf,0.6557551366939866,1,0.661202703289028,0.7296973447976616,0.884494139009676,MoneyMaker,log2-1,FALSE,0 +m_85,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5737613387120818,0.6964033554670344,0.0874413645769462,0.10768222545085282,leaf,leaf,0.23450312341501472,1,0.661202703289028,0.8040855809178872,0.884494139009676,MoneyMaker,transp1-1,FALSE,0 +m_86,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.2626277604694729,0.22265320888145837,0.06042538244668041,0.03760090973747809,fruit,fruit,0.5880892073409312,1,0.3230531429161533,0.26025411861893644,0.35535845720776865,MoneyMaker,panK4-1,FALSE,0 +m_86,967514 MM WT,1017361 Sl10g086080 #2,ns,0.2626277604694729,0.073102903188257,0.06042538244668041,0.013382922727815811,fruit,fruit,0.015605261695641172,0.07802630847820585,0.3230531429161533,0.08648582591607282,0.35535845720776865,MoneyMaker,log2-1,FALSE,0 +m_86,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.2626277604694729,0.13790615672040127,0.06042538244668041,0.02028511701620392,fruit,fruit,0.09963390072478225,0.29890170217434675,0.3230531429161533,0.1581912737366052,0.35535845720776865,MoneyMaker,transp1-1,FALSE,0 +m_86,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5129943861730327,0.35596770595831245,0.06741166481660704,0.06384245197820024,leaf,leaf,0.041280302873182184,0.16512121149272874,0.5804060509896398,0.41981015793651266,0.6491380216835603,MoneyMaker,panK4-1,FALSE,0 +m_86,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5129943861730327,0.3115546079950747,0.06741166481660704,0.058740380175407024,leaf,leaf,0.010732524878690482,0.06439514927214289,0.5804060509896398,0.3702949881704817,0.6491380216835603,MoneyMaker,log2-1,FALSE,0 +m_86,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5129943861730327,0.5311149096255728,0.06741166481660704,0.05901056463220918,leaf,leaf,0.805590549560896,1,0.5804060509896398,0.5901254742577821,0.6491380216835603,MoneyMaker,transp1-1,FALSE,0 +m_87,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.10413367433513382,0.13600634875821332,0.0072267336359360035,0.02736361191926142,fruit,fruit,0.5345321497526345,1,0.11136040797106982,0.16336996067747475,0.22491397943957006,MoneyMaker,panK4-1,FALSE,0 +m_87,967514 MM WT,1017361 Sl10g086080 #2,ns,0.10413367433513382,0.10260609927024601,0.0072267336359360035,0.014383739343749277,fruit,fruit,0.9761550379601378,1,0.11136040797106982,0.11698983861399528,0.22491397943957006,MoneyMaker,log2-1,FALSE,0 +m_87,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.10413367433513382,0.17075771448667745,0.0072267336359360035,0.03370953954929531,fruit,fruit,0.20018512151873902,1,0.11136040797106982,0.20446725403597277,0.22491397943957006,MoneyMaker,transp1-1,FALSE,0 +m_87,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.305800231011702,0.32602207780541576,0.030599106408199614,0.04691947831201752,leaf,leaf,0.692824172550828,1,0.33639933741990163,0.3729415561174333,0.5235288958808562,MoneyMaker,panK4-1,FALSE,0 +m_87,967514 MM WT,1017361 Sl10g086080 #2,ns,0.305800231011702,0.4214801388547635,0.030599106408199614,0.05445522103692387,leaf,leaf,0.03129854435562996,0.18779126613377978,0.33639933741990163,0.47593535989168734,0.5235288958808562,MoneyMaker,log2-1,FALSE,0 +m_87,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.305800231011702,0.29252321263392594,0.030599106408199614,0.044551914326812186,leaf,leaf,0.7951684711251072,1,0.33639933741990163,0.33707512696073816,0.5235288958808562,MoneyMaker,transp1-1,FALSE,0 +m_88,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.23097065147205875,0.09386638143545566,0.022689553302381833,0.011188153470547203,fruit,fruit,0.0025023432254222353,0.012511716127111177,0.25366020477444057,0.10505453490600286,0.3090911853170184,MoneyMaker,panK4-1,FALSE,0 +m_88,967514 MM WT,1017361 Sl10g086080 #2,*,0.23097065147205875,0.08919523622305373,0.022689553302381833,0.012871448551528438,fruit,fruit,0.0018849987870654652,0.011309992722392791,0.25366020477444057,0.10206668477458217,0.3090911853170184,MoneyMaker,log2-1,FALSE,0 +m_88,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.23097065147205875,0.24047170571363194,0.022689553302381833,0.04052028093820297,fruit,fruit,0.8170218339645543,1,0.25366020477444057,0.2809919866518349,0.3090911853170184,MoneyMaker,transp1-1,FALSE,0 +m_88,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.27695458762099845,0.2615679585388366,0.017606259552178382,0.03979594778926849,leaf,leaf,0.70813409590974,1,0.2945608471731768,0.30136390632810506,0.43399551839207506,MoneyMaker,panK4-1,FALSE,0 +m_88,967514 MM WT,1017361 Sl10g086080 #2,ns,0.27695458762099845,0.36119839058730685,0.017606259552178382,0.03334298976912495,leaf,leaf,0.04895219333544709,0.19580877334178837,0.2945608471731768,0.3945413803564318,0.43399551839207506,MoneyMaker,log2-1,FALSE,0 +m_88,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.27695458762099845,0.2225421595299799,0.017606259552178382,0.0338404575539902,leaf,leaf,0.1928832090168675,0.5786496270506025,0.2945608471731768,0.2563826170839701,0.43399551839207506,MoneyMaker,transp1-1,FALSE,0 +m_89,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.8020714788781488,0.8310107783192903,0.0880155065058015,0.09457079112219735,fruit,fruit,0.8662240635106199,0.9432793664937833,0.8900869853839503,0.9255815694414876,1.4398635319803186,MoneyMaker,panK4-1,FALSE,0 +m_89,967514 MM WT,1017361 Sl10g086080 #2,ns,0.8020714788781488,0.9869320309969379,0.0880155065058015,0.1282018602986065,fruit,fruit,0.28754323102702967,0.862629693081089,0.8900869853839503,1.1151338912955444,1.4398635319803186,MoneyMaker,log2-1,FALSE,0 +m_89,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.8020714788781488,1.0641716013702227,0.0880155065058015,0.24479524588461243,fruit,fruit,0.13612599790059263,0.5445039916023705,0.8900869853839503,1.308966847254835,1.4398635319803186,MoneyMaker,transp1-1,FALSE,0 +m_89,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6421627644414007,0.2802748249054059,0.11427799681020734,0.0312098655514559,leaf,leaf,0.043691732891976365,0.2621503973518582,0.7564407612516081,0.3114846904568618,0.832084837376769,MoneyMaker,panK4-1,FALSE,0 +m_89,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6421627644414007,0.3360360891885371,0.11427799681020734,0.026036730226881,leaf,leaf,0.08425544581127643,0.42127722905638215,0.7564407612516081,0.36207281941541813,0.832084837376769,MoneyMaker,log2-1,FALSE,0 +m_89,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6421627644414007,0.5178606392358724,0.11427799681020734,0.08822340974163978,leaf,leaf,0.47163968324689165,0.9432793664937833,0.7564407612516081,0.6060840489775122,0.832084837376769,MoneyMaker,transp1-1,FALSE,0 +m_9,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.0953942033420021,0.5525870618472043,0.022532113401702216,0.08739154916939439,fruit,fruit,1.3707228317407834e-8,8.2243369904447e-8,0.11792631674370432,0.6399786110165987,0.7039764721182586,MoneyMaker,panK4-1,FALSE,0 +m_9,967514 MM WT,1017361 Sl10g086080 #2,ns,0.0953942033420021,0.2375564959884462,0.022532113401702216,0.052974370812042045,fruit,fruit,0.015488060316884373,0.06838187624648163,0.11792631674370432,0.29053086680048823,0.7039764721182586,MoneyMaker,log2-1,FALSE,0 +m_9,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.0953942033420021,0.24054386764449148,0.022532113401702216,0.03017182678116121,fruit,fruit,0.013676375249296328,0.06838187624648163,0.11792631674370432,0.2707156944256527,0.7039764721182586,MoneyMaker,transp1-1,FALSE,0 +m_9,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.02709216318715369,0.022232950649545398,0.002831566243848386,0.002159214967490155,leaf,leaf,0.9297578453577845,1,0.029923729431002077,0.02439216561703555,0.036804312089313625,MoneyMaker,panK4-1,FALSE,0 +m_9,967514 MM WT,1017361 Sl10g086080 #2,ns,0.02709216318715369,0.01630452653479851,0.002831566243848386,0.0037552244431348723,leaf,leaf,0.8448982066907874,1,0.029923729431002077,0.02005975097793338,0.036804312089313625,MoneyMaker,log2-1,FALSE,0 +m_9,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.02709216318715369,0.02971206642503363,0.002831566243848386,0.0037463991107060226,leaf,leaf,0.9620910983635496,1,0.029923729431002077,0.033458465535739654,0.036804312089313625,MoneyMaker,transp1-1,FALSE,0 +m_90,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.3483528163337858,0.163734680722995,0.03740443468292128,0.019584961451263646,fruit,fruit,0.0023733528571435727,0.014240117142861436,0.38575725101670705,0.18331964217425864,0.4243329761183778,MoneyMaker,panK4-1,FALSE,0 +m_90,967514 MM WT,1017361 Sl10g086080 #2,*,0.3483528163337858,0.19327853594708805,0.03740443468292128,0.032413239137687795,fruit,fruit,0.00876267950871565,0.04381339754357825,0.38575725101670705,0.22569177508477584,0.4243329761183778,MoneyMaker,log2-1,FALSE,0 +m_90,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3483528163337858,0.24774323165409273,0.03740443468292128,0.0590759318177239,fruit,fruit,0.07645755544990848,0.30583022179963393,0.38575725101670705,0.30681916347181665,0.4243329761183778,MoneyMaker,transp1-1,FALSE,0 +m_90,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.24834798535024594,0.25683356417749814,0.04181990655496023,0.0228396340583378,leaf,leaf,0.8772214877235416,1,0.29016789190520614,0.2796731982358359,0.39500790862405055,MoneyMaker,panK4-1,FALSE,0 +m_90,967514 MM WT,1017361 Sl10g086080 #2,ns,0.24834798535024594,0.257674305447514,0.04181990655496023,0.034308225509580306,leaf,leaf,0.8651749613987246,1,0.29016789190520614,0.2919825309570943,0.39500790862405055,MoneyMaker,log2-1,FALSE,0 +m_90,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.24834798535024594,0.3139129681893559,0.04181990655496023,0.04518513055978097,leaf,leaf,0.2393804424056758,0.7181413272170274,0.29016789190520614,0.35909809874913684,0.39500790862405055,MoneyMaker,transp1-1,FALSE,0 +m_91,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.09349207864258957,0.2965381210660341,0.02197879909727422,0.07304117477545644,fruit,fruit,0.014431879945805519,0.057727519783222075,0.1154708777398638,0.3695792958414905,0.4065372254256396,MoneyMaker,panK4-1,FALSE,0 +m_91,967514 MM WT,1017361 Sl10g086080 #2,ns,0.09349207864258957,0.21860168980059785,0.02197879909727422,0.05821732987419298,fruit,fruit,0.11722503441378346,0.23445006882756692,0.1154708777398638,0.27681901967479083,0.4065372254256396,MoneyMaker,log2-1,FALSE,0 +m_91,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.09349207864258957,0.15172046555170138,0.02197879909727422,0.02907986800132673,fruit,fruit,0.4568269631692212,0.4568269631692212,0.1154708777398638,0.1808003335530281,0.4065372254256396,MoneyMaker,transp1-1,FALSE,0 +m_91,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.45776289678873705,0.22715964742734823,0.06985260285445527,0.05536187800543108,leaf,leaf,0.006276754419281867,0.0376605265156912,0.5276154996431923,0.2825215254327793,0.5803770496075116,MoneyMaker,panK4-1,FALSE,0 +m_91,967514 MM WT,1017361 Sl10g086080 #2,*,0.45776289678873705,0.23953340772179815,0.06985260285445527,0.04430384016430826,leaf,leaf,0.009163200983541337,0.04581600491770668,0.5276154996431923,0.2838372478861064,0.5803770496075116,MoneyMaker,log2-1,FALSE,0 +m_91,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.45776289678873705,0.2892790487722703,0.06985260285445527,0.06123832804310238,leaf,leaf,0.03861145786938679,0.11583437360816036,0.5276154996431923,0.35051737681537265,0.5803770496075116,MoneyMaker,transp1-1,FALSE,0 +m_92,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.3515550750316242,0.2785362002873892,0.04559370506544485,0.04895266539227795,fruit,fruit,0.5022802503290795,1,0.39714878009706905,0.3274888656796671,0.6853003678679164,MoneyMaker,panK4-1,FALSE,0 +m_92,967514 MM WT,1017361 Sl10g086080 #2,ns,0.3515550750316242,0.3235542273687538,0.04559370506544485,0.05683668312627745,fruit,fruit,0.7961564421148319,1,0.39714878009706905,0.3803909104950312,0.6853003678679164,MoneyMaker,log2-1,FALSE,0 +m_92,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.3515550750316242,0.5535669649341137,0.04559370506544485,0.06943336949126477,fruit,fruit,0.0716620329791273,0.42997219787476376,0.39714878009706905,0.6230003344253785,0.6853003678679164,MoneyMaker,transp1-1,FALSE,0 +m_92,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6500114454161715,0.5652601083912523,0.09760515528584347,0.08164092115330761,leaf,leaf,0.4369059117616778,1,0.747616600702015,0.6469010295445599,0.9090342872563398,MoneyMaker,panK4-1,FALSE,0 +m_92,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6500114454161715,0.5657148629624508,0.09760515528584347,0.0912202542135542,leaf,leaf,0.4393390969849418,1,0.747616600702015,0.656935117176005,0.9090342872563398,MoneyMaker,log2-1,FALSE,0 +m_92,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6500114454161715,0.7319298654767513,0.09760515528584347,0.09446494111992124,leaf,leaf,0.4521977222783189,1,0.747616600702015,0.8263948065966725,0.9090342872563398,MoneyMaker,transp1-1,FALSE,0 +m_93,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.7560557226550133,0.8358169796373949,0.1277006472625656,0.09864991513467286,fruit,fruit,0.589571440306248,0.9395352318693408,0.8837563699175789,0.9344668947720678,1.0279135842492746,MoneyMaker,panK4-1,FALSE,0 +m_93,967514 MM WT,1017361 Sl10g086080 #2,ns,0.7560557226550133,0.5583397349627678,0.1277006472625656,0.09599404573235805,fruit,fruit,0.18790704637386818,0.9395352318693408,0.8837563699175789,0.6543337806951258,1.0279135842492746,MoneyMaker,log2-1,FALSE,0 +m_93,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.7560557226550133,0.5943818825616554,0.1277006472625656,0.12006765469888211,fruit,fruit,0.2787041811418923,0.9395352318693408,0.8837563699175789,0.7144495372605375,1.0279135842492746,MoneyMaker,transp1-1,FALSE,0 +m_93,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.1885969781332888,0.311574829950348,0.03865568287112024,0.05522144738032874,leaf,leaf,0.40752228810827407,0.9395352318693408,0.22725266100440905,0.36679627733067677,0.6882638485364986,MoneyMaker,panK4-1,FALSE,0 +m_93,967514 MM WT,1017361 Sl10g086080 #2,ns,0.1885969781332888,0.4778012482429281,0.03865568287112024,0.14789315951752505,leaf,leaf,0.058972739976981596,0.35383643986188956,0.22725266100440905,0.6256944077604532,0.6882638485364986,MoneyMaker,log2-1,FALSE,0 +m_93,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.1885969781332888,0.3720432471954328,0.03865568287112024,0.0950158591432388,leaf,leaf,0.2206416265653477,0.9395352318693408,0.22725266100440905,0.4670591063386716,0.6882638485364986,MoneyMaker,transp1-1,FALSE,0 +m_94,967514 MM WT,1015695 Sl10g074590 #30.1,*,0.40189076740885415,0.07720425936108058,0.06291116536056421,0.014158683733889354,fruit,fruit,0.0012858196572548461,0.007714917943529077,0.4648019327694184,0.09136294309496994,0.6333700748403517,MoneyMaker,panK4-1,FALSE,0 +m_94,967514 MM WT,1017361 Sl10g086080 #2,ns,0.40189076740885415,0.16340543810273664,0.06291116536056421,0.037713068197198815,fruit,fruit,0.013178469440672028,0.06589234720336014,0.4648019327694184,0.20111850629993544,0.6333700748403517,MoneyMaker,log2-1,FALSE,0 +m_94,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.40189076740885415,0.49944074463680804,0.06291116536056421,0.07635023249078439,fruit,fruit,0.2843594120723618,1,0.4648019327694184,0.5757909771275924,0.6333700748403517,MoneyMaker,transp1-1,FALSE,0 +m_94,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.35096416283615023,0.36504821634732976,0.059257934252956786,0.06450616100332637,leaf,leaf,0.8756990911085425,1,0.410222097089107,0.42955437735065616,0.5669211771476083,MoneyMaker,panK4-1,FALSE,0 +m_94,967514 MM WT,1017361 Sl10g086080 #2,ns,0.35096416283615023,0.4051390140362886,0.059257934252956786,0.09075416563411307,leaf,leaf,0.5488033066204783,1,0.410222097089107,0.4958931796704017,0.5669211771476083,MoneyMaker,log2-1,FALSE,0 +m_94,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.35096416283615023,0.448872475533011,0.059257934252956786,0.06651041278299638,leaf,leaf,0.2826364171936624,1,0.410222097089107,0.5153828883160074,0.5669211771476083,MoneyMaker,transp1-1,FALSE,0 +m_97,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.5429861375797922,0.22507540969209633,0.15302894085348526,0.049548410318796546,fruit,fruit,0.01004702615586256,0.06028215693517536,0.6960150784332775,0.27462382001089286,0.7656165862766053,MoneyMaker,panK4-1,FALSE,0 +m_97,967514 MM WT,1017361 Sl10g086080 #2,ns,0.5429861375797922,0.5515062690023603,0.15302894085348526,0.07283311148186458,fruit,fruit,0.9409112387699232,1,0.6960150784332775,0.6243393804842249,0.7656165862766053,MoneyMaker,log2-1,FALSE,0 +m_97,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.5429861375797922,0.4146352344298909,0.15302894085348526,0.06890679097879407,fruit,fruit,0.2703052548976797,1,0.6960150784332775,0.48354202540868496,0.7656165862766053,MoneyMaker,transp1-1,FALSE,0 +m_97,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.46358992379738756,0.25616943518382246,0.08571853011027666,0.04077036129152021,leaf,leaf,0.08070067697046093,0.40350338485230464,0.5493084539076643,0.2969397964753427,0.6042392992984307,MoneyMaker,panK4-1,FALSE,0 +m_97,967514 MM WT,1017361 Sl10g086080 #2,ns,0.46358992379738756,0.3833232579461351,0.08571853011027666,0.06907500691998199,leaf,leaf,0.48718948966311015,1,0.5493084539076643,0.45239826486611706,0.6042392992984307,MoneyMaker,log2-1,FALSE,0 +m_97,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.46358992379738756,0.32987718420049467,0.08571853011027666,0.04522864366499029,leaf,leaf,0.25130986681351436,1,0.5493084539076643,0.37510582786548496,0.6042392992984307,MoneyMaker,transp1-1,FALSE,0 +m_98,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.32207155302052504,0.44881745270051654,0.031778076882560145,0.06763286775212754,fruit,fruit,0.21538703281934124,0.9176396821585504,0.35384962990308516,0.516450320452644,0.8388284867256446,MoneyMaker,panK4-1,FALSE,0 +m_98,967514 MM WT,1017361 Sl10g086080 #2,*,0.32207155302052504,0.6789962694065852,0.031778076882560145,0.08357508216218254,fruit,fruit,0.0014980515443198225,0.008988309265918936,0.35384962990308516,0.7625713515687678,0.8388284867256446,MoneyMaker,log2-1,FALSE,0 +m_98,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.32207155302052504,0.3360697739603135,0.031778076882560145,0.08894187984052994,fruit,fruit,0.8894073056767677,1,0.35384962990308516,0.42501165380084344,0.8388284867256446,MoneyMaker,transp1-1,FALSE,0 +m_98,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.6726472820079383,0.536241330777052,0.06807802133951207,0.05598282570118026,leaf,leaf,0.1835279364317101,0.9176396821585504,0.7407253033474503,0.5922241564782323,0.8338762406295204,MoneyMaker,panK4-1,FALSE,0 +m_98,967514 MM WT,1017361 Sl10g086080 #2,ns,0.6726472820079383,0.5757329009444423,0.06807802133951207,0.07515077425573455,leaf,leaf,0.3402604854553365,1,0.7407253033474503,0.6508836752001769,0.8338762406295204,MoneyMaker,log2-1,FALSE,0 +m_98,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.6726472820079383,0.6819901016442403,0.06807802133951207,0.07607920801895993,leaf,leaf,0.9260470590512824,1,0.7407253033474503,0.7580693096632003,0.8338762406295204,MoneyMaker,transp1-1,FALSE,0 +m_99,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.4496849429835359,0.6096908766459502,0.09631514731554754,0.08538924121020658,fruit,fruit,0.2612423164454477,1,0.5460000902990835,0.6950801178561568,1.1428372218814133,MoneyMaker,panK4-1,FALSE,0 +m_99,967514 MM WT,1017361 Sl10g086080 #2,ns,0.4496849429835359,0.5437855174632946,0.09631514731554754,0.10922957215375538,fruit,fruit,0.5050909215699992,1,0.5460000902990835,0.65301508961705,1.1428372218814133,MoneyMaker,log2-1,FALSE,0 +m_99,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.4496849429835359,0.8249763431192457,0.09631514731554754,0.21396658586385708,fruit,fruit,0.012545272356300327,0.07527163413780197,0.5460000902990835,1.038942928983103,1.1428372218814133,MoneyMaker,transp1-1,FALSE,0 +m_99,967514 MM WT,1015695 Sl10g074590 #30.1,ns,0.36263963034565583,0.28316714323504066,0.039247384411095425,0.023406613206613153,leaf,leaf,0.5729925953603426,1,0.40188701475675126,0.3065737564416538,0.4420757162324264,MoneyMaker,panK4-1,FALSE,0 +m_99,967514 MM WT,1017361 Sl10g086080 #2,ns,0.36263963034565583,0.21669010935879726,0.039247384411095425,0.013606184348354497,leaf,leaf,0.30440293760918835,1,0.40188701475675126,0.23029629370715177,0.4420757162324264,MoneyMaker,log2-1,FALSE,0 +m_99,967514 MM WT,1017363 Sl10g007190 #19.2,ns,0.36263963034565583,0.3414002365266878,0.039247384411095425,0.028343596508620665,leaf,leaf,0.8798889032887884,1,0.40188701475675126,0.36974383303530844,0.4420757162324264,MoneyMaker,transp1-1,FALSE,0 diff --git a/runs/GC-MS analysis/p_values_levene.csv b/runs/GC-MS analysis/p_values_levene.csv new file mode 100644 index 0000000000000000000000000000000000000000..7cc38d2545ca6ed774365b6439b4704b92b195b2 --- /dev/null +++ b/runs/GC-MS analysis/p_values_levene.csv @@ -0,0 +1,2737 @@ +met,treatment,treatment2,group1,group2,tissue,tissue2,p.signif,mean1,mean2,se1,se2,p.value,adj.p.value,tot_val1,tot_val2,y.position,na,n_treat,percent_na +m_1,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2290544112253427,0.4305063121201095,0.11085477640733198,0.2164795320095669,0.4336215569795707,1,0.3399091876326747,0.6469858441296764,0.7116844285426441,0,24,0 +m_1,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2290544112253427,0.25051815688388296,0.11085477640733198,0.07406783006714737,0.876513901626161,1,0.3399091876326747,0.32458598695103036,0.7116844285426441,0,24,0 +m_1,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2290544112253427,0.0981336404471193,0.11085477640733198,0.06780883851284888,0.34823879783127787,1,0.3399091876326747,0.16594247895996816,0.7116844285426441,0,24,0 +m_1,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.13386795123818096,0.32075429851888193,0.026986282472377887,0.059466469168379055,0.024365349830255317,0.5847683959261276,0.16085423371055885,0.380220767687261,0.41824284445598714,0,24,0 +m_1,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,0.13386795123818096,0.04900399835753655,0.026986282472377887,0.021904629906428053,0.03570459135997437,0.8212056012794106,0.16085423371055885,0.0709086282639646,0.41824284445598714,0,24,0 +m_1,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13386795123818096,0.09617426791405947,0.026986282472377887,0.03251248038606596,0.3939955591080908,1,0.16085423371055885,0.12868674830012544,0.41824284445598714,0,24,0 +m_1,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08528235556982051,0.21902295444880485,0.053193952845316646,0.12159833470178723,0.34818921357074323,1,0.13847630841513717,0.3406212891505921,0.3746834180656513,0,24,0 +m_1,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08528235556982051,0.08646277766852366,0.053193952845316646,0.05224735768636042,0.9877565911894329,1,0.13847630841513717,0.13871013535488408,0.3746834180656513,0,24,0 +m_1,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08528235556982051,0.10901408068763563,0.053193952845316646,0.06365479609691176,0.7813213753966849,1,0.13847630841513717,0.1726688767845474,0.3746834180656513,0,24,0 +m_1,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07729543085669661,0.3827352214369719,0.034105650060358185,0.20996470714757617,0.20769837243222783,1,0.1114010809170548,0.5926999285845481,0.651969921443003,0,24,0 +m_1,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07729543085669661,0.19356467307422268,0.034105650060358185,0.04956805785619656,0.08732952747968145,1,0.1114010809170548,0.24313273093041923,0.651969921443003,0,24,0 +m_1,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07729543085669661,0.13435649578794662,0.034105650060358185,0.03540975573898754,0.2758066601852978,1,0.1114010809170548,0.16976625152693414,0.651969921443003,0,24,0 +m_1,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.9634217844929773,0.5559327081575206,0.42663630392733626,0.21924469115398856,0.42198907161636867,1,1.3900580884203135,0.7751773993115092,1.529063897262345,0,24,0 +m_1,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.9634217844929773,0.3478518927597188,0.42663630392733626,0.22091996286104265,0.23828704167171916,1,1.3900580884203135,0.5687718556207615,1.529063897262345,0,24,0 +m_1,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.9634217844929773,0.5935809065531372,0.42663630392733626,0.157665985981169,0.4455968078777234,1,1.3900580884203135,0.7512468925343062,1.529063897262345,0,24,0 +m_1,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.6091234888948323,0.5474945380105819,0.26959532635741457,0.12586145475347751,0.8417341799020336,1,0.8787188152522468,0.6733559927640594,0.9665906967774716,0,24,0 +m_1,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.6091234888948323,0.6647948735830382,0.26959532635741457,0.1882699836313562,0.8693273080717017,1,0.8787188152522468,0.8530648572143944,0.9665906967774716,0,24,0 +m_1,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.6091234888948323,0.29769520877828065,0.26959532635741457,0.11181211411339657,0.32304221304517255,1,0.8787188152522468,0.40950732289167724,0.9665906967774716,0,24,0 +m_1,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.6177248288403355,0.5918048106122107,0.27770052025139447,0.3272658087519123,0.9530657637368163,1,0.89542534909173,0.9190706193641229,1.0109776813005353,0,24,0 +m_1,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.6177248288403355,0.3786066095674548,0.27770052025139447,0.18783879811851167,0.49421783376391737,1,0.89542534909173,0.5664454076859664,1.0109776813005353,0,24,0 +m_1,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.6177248288403355,0.6017347671602691,0.27770052025139447,0.1934337755651939,0.9633557257360896,1,0.89542534909173,0.795168542725463,1.0109776813005353,0,24,0 +m_1,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.33350241418019294,0.49838199692136775,0.1751899090523738,0.2340756821740746,0.5861914989267023,1,0.5086923232325667,0.7324576790954423,1.0558079386727115,0,24,0 +m_1,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.33350241418019294,0.4250509172000538,0.1751899090523738,0.18675595924361268,0.7281623828164144,1,0.5086923232325667,0.6118068764436665,1.0558079386727115,0,24,0 +m_1,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.33350241418019294,0.7414899616439693,0.1751899090523738,0.2183354371494048,0.1770697813642229,1,0.5086923232325667,0.959825398793374,1.0558079386727115,0,24,0 +m_2,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.7810640846901244,0.43956107898694247,0.35227189265155645,0.2017992754189262,0.4301147182800219,1,1.133335977341681,0.6413603544058687,1.535922370016726,0,24,0 +m_2,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.7810640846901244,1.060065349085094,0.35227189265155645,0.33622771456647493,0.5810689877663504,1,1.133335977341681,1.396293063651569,1.535922370016726,0,24,0 +m_2,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.7810640846901244,0.7129759062426002,0.35227189265155645,0.2136551787263532,0.8735753017099741,1,1.133335977341681,0.9266310849689534,1.535922370016726,0,24,0 +m_2,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.5194900431331457,0.5965508103808851,0.1849187485163972,0.1920750790813686,0.7784734312086494,1,0.704408791649543,0.7886258894622536,2.4668388755578685,0,24,0 +m_2,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.5194900431331457,1.491702530964676,0.1849187485163972,0.7508782649970223,0.2585305938156722,1,0.704408791649543,2.2425807959616986,2.4668388755578685,0,24,0 +m_2,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.5194900431331457,0.902808152405915,0.1849187485163972,0.23919225636209243,0.23534322164739127,1,0.704408791649543,1.1420004087680076,2.4668388755578685,0,24,0 +m_2,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1607841388702667,0.42357646201689136,0.08591667594363253,0.20904519349376469,0.2852685359483802,1,0.24670081481389924,0.6326216555106561,1.1496198249186835,0,24,0 +m_2,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1607841388702667,0.3586399037773872,0.08591667594363253,0.17487713405516228,0.3501935100610495,1,0.24670081481389924,0.5335170378325494,1.1496198249186835,0,24,0 +m_2,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1607841388702667,0.77349807285934,0.08591667594363253,0.2716108588849177,0.07520613154757716,1,0.24670081481389924,1.0451089317442577,1.1496198249186835,0,24,0 +m_2,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.29348781478381475,1.1378590041399408,0.20468670438960954,0.41528336892677564,0.10981460272625655,1,0.49817451917342426,1.5531423730667164,1.7084566103733883,0,24,0 +m_2,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.29348781478381475,0.5059116158352889,0.20468670438960954,0.18784661738317118,0.46482393023791835,1,0.49817451917342426,0.6937582332184601,1.7084566103733883,0,24,0 +m_2,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.29348781478381475,0.5052342107252712,0.20468670438960954,0.14670219456329484,0.4262098710151917,1,0.49817451917342426,0.651936405288566,1.7084566103733883,0,24,0 +m_2,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2404523329747442,0.13132735194815334,0.08558842821443975,0.03365134848999143,0.27688678821814716,1,0.32604076118918396,0.16497870043814478,0.35864483730810237,0,24,0 +m_2,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2404523329747442,0.0593115229865356,0.08558842821443975,0.02279009053389007,0.08925260861747,1,0.32604076118918396,0.08210161352042566,0.35864483730810237,0,24,0 +m_2,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2404523329747442,0.1658686167355378,0.08558842821443975,0.07883524927845653,0.5360576178730417,1,0.32604076118918396,0.24470386601399433,0.35864483730810237,0,24,0 +m_2,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.58856914340598665,0.06552943020070738,0.15048770510266637,0.015023289118196902,0.017508416520412743,0.31520420285856576,0.739056848508653,0.08055271931890429,0.8129625333595184,0,24,0 +m_2,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.58856914340598665,0.07190916875988355,0.15048770510266637,0.041272437212599856,0.017244129038066904,0.31520420285856576,0.739056848508653,0.11318160597248342,0.8129625333595184,0,24,0 +m_2,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.58856914340598665,0.06359722546995439,0.15048770510266637,0.03198224095338737,0.016589694887292936,0.31520420285856576,0.739056848508653,0.09557946642334175,0.8129625333595184,0,24,0 +m_2,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.41645666129574455,0.06500309369687234,0.04517981734312816,0.025294889432885968,1.5196953327611213e-4,0.003495299265350579,0.4616364786388727,0.0902979831297583,0.50780012650276,0,24,0 +m_2,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.41645666129574455,0.22295571380281368,0.04517981734312816,0.10223889156638688,0.12777849436182828,1,0.4616364786388727,0.32519460536920053,0.50780012650276,0,24,0 +m_2,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.41645666129574455,0.05449169556654162,0.04517981734312816,0.029243521228042302,1.0855001650402321e-4,0.0026052003960965573,0.4616364786388727,0.08373521679458393,0.50780012650276,0,24,0 +m_2,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.36980553585962045,0.11903631230584133,0.05839222828981127,0.05101685818614985,0.009163601069004169,0.19243562244908755,0.4281977641494317,0.17005317049199117,0.47101754056437495,0,24,0 +m_2,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.36980553585962045,0.14077638465609552,0.05839222828981127,0.03532710567506236,0.009595767652804173,0.19243562244908755,0.4281977641494317,0.17610349033115788,0.47101754056437495,0,24,0 +m_2,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.36980553585962045,0.10821694925606044,0.05839222828981127,0.040848393685601586,0.00519917687646674,0.11438189128226828,0.4281977641494317,0.14906534294166202,0.47101754056437495,0,24,0 +m_3,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2302231147207691,0.14835412023197406,0.1460047634527979,0.061730423378725405,0.6259123792547114,1,0.37622787817356695,0.21008454361069945,0.6523978924648782,0,24,0 +m_3,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2302231147207691,0.31896207400528204,0.1460047634527979,0.1410904343864715,0.6725835387495808,1,0.37622787817356695,0.46005250839175355,0.6523978924648782,0,24,0 +m_3,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2302231147207691,0.45945029748891836,0.1460047634527979,0.13363869566097095,0.2777850540247397,1,0.37622787817356695,0.5930889931498893,0.6523978924648782,0,24,0 +m_3,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1321379263720681,0.279974915214152,0.051810286278762815,0.13138556882218436,0.33246223008606907,1,0.1839482126508309,0.4113604840363364,0.7711891285064068,0,24,0 +m_3,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1321379263720681,0.5372065986590526,0.051810286278762815,0.1638744272558625,0.05660013720615858,1,0.1839482126508309,0.7010810259149152,0.7711891285064068,0,24,0 +m_3,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1321379263720681,0.32734841511296975,0.051810286278762815,0.1351537219956452,0.22295177611855627,1,0.1839482126508309,0.462502137108615,0.7711891285064068,0,24,0 +m_3,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.24176739827667176,0.3509576631574625,0.1127512803637199,0.1975409531806801,0.6444289813842035,1,0.35451867864039166,0.5484986163381427,0.7695688157342724,0,24,0 +m_3,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.24176739827667176,0.41396924031185406,0.1127512803637199,0.2856387739920299,0.5981930820250578,1,0.35451867864039166,0.699608014303884,0.7695688157342724,0,24,0 +m_3,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.24176739827667176,0.3759062376939201,0.1127512803637199,0.14936752684737908,0.49217821517154436,1,0.35451867864039166,0.5252737645412993,0.7695688157342724,0,24,0 +m_3,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.25358633129948377,0.33489983840944976,0.16344607092343494,0.05213477114681293,0.6562313299713642,1,0.4170324022229187,0.3870346095562627,0.7213756273564704,0,24,0 +m_3,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.25358633129948377,0.44304134738092926,0.16344607092343494,0.21275467748858917,0.4983397366042511,1,0.4170324022229187,0.6557960248695185,0.7213756273564704,0,24,0 +m_3,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.25358633129948377,0.3660789910905694,0.16344607092343494,0.1236570595941394,0.5983810393133167,1,0.4170324022229187,0.4897360506847088,0.7213756273564704,0,24,0 +m_3,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.3439130001784489,0.5032234614205051,0.17224044280057915,0.09087933605321467,0.4382766421719505,1,0.516153442979028,0.5941027974737197,0.6535130772210918,0,24,0 +m_3,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.3439130001784489,0.2620491844537752,0.17224044280057915,0.12198001189552193,0.707118033422329,1,0.516153442979028,0.3840291963492971,0.6535130772210918,0,24,0 +m_3,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.3439130001784489,0.37167685582049026,0.17224044280057915,0.15952488531099174,0.9082154096038872,1,0.516153442979028,0.531201741131482,0.6535130772210918,0,24,0 +m_3,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.330569526727754,0.2750861367660502,0.17586538131900242,0.07610661168369874,0.7807860685911179,1,0.5064349080467565,0.35119274844974896,0.5570783988514322,0,24,0 +m_3,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.330569526727754,0.36370295420772264,0.17586538131900242,0.08931269592519293,0.8710864222737175,1,0.5064349080467565,0.45301565013291556,0.5570783988514322,0,24,0 +m_3,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.330569526727754,0.22718992594794243,0.17586538131900242,0.0897257821663491,0.6157781811100393,1,0.5064349080467565,0.31691570811429154,0.5570783988514322,0,24,0 +m_3,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.3182812837631292,0.336247481698249,0.15128044450176417,0.09284627812904163,0.9217803018566647,1,0.4695617282648934,0.4290937598272906,0.5165179010913827,0,24,0 +m_3,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.3182812837631292,0.2848401576093994,0.15128044450176417,0.05803867324673594,0.8428601920538566,1,0.4695617282648934,0.34287883085613535,0.5165179010913827,0,24,0 +m_3,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.3182812837631292,0.17367595289186688,0.15128044450176417,0.03965722016032272,0.39271993911499375,1,0.4695617282648934,0.2133331730521896,0.5165179010913827,0,24,0 +m_3,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.20183293815143466,0.5147221406249518,0.08723983431598287,0.20606414428851583,0.2063438482909004,1,0.2890727724674175,0.7207862849134676,0.7928649134048145,0,24,0 +m_3,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.20183293815143466,0.19055377496195944,0.08723983431598287,0.0899483551640415,0.9300557154200424,1,0.2890727724674175,0.28050213012600095,0.7928649134048145,0,24,0 +m_3,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.20183293815143466,0.23938376168412664,0.08723983431598287,0.07687838684510834,0.7534997049557823,1,0.2890727724674175,0.31626214852923495,0.7928649134048145,0,24,0 +m_4,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3145457567512343,0.12518025124182255,0.12170018482430693,0.05024587053920819,0.2061347630223882,1,0.43624594157554125,0.17542612178103073,0.4798705357330954,0,24,0 +m_4,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3145457567512343,0.1411087566158351,0.12170018482430693,0.02969003635245943,0.23121310721149102,1,0.43624594157554125,0.17079879296829453,0.4798705357330954,0,24,0 +m_4,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3145457567512343,0.3061279387969536,0.12170018482430693,0.08130215301733595,0.9556952213937178,1,0.43624594157554125,0.38743009181428956,0.4798705357330954,0,24,0 +m_4,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.20535799810809888,0.2259826780119085,0.07890362323444308,0.11057111669735403,0.8826512406409972,1,0.28426162134254196,0.3365537947092625,0.3702091741801888,0,24,0 +m_4,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.20535799810809888,0.14076208592340667,0.07890362323444308,0.041966063852532584,0.49139319288495653,1,0.28426162134254196,0.18272814977593926,0.3702091741801888,0,24,0 +m_4,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.20535799810809888,0.10835456166451474,0.07890362323444308,0.027420841506297353,0.28834678971947825,1,0.28426162134254196,0.1357754031708121,0.3702091741801888,0,24,0 +m_4,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11346237107188983,0.20072754299161108,0.07019514680978228,0.055636452869349325,0.35825344351665106,1,0.18365751788167212,0.2563639958609604,0.28719786914146384,0,24,0 +m_4,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11346237107188983,0.1555508785137763,0.07019514680978228,0.06322018919856559,0.6678699959147131,1,0.18365751788167212,0.2187710677123419,0.28719786914146384,0,24,0 +m_4,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11346237107188983,0.1999162605251393,0.07019514680978228,0.06117271142164595,0.3788325571220461,1,0.18365751788167212,0.26108897194678526,0.28719786914146384,0,24,0 +m_4,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13243592727798897,0.16110172747280047,0.06573235034526784,0.07750822347407914,0.7842892012113318,1,0.1981682776232568,0.2386099509468796,0.6817187575104596,0,24,0 +m_4,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13243592727798897,0.44041348432903127,0.06573235034526784,0.1793308406804774,0.15569399752421847,1,0.1981682776232568,0.6197443250095087,0.6817187575104596,0,24,0 +m_4,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13243592727798897,0.2749142756272523,0.06573235034526784,0.098631128129106,0.2622596824059859,1,0.1981682776232568,0.3735454037563583,0.6817187575104596,0,24,0 +m_4,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.17672209274212816,0.11519325787348489,0.059390009558031344,0.0409687570755816,0.4161830945292473,1,0.2361121023001595,0.15616201494906648,0.36080832322314454,0,24,0 +m_4,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.17672209274212816,0.23306184956912493,0.059390009558031344,0.09494571699737009,0.6278452753223114,1,0.2361121023001595,0.328007566566495,0.36080832322314454,0,24,0 +m_4,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.17672209274212816,0.11792727773894003,0.059390009558031344,0.07127001936551652,0.540915997011687,1,0.2361121023001595,0.18919729710445654,0.36080832322314454,0,24,0 +m_4,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16533517433843112,0.12729326635838345,0.07666103736587702,0.03317276136180799,0.6629696900100055,1,0.24199621170430813,0.16046602772019145,0.26619583287473897,0,24,0 +m_4,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16533517433843112,0.08700203191971627,0.07666103736587702,0.045453182687132894,0.4046693124688995,1,0.24199621170430813,0.13245521460684917,0.26619583287473897,0,24,0 +m_4,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16533517433843112,0.129221549533993,0.07666103736587702,0.04206927603661607,0.6907917729998925,1,0.24199621170430813,0.17129082557060907,0.26619583287473897,0,24,0 +m_4,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.06349084011043378,0.16060871186621398,0.017049043941219432,0.036396545378917886,0.04588741572560352,1,0.08053988405165322,0.19700525724513185,0.31109068505654736,0,24,0 +m_4,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06349084011043378,0.2208605830197609,0.017049043941219432,0.061949130668009424,0.051573655872840275,1,0.08053988405165322,0.2828097136877703,0.31109068505654736,0,24,0 +m_4,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06349084011043378,0.20132621098776107,0.017049043941219432,0.05511202666115385,0.05443853340824004,1,0.08053988405165322,0.25643823764891494,0.31109068505654736,0,24,0 +m_4,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09074605130189199,0.273089440162362,0.03533754444138896,0.10587388482082741,0.15263204803640157,1,0.12608359574328096,0.3789633249831894,0.4168596574815084,0,24,0 +m_4,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09074605130189199,0.12177630057249285,0.03533754444138896,0.0715888675990831,0.7086033384080365,1,0.12608359574328096,0.19336516817157595,0.4168596574815084,0,24,0 +m_4,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09074605130189199,0.12795954078998006,0.03533754444138896,0.04523438240021766,0.5322278856114941,1,0.12608359574328096,0.17319392319019772,0.4168596574815084,0,24,0 +m_5,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.21292433407271547,0.20710339295236993,0.07187457826779288,0.06627863765945227,0.9538726428549702,1,0.28479891234050836,0.2733820306118222,0.31327880357455923,0,24,0 +m_5,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.21292433407271547,0.15274604325002628,0.07187457826779288,0.07106077784020007,0.5664631198472332,1,0.28479891234050836,0.22380682109022634,0.31327880357455923,0,24,0 +m_5,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.21292433407271547,0.1703105674788008,0.07187457826779288,0.04627216546853372,0.6333252135757059,1,0.28479891234050836,0.21658273294733452,0.31327880357455923,0,24,0 +m_5,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10595819294264645,0.25010809242626325,0.03452807001100758,0.060229179617141484,0.07166670065454063,1,0.14048626295365402,0.3103372720434047,0.3413709992477452,0,24,0 +m_5,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10595819294264645,0.07653099127038428,0.03452807001100758,0.018782844979164746,0.4762444492681034,1,0.14048626295365402,0.09531383624954902,0.3413709992477452,0,24,0 +m_5,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10595819294264645,0.12834893803656713,0.03452807001100758,0.0497265783529053,0.7201237310247679,1,0.14048626295365402,0.17807551638947244,0.3413709992477452,0,24,0 +m_5,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14620747798472422,0.14369677216267088,0.06361402106588207,0.06493117277980337,0.9785724813385189,1,0.2098214990506063,0.20862794494247425,0.23668784165556503,0,24,0 +m_5,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14620747798472422,0.16188353480545006,0.06361402106588207,0.0532872303359727,0.8550126964894849,1,0.2098214990506063,0.21517076514142275,0.23668784165556503,0,24,0 +m_5,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14620747798472422,0.07104271719482484,0.06361402106588207,0.03395806261831931,0.3361651382417876,1,0.2098214990506063,0.10500077981314415,0.23668784165556503,0,24,0 +m_5,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.26100624209999096,0.2675379842245397,0.06925739655385188,0.12464230106617025,0.9646364842378932,1,0.33026363865384284,0.39218028529071,0.431398313819781,0,24,0 +m_5,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.26100624209999096,0.23404373492663302,0.06925739655385188,0.04700275457741362,0.756390294142635,1,0.33026363865384284,0.28104648950404665,0.431398313819781,0,24,0 +m_5,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.26100624209999096,0.20720517435179753,0.06925739655385188,0.06597570341306098,0.587880220958922,1,0.33026363865384284,0.2731808777648585,0.431398313819781,0,24,0 +m_5,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06045377256546717,0.05796836128420576,0.020392598795850075,0.02025503185195701,0.9327982271228383,1,0.08084637136131724,0.07822339313616278,0.09976116446076048,0,24,0 +m_5,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06045377256546717,0.05969090991808009,0.020392598795850075,0.03100105777352033,0.984064514597402,1,0.08084637136131724,0.09069196769160043,0.09976116446076048,0,24,0 +m_5,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06045377256546717,0.06756435926995596,0.020392598795850075,0.01920829223547325,0.8047971067016186,1,0.08084637136131724,0.08677265150542922,0.09976116446076048,0,24,0 +m_5,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.034631721480141785,0.05456251320050084,0.016085526846939705,0.02184407379855787,0.48084490322344453,1,0.05071724832708149,0.07640658699905871,0.23908004589257636,0,24,0 +m_5,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.034631721480141785,0.13214623002716866,0.016085526846939705,0.08519926623880984,0.308587357447421,1,0.05071724832708149,0.2173454962659785,0.23908004589257636,0,24,0 +m_5,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.034631721480141785,0.10326823164840711,0.016085526846939705,0.07679122325561896,0.41862748054665483,1,0.05071724832708149,0.18005945490402608,0.23908004589257636,0,24,0 +m_5,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06948346099124691,0.039087376571411404,0.02766739623312042,0.01287662802619169,0.3520983967996138,1,0.09715085722436734,0.05196400459760309,0.16231584215801753,0,24,0 +m_5,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06948346099124691,0.09995304554332396,0.02766739623312042,0.047606810963964685,0.5950792610175424,1,0.09715085722436734,0.14755985650728864,0.16231584215801753,0,24,0 +m_5,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06948346099124691,0.05107680166577463,0.02766739623312042,0.01947400627016501,0.5996671217426663,1,0.09715085722436734,0.07055080793593964,0.16231584215801753,0,24,0 +m_5,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06413063485225783,0.043804500827247995,0.016837516192478925,0.017829097262535884,0.42658675565526105,1,0.08096815104473676,0.06163359808978388,0.13212340016524338,0,24,0 +m_5,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06413063485225783,0.05413065088753514,0.016837516192478925,0.016116814493549285,0.6770069827404854,1,0.08096815104473676,0.07024746538108442,0.13212340016524338,0,24,0 +m_5,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06413063485225783,0.08409250622076632,0.016837516192478925,0.03601967574763675,0.6308556217329231,1,0.08096815104473676,0.12011218196840306,0.13212340016524338,0,24,0 +m_6,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3254196195260456,0.16686397561727895,0.14333475326387146,0.07088975897454193,0.3602414764622193,1,0.46875437278991705,0.23775373459182086,0.5156298100689088,0,24,0 +m_6,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3254196195260456,0.27652911623706783,0.14333475326387146,0.12768766299826254,0.8049775692876413,1,0.46875437278991705,0.4042167792353304,0.5156298100689088,0,24,0 +m_6,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3254196195260456,0.23080372049498346,0.14333475326387146,0.06085543960410249,0.5679614367751431,1,0.46875437278991705,0.29165916009908593,0.5156298100689088,0,24,0 +m_6,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10984711225002042,0.24114374879734365,0.037441209225458724,0.1296860674085795,0.3693303763137598,1,0.14728832147547916,0.37082981620592315,0.4079127978265155,0,24,0 +m_6,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10984711225002042,0.11624816110664811,0.037441209225458724,0.041863081386692244,0.9115437626190027,1,0.14728832147547916,0.15811124249334035,0.4079127978265155,0,24,0 +m_6,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10984711225002042,0.10497391158229892,0.037441209225458724,0.031080583605824656,0.9222729973251975,1,0.14728832147547916,0.13605449518812357,0.4079127978265155,0,24,0 +m_6,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10756362732716034,0.08680328271385189,0.04665964887717518,0.03499051347621509,0.7313141246251386,1,0.1542232762043355,0.12179379619006697,0.6774067991148656,0,24,0 +m_6,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10756362732716034,0.39103084332804894,0.04665964887717518,0.224793519503647,0.27952906447062553,1,0.1542232762043355,0.615824362831696,0.6774067991148656,0,24,0 +m_6,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10756362732716034,0.11180905827396719,0.04665964887717518,0.011480996661833878,0.9334033841068892,1,0.1542232762043355,0.12329005493580106,0.6774067991148656,0,24,0 +m_6,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.198498914701387,0.19307367135333722,0.11613701115466411,0.06429596701118304,0.9686551411532351,1,0.3146359258560511,0.25736963836452026,0.34609951844165626,0,24,0 +m_6,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.198498914701387,0.17657705234009993,0.11613701115466411,0.06395835122383343,0.8738299262510402,1,0.3146359258560511,0.24053540356393338,0.34609951844165626,0,24,0 +m_6,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.198498914701387,0.15594880518319307,0.11613701115466411,0.05260065857693363,0.75067112782333,1,0.3146359258560511,0.2085494637601267,0.34609951844165626,0,24,0 +m_6,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07072871139382479,0.13611795367742863,0.020344738876762396,0.04709705767823881,0.24426903013320508,1,0.09107345027058719,0.18321501135566742,0.28091510838444217,0,24,0 +m_6,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07072871139382479,0.15614992679255538,0.020344738876762396,0.09922744446602842,0.4346819554843908,1,0.09107345027058719,0.2553773712585838,0.28091510838444217,0,24,0 +m_6,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07072871139382479,0.09934144037348373,0.020344738876762396,0.027433402926578997,0.4233470755783626,1,0.09107345027058719,0.12677484330006272,0.28091510838444217,0,24,0 +m_6,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13146557016176508,0.14836787017292574,0.06268455434735659,0.07629270179641982,0.8676251785060274,1,0.19415012450912167,0.22466057196934558,0.24712662916628017,0,24,0 +m_6,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13146557016176508,0.07442920177145022,0.06268455434735659,0.028530681982675412,0.4349596424622755,1,0.19415012450912167,0.10295988375412564,0.24712662916628017,0,24,0 +m_6,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13146557016176508,0.11934985235990585,0.06268455434735659,0.04195172336600288,0.8760419047804093,1,0.19415012450912167,0.16130157572590872,0.24712662916628017,0,24,0 +m_6,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10524066517917907,0.21414536318631863,0.024900217606335286,0.057739051726589496,0.12816042356331617,1,0.13014088278551436,0.27188441491290816,0.299072856404199,0,24,0 +m_6,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10524066517917907,0.15023608924013884,0.024900217606335286,0.050529574256157145,0.4496559127647318,1,0.13014088278551436,0.200765663496296,0.299072856404199,0,24,0 +m_6,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10524066517917907,0.13386957516575182,0.024900217606335286,0.03641644808654123,0.5328694775055667,1,0.13014088278551436,0.17028602325229306,0.299072856404199,0,24,0 +m_6,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16831058183837866,0.11302202317780212,0.06214148048531241,0.024745955875405224,0.4375516831359101,1,0.23045206232369106,0.13776797905320734,0.6868555862948388,0,24,0 +m_6,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16831058183837866,0.24840123196702782,0.06214148048531241,0.15127565352743327,0.6400880539539364,1,0.23045206232369106,0.3996768854944611,0.6868555862948388,0,24,0 +m_6,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16831058183837866,0.4309651599386685,0.06214148048531241,0.1934490094202758,0.2435056571908786,1,0.23045206232369106,0.6244141693589443,0.6868555862948388,0,24,0 +m_7,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14344361543419634,0.12894352363312775,0.05395252017560365,0.03456958641895927,0.8274301062527203,1,0.1973961356098,0.16351311005208702,0.3587576538913388,0,24,0 +m_7,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14344361543419634,0.23091754960327052,0.05395252017560365,0.09522577211612836,0.448017471026421,1,0.1973961356098,0.32614332171939886,0.3587576538913388,0,24,0 +m_7,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14344361543419634,0.1361331383390675,0.05395252017560365,0.04917677184957762,0.9225177032449201,1,0.1973961356098,0.18530991018864512,0.3587576538913388,0,24,0 +m_7,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12224703106675512,0.34079756750101176,0.035944661434821785,0.1037477474718795,0.09223846246772478,1,0.1581916925015769,0.44454531497289124,0.4889998464701804,0,24,0 +m_7,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12224703106675512,0.18356824573140507,0.035944661434821785,0.07015178312218041,0.46056984026248615,1,0.1581916925015769,0.25372002885358547,0.4889998464701804,0,24,0 +m_7,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12224703106675512,0.09506048142546113,0.035944661434821785,0.05408463753201852,0.6856269753629309,1,0.1581916925015769,0.14914511895747964,0.4889998464701804,0,24,0 +m_7,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.193940427251258,0.18708562071396295,0.08029009257913011,0.10146243821064041,0.9589222644842423,1,0.27423051983038815,0.28854805892460333,0.3880179924265468,0,24,0 +m_7,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.193940427251258,0.2223781138831736,0.08029009257913011,0.13036551559550524,0.8581858286651431,1,0.27423051983038815,0.3527436294786789,0.3880179924265468,0,24,0 +m_7,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.193940427251258,0.1318412982517043,0.08029009257913011,0.03032115270931637,0.5009245871342434,1,0.27423051983038815,0.16216245096102067,0.3880179924265468,0,24,0 +m_7,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1754668892032391,0.1286871174037608,0.059917066417378886,0.030521110432129718,0.5125704515702549,1,0.23538395562061798,0.1592082278358905,0.3476568972761619,0,24,0 +m_7,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1754668892032391,0.23279916271995593,0.059917066417378886,0.08325256207655488,0.5904088180371299,1,0.23538395562061798,0.3160517247965108,0.3476568972761619,0,24,0 +m_7,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1754668892032391,0.1954808147097048,0.059917066417378886,0.04275910077879587,0.7929948593852156,1,0.23538395562061798,0.23823991548850065,0.3476568972761619,0,24,0 +m_7,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.24383811269689168,0.18096301891644004,0.11097080753343572,0.07290959706759577,0.6475715052843155,1,0.3548089202303274,0.2538726159840358,0.3902898122533602,0,24,0 +m_7,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.24383811269689168,0.19398001763692774,0.11097080753343572,0.06935264862486593,0.7126691426033986,1,0.3548089202303274,0.26333266626179364,0.3902898122533602,0,24,0 +m_7,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.24383811269689168,0.22595166349464893,0.11097080753343572,0.10428777040900002,0.9088343484077268,1,0.3548089202303274,0.33023943390364896,0.3902898122533602,0,24,0 +m_7,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14828577556372755,0.10589245391976794,0.04941630176176202,0.03116816063408526,0.48772129869420144,1,0.19770207732548956,0.1370606145538532,0.3158261771534923,0,24,0 +m_7,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14828577556372755,0.14236686683140817,0.04941630176176202,0.08867091652608429,0.9549633600290105,1,0.19770207732548956,0.23103778335749248,0.3158261771534923,0,24,0 +m_7,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14828577556372755,0.23313917725953828,0.04941630176176202,0.05397552924363655,0.27338607841379026,1,0.19770207732548956,0.28711470650317483,0.3158261771534923,0,24,0 +m_7,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.26030969561091616,0.1190047851315265,0.04633452665764666,0.060555532416042154,0.09558413531828203,1,0.3066442222685628,0.17956031754756865,0.3373086444954191,0,24,0 +m_7,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.26030969561091616,0.0730156383144176,0.04633452665764666,0.0167032481368512,0.008209460629235837,0.19702705510166008,0.3066442222685628,0.0897188864512688,0.3373086444954191,0,24,0 +m_7,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.26030969561091616,0.15681516523213065,0.04633452665764666,0.00994768257496538,0.07614126370216578,1,0.3066442222685628,0.16676284780709605,0.3373086444954191,0,24,0 +m_7,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10379355561726948,0.18229848068845214,0.0486772908920819,0.061464852320255406,0.3415136225952059,1,0.1524708465093514,0.24376333300870756,0.26813966630957836,0,24,0 +m_7,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10379355561726948,0.053541576051052774,0.0486772908920819,0.014983390765186188,0.3622817612424658,1,0.1524708465093514,0.06852496681623896,0.26813966630957836,0,24,0 +m_7,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10379355561726948,0.15716182512433718,0.0486772908920819,0.0747233881199816,0.5649832114975104,1,0.1524708465093514,0.23188521324431877,0.26813966630957836,0,24,0 +m_8,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.04938118110515903,0.16843446969166856,0.02504281970404705,0.05342608409266119,0.08332353215381848,1,0.07442400080920608,0.22186055378432976,0.3021596080238995,0,24,0 +m_8,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04938118110515903,0.1831544627136866,0.02504281970404705,0.09153609003531293,0.2104932380443678,1,0.07442400080920608,0.27469055274899956,0.3021596080238995,0,24,0 +m_8,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04938118110515903,0.043369249161876754,0.02504281970404705,0.02054688107011678,0.8572631477031367,1,0.07442400080920608,0.06391613023199354,0.3021596080238995,0,24,0 +m_8,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14457290163529216,0.09678252373856759,0.046984284413040873,0.03266156801217171,0.4254244393833567,1,0.19155718604833302,0.1294440917507393,0.21071290465316633,0,24,0 +m_8,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14457290163529216,0.12091244856623203,0.046984284413040873,0.02355049168259543,0.6655277682934564,1,0.19155718604833302,0.14446294024882744,0.21071290465316633,0,24,0 +m_8,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14457290163529216,0.1277283006364717,0.046984284413040873,0.050121644984160024,0.8112877320506433,1,0.19155718604833302,0.17784994562063172,0.21071290465316633,0,24,0 +m_8,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1672309303318626,0.1375095691226703,0.11184282398237717,0.07666915118371502,0.8324719179239131,1,0.27907375431423975,0.2141787203063853,0.30698112974566377,0,24,0 +m_8,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1672309303318626,0.17161297483629992,0.11184282398237717,0.051629186686190445,0.9728500627830788,1,0.27907375431423975,0.22324216152249038,0.30698112974566377,0,24,0 +m_8,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1672309303318626,0.10848690480878968,0.11184282398237717,0.03310492246577906,0.6372092783304828,1,0.27907375431423975,0.14159182727456876,0.30698112974566377,0,24,0 +m_8,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.18229209819579073,0.11728274041166568,0.07538401884130744,0.04931858469512005,0.4935363853696696,1,0.25767611703709814,0.16660132510678574,0.36367517175984254,0,24,0 +m_8,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.18229209819579073,0.23638093004677896,0.07538401884130744,0.09423286246216875,0.6647157087373029,1,0.25767611703709814,0.33061379250894773,0.36367517175984254,0,24,0 +m_8,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.18229209819579073,0.1469900086664434,0.07538401884130744,0.027505829889132288,0.678132183870354,1,0.25767611703709814,0.17449583855557568,0.36367517175984254,0,24,0 +m_8,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05852650935629292,0.05788973783512352,0.025965625945442123,0.020739789873856884,0.9851073028374681,1,0.08449213530173505,0.0786295277089804,0.1749304119453544,0,24,0 +m_8,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05852650935629292,0.05227753458144805,0.025965625945442123,0.022388756717354855,0.8590942994522787,1,0.08449213530173505,0.07466629129880291,0.1749304119453544,0,24,0 +m_8,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05852650935629292,0.09930383992837943,0.025965625945442123,0.05972380729467003,0.5515746096814995,1,0.08449213530173505,0.15902764722304946,0.1749304119453544,0,24,0 +m_8,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05697733512385931,0.05014549175380726,0.017631681131695436,0.015887614045944617,0.7793989050796002,1,0.07460901625555474,0.06603310579975188,0.1072486936666414,0,24,0 +m_8,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05697733512385931,0.06273253041750644,0.017631681131695436,0.021000848688324046,0.8380978205413043,1,0.07460901625555474,0.08373337910583048,0.1072486936666414,0,24,0 +m_8,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05697733512385931,0.07376422700092104,0.017631681131695436,0.0237345854232984,0.5837437297997132,1,0.07460901625555474,0.09749881242421944,0.1072486936666414,0,24,0 +m_8,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04081305673141222,0.10541872581613425,0.018018519262733658,0.03306446211665466,0.12587478452862416,1,0.05883157599414588,0.1384831879327889,0.1600762530380241,0,24,0 +m_8,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04081305673141222,0.10356851877320301,0.018018519262733658,0.0419553476250007,0.21300476089619766,1,0.05883157599414588,0.14552386639820372,0.1600762530380241,0,24,0 +m_8,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04081305673141222,0.04678457864543306,0.018018519262733658,0.018825588842971842,0.8233764833506596,1,0.05883157599414588,0.0656101674884049,0.1600762530380241,0,24,0 +m_8,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05529999665402996,0.038933476415160394,0.03153163240424199,0.016110125615942227,0.6571335189566319,1,0.08683162905827195,0.05504360203110262,0.09978810826549969,0,24,0 +m_8,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05529999665402996,0.07352184304055731,0.03153163240424199,0.01719461901898786,0.626053938438567,1,0.08683162905827195,0.09071646205954517,0.09978810826549969,0,24,0 +m_8,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05529999665402996,0.06403811474715286,0.03153163240424199,0.011375386066151,0.8026797742118885,1,0.08683162905827195,0.07541350081330386,0.09978810826549969,0,24,0 +m_9,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2414459082718025,0.3626588687975597,0.13669340894924095,0.10189081843952819,0.4979060261314202,1,0.37813931722104344,0.4645496872370879,0.5110046559607967,0,24,0 +m_9,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2414459082718025,0.18932902034821528,0.13669340894924095,0.07811377302863337,0.7510574596387154,1,0.37813931722104344,0.2674427933768486,0.5110046559607967,0,24,0 +m_9,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2414459082718025,0.274521018089525,0.13669340894924095,0.08720171354203744,0.8441705209847838,1,0.37813931722104344,0.36172273163156243,0.5110046559607967,0,24,0 +m_9,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.343496881994502,0.3967225246974582,0.07847607141916078,0.13743061429422718,0.7453363514058251,1,0.4219729534136628,0.5341531389916854,0.5875684528908539,0,23,0 +m_9,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.343496881994502,0.18739238158745394,0.07847607141916078,0.06193873734551267,0.15335336030023414,1,0.4219729534136628,0.2493311189329666,0.5875684528908539,0,23,0 +m_9,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.343496881994502,0.2552940787590794,0.07847607141916078,0.07973993710912591,0.44876713341959196,1,0.4219729534136628,0.3350340158682053,0.5875684528908539,0,23,0 +m_9,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10870403321661817,0.23451754453130283,0.03930811259749626,0.15911750287680373,0.47380841642519544,1,0.14801214581411443,0.39363504740810656,0.43299855214891725,0,24,0 +m_9,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10870403321661817,0.220917945085718,0.03930811259749626,0.13365254852940142,0.4594368539788232,1,0.14801214581411443,0.3545704936151194,0.43299855214891725,0,24,0 +m_9,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10870403321661817,0.28056743932930184,0.03930811259749626,0.09446483011803916,0.13927285351208718,1,0.14801214581411443,0.375032269447341,0.43299855214891725,0,24,0 +m_9,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07616883436534119,0.14415812307658007,0.026518224471377007,0.044898828528876035,0.22901271383398747,1,0.10268705883671819,0.1890569516054561,0.3589602042885568,0,24,0 +m_9,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07616883436534119,0.12630130087902472,0.026518224471377007,0.04380508274675704,0.3562615379671354,1,0.10268705883671819,0.17010638362578176,0.3589602042885568,0,24,0 +m_9,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07616883436534119,0.23295834807650195,0.026518224471377007,0.09336911036764055,0.15913066599107756,1,0.10268705883671819,0.3263274584441425,0.3589602042885568,0,24,0 +m_9,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.015335570245592697,0.008692246803952678,0.005206051844875975,0.0038431823380767156,0.33082013347284855,1,0.020541622090468673,0.012535429142029392,0.03571977714851753,0,24,0 +m_9,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.015335570245592697,0.0037547378105754112,0.005206051844875975,0.0022982479925907993,0.08202822324537466,1,0.020541622090468673,0.006052985803166211,0.03571977714851753,0,24,0 +m_9,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.015335570245592697,0.02109831342064683,0.005206051844875975,0.011374211259823653,0.658980272264756,1,0.020541622090468673,0.03247252468047048,0.03571977714851753,0,24,0 +m_9,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.022065196324419167,0.02153167559821223,0.0082667300153361975,0.006128728844959709,0.9597583447662119,1,0.030331926339755365,0.02766040444317194,0.0333651189737309,0,24,0 +m_9,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.022065196324419167,0.018920331316754968,0.0082667300153361975,0.005050561561992674,0.7535133314658635,1,0.030331926339755365,0.02397089287874764,0.0333651189737309,0,24,0 +m_9,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.022065196324419167,0.023412216948898907,0.0082667300153361975,0.005254641907959438,0.8938352881912595,1,0.030331926339755365,0.028666858856858345,0.0333651189737309,0,24,0 +m_9,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.01497815582926254,0.0126629604392976,0.0030631767665919344,0.005518753501364878,0.7235019006420236,1,0.018041332595854474,0.018181713940662477,0.019999885334728726,0,24,0 +m_9,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.01497815582926254,0.01063753166359871,0.0030631767665919344,0.005397772673686976,0.5043368063559595,1,0.018041332595854474,0.016035304337285686,0.019999885334728726,0,24,0 +m_9,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.01497815582926254,0.005791648085628672,0.0030631767665919344,0.0024298133833157384,0.04190841053351085,0.9638934422707495,0.018041332595854474,0.00822146146894441,0.019999885334728726,0,24,0 +m_9,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.010750161148982418,0.010590018049528416,0.004683074877761197,0.005012098900994503,0.9818354268703525,1,0.015433236026743614,0.01560211695052292,0.032705053686841845,0,24,0 +m_9,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.010750161148982418,0.014154685977209258,0.004683074877761197,0.011806742344425735,0.7969305987918851,1,0.015433236026743614,0.02596142832163499,0.032705053686841845,0,24,0 +m_9,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.010750161148982418,0.0256564251680087,0.004683074877761197,0.004075441820029339,0.037685529394978226,0.9044527054794774,0.015433236026743614,0.02973186698803804,0.032705053686841845,0,24,0 +m_10,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11622052155787452,0.04771008713195427,0.06708496171885502,0.012503797994637406,0.36874854805936214,1,0.18330548327672952,0.060213885126591676,0.2016360316044025,0,24,0 +m_10,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11622052155787452,0.03811332557598398,0.06708496171885502,0.016948181150627555,0.31538273959235025,1,0.18330548327672952,0.05506150672661153,0.2016360316044025,0,24,0 +m_10,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11622052155787452,0.09253171238479034,0.06708496171885502,0.06576714935776605,0.8066814534958363,1,0.18330548327672952,0.1582988617425564,0.2016360316044025,0,24,0 +m_10,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.04840423240570187,0.06818060549877485,0.019783447971486495,0.02488673655637338,0.5485194305641856,1,0.06818768037718836,0.09306734205514823,0.10237407626066305,0,24,0 +m_10,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04840423240570187,0.0415588240294689,0.019783447971486495,0.01635894799053312,0.7953374417352796,1,0.06818768037718836,0.05791777202000202,0.10237407626066305,0,24,0 +m_10,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04840423240570187,0.008788981074370353,0.019783447971486495,0.0022886216798133165,0.10186994791973368,1,0.06818768037718836,0.01107760275418367,0.10237407626066305,0,24,0 +m_10,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.012815651191332388,0.05276481644668533,0.00835591964961938,0.007919284871674892,0.007343921054749677,0.17625410531399224,0.021171570840951767,0.06068410131836022,0.07217506744672904,0,24,0 +m_10,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.012815651191332388,0.026113437818576068,0.00835591964961938,0.01603875595454596,0.48979082805658036,1,0.021171570840951767,0.04215219377312203,0.07217506744672904,0,24,0 +m_10,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.012815651191332388,0.04129806561452106,0.00835591964961938,0.02431563206432352,0.30943381333096154,1,0.021171570840951767,0.06561369767884458,0.07217506744672904,0,24,0 +m_10,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03609883824099338,0.042106594473121074,0.017887755111999446,0.027630071374367755,0.8595739741055793,1,0.05398659335299283,0.06973666584748883,0.07671033243223772,0,24,0 +m_10,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03609883824099338,0.042929590025592525,0.017887755111999446,0.01781812009446659,0.7929216140064916,1,0.05398659335299283,0.06074771012005911,0.07671033243223772,0,24,0 +m_10,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03609883824099338,0.0351433876208734,0.017887755111999446,0.012359890064858268,0.9661139877124084,1,0.05398659335299283,0.04750327768573167,0.07671033243223772,0,24,0 +m_10,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.013437896136773228,0.016035103578560788,0.006351250600731087,0.004352901720087357,0.7437462961458426,1,0.019789146737504315,0.020388005298648145,0.04059144287946637,0,24,0 +m_10,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.013437896136773228,0.02593356868532659,0.006351250600731087,0.010967743023279198,0.3529927221517347,1,0.019789146737504315,0.03690131170860579,0.04059144287946637,0,24,0 +m_10,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.013437896136773228,0.027583114811510805,0.006351250600731087,0.004506696762422059,0.10263480314869952,1,0.019789146737504315,0.03208981157393286,0.04059144287946637,0,24,0 +m_10,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.020983386863345627,0.018362623597110012,0.008893291331041076,0.00808301969313277,0.8317957699248686,1,0.029876678194386705,0.026445643290242783,0.048699709548577254,0,24,0 +m_10,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.020983386863345627,0.019017163489134292,0.008893291331041076,0.003040671017345573,0.8410460562482079,1,0.029876678194386705,0.022057834506479863,0.048699709548577254,0,24,0 +m_10,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.020983386863345627,0.030437349503716238,0.008893291331041076,0.013835113722263077,0.5802577196884734,1,0.029876678194386705,0.04427246322597932,0.048699709548577254,0,24,0 +m_10,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.024980272786189344,0.013223593563483979,0.01390400059389428,0.004370585025671609,0.45075768703321295,1,0.03888427338008363,0.017594178589155587,0.04277270071809199,0,24,0 +m_10,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.024980272786189344,0.015470196554383234,0.01390400059389428,0.0048677103671077296,0.541676346174284,1,0.03888427338008363,0.020337906921490963,0.04277270071809199,0,24,0 +m_10,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.024980272786189344,0.015184810188587564,0.01390400059389428,0.006814529408785789,0.54635955912659,1,0.03888427338008363,0.021999339597373352,0.04277270071809199,0,24,0 +m_10,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.015194000832375357,0.00722919863617862,0.006296219502514601,0.0032851994726948016,0.29653131473516886,1,0.021490220334889957,0.010514398108873422,0.04440378148549982,0,24,0 +m_10,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.015194000832375357,0.02586617998969487,0.006296219502514601,0.009178971606872064,0.363115886047369,1,0.021490220334889957,0.03504515159656693,0.04440378148549982,0,24,0 +m_10,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.015194000832375357,0.03252813734880681,0.006296219502514601,0.007838936728920299,0.11683366864235513,1,0.021490220334889957,0.040367074077727105,0.04440378148549982,0,24,0 +m_11,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10819217617250709,0.09714052485304843,0.03898838270250659,0.049703725301012205,0.8650546384049167,1,0.1471805588750137,0.14684425015406063,0.1935904941759324,0,24,0 +m_11,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10819217617250709,0.09061769796663437,0.03898838270250659,0.031461551743290614,0.7346453735348799,1,0.1471805588750137,0.12207924970992498,0.1935904941759324,0,24,0 +m_11,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10819217617250709,0.11361671766355896,0.03898838270250659,0.06237464067819774,0.9429969258660629,1,0.1471805588750137,0.17599135834175672,0.1935904941759324,0,24,0 +m_11,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13123856723977986,0.1698344511824529,0.043144876621970946,0.05262894289937946,0.5835966894936158,1,0.1743834438617508,0.22246339408183236,0.29480280760287,0,24,0 +m_11,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13123856723977986,0.20998596585224782,0.043144876621970946,0.058016586513997596,0.30368579778545274,1,0.1743834438617508,0.26800255236624543,0.29480280760287,0,24,0 +m_11,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13123856723977986,0.1615943910891633,0.043144876621970946,0.04478969263344079,0.6360087849000946,1,0.1743834438617508,0.20638408372260408,0.29480280760287,0,24,0 +m_11,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.30671794073436043,0.07138905050606799,0.14019901297637957,0.03701366795760495,0.17114158557641926,1,0.44691695371074003,0.10840271846367294,0.49160864908181406,0,24,0 +m_11,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.30671794073436043,0.27564029058946654,0.14019901297637957,0.12739068092636482,0.873791155797814,1,0.44691695371074003,0.40303097151583134,0.49160864908181406,0,24,0 +m_11,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.30671794073436043,0.21775285503242178,0.14019901297637957,0.054895397487964875,0.5792474255121515,1,0.44691695371074003,0.27264825252038666,0.49160864908181406,0,24,0 +m_11,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.23575687568836426,0.08345102982786057,0.06284918047281296,0.049893695396006264,0.09395346584989375,1,0.2986060561611772,0.13334472522386684,0.32846666177729494,0,24,0 +m_11,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.23575687568836426,0.06551687265432753,0.06284918047281296,0.030510932418788796,0.051751308948855504,1,0.2986060561611772,0.09602780507311633,0.32846666177729494,0,24,0 +m_11,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.23575687568836426,0.1688198634440088,0.06284918047281296,0.06073302104893765,0.46376761974327096,1,0.2986060561611772,0.22955288449294645,0.32846666177729494,0,24,0 +m_11,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.26979017504057784,0.20279611066584743,0.11785991142268332,0.073625311305463,0.6420738266189283,1,0.38765008646326116,0.2764214219713104,0.43173133082261494,0,24,0 +m_11,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.26979017504057784,0.22198230778830155,0.11785991142268332,0.06479524594827712,0.731703722441543,1,0.38765008646326116,0.28677755373657865,0.43173133082261494,0,24,0 +m_11,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.26979017504057784,0.24803234892338524,0.11785991142268332,0.14445067909717377,0.9094948477739607,1,0.38765008646326116,0.392483028020559,0.43173133082261494,0,24,0 +m_11,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.9881732978455263,0.11899711315389183,0.49425399942953047,0.09059848468754039,0.14054271216289074,1,1.4824272972750567,0.20959559784143222,1.6306700270025625,3,24,12.5 +m_11,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.9881732978455263,0.48667531333679587,0.49425399942953047,0.3970914993594038,0.4481332513292742,1,1.4824272972750567,0.8837668126961997,1.6306700270025625,3,24,12.5 +m_11,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.9881732978455263,0.05682996481789315,0.49425399942953047,0.017289738882899152,0.11824901174739558,1,1.4824272972750567,0.07411970370079231,1.6306700270025625,3,24,12.5 +m_11,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14057432468502062,0.12499703520369605,0.04951179536881508,0.04981274877446383,0.8289387729722115,1,0.1900861200538357,0.17480978397815988,0.2792610529892206,0,24,0 +m_11,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14057432468502062,0.17335086846721434,0.04951179536881508,0.08052281606844072,0.7374040346781114,1,0.1900861200538357,0.25387368453565506,0.2792610529892206,0,24,0 +m_11,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14057432468502062,0.1845721927249809,0.04951179536881508,0.046663157805944204,0.532445840954705,1,0.1900861200538357,0.23123535053092512,0.2792610529892206,0,24,0 +m_11,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08924865699800237,0.11980044144596791,0.028287339612599476,0.029622760780231547,0.4729316387023419,1,0.11753599661060185,0.14942320222619945,1.5534368757238068,4,24,16.666666666666664 +m_11,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08924865699800237,0.48317742417147924,0.028287339612599476,0.3601079877688714,0.32463871356333823,1,0.11753599661060185,0.8432854119403506,1.5534368757238068,4,24,16.666666666666664 +m_11,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.08924865699800237,1.0757833566864379,0.028287339612599476,0.3364319848806593,0.03238759429993191,0.7773022631983659,0.11753599661060185,1.412215341567097,1.5534368757238068,4,24,16.666666666666664 +m_12,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10913829165971131,0.07490988397278464,0.04407433447458568,0.035563168902457164,0.5620419717554337,1,0.15321262613429698,0.11047305287524181,0.19404531839001476,0,24,0 +m_12,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10913829165971131,0.09024802089468704,0.04407433447458568,0.042792882964880756,0.7655944296978304,1,0.15321262613429698,0.1330409038595678,0.19404531839001476,0,24,0 +m_12,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10913829165971131,0.1168219259538162,0.04407433447458568,0.059582908946197194,0.9197750888064533,1,0.15321262613429698,0.1764048349000134,0.19404531839001476,0,24,0 +m_12,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14306524118912078,0.17251402994893625,0.045959921210006485,0.05800987868139937,0.69949276023152,1,0.18902516239912726,0.23052390863033562,0.27131815611668497,0,24,0 +m_12,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14306524118912078,0.22592360683855253,0.045959921210006485,0.02072926235843377,0.14458467829244723,1,0.18902516239912726,0.2466528691969863,0.27131815611668497,0,24,0 +m_12,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14306524118912078,0.12048293198059527,0.045959921210006485,0.026618565964807946,0.681887412317573,1,0.18902516239912726,0.14710149794540323,0.27131815611668497,0,24,0 +m_12,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.287558732478046,0.11364347555871997,0.13357063008431913,0.04562680805348999,0.273361092717452,1,0.4211293625623651,0.15927028361220996,0.4761882945715606,0,24,0 +m_12,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.287558732478046,0.2851312393430342,0.13357063008431913,0.1477672102674754,0.9905779127450757,1,0.4211293625623651,0.4328984496105096,0.4761882945715606,0,24,0 +m_12,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.287558732478046,0.20876666226761964,0.13357063008431913,0.04432218158251269,0.6002785658990131,1,0.4211293625623651,0.2530888438501323,0.4761882945715606,0,24,0 +m_12,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3071561753146736,0.08432623975193491,0.10152170277599971,0.04365624861185835,0.09498064374153395,1,0.4086778780906733,0.12798248836379328,0.44954566589974065,0,24,0 +m_12,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3071561753146736,0.04122838102503127,0.10152170277599971,0.02205030747244016,0.05742553884143843,1,0.4086778780906733,0.06327868849747142,0.44954566589974065,0,24,0 +m_12,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3071561753146736,0.22795598224951674,0.10152170277599971,0.05976843369252254,0.524176491490769,1,0.4086778780906733,0.2877244159420393,0.44954566589974065,0,24,0 +m_12,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.3573482027489143,0.2662481971351249,0.11249847242669767,0.09713544399459068,0.5538926808207004,1,0.46984667517561196,0.36338364112971555,0.5553900880358603,0,24,0 +m_12,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.3573482027489143,0.16740361270280313,0.11249847242669767,0.0729799528420644,0.19192245030387878,1,0.46984667517561196,0.24038356554486753,0.5553900880358603,0,24,0 +m_12,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.3573482027489143,0.3371068911861628,0.11249847242669767,0.16779318884643746,0.9224489925792418,1,0.46984667517561196,0.5049000800326002,0.5553900880358603,0,24,0 +m_12,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.3293780771330605,0.11856650949225012,0.10504060979851196,0.0517144342938265,0.11309913262823326,1,0.4344186869315725,0.1702809437860766,0.4778605556247298,0,24,0 +m_12,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.3293780771330605,0.12780818192103116,0.10504060979851196,0.054999261974891446,0.12979453117000925,1,0.4344186869315725,0.1828074438959226,0.4778605556247298,0,24,0 +m_12,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.3293780771330605,0.21256764201778341,0.10504060979851196,0.06361092452462119,0.36857855069357326,1,0.4344186869315725,0.2761785665424046,0.4778605556247298,0,24,0 +m_12,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.3645965083577079,0.4525757944102096,0.10914639632598781,0.11813377472536267,0.5964405891749671,1,0.47374290468369573,0.5707095691355722,0.6277805260491295,0,24,0 +m_12,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.3645965083577079,0.40995038337731887,0.10914639632598781,0.1503477424130676,0.8125419342914908,1,0.47374290468369573,0.5602981257903865,0.6277805260491295,0,24,0 +m_12,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.3645965083577079,0.29805744749716045,0.10914639632598781,0.0650727267599078,0.6144620369725897,1,0.47374290468369573,0.3631301742570683,0.6277805260491295,0,24,0 +m_12,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.12856624554432006,0.29439668127778135,0.03242929534455852,0.09215248713625457,0.13877558047416183,1,0.16099554088887857,0.3865491684140359,0.42520408525543957,0,24,0 +m_12,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.12856624554432006,0.11504418801046752,0.03242929534455852,0.07041676388178203,0.8664516379901883,1,0.16099554088887857,0.18546095189224954,0.42520408525543957,0,24,0 +m_12,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.12856624554432006,0.2013331282828108,0.03242929534455852,0.09163249946874351,0.48137248826308066,1,0.16099554088887857,0.2929656277515543,0.42520408525543957,0,24,0 +m_13,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1798886967797017,0.06250529097669033,0.07083104400004209,0.01501729724573296,0.17438806400573773,1,0.2507197407797438,0.07752258822242329,0.2757917148577182,0,24,0 +m_13,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1798886967797017,0.09895707671364613,0.07083104400004209,0.03253016950935102,0.34139693984842256,1,0.2507197407797438,0.13148724622299715,0.2757917148577182,0,24,0 +m_13,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1798886967797017,0.05149005980793856,0.07083104400004209,0.012914729321501135,0.14460788267823205,1,0.2507197407797438,0.0644047891294397,0.2757917148577182,0,24,0 +m_13,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.162928146824154,0.07616597618162031,0.02446262408046827,0.04702039893505686,0.14267966740642343,1,0.18739077090462225,0.12318637511667718,0.26234072252323964,0,24,0 +m_13,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.162928146824154,0.18867063992319313,0.02446262408046827,0.049820926007024695,0.656338989548287,1,0.18739077090462225,0.23849156593021784,0.26234072252323964,0,24,0 +m_13,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.162928146824154,0.11561743982486779,0.02446262408046827,0.037108931734864896,0.31592133288088176,1,0.18739077090462225,0.15272637155973268,0.26234072252323964,0,24,0 +m_13,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.36462916096029696,0.14746427303627754,0.12381745409882285,0.07095273919245873,0.1751420779068184,1,0.4884466150591198,0.21841701222873627,0.5372912765650318,0,24,0 +m_13,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.36462916096029696,0.21552282148249305,0.12381745409882285,0.14790637815362143,0.46241198725921473,1,0.4884466150591198,0.3634291996361145,0.5372912765650318,0,24,0 +m_13,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.36462916096029696,0.18980461180176653,0.12381745409882285,0.03269200742558421,0.23569231503946123,1,0.4884466150591198,0.22249661922735073,0.5372912765650318,0,24,0 +m_13,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.24625862250744568,0.14209593479208582,0.07179363151490596,0.05585728306505907,0.28537978514091283,1,0.31805225402235165,0.1979532178571449,0.34985747942458684,0,24,0 +m_13,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.24625862250744568,0.11568071512277205,0.07179363151490596,0.038422986724024374,0.15824248087416676,1,0.31805225402235165,0.15410370184679642,0.34985747942458684,0,24,0 +m_13,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.24625862250744568,0.15426620870460428,0.07179363151490596,0.03268827673881429,0.29051101658769585,1,0.31805225402235165,0.18695448544341858,0.34985747942458684,0,24,0 +m_13,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10966758507200296,0.0654233009426058,0.01916080701922518,0.023911980371528644,0.18076570566648428,1,0.12882839209122815,0.08933528131413444,0.17124822551129001,0,24,0 +m_13,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.10966758507200296,0.04174812174944117,0.01916080701922518,0.01993332949525833,0.03391474668618635,0.8139539204684725,0.12882839209122815,0.061681451244699495,0.17124822551129001,0,24,0 +m_13,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10966758507200296,0.11761346834456592,0.01916080701922518,0.03806673666569771,0.8571149029030989,1,0.12882839209122815,0.15568020501026364,0.17124822551129001,0,24,0 +m_13,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09723267763772665,0.08033333449698077,0.022453531742315635,0.018418932164984834,0.5740001070237446,1,0.11968620938004229,0.0987522666619656,0.13165483031804653,0,24,0 +m_13,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09723267763772665,0.07867246212205463,0.022453531742315635,0.03493678647735361,0.6660715878370982,1,0.11968620938004229,0.11360924859940824,0.13165483031804653,0,24,0 +m_13,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09723267763772665,0.04834301308178738,0.022453531742315635,0.01613361576670366,0.11053187351980279,1,0.11968620938004229,0.06447662884849104,0.13165483031804653,0,24,0 +m_13,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0688247906559818,0.0503587608840886,0.02066180822005501,0.021278357321374685,0.5474910628465706,1,0.0894865988760368,0.07163711820546328,0.09843525876364048,0,24,0 +m_13,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0688247906559818,0.06079852168219076,0.02066180822005501,0.024434195949324097,0.8071633094141252,1,0.0894865988760368,0.08523271763151485,0.09843525876364048,0,24,0 +m_13,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0688247906559818,0.029948500949713353,0.02066180822005501,0.009631593713700013,0.13144117909042885,1,0.0894865988760368,0.03958009466341336,0.09843525876364048,0,24,0 +m_13,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0969009314193312,0.07079889222376456,0.03808870711512455,0.01059059006041788,0.5345524295910171,1,0.13498963853445575,0.08138948228418244,0.1697707173309309,0,24,0 +m_13,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0969009314193312,0.11668722270097476,0.03808870711512455,0.037649793054416965,0.719496706858499,1,0.13498963853445575,0.15433701575539172,0.1697707173309309,0,24,0 +m_13,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0969009314193312,0.09806227156465264,0.03808870711512455,0.024401193171328807,0.9801093085689563,1,0.13498963853445575,0.12246346473598144,0.1697707173309309,0,24,0 +m_14,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.4593333726917689,0.23477826497178234,0.21329588036217775,0.07066665139607373,0.36456658130095215,1,0.6726292530539466,0.3054449163678561,0.7398921783593413,0,24,0 +m_14,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.4593333726917689,0.48953270967713125,0.21329588036217775,0.1483601627711794,0.9105531477967909,1,0.6726292530539466,0.6378928724483106,0.7398921783593413,0,24,0 +m_14,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.4593333726917689,0.4468618064842374,0.21329588036217775,0.09832710431164202,0.9594713884782253,1,0.6726292530539466,0.5451889107958794,0.7398921783593413,0,24,0 +m_14,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3859706383380984,0.4178423529591117,0.09860127063127386,0.17368331553626645,0.8772051839945066,1,0.4845719089693723,0.5915256684953781,0.650678235344916,0,24,0 +m_14,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3859706383380984,0.35988957021160406,0.09860127063127386,0.059166761631110044,0.8261323642089418,1,0.4845719089693723,0.4190563318427141,0.650678235344916,0,24,0 +m_14,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3859706383380984,0.36219909556417507,0.09860127063127386,0.13815052772229416,0.8916849585565069,1,0.4845719089693723,0.5003496232864693,0.650678235344916,0,24,0 +m_14,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14036049074143064,0.2971892197602282,0.05557387361624212,0.17227501336848994,0.41950448929463746,1,0.19593436435767275,0.46946423312871816,0.5178757897829104,0,24,0 +m_14,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14036049074143064,0.37098416551493674,0.05557387361624212,0.09981200701498176,0.0880672658930942,1,0.19593436435767275,0.4707961725299185,0.5178757897829104,0,24,0 +m_14,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14036049074143064,0.30681989105405355,0.05557387361624212,0.07894668425218719,0.12051174874432048,1,0.19593436435767275,0.38576657530624076,0.5178757897829104,0,24,0 +m_14,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.26083660590641117,0.1932879092877179,0.10084631430750725,0.10292484066277005,0.6504667765472792,1,0.3616829202139184,0.29621274995048796,0.3978512122353103,0,24,0 +m_14,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.26083660590641117,0.20706180657962558,0.10084631430750725,0.10248290488665394,0.7171356879484426,1,0.3616829202139184,0.30954471146627954,0.3978512122353103,0,24,0 +m_14,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.26083660590641117,0.23913086832041144,0.10084631430750725,0.10628433215570991,0.8855032910628323,1,0.3616829202139184,0.34541520047612134,0.3978512122353103,0,24,0 +m_14,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.5429704957271277,0.31663342785279697,0.1638479678878666,0.14692596846333567,0.32824955737277706,1,0.7068184636149943,0.46355939631613263,0.7775003099764939,0,24,0 +m_14,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.5429704957271277,0.17927577233331315,0.1638479678878666,0.04465805339651604,0.07806544180803844,1,0.7068184636149943,0.2239338257298292,0.7775003099764939,0,24,0 +m_14,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.5429704957271277,0.35656865316434705,0.1638479678878666,0.10183231776137791,0.36103706437253597,1,0.7068184636149943,0.45840097092572496,0.7775003099764939,0,24,0 +m_14,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.42139187334646816,0.26848639405521796,0.20497049144599117,0.15308805631717512,0.5643877040556478,1,0.6263623647924593,0.42157445037239305,0.6889986012717053,0,24,0 +m_14,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.42139187334646816,0.08638823238990297,0.20497049144599117,0.032147740587896066,0.1645676115811055,1,0.6263623647924593,0.11853597297779903,0.6889986012717053,0,24,0 +m_14,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.42139187334646816,0.21301389255194414,0.20497049144599117,0.0949352205977034,0.38675486505149104,1,0.6263623647924593,0.30794911314964757,0.6889986012717053,0,24,0 +m_14,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2783900626750451,0.18500362185043637,0.16133481393145355,0.07146385239216066,0.6132566717573973,1,0.43972487660649867,0.256467474242597,0.4886145046210157,0,24,0 +m_14,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2783900626750451,0.3572693783533732,0.16133481393145355,0.08692562584755015,0.6787183591854868,1,0.43972487660649867,0.44419500420092334,0.4886145046210157,0,24,0 +m_14,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2783900626750451,0.2177258374170984,0.16133481393145355,0.10290083540183118,0.7588834654736534,1,0.43972487660649867,0.32062667281892954,0.4886145046210157,0,24,0 +m_14,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.22735610280917243,0.12697432202742373,0.08792373539596403,0.03688719272150962,0.3288783201200389,1,0.31527983820513644,0.16386151474893335,0.49436728475931563,0,24,0 +m_14,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.22735610280917243,0.29175336227147075,0.08792373539596403,0.15767144205517977,0.730721496536793,1,0.31527983820513644,0.44942480432665055,0.49436728475931563,0,24,0 +m_14,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.22735610280917243,0.24558771660993203,0.08792373539596403,0.09278289289599247,0.88942379055252,1,0.31527983820513644,0.3383706095059245,0.49436728475931563,0,24,0 +m_15,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1251542720244198,0.08768509065413803,0.08473044508051016,0.029003283205967584,0.6932383260882862,1,0.20988471710492995,0.11668837386010561,0.6318302102358168,0,24,0 +m_15,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,0.1251542720244198,0.46616487614009794,0.08473044508051016,0.1082262240742808,0.0353496982170319,0.8483927572087655,0.20988471710492995,0.5743911002143788,0.6318302102358168,0,24,0 +m_15,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1251542720244198,0.27754918862618333,0.08473044508051016,0.17235548479613783,0.45289835785853694,1,0.20988471710492995,0.44990467342232116,0.6318302102358168,0,24,0 +m_15,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17780777112660615,0.35653441030920757,0.09326928185089499,0.2318514192368204,0.4990965521018631,1,0.2710770529775011,0.588385829546028,0.6472244125006309,0,24,0 +m_15,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17780777112660615,0.07971870713462854,0.09326928185089499,0.03917025875783994,0.3658677977708462,1,0.2710770529775011,0.11888896589246849,0.6472244125006309,0,24,0 +m_15,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17780777112660615,0.13025533025636646,0.09326928185089499,0.08089976410890891,0.7083533550943193,1,0.2710770529775011,0.21115509436527535,0.6472244125006309,0,24,0 +m_15,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06004960733295839,0.14740062042427618,0.022945019582226934,0.0662084836045649,0.25784073905469373,1,0.08299462691518532,0.2136091040288411,0.310963338819335,0,24,0 +m_15,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,0.06004960733295839,0.22474310182106141,0.022945019582226934,0.05795084256015223,0.043907223236060944,1,0.08299462691518532,0.28269394438121365,0.310963338819335,0,24,0 +m_15,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06004960733295839,0.17382945840362005,0.022945019582226934,0.08710162938682703,0.2558604990956422,1,0.08299462691518532,0.26093108779044705,0.310963338819335,0,24,0 +m_15,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1523406969004828,0.07033224541939805,0.0750911304302389,0.049123122769192736,0.39067679340093786,1,0.2274318273307217,0.11945536818859079,0.2501750100637939,0,24,0 +m_15,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1523406969004828,0.12781656013187292,0.0750911304302389,0.05372780198466243,0.7976422385460441,1,0.2274318273307217,0.18154436211653535,0.2501750100637939,0,24,0 +m_15,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1523406969004828,0.10028257670065273,0.0750911304302389,0.05617529773410035,0.5944076460384939,1,0.2274318273307217,0.15645787443475306,0.2501750100637939,0,24,0 +m_15,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08151479369115074,0.08772880228776107,0.03432210761929959,0.02698000955819342,0.8897955806528591,1,0.11583690131045032,0.1147088118459545,0.12742059144149537,0,24,0 +m_15,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08151479369115074,0.06855165978686532,0.03432210761929959,0.04079561108348071,0.8129449847033672,1,0.11583690131045032,0.10934727087034604,0.12742059144149537,0,24,0 +m_15,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08151479369115074,0.042005500255870576,0.03432210761929959,0.011127451317203397,0.3152424423769445,1,0.11583690131045032,0.053132951573073975,0.12742059144149537,0,24,0 +m_15,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0699092879397003,0.06514947368108381,0.017425339112330802,0.019696838750071503,0.8600421936835346,1,0.0873346270520311,0.08484631243115531,0.10809845673921392,0,24,0 +m_15,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0699092879397003,0.05040688000056052,0.017425339112330802,0.028591495979053295,0.5758029095291506,1,0.0873346270520311,0.07899837597961382,0.10809845673921392,0,24,0 +m_15,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0699092879397003,0.07728162304726387,0.017425339112330802,0.020989701261112426,0.7926501733898998,1,0.0873346270520311,0.09827132430837629,0.10809845673921392,0,24,0 +m_15,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14057948063012482,0.06130351946038104,0.08739831320642004,0.009503696113647406,0.40761943969858555,1,0.22797779383654487,0.07080721557402844,0.2507755732201994,0,24,0 +m_15,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14057948063012482,0.07102083211341521,0.08739831320642004,0.02815141342646652,0.4772850212148507,1,0.22797779383654487,0.09917224553988173,0.2507755732201994,0,24,0 +m_15,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14057948063012482,0.06070585120100199,0.08739831320642004,0.02052644248893188,0.4105325598804337,1,0.22797779383654487,0.08123229368993387,0.2507755732201994,0,24,0 +m_15,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11663644816659262,0.07577018074596838,0.07949967269626355,0.013415817934595802,0.6326818456686012,1,0.19613612086285617,0.08918599868056418,0.21574973294914182,0,24,0 +m_15,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11663644816659262,0.10058719764304296,0.07949967269626355,0.03376016272423595,0.8580506308894651,1,0.19613612086285617,0.1343473603672789,0.21574973294914182,0,24,0 +m_15,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11663644816659262,0.07645058417535126,0.07949967269626355,0.019896486377436,0.642417148740253,1,0.19613612086285617,0.09634707055278727,0.21574973294914182,0,24,0 +m_16,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.251035199147432,0.5558148279605963,0.08765112759276526,0.13858229260959049,0.09937419338451674,1,0.3386863267401973,0.6943971205701869,0.7638368326272056,0,24,0 +m_16,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.251035199147432,0.41977039813697165,0.08765112759276526,0.1855758518210907,0.43793570338517807,1,0.3386863267401973,0.6053462499580624,0.7638368326272056,0,24,0 +m_16,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.251035199147432,0.47958792605491085,0.08765112759276526,0.13913833767930125,0.2013567638600885,1,0.3386863267401973,0.6187262637342121,0.7638368326272056,0,24,0 +m_16,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.4381551668755624,0.49779423711954435,0.2074310020384654,0.14065575120294616,0.8173600061700013,1,0.6455861689140278,0.6384499883224906,0.7679969488440761,0,24,0 +m_16,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.4381551668755624,0.4093750366555383,0.2074310020384654,0.2888040077481671,0.9372474311457342,1,0.6455861689140278,0.6981790444037055,0.7679969488440761,0,24,0 +m_16,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.4381551668755624,0.29267690260285817,0.2074310020384654,0.05643961913152599,0.5249090991987335,1,0.6455861689140278,0.3491165217343842,0.7679969488440761,0,24,0 +m_16,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.21117230593547814,0.26533006147401533,0.11614368767932232,0.0980142616462863,0.7304160108754447,1,0.32731599361480046,0.3633443231203016,0.936606103757331,0,24,0 +m_16,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.21117230593547814,0.3186750083491952,0.11614368767932232,0.1336808426471285,0.5609610618777103,1,0.32731599361480046,0.4523558509963237,0.936606103757331,0,24,0 +m_16,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.21117230593547814,0.5670054386385578,0.11614368767932232,0.2844546556862884,0.2871323952543439,1,0.32731599361480046,0.8514600943248463,0.936606103757331,0,24,0 +m_16,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.45362960813645725,0.35652711529715003,0.31174923534574356,0.10349596212850029,0.7796835635133436,1,0.7653788434822009,0.4600230774256503,1.0822879320158254,0,24,0 +m_16,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.45362960813645725,0.7252586230906202,0.31174923534574356,0.2586394969237665,0.5207811798705873,1,0.7653788434822009,0.9838981200143866,1.0822879320158254,0,24,0 +m_16,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.45362960813645725,0.49806742812146226,0.31174923534574356,0.2509225061680027,0.9142746104153716,1,0.7653788434822009,0.748989934289465,1.0822879320158254,0,24,0 +m_16,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.38409002330700565,0.35433288956646786,0.1313814781898604,0.1559264057452601,0.8869494332863685,1,0.515471501496866,0.510259295311728,0.731666220781368,0,24,0 +m_16,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.38409002330700565,0.4786072486653326,0.1313814781898604,0.186543861135911,0.6884115150829714,1,0.515471501496866,0.6651511098012436,0.731666220781368,0,24,0 +m_16,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.38409002330700565,0.4548898132323396,0.1313814781898604,0.17373346465843834,0.7523354396057963,1,0.515471501496866,0.628623277890778,0.731666220781368,0,24,0 +m_16,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.23212077533481,0.5886363649678923,0.07507223709476436,0.2103849876248743,0.15959939798770595,1,0.30719301242957436,0.7990213525927665,0.8789234878520432,0,24,0 +m_16,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.23212077533481,0.2845347870077453,0.07507223709476436,0.154956705623767,0.7694000864639232,1,0.30719301242957436,0.4394914926315123,0.8789234878520432,0,24,0 +m_16,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.23212077533481,0.4515589070286266,0.07507223709476436,0.10049511807601244,0.11323340224541804,1,0.30719301242957436,0.5520540251046391,0.8789234878520432,0,24,0 +m_16,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.38005358501303027,0.2930151687042741,0.19621375477046443,0.07101497015535663,0.6904651971715914,1,0.5762673397834948,0.3640301388596307,0.8922454592889649,0,24,0 +m_16,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.38005358501303027,0.657139172976522,0.19621375477046443,0.10714477662112787,0.25146104413762105,1,0.5762673397834948,0.7642839495976499,0.8922454592889649,0,24,0 +m_16,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.38005358501303027,0.6050227533505742,0.19621375477046443,0.20610948236666654,0.4475901251603429,1,0.5762673397834948,0.8111322357172408,0.8922454592889649,0,24,0 +m_16,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.5481815606499026,0.39186791629745266,0.1787357764366494,0.1774023315772987,0.5486746250676318,1,0.726917337086552,0.5692702478747513,0.7996090707952073,0,24,0 +m_16,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.5481815606499026,0.25400921515973446,0.1787357764366494,0.08463098589324904,0.17967990867735015,1,0.726917337086552,0.3386402010529835,0.7996090707952073,0,24,0 +m_16,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.5481815606499026,0.387424645236018,0.1787357764366494,0.2155059927484805,0.5789628585605571,1,0.726917337086552,0.6029306379844985,0.7996090707952073,0,24,0 +m_17,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.16872734237088682,0.1615711683177977,0.12527520992631902,0.07127058644372172,0.9618990196978734,1,0.29400255229720584,0.23284175476151941,0.32599948871497786,0,24,0 +m_17,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.16872734237088682,0.21134785240687637,0.12527520992631902,0.08501531915219442,0.7861364556923242,1,0.29400255229720584,0.29636317155907077,0.32599948871497786,0,24,0 +m_17,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.16872734237088682,0.09240395088619972,0.12527520992631902,0.024255643893851056,0.5798321405678607,1,0.29400255229720584,0.11665959478005078,0.32599948871497786,0,24,0 +m_17,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.258062766506531,0.20539645873100354,0.060481752580506594,0.09990414942626584,0.6636581614250963,1,0.31854451908703757,0.3053006081572694,0.35039897099574135,0,24,0 +m_17,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.258062766506531,0.20770519107405735,0.060481752580506594,0.08959752718374299,0.6526783509268816,1,0.31854451908703757,0.29730271825780036,0.35039897099574135,0,24,0 +m_17,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.258062766506531,0.1798914091617574,0.060481752580506594,0.0738664700484352,0.43269655599148815,1,0.31854451908703757,0.2537578792101926,0.35039897099574135,0,24,0 +m_17,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.4235172892897837,0.0797079580995479,0.2272779965768643,0.0325099836757053,0.20587790615123658,1,0.650795285866648,0.1122179417752532,0.7158748144533129,0,24,0 +m_17,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.4235172892897837,0.24014430926362448,0.2272779965768643,0.16956400690917547,0.537376733205285,1,0.650795285866648,0.40970831617279996,0.7158748144533129,0,24,0 +m_17,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.4235172892897837,0.17875025306867257,0.2272779965768643,0.07303597263927165,0.353819501744274,1,0.650795285866648,0.25178622570794423,0.7158748144533129,0,24,0 +m_17,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.4045920272779531,0.11965684176936264,0.11638161723483471,0.04014104615639007,0.0690256384158286,1,0.5209736445127878,0.15979788792575272,0.5730710089640667,0,24,0 +m_17,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.4045920272779531,0.11974634750264257,0.11638161723483471,0.03968516602598339,0.0690769334210835,1,0.5209736445127878,0.15943151352862595,0.5730710089640667,0,24,0 +m_17,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.4045920272779531,0.27999657377280124,0.11638161723483471,0.10107180939592282,0.44105024435843354,1,0.5209736445127878,0.38106838316872405,0.5730710089640667,0,24,0 +m_17,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08352904712731624,0.06864508191720094,0.035243942019939425,0.020059045523209012,0.7231955674852522,1,0.11877298914725566,0.08870412744040995,0.19124252300021263,0,24,0 +m_17,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08352904712731624,0.08652254365333507,0.035243942019939425,0.022201806001578672,0.9443849833505398,1,0.11877298914725566,0.10872434965491375,0.19124252300021263,0,24,0 +m_17,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08352904712731624,0.13434865923850658,0.035243942019939425,0.039508179852595804,0.36003360173638976,1,0.11877298914725566,0.1738568390911024,0.19124252300021263,0,24,0 +m_17,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.042972044006669506,0.10729082731801132,0.016991018699854456,0.034910873690127776,0.14013319380352485,1,0.05996306270652396,0.1422017010081391,0.16049507851031708,0,24,0 +m_17,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.042972044006669506,0.10837483052796,0.016991018699854456,0.03752978629960098,0.15660823534145604,1,0.05996306270652396,0.14590461682756098,0.16049507851031708,0,24,0 +m_17,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.042972044006669506,0.0664861123038869,0.016991018699854456,0.015429287438881513,0.32994947694402854,1,0.05996306270652396,0.08191539974276842,0.16049507851031708,0,24,0 +m_17,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07875174365840909,0.06776077944427561,0.026641978207228915,0.016591336682563972,0.7348453507629432,1,0.105393721865638,0.08435211612683959,0.14961655469029728,0,24,0 +m_17,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07875174365840909,0.10742548709758874,0.026641978207228915,0.0285895626208633,0.4800378156525744,1,0.105393721865638,0.13601504971845205,0.14961655469029728,0,24,0 +m_17,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07875174365840909,0.044936903634246995,0.026641978207228915,0.014146420499127912,0.2964039364944982,1,0.105393721865638,0.05908332413337491,0.14961655469029728,0,24,0 +m_17,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08623686711707161,0.07057356011944964,0.013078430203875332,0.015130575515164781,0.4520391178742441,1,0.09931529732094695,0.08570413563461442,0.1931310743230577,0,24,0 +m_17,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08623686711707161,0.0828699953397134,0.013078430203875332,0.03267026638646538,0.9266343911695749,1,0.09931529732094695,0.11554026172617878,0.1931310743230577,0,24,0 +m_17,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08623686711707161,0.13096737789707205,0.013078430203875332,0.044606326032980405,0.37396056028662944,1,0.09931529732094695,0.17557370393005245,0.1931310743230577,0,24,0 +m_18,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1570373964086697,0.25208664012025134,0.09263777969811618,0.17158194770023255,0.6397952307427635,1,0.24967517610678588,0.4236685878204839,0.5489857997383517,0,24,0 +m_18,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1570373964086697,0.2514098059173329,0.09263777969811618,0.09753120594308787,0.5007419121963614,1,0.24967517610678588,0.3489410118604208,0.5489857997383517,0,24,0 +m_18,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1570373964086697,0.3618736723748486,0.09263777969811618,0.1372043273872893,0.24939475907938155,1,0.24967517610678588,0.49907799976213785,0.5489857997383517,0,24,0 +m_18,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.23043451928137984,0.33784871135430233,0.11384809698332544,0.20546491936167685,0.6599276781512345,1,0.3442826162647053,0.5433136307159792,0.5976449937875771,1,24,4.166666666666666 +m_18,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.23043451928137984,0.133322585476949,0.11384809698332544,0.030898865767718595,0.4432745524467313,1,0.3442826162647053,0.16422145124466758,0.5976449937875771,1,24,4.166666666666666 +m_18,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.23043451928137984,0.23481164434681992,0.11384809698332544,0.11807149378545573,0.9792353759290952,1,0.3442826162647053,0.3528831381322757,0.5976449937875771,1,24,4.166666666666666 +m_18,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3532755208372961,0.07820758264891685,0.18349838288151457,0.03878988610568164,0.21067271394233109,1,0.5367739037188106,0.11699746875459849,0.5904512940906917,0,24,0 +m_18,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3532755208372961,0.14372820957653382,0.18349838288151457,0.05148661494514031,0.32545053257497236,1,0.5367739037188106,0.19521482452167413,0.5904512940906917,0,24,0 +m_18,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3532755208372961,0.30655555698741616,0.18349838288151457,0.1131474586058389,0.8347577788709307,1,0.5367739037188106,0.41970301559325507,0.5904512940906917,0,24,0 +m_18,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10065747502836846,0.4566131837711166,0.05288812996531544,0.16806811273618838,0.09013716589212177,1,0.1535456049936839,0.624681296507305,0.6871494261580355,0,24,0 +m_18,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10065747502836846,0.2263403538352111,0.05288812996531544,0.049888759380362774,0.11890946979983849,1,0.1535456049936839,0.27622911321557386,0.6871494261580355,0,24,0 +m_18,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10065747502836846,0.26033621771937515,0.05288812996531544,0.07980125865452238,0.13232819767571533,1,0.1535456049936839,0.3401374763738975,0.6871494261580355,0,24,0 +m_18,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2706540678601748,0.2196849722531838,0.061443988587856796,0.06157544712979338,0.5709075027103532,1,0.3320980564480316,0.2812604193829772,0.5033489631077449,0,24,0 +m_18,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2706540678601748,0.15665256213031262,0.061443988587856796,0.046841839729134596,0.17295799720353833,1,0.3320980564480316,0.20349440185944723,0.5033489631077449,0,24,0 +m_18,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2706540678601748,0.3505329535158945,0.061443988587856796,0.10705701294569175,0.5357365031016844,1,0.3320980564480316,0.45758996646158623,0.5033489631077449,0,24,0 +m_18,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.14129554428594218,0.32147811118773345,0.06557060206196824,0.04024614199998194,0.046165786609586805,1,0.20686614634791042,0.3617242531877154,0.39789667850648697,0,24,0 +m_18,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14129554428594218,0.12760931137324594,0.06557060206196824,0.023620508645413107,0.8505238326589182,1,0.20686614634791042,0.15122982001865903,0.39789667850648697,0,24,0 +m_18,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14129554428594218,0.13164420462161944,0.06557060206196824,0.07849068935163407,0.926740516482532,1,0.20686614634791042,0.21013489397325352,0.39789667850648697,0,24,0 +m_18,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.17374757342445526,0.13831824225928813,0.09076004543322676,0.030647200367717897,0.7239476580345989,1,0.26450761885768204,0.16896544262700602,0.3437805954091301,0,24,0 +m_18,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.17374757342445526,0.19570481117567753,0.09076004543322676,0.050897750011387695,0.8382455949794848,1,0.26450761885768204,0.24660256118706522,0.3437805954091301,0,24,0 +m_18,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.17374757342445526,0.22050882232932234,0.09076004543322676,0.09201899167897772,0.7250334594149358,1,0.26450761885768204,0.31252781400830004,0.3437805954091301,0,24,0 +m_18,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.260342103292428,0.4064191517360401,0.10676875238040741,0.07544156609863806,0.29278499277012426,1,0.3671108556728354,0.48186071783467815,0.6941364393051449,0,24,0 +m_18,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.260342103292428,0.2051361896996291,0.10676875238040741,0.07650333027012883,0.6840543621119635,1,0.3671108556728354,0.28163951996975795,0.6941364393051449,0,24,0 +m_18,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.260342103292428,0.49922820591884015,0.10676875238040741,0.1318049207222005,0.19062672730797434,1,0.3671108556728354,0.6310331266410407,0.6941364393051449,0,24,0 +m_19,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0696840118995431,0.09106873031407049,0.0341676148819545,0.053244435829628824,0.7438159849426044,1,0.10385162678149759,0.14431316614369932,0.23612636100146964,7,24,29.166666666666668 +m_19,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0696840118995431,0.10863463845683398,0.0341676148819545,0.04864494825557139,0.5295506145526905,1,0.10385162678149759,0.15727958671240538,0.23612636100146964,7,24,29.166666666666668 +m_19,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0696840118995431,0.16163776865825186,0.0341676148819545,0.05302255952490234,0.18193805231000734,1,0.10385162678149759,0.2146603281831542,0.23612636100146964,7,24,29.166666666666668 +m_19,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07342027637216282,0.13926445843433888,0.026612888107116022,0.05731608811468338,0.331794270618084,1,0.10003316447927885,0.19658054654902227,0.21623860120392452,6,24,25 +m_19,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07342027637216282,0.06636102615329001,0.026612888107116022,0.04357478048526915,0.8933428783996311,1,0.10003316447927885,0.10993580663855916,0.21623860120392452,6,24,25 +m_19,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07342027637216282,0.09857621791301721,0.026612888107116022,0.04503412722100055,0.6432876667984975,1,0.10003316447927885,0.14361034513401777,0.21623860120392452,6,24,25 +m_19,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.16111854615271032,0.04495427641807981,0.07195599317784669,0.02363015629056353,0.18727077743984255,1,0.233074539330557,0.06858443270864334,0.2563819932636127,4,24,16.666666666666664 +m_19,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.16111854615271032,0.013096166903330842,0.07195599317784669,0.005686016824716525,0.10873635509604657,1,0.233074539330557,0.018782183728047366,0.2563819932636127,4,24,16.666666666666664 +m_19,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.16111854615271032,0.10754179736429482,0.07195599317784669,0.023503359633428065,0.5116022372009462,1,0.233074539330557,0.1310451569977229,0.2563819932636127,4,24,16.666666666666664 +m_19,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.04110808127703193,0.07264730511500955,0.019239737233206072,0.03107641184123491,0.4130593721224751,1,0.060347818510238,0.10372371695624447,0.11831275487223526,7,24,29.166666666666668 +m_19,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04110808127703193,0.0334446142467916,0.019239737233206072,0.008294183525464571,0.728249364808439,1,0.060347818510238,0.04173879777225617,0.11831275487223526,7,24,29.166666666666668 +m_19,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04110808127703193,0.08935103888147117,0.019239737233206072,0.018206011002379056,0.10282314756147626,1,0.060347818510238,0.10755704988385023,0.11831275487223526,7,24,29.166666666666668 +m_19,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10651967863961335,0.11256858498841556,0.009411725044311144,0.03648566979283094,0.8780335651082936,1,0.1159314036839245,0.1490542547812465,0.26455095021568853,0,24,0 +m_19,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10651967863961335,0.07874210094969485,0.009411725044311144,0.03460275037075695,0.4692837719980547,1,0.1159314036839245,0.1133448513204518,0.26455095021568853,0,24,0 +m_19,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10651967863961335,0.17859007878758212,0.009411725044311144,0.06191078504486201,0.29965823669108743,1,0.1159314036839245,0.24050086383244412,0.26455095021568853,0,24,0 +m_19,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05945684825474551,0.1245354152446864,0.02348301263931716,0.019019888982686774,0.057874662303185345,1,0.08293986089406266,0.14355530422737317,0.1579108346501105,0,24,0 +m_19,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05945684825474551,0.06681521794970739,0.02348301263931716,0.01814675977658491,0.809508421296641,1,0.08293986089406266,0.0849619777262923,0.1579108346501105,0,24,0 +m_19,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05945684825474551,0.06578130582456783,0.02348301263931716,0.03916701802951896,0.8932008500270952,1,0.08293986089406266,0.10494832385408678,0.1579108346501105,0,24,0 +m_19,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06556665737869889,0.053341792003267274,0.032345237685093155,0.02113640184749248,0.7592421979418866,1,0.09791189506379205,0.07447819385075975,0.1847712125913156,0,24,0 +m_19,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06556665737869889,0.14444087166411332,0.032345237685093155,0.023532957964355384,0.07963197334117868,1,0.09791189506379205,0.1679738296284687,0.1847712125913156,0,24,0 +m_19,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06556665737869889,0.11925544843174236,0.032345237685093155,0.04748653537759172,0.37496077805739714,1,0.09791189506379205,0.16674198380933408,0.1847712125913156,0,24,0 +m_19,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13243488541257994,0.12180230209014582,0.05964664679266465,0.02997180562060175,0.8777229249280131,1,0.1920815322052446,0.15177410771074756,0.2713168618629424,0,24,0 +m_19,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13243488541257994,0.17577541436145946,0.05964664679266465,0.03544929786392566,0.5493156486734527,1,0.1920815322052446,0.21122471222538514,0.2713168618629424,0,24,0 +m_19,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13243488541257994,0.18587469839147386,0.05964664679266465,0.06077699421120102,0.5443655995214585,1,0.1920815322052446,0.2466516926026749,0.2713168618629424,0,24,0 +m_20,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.25893859176971484,0.38621528964426166,0.12540529300485265,0.08360167591917626,0.42554790476157833,1,0.3843438847745675,0.46981696556343794,0.5167986621197818,0,24,0 +m_20,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.25893859176971484,0.17410320710926183,0.12540529300485265,0.08127724293467192,0.5878175526960192,1,0.3843438847745675,0.2553804500439337,0.5167986621197818,0,24,0 +m_20,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.25893859176971484,0.22189897912380874,0.12540529300485265,0.08598338569102452,0.8142047839268356,1,0.3843438847745675,0.3078823648148333,0.5167986621197818,0,24,0 +m_20,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.39299740135009426,0.35681544634856294,0.08820583548527025,0.153490122867399,0.8431715698327902,1,0.4812032368353645,0.5103055692159619,0.5613361261375581,0,24,0 +m_20,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.39299740135009426,0.25865702529822643,0.08820583548527025,0.12951504230921948,0.41396411814662193,1,0.4812032368353645,0.38817206760744594,0.5613361261375581,0,24,0 +m_20,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.39299740135009426,0.28546308262446407,0.08820583548527025,0.09904454970028642,0.43659807749219137,1,0.4812032368353645,0.3845076323247505,0.5613361261375581,0,24,0 +m_20,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.19118955198528337,0.28673503621813,0.08956360956390202,0.08944703149617675,0.46988495682037845,1,0.2807531615491854,0.37618206771430673,0.481883241059109,0,24,0 +m_20,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.19118955198528337,0.2855417097413745,0.08956360956390202,0.1525339639487246,0.6115842554774038,1,0.2807531615491854,0.4380756736900991,0.481883241059109,0,24,0 +m_20,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.19118955198528337,0.2580849302860467,0.08956360956390202,0.08040661088311628,0.5925424979429259,1,0.2807531615491854,0.33849154116916297,0.481883241059109,0,24,0 +m_20,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.22556621537006274,0.3632816150714155,0.07758298387073097,0.13720464439041516,0.4086225770776434,1,0.3031491992407937,0.5004862594618307,0.5682950549145092,0,24,0 +m_20,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.22556621537006274,0.14925901366582153,0.07758298387073097,0.08681084986755756,0.528600256404115,1,0.3031491992407937,0.2360698635333791,0.5682950549145092,0,24,0 +m_20,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.22556621537006274,0.35464499923637566,0.07758298387073097,0.16198686886772354,0.49533832346668116,1,0.3031491992407937,0.5166318681040992,0.5682950549145092,0,24,0 +m_20,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2991847081399426,0.17034121629647106,0.06236856003613897,0.08823367689585748,0.2635872371526935,1,0.3615532681760816,0.2585748931923285,0.5371340913344861,0,24,0 +m_20,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2991847081399426,0.3555064341208613,0.06236856003613897,0.13279728527412596,0.7122938895781952,1,0.3615532681760816,0.4883037193949873,0.5371340913344861,0,24,0 +m_20,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2991847081399426,0.20627638173881327,0.06236856003613897,0.05482981366456105,0.2897981376941377,1,0.3615532681760816,0.2611061954033743,0.5371340913344861,0,24,0 +m_20,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08342296002108518,0.2773853841671654,0.04713664256526615,0.1334812631223048,0.21796978930091143,1,0.13055960258635133,0.4108666472894702,0.6731348127977029,0,24,0 +m_20,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08342296002108518,0.2807345105904819,0.04713664256526615,0.09652189522566561,0.1073442155587363,1,0.13055960258635133,0.3772564058161475,0.6731348127977029,0,24,0 +m_20,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.08342296002108518,0.48166667322734485,0.04713664256526615,0.13027406567965774,0.02681817211668634,0.6168179586837857,0.13055960258635133,0.6119407389070026,0.6731348127977029,0,24,0 +m_20,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.47242506320619365,0.2941482878953325,0.1973230899067768,0.12139016720735059,0.462893193374181,1,0.6697481531129704,0.41553845510268306,0.7367229684242675,0,24,0 +m_20,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.47242506320619365,0.15741461483349392,0.1973230899067768,0.061354421653633084,0.17858613364070755,1,0.6697481531129704,0.218769036487127,0.7367229684242675,0,24,0 +m_20,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.47242506320619365,0.38042586398783207,0.1973230899067768,0.20828373127696523,0.7550925874337371,1,0.6697481531129704,0.5887095952647973,0.7367229684242675,0,24,0 +m_20,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0959731849741338,0.20167490989781792,0.03091283065165798,0.06924250847226109,0.2064785788364494,1,0.12688601562579177,0.270917418370079,0.8268270645628084,0,24,0 +m_20,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0959731849741338,0.28575275959219465,0.03091283065165798,0.17796498198288085,0.3389322139599364,1,0.12688601562579177,0.4637177415750755,0.8268270645628084,0,24,0 +m_20,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.0959731849741338,0.640637369871504,0.03091283065165798,0.11102359791286724,0.003589251425296111,0.08614203420710667,0.12688601562579177,0.7516609677843712,0.8268270645628084,0,24,0 +m_21,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11177906235402002,0.15045251478824798,0.030704026707327556,0.0484101877960171,0.5185298830077788,1,0.14248308906134757,0.19886270258426508,0.38769496112285323,0,24,0 +m_21,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11177906235402002,0.21586205143729545,0.030704026707327556,0.13658791321984387,0.48772292798013206,1,0.14248308906134757,0.3524499646571393,0.38769496112285323,0,24,0 +m_21,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11177906235402002,0.16403245619288373,0.030704026707327556,0.06585017997231683,0.49533988943938423,1,0.14248308906134757,0.22988263616520055,0.38769496112285323,0,24,0 +m_21,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10864848595624406,0.12543790374933303,0.04950667909963342,0.06260631864519603,0.8378365563945243,1,0.15815516505587748,0.18804422239452906,0.9722446864986501,0,23,0 +m_21,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10864848595624406,0.4807985310994504,0.04950667909963342,0.4030602748084133,0.40987558288734366,1,0.15815516505587748,0.8838588059078637,0.9722446864986501,0,23,0 +m_21,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10864848595624406,0.15840471608788573,0.04950667909963342,0.04131215965331272,0.4587215240217264,1,0.15815516505587748,0.19971687574119845,0.9722446864986501,0,23,0 +m_21,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.26388311186179936,0.11393394499064269,0.11610527449061277,0.03016858235522622,0.2718441598016718,1,0.3799883863524121,0.1441025273458689,0.41798722498765334,0,24,0 +m_21,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.26388311186179936,0.2280468154606301,0.11610527449061277,0.1068111497610758,0.8260405356117265,1,0.3799883863524121,0.3348579652217059,0.41798722498765334,0,24,0 +m_21,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.26388311186179936,0.10638703396660909,0.11610527449061277,0.04649722101389605,0.2607607959869426,1,0.3799883863524121,0.15288425498050515,0.41798722498765334,0,24,0 +m_21,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14956351876573262,0.1182187095308022,0.061413201215440555,0.03728844831136947,0.6762365584390615,1,0.21097671998117318,0.15550715784217167,0.23548382217324532,0,24,0 +m_21,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14956351876573262,0.12742232386329633,0.061413201215440555,0.043964400843314946,0.777288482473716,1,0.21097671998117318,0.17138672470661126,0.23548382217324532,0,24,0 +m_21,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14956351876573262,0.15785208091879296,0.061413201215440555,0.05622412105688457,0.9229722904066069,1,0.21097671998117318,0.21407620197567753,0.23548382217324532,0,24,0 +m_21,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.060758520336455867,0.07655995005389664,0.014562000054167072,0.019179108784999777,0.5275627937958633,1,0.07532052039062294,0.09573905883889641,0.12740710383651715,0,24,0 +m_21,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.060758520336455867,0.07224088004484575,0.014562000054167072,0.02609678828854904,0.711026774756949,1,0.07532052039062294,0.09833766833339479,0.12740710383651715,0,24,0 +m_21,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.060758520336455867,0.09882584041590133,0.014562000054167072,0.01699879943547789,0.12055128720980227,1,0.07532052039062294,0.11582463985137921,0.12740710383651715,0,24,0 +m_21,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09404031062141671,0.07883992707384675,0.04124677476511081,0.04883779490478497,0.8169819463192558,1,0.1352870853865275,0.12767772197863173,0.17843506661785943,0,24,0 +m_21,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09404031062141671,0.1200341084397351,0.04124677476511081,0.0354334774460113,0.6431350368138078,1,0.1352870853865275,0.15546758588574638,0.17843506661785943,0,24,0 +m_21,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09404031062141671,0.11968710777388836,0.04124677476511081,0.0425265891514384,0.674280961406938,1,0.1352870853865275,0.16221369692532675,0.17843506661785943,0,24,0 +m_21,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.19328475025076886,0.10071323495884554,0.05262288069099389,0.06454415708999553,0.29334308002267145,1,0.24590763094176274,0.16525739204884107,0.27049839403593906,0,24,0 +m_21,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.19328475025076886,0.14515995924952887,0.05262288069099389,0.07238980942801305,0.6036179556438417,1,0.24590763094176274,0.21754976867754194,0.27049839403593906,0,24,0 +m_21,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.19328475025076886,0.05552657500630372,0.05262288069099389,0.020804974096661082,0.047605438531430164,1,0.24590763094176274,0.0763315491029648,0.27049839403593906,0,24,0 +m_21,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.17522759039149674,0.0817044611123497,0.08765511425649647,0.02512707994659044,0.3458135956614998,1,0.26288270464799324,0.10683154105894015,0.2891709751127926,0,24,0 +m_21,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.17522759039149674,0.09940628858139207,0.08765511425649647,0.010042747766090175,0.4284470975666674,1,0.26288270464799324,0.10944903634748224,0.2891709751127926,0,24,0 +m_21,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.17522759039149674,0.0827181063616571,0.08765511425649647,0.04034369768634158,0.3695190844886372,1,0.26288270464799324,0.12306180404799869,0.2891709751127926,0,24,0 +m_22,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.18781113533032795,0.4226102026813871,0.08639410185861547,0.10210824429185639,0.11316872456211587,1,0.2742052371889434,0.5247184469732435,0.6633691632927137,0,24,0 +m_22,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.18781113533032795,0.49390809100466676,0.08639410185861547,0.10915478471598201,0.05585867884414516,1,0.2742052371889434,0.6030628757206488,0.6633691632927137,0,24,0 +m_22,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.18781113533032795,0.3164948597647259,0.08639410185861547,0.15092501130015384,0.4810713720101938,1,0.2742052371889434,0.46741987106487976,0.6633691632927137,0,24,0 +m_22,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2257664635279999,0.29777813370829603,0.09143707782855472,0.09911670956187198,0.6050769465044994,1,0.3172035413565546,0.396894843270168,0.9850657329833763,0,24,0 +m_22,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,0.2257664635279999,0.6627126190243962,0.09143707782855472,0.15463126441643318,0.04063872519034279,0.975329404568227,0.3172035413565546,0.8173438834408293,0.9850657329833763,0,24,0 +m_22,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,0.2257664635279999,0.7152801625100689,0.09143707782855472,0.18023414020209133,0.04404692293254511,1,0.3172035413565546,0.8955143027121601,0.9850657329833763,0,24,0 +m_22,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.28788972775644667,0.4360898928656411,0.16526486715829608,0.1705970858071086,0.5482451361809499,1,0.45315459491474275,0.6066869786727497,0.7345668107442105,0,24,0 +m_22,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.28788972775644667,0.4648348336659779,0.16526486715829608,0.20295317610148608,0.5188261040131265,1,0.45315459491474275,0.667788009767464,0.7345668107442105,0,24,0 +m_22,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.28788972775644667,0.25309485715649144,0.16526486715829608,0.083105799339199593,0.8570281308304487,1,0.45315459491474275,0.33620065649569103,0.7345668107442105,0,24,0 +m_22,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.5354478801369623,0.36442317317616385,0.3105769262823403,0.17165397646694625,0.6460177689934374,1,0.8460248064193026,0.53607714964311,0.9306272870612329,0,24,0 +m_22,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.5354478801369623,0.1995379969397875,0.3105769262823403,0.05630452395382859,0.3437489650137691,1,0.8460248064193026,0.2558425208936161,0.9306272870612329,0,24,0 +m_22,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.5354478801369623,0.26589560902387727,0.3105769262823403,0.08608031245212631,0.44406440600948477,1,0.8460248064193026,0.3519759214760036,0.9306272870612329,0,24,0 +m_22,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1578322201096589,0.3006440081436716,0.05965954168230668,0.12117007613136652,0.3241114038933057,1,0.21749176179196555,0.4218140842750381,0.6921533937682349,0,24,0 +m_22,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1578322201096589,0.2712872812466646,0.05965954168230668,0.12388183427811476,0.4357746758165326,1,0.21749176179196555,0.3951691155247794,0.6921533937682349,0,24,0 +m_22,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1578322201096589,0.3974417101868918,0.05965954168230668,0.23178864778423083,0.35763429797891494,1,0.21749176179196555,0.6292303579711226,0.6921533937682349,0,24,0 +m_22,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.19449804492969655,0.27824126387118037,0.10938663199307412,0.08470586209430978,0.5592906431965778,1,0.30388467692277066,0.36294712596549017,0.6743918823212931,0,24,0 +m_22,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.19449804492969655,0.42879003050016506,0.10938663199307412,0.18429349888282864,0.30560964734064056,1,0.30388467692277066,0.6130835293829937,0.6743918823212931,0,24,0 +m_22,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.19449804492969655,0.30496540072314793,0.10938663199307412,0.05376517056233083,0.39376449955708204,1,0.30388467692277066,0.35873057128547875,0.6743918823212931,0,24,0 +m_22,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.40066671746286836,0.23502464608442583,0.06007817688110447,0.07781023212372777,0.12484267883724327,1,0.4607448943439728,0.3128348782081536,0.6220291200985418,0,24,0 +m_22,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.40066671746286836,0.2719033442506329,0.06007817688110447,0.10431995180689325,0.316045528404052,1,0.4607448943439728,0.37622329605752614,0.6220291200985418,0,24,0 +m_22,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.40066671746286836,0.4574184435067916,0.06007817688110447,0.10806257476461002,0.6587155997724676,1,0.4607448943439728,0.5654810182714016,0.6220291200985418,0,24,0 +m_22,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1496778282611895,0.32169596206342144,0.05121336836410358,0.09950583309496375,0.1654511896292187,1,0.2008911966252931,0.4212017951583852,0.46332197467422376,0,24,0 +m_22,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1496778282611895,0.16752991096220285,0.05121336836410358,0.09527153909399459,0.8731758720932316,1,0.2008911966252931,0.2628014500561974,0.46332197467422376,0,24,0 +m_22,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1496778282611895,0.20408032029833165,0.05121336836410358,0.06221944614459413,0.5154786450738609,1,0.2008911966252931,0.2662997664429258,0.46332197467422376,0,24,0 +m_23,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.15251861975030395,0.12519793852996228,0.06977053260795602,0.042664274805892195,0.7484049671198076,1,0.22228915235825997,0.16786221333585447,0.24451806759408598,0,24,0 +m_23,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.15251861975030395,0.08229968653378328,0.06977053260795602,0.028723698038444368,0.3921124106258767,1,0.22228915235825997,0.11102338457222764,0.24451806759408598,0,24,0 +m_23,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.15251861975030395,0.03206379074060509,0.06977053260795602,0.015210227929813325,0.16065995089544105,1,0.22228915235825997,0.047274018670418416,0.24451806759408598,0,24,0 +m_23,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08607849260970468,0.10035496688786227,0.02273995018910307,0.027287411894944966,0.696467522013218,1,0.10881844279880776,0.12764237878280724,0.18153780190513003,0,24,0 +m_23,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08607849260970468,0.06811096247701036,0.02273995018910307,0.03481625506640535,0.6763081830498976,1,0.10881844279880776,0.10292721754341572,0.18153780190513003,0,24,0 +m_23,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08607849260970468,0.10333704071198808,0.02273995018910307,0.061697324656311926,0.8012893769402392,1,0.10881844279880776,0.16503436536830002,0.18153780190513003,0,24,0 +m_23,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06389606119755013,0.06293508284850084,0.026146083643376946,0.024561731510295056,0.9792308291198825,1,0.09004214484092708,0.0874968143587959,0.19474362870610162,0,24,0 +m_23,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.06389606119755013,0.0861126742119577,0.026146083643376946,0.03681310882272881,0.6373139764822525,1,0.09004214484092708,0.12292578303468651,0.19474362870610162,0,24,0 +m_23,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06389606119755013,0.12486748737196374,0.026146083643376946,0.05217217508812864,0.32967408068680576,1,0.09004214484092708,0.17703966246009237,0.19474362870610162,0,24,0 +m_23,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14649837701328722,0.09943412622977917,0.06136274629145689,0.0506006843869314,0.5698962950028255,1,0.2078611233047441,0.15003481061671056,0.22864723563521852,0,24,0 +m_23,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14649837701328722,0.10794458613545466,0.06136274629145689,0.026361157880304638,0.5867281092106388,1,0.2078611233047441,0.1343057440157593,0.22864723563521852,0,24,0 +m_23,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14649837701328722,0.08777154122333375,0.06136274629145689,0.032750569444614526,0.42985803937092454,1,0.2078611233047441,0.12052211066794827,0.22864723563521852,0,24,0 +m_23,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04144774834023757,0.045589334535670524,0.017238179270771852,0.01793889269813395,0.8711101138289763,1,0.05868592761100942,0.06352822723380447,0.12832251132794548,0,24,0 +m_23,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04144774834023757,0.04586418621766045,0.017238179270771852,0.015728146807696037,0.8537054527848473,1,0.05868592761100942,0.061592333025356494,0.12832251132794548,0,24,0 +m_23,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04144774834023757,0.08714871343335402,0.017238179270771852,0.029508115046596416,0.2176510498077558,1,0.05868592761100942,0.11665682847995043,0.12832251132794548,0,24,0 +m_23,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06455730510869555,0.07087035192112563,0.033230621477884706,0.02962400784939499,0.8900836042019242,1,0.09778792658658025,0.10049435977052062,0.14792792869293847,0,24,0 +m_23,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06455730510869555,0.06268121220470164,0.033230621477884706,0.014471736646151458,0.9601999492674413,1,0.09778792658658025,0.07715294885085311,0.14792792869293847,0,24,0 +m_23,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06455730510869555,0.10025919713608882,0.033230621477884706,0.03422073803930979,0.47143386921620656,1,0.09778792658658025,0.1344799351753986,0.14792792869293847,0,24,0 +m_23,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09134527722497543,0.08220568727960309,0.039585880520223195,0.025982854465666446,0.8514099361992118,1,0.13093115774519862,0.10818854174526954,0.1440242735197185,0,24,0 +m_23,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09134527722497543,0.0760250987844091,0.039585880520223195,0.03252797396894745,0.7712781484667668,1,0.13093115774519862,0.10855307275335656,0.1440242735197185,0,24,0 +m_23,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09134527722497543,0.0634688339961557,0.039585880520223195,0.026047979208409306,0.5713944743758529,1,0.13093115774519862,0.089516813204565,0.1440242735197185,0,24,0 +m_23,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08209387858990051,0.11239076646841777,0.030947025390913097,0.04118526076523186,0.5704957059986272,1,0.11304090398081361,0.15357602723364963,0.1689336299570146,0,24,0 +m_23,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08209387858990051,0.09937290398819654,0.030947025390913097,0.033633415069126565,0.7133427135248214,1,0.11304090398081361,0.1330063190573231,0.1689336299570146,0,24,0 +m_23,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08209387858990051,0.09091945696640262,0.030947025390913097,0.03106436142480778,0.844520075349477,1,0.11304090398081361,0.1219838183912104,0.1689336299570146,0,24,0 +m_24,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.15943872587362584,0.08605331976561725,0.07941348004757443,0.030567612594757203,0.4265618638964183,1,0.23885220592120027,0.11662093236037446,0.49404090427491765,0,24,0 +m_24,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.15943872587362584,0.3237902213222802,0.07941348004757443,0.12533787347309944,0.2995399414414878,1,0.23885220592120027,0.44912809479537963,0.49404090427491765,0,24,0 +m_24,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.15943872587362584,0.13036783272983601,0.07941348004757443,0.076294097511404535,0.7978729446157238,1,0.23885220592120027,0.20666193024124055,0.49404090427491765,0,24,0 +m_24,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.053971229924288155,0.06730356440368894,0.02491981851305631,0.02797644496013377,0.7294385554064301,1,0.07889104843734446,0.095280009363822707,0.11359849024577054,0,24,0 +m_24,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.053971229924288155,0.06273145025151912,0.02491981851305631,0.034665882493757454,0.8419511315962296,1,0.07889104843734446,0.09739733274527657,0.11359849024577054,0,24,0 +m_24,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.053971229924288155,0.07674964453855526,0.02491981851305631,0.026521710230327032,0.5454450835175952,1,0.07889104843734446,0.1032713547688823,0.11359849024577054,0,24,0 +m_24,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.04069751288558945,0.0555823928959854,0.01776137435415608,0.03882091734578525,0.7376896862443436,1,0.05845888723974553,0.09440331024177065,0.17228610697127722,0,24,0 +m_24,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04069751288558945,0.09907887424317438,0.01776137435415608,0.05754485936707763,0.37902355771871526,1,0.05845888723974553,0.156623733610252,0.17228610697127722,0,24,0 +m_24,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04069751288558945,0.08134027358997116,0.01776137435415608,0.027055722116772568,0.24335913871787615,1,0.05845888723974553,0.10839599570674373,0.17228610697127722,0,24,0 +m_24,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08483350534651364,0.03881455544420328,0.023757020612005224,0.009601677978019267,0.12912722558582246,1,0.10859052595851887,0.048416233422222545,0.21478739366814567,0,24,0 +m_24,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08483350534651364,0.09110221655264177,0.023757020612005224,0.03765706267200836,0.8914494006195435,1,0.10859052595851887,0.12875927922465014,0.21478739366814567,0,24,0 +m_24,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08483350534651364,0.14784992422704235,0.023757020612005224,0.04741134274399918,0.27215575297397104,1,0.10859052595851887,0.19526126697104151,0.21478739366814567,0,24,0 +m_24,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.19582880549979131,0.06518348334799413,0.07596352428929848,0.022685712754637453,0.15143253427015643,1,0.2717923297890898,0.08786919610263158,0.38022235152857403,0,24,0 +m_24,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.19582880549979131,0.24842956648546696,0.07596352428929848,0.09722711672232756,0.6794260300501473,1,0.2717923297890898,0.3456566832077945,0.38022235152857403,0,24,0 +m_24,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.19582880549979131,0.17617086833381937,0.07596352428929848,0.04418416837109637,0.8285780488779869,1,0.2717923297890898,0.22035503670491574,0.38022235152857403,0,24,0 +m_24,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08850332461484323,0.18623616936351564,0.024586679508651524,0.06330334923580168,0.19664404620870168,1,0.11309000412349475,0.24953951859931733,0.3016618888314537,0,24,0 +m_24,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08850332461484323,0.1518916455876537,0.024586679508651524,0.12106662386532484,0.6281341480954667,1,0.11309000412349475,0.2729582694529785,0.3016618888314537,0,24,0 +m_24,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08850332461484323,0.20505523888582614,0.024586679508651524,0.06918284187004083,0.16159259388917316,1,0.11309000412349475,0.274238080755867,0.3016618888314537,0,24,0 +m_24,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.116820757130997,0.19785440600408047,0.03719351776635958,0.0807945896306609,0.39243977023840126,1,0.15401427489735658,0.2786489956347414,0.8362703425341149,1,24,4.166666666666666 +m_24,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.116820757130997,0.4666880330773734,0.03719351776635958,0.293557732862731,0.2886589690661993,1,0.15401427489735658,0.7602457659401044,0.8362703425341149,1,24,4.166666666666666 +m_24,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.116820757130997,0.16034517445290963,0.03719351776635958,0.056993443227377094,0.5391228246259117,1,0.15401427489735658,0.21733861768028673,0.8362703425341149,1,24,4.166666666666666 +m_24,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16667015379648722,0.21921307342327181,0.08210000315624005,0.06563251412850707,0.6284849857074009,1,0.24877015695272728,0.2848455875517789,0.3133301463069568,0,24,0 +m_24,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16667015379648722,0.08954653126450092,0.08210000315624005,0.017572802929126576,0.39709856276697153,1,0.24877015695272728,0.1071193341936275,0.3133301463069568,0,24,0 +m_24,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16667015379648722,0.1283128648829557,0.08210000315624005,0.02319125545718803,0.6693243239663915,1,0.24877015695272728,0.15150412034014374,0.3133301463069568,0,24,0 +m_25,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1335540363194013,0.025953118102858164,0.07522305795907616,0.010352682921971685,0.22693751362856532,1,0.20877709427847746,0.036305801024829845,0.2296548037063252,0,24,0 +m_25,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1335540363194013,0.07522231128793493,0.07522305795907616,0.03159172449387159,0.5043464085955388,1,0.20877709427847746,0.10681403578180651,0.2296548037063252,0,24,0 +m_25,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1335540363194013,0.06077715592030649,0.07522305795907616,0.018274334795282152,0.39508533331946166,1,0.20877709427847746,0.07905149071558865,0.2296548037063252,0,24,0 +m_25,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03728072199769069,0.03897454196346454,0.014937763469273693,0.01607770675907517,0.9400099990502038,1,0.05221848546696438,0.05505224872253971,0.10177486396691807,0,24,0 +m_25,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03728072199769069,0.06025469867524454,0.014937763469273693,0.0322679049310446,0.5386706057080434,1,0.05221848546696438,0.09252260360628914,0.10177486396691807,0,24,0 +m_25,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03728072199769069,0.0354755792925994,0.014937763469273693,0.009177442383989225,0.9204347161417051,1,0.05221848546696438,0.044653021676588626,0.10177486396691807,0,24,0 +m_25,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.016780261306849332,0.07046435727355971,0.007085198305739134,0.03207407819796028,0.1579419841559096,1,0.023865459612588465,0.10253843547151999,0.11279227901867199,0,24,0 +m_25,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.016780261306849332,0.06781443197618393,0.007085198305739134,0.025842366495101656,0.12023985347315055,1,0.023865459612588465,0.0936567984712856,0.11279227901867199,0,24,0 +m_25,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.016780261306849332,0.06460234019262971,0.007085198305739134,0.027014951065938222,0.14048599357106617,1,0.023865459612588465,0.09161729125856793,0.11279227901867199,0,24,0 +m_25,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.04979135240743471,0.04882284175227051,0.018663007704607583,0.01520057297569861,0.9688681406710159,1,0.06845436011204228,0.06402341472796912,0.18061786648231914,0,24,0 +m_25,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04979135240743471,0.10897009643529394,0.018663007704607583,0.05522796400317799,0.34855267106471044,1,0.06845436011204228,0.16419806043847193,0.18061786648231914,0,24,0 +m_25,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04979135240743471,0.0547819129592888,0.018663007704607583,0.023293732705689168,0.8709520374559416,1,0.06845436011204228,0.07807564566497797,0.18061786648231914,0,24,0 +m_25,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05448569087831068,0.03898339638104013,0.02162506505844762,0.01547944955871947,0.5741713590776,1,0.0761107559367583,0.0544628459397596,0.08372183153043414,0,24,0 +m_25,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05448569087831068,0.03874740403272692,0.02162506505844762,0.01135338798037852,0.5383842813201294,1,0.0761107559367583,0.05010079201310544,0.08372183153043414,0,24,0 +m_25,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05448569087831068,0.026228877898586116,0.02162506505844762,0.008439666975608509,0.26591916400270693,1,0.0761107559367583,0.03466854487419463,0.08372183153043414,0,24,0 +m_25,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06397152225292031,0.04856963317692838,0.02205801932954179,0.018212185198755265,0.6024686004704565,1,0.08602954158246211,0.06678181837568364,0.09463249574070833,0,24,0 +m_25,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06397152225292031,0.034774644478974194,0.02205801932954179,0.015298479406912207,0.3053055016610921,1,0.08602954158246211,0.0500731238858864,0.09463249574070833,0,24,0 +m_25,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06397152225292031,0.047939433569167855,0.02205801932954179,0.015034194166200662,0.5632289978611018,1,0.08602954158246211,0.06297362773536852,0.09463249574070833,0,24,0 +m_25,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07757083340874556,0.04819973036674304,0.02009671613606108,0.013316213471558522,0.2551801924385266,1,0.09766754954480664,0.061515943838301564,0.11769307783779229,0,24,0 +m_25,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07757083340874556,0.07172428762724563,0.02009671613606108,0.03526941949802007,0.8890683395699571,1,0.09766754954480664,0.10699370712526571,0.11769307783779229,0,24,0 +m_25,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07757083340874556,0.03801876585645755,0.02009671613606108,0.01299269754552597,0.13451233316130964,1,0.09766754954480664,0.051011463401983516,0.11769307783779229,0,24,0 +m_25,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05045561157405457,0.02975089319365794,0.017695160825701543,0.008524407810579723,0.3258950179448453,1,0.06815077239975612,0.038275301004237663,0.1098739678225917,0,24,0 +m_25,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05045561157405457,0.08666535485227334,0.017695160825701543,0.013220070440991844,0.13463392006596134,1,0.06815077239975612,0.09988542529326518,0.1098739678225917,0,24,0 +m_25,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05045561157405457,0.06335158091905346,0.017695160825701543,0.02363099289427064,0.6722396761062219,1,0.06815077239975612,0.08698257381332411,0.1098739678225917,0,24,0 +m_26,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.16306897029008632,0.05622164687049221,0.06544507966821886,0.0121095944609915,0.17911095460720772,1,0.22851404995830518,0.06833124133148372,0.2996785332896323,0,24,0 +m_26,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.16306897029008632,0.1363480471225126,0.06544507966821886,0.049405242348823035,0.7530684941806982,1,0.22851404995830518,0.18575328947133565,0.2996785332896323,0,24,0 +m_26,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.16306897029008632,0.1816600147224113,0.06544507966821886,0.09077501554089076,0.8718803426416253,1,0.22851404995830518,0.27243503026330207,0.2996785332896323,0,24,0 +m_26,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09026901009733719,0.0374287089803215,0.022502404825955637,0.008490198640397777,0.06762353558951527,1,0.11277141492329283,0.045918907620719276,0.12404855641562212,0,24,0 +m_26,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09026901009733719,0.09618314613090795,0.022502404825955637,0.016043363932559642,0.8352953542438365,1,0.11277141492329283,0.1122265100634676,0.12404855641562212,0,24,0 +m_26,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09026901009733719,0.0681891464668493,0.022502404825955637,0.021434345146620844,0.49367704231521137,1,0.11277141492329283,0.08962349161347015,0.12404855641562212,0,24,0 +m_26,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08225653739198328,0.04614256327257057,0.03649235528790331,0.02136184867670599,0.4230184518472303,1,0.11874889267988659,0.06750441194927656,0.15216806952535633,0,24,0 +m_26,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08225653739198328,0.03999763352650385,0.03649235528790331,0.01151147304971147,0.32181130444866496,1,0.11874889267988659,0.051509106576215324,0.15216806952535633,0,24,0 +m_26,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08225653739198328,0.10085747670049867,0.03649235528790331,0.03747713195891616,0.7303921022368592,1,0.11874889267988659,0.13833460865941483,0.15216806952535633,0,24,0 +m_26,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11373037678601597,0.08784710453327989,0.037763918917147955,0.030480934761044846,0.6080408900090926,1,0.15149429570316392,0.11832803929432473,0.16664372527348031,0,24,0 +m_26,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11373037678601597,0.04644131924980691,0.037763918917147955,0.0160526404082385,0.1572797924525559,1,0.15149429570316392,0.06249395965804541,0.16664372527348031,0,24,0 +m_26,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11373037678601597,0.09573302224665199,0.037763918917147955,0.027103082933100188,0.7092741182571208,1,0.15149429570316392,0.12283610517975219,0.16664372527348031,0,24,0 +m_26,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05373528466887256,0.03802806423622725,0.020601069504092268,0.016516697001643373,0.5657619575850923,1,0.07433635417296483,0.05454476123787062,0.1300182548339642,0,24,0 +m_26,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05373528466887256,0.04466301449802157,0.020601069504092268,0.013593662317217776,0.7220164790728669,1,0.07433635417296483,0.05825667681523934,0.1300182548339642,0,24,0 +m_26,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05373528466887256,0.08772041754776579,0.020601069504092268,0.030477995937656207,0.3802661594925826,1,0.07433635417296483,0.118198413485422,0.1300182548339642,0,24,0 +m_26,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.030582449923569694,0.032124143393519544,0.016450643136958057,0.014962433749616349,0.9461064324513127,1,0.04703309306052775,0.047086577143135896,0.1689320309775802,0,24,0 +m_26,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.030582449923569694,0.09439806524938692,0.016450643136958057,0.04516147627009013,0.2303273203631236,1,0.04703309306052775,0.13955954151947705,0.1689320309775802,0,24,0 +m_26,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.030582449923569694,0.10698567177832181,0.016450643136958057,0.04658890183766016,0.17118066443018048,1,0.04703309306052775,0.15357457361598198,0.1689320309775802,0,24,0 +m_26,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.049431853585261,0.024940280577251988,0.021165253537278446,0.00811024473301895,0.3187098096283921,1,0.07059710712253944,0.03305052531027094,0.09243360046273137,0,24,0 +m_26,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.049431853585261,0.061346512502305085,0.021165253537278446,0.022684033372905248,0.7090278802927802,1,0.07059710712253944,0.08403054587521033,0.09243360046273137,0,24,0 +m_26,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.049431853585261,0.032093925418183934,0.021165253537278446,0.008484847203876876,0.4734564516779711,1,0.07059710712253944,0.04057877262206081,0.09243360046273137,0,24,0 +m_26,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.034703405534005194,0.032841582279564095,0.013443449330845327,0.012735731820679623,0.9219085297006784,1,0.04814685486485052,0.04557731410024372,0.15671068584071107,0,24,0 +m_26,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.034703405534005194,0.04392252164302324,0.013443449330845327,0.016961590683559773,0.679620318331059,1,0.04814685486485052,0.060884112326583015,0.15671068584071107,0,24,0 +m_26,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.034703405534005194,0.089176995720335,0.013443449330845327,0.05328726413485687,0.36222688268296727,1,0.04814685486485052,0.14246425985519187,0.15671068584071107,0,24,0 +m_27,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17225335880055176,0.12569582059083798,0.07008659132385286,0.04135215021754839,0.5861099683940953,1,0.24233995012440462,0.16704797080838638,0.2665739451368451,0,24,0 +m_27,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17225335880055176,0.13224727496431046,0.07008659132385286,0.052138442644529936,0.6595279373360834,1,0.24233995012440462,0.1843857176088404,0.2665739451368451,0,24,0 +m_27,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17225335880055176,0.13995835137608348,0.07008659132385286,0.06433867426003045,0.742357620590016,1,0.24233995012440462,0.20429702563611393,0.2665739451368451,0,24,0 +m_27,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11640308912547614,0.061919560942088316,0.04322299477783063,0.01041290195200922,0.26960916845373245,1,0.15962608390330676,0.07233246289409753,0.28595993556273547,0,24,0 +m_27,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11640308912547614,0.10299908640323747,0.04322299477783063,0.06152847553841728,0.8624792932477996,1,0.15962608390330676,0.16452756194165474,0.28595993556273547,0,24,0 +m_27,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11640308912547614,0.17405474891998096,0.04322299477783063,0.08590882886432401,0.5667978328103092,1,0.15962608390330676,0.25996357778430496,0.28595993556273547,0,24,0 +m_27,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11810988595165788,0.10156503997031822,0.08011541074688053,0.024176605504374348,0.8514874921960905,1,0.1982252966985384,0.12574164547469258,0.21804782636839223,0,24,0 +m_27,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11810988595165788,0.13014624451401824,0.08011541074688053,0.061044347201018034,0.9080278088984546,1,0.1982252966985384,0.19119059171503627,0.21804782636839223,0,24,0 +m_27,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11810988595165788,0.12358693115059576,0.08011541074688053,0.06289530640325772,0.9584320075096429,1,0.1982252966985384,0.18648223755385346,0.21804782636839223,0,24,0 +m_27,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13302120760438507,0.17524195104870846,0.06556312126029118,0.10439775754860559,0.7406630219159214,1,0.19858432886467625,0.279639708597314,0.3076036794570454,0,24,0 +m_27,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13302120760438507,0.13571735717697628,0.06556312126029118,0.08039079607675442,0.9798366974070547,1,0.19858432886467625,0.2161081532537307,0.3076036794570454,0,24,0 +m_27,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13302120760438507,0.1835308669856246,0.06556312126029118,0.04642472323134024,0.5481702577458113,1,0.19858432886467625,0.22995559021696482,0.3076036794570454,0,24,0 +m_27,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16080898004551072,0.1209104271119265,0.08917795391190375,0.040393434474582456,0.6958360211400323,1,0.24998693395741448,0.16130386158650895,0.3244030910211974,0,24,0 +m_27,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16080898004551072,0.06948445623587118,0.08917795391190375,0.030661997429940097,0.3692691509896507,1,0.24998693395741448,0.10014645366581128,0.3244030910211974,0,24,0 +m_27,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16080898004551072,0.2227596886334843,0.08917795391190375,0.07215221229487698,0.6014810601641319,1,0.24998693395741448,0.2949119009283613,0.3244030910211974,0,24,0 +m_27,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08454901757967777,0.03784196935519183,0.035342712958118264,0.013075511311270731,0.2590679337469352,1,0.11989173053779603,0.05091748066646256,0.19726221471432204,0,24,0 +m_27,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08454901757967777,0.06349770200553755,0.035342712958118264,0.030207519035065942,0.6605989584310584,1,0.11989173053779603,0.09370522104060348,0.19726221471432204,0,24,0 +m_27,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08454901757967777,0.1369100284921092,0.035342712958118264,0.042419257611819916,0.3660188273482019,1,0.11989173053779603,0.17932928610392912,0.19726221471432204,0,24,0 +m_27,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.055503212544787406,0.08234655262808672,0.01919259055082546,0.031149297958930046,0.48330890850424235,1,0.07469580309561287,0.11349585058701678,0.1374176408963883,0,24,0 +m_27,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.055503212544787406,0.08593301887867955,0.01919259055082546,0.03899210920894618,0.5055412854441494,1,0.07469580309561287,0.12492512808762572,0.1374176408963883,0,24,0 +m_27,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.055503212544787406,0.0693617854222482,0.01919259055082546,0.028548885048873495,0.6967133625793575,1,0.07469580309561287,0.0979106704711217,0.1374176408963883,0,24,0 +m_27,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14802638980929453,0.06779262656994585,0.0529717139242555,0.011727039051213138,0.194145368077733,1,0.20099810373355004,0.07951966562115899,0.22109791410690505,0,24,0 +m_27,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14802638980929453,0.0980389692923469,0.0529717139242555,0.024709536224398594,0.420446908931593,1,0.20099810373355004,0.12274850551674549,0.22109791410690505,0,24,0 +m_27,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14802638980929453,0.0632713175720998,0.0529717139242555,0.02696344310870243,0.1945369931902594,1,0.20099810373355004,0.09023476068080223,0.22109791410690505,0,24,0 +m_28,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.31488108008357524,0.29533778656935566,0.1186803195345061,0.12318799496088671,0.9115609562899417,1,0.4335613996180813,0.4185257815302424,0.47691753957988947,0,24,0 +m_28,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.31488108008357524,0.17392670271802632,0.1186803195345061,0.05035610323940553,0.32036831138812905,1,0.4335613996180813,0.22428280595743186,0.47691753957988947,0,24,0 +m_28,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.31488108008357524,0.21688729927774963,0.1186803195345061,0.05515096460609437,0.4837148270073972,1,0.4335613996180813,0.272038263883844,0.47691753957988947,0,24,0 +m_28,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.29204348945851694,0.1747736713951001,0.07935602751687766,0.062003771601944466,0.2727963878078004,1,0.3713995169753946,0.23677744299704456,0.40853946867293406,0,24,0 +m_28,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.29204348945851694,0.16517387929334834,0.07935602751687766,0.07825231045022173,0.2815092160739889,1,0.3713995169753946,0.24342618974357005,0.40853946867293406,0,24,0 +m_28,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.29204348945851694,0.20520215144389867,0.07935602751687766,0.09418461585361469,0.4972860836229789,1,0.3713995169753946,0.29938676729751335,0.40853946867293406,0,24,0 +m_28,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2326670179810027,0.090432977811277307,0.15672442559435262,0.033683036950441246,0.4210643247112376,1,0.3893914435753553,0.12411601476171855,0.4283305879328909,0,24,0 +m_28,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2326670179810027,0.2443676691010686,0.15672442559435262,0.1014239272073411,0.9518126762861207,1,0.3893914435753553,0.3457915963084097,0.4283305879328909,0,24,0 +m_28,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2326670179810027,0.13340263150335074,0.15672442559435262,0.057917969778598616,0.5778605306610116,1,0.3893914435753553,0.19132060128194936,0.4283305879328909,0,24,0 +m_28,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2672394373903527,0.15792186770771124,0.14049874733107492,0.10323588893667138,0.5488102185965338,1,0.40773818472142764,0.2611577566443826,0.9564982424538239,0,24,0 +m_28,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2672394373903527,0.2951060563334871,0.14049874733107492,0.11467598896750221,0.881597598832352,1,0.40773818472142764,0.4097820453009893,0.9564982424538239,0,24,0 +m_28,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2672394373903527,0.5419714343167876,0.14049874733107492,0.3275724224594158,0.46704718138291723,1,0.40773818472142764,0.8695438567762035,0.9564982424538239,0,24,0 +m_28,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.12734346148898198,0.174177209028436,0.04741395334929925,0.06293338177862984,0.566450306564694,1,0.17475741483828122,0.23711059080706584,0.46683611476858006,0,24,0 +m_28,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.12734346148898198,0.2162710264250526,0.04741395334929925,0.05143374075218888,0.23260176899546772,1,0.17475741483828122,0.2677047671772415,0.46683611476858006,0,24,0 +m_28,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.12734346148898198,0.32981808035250443,0.04741395334929925,0.09457838761893196,0.09515062899709964,1,0.17475741483828122,0.4243964679714364,0.46683611476858006,0,24,0 +m_28,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15145794185182293,0.17146903550683334,0.04700735563294724,0.07522144083861111,0.8269120676620026,1,0.19846529748477015,0.24669047634544444,0.29859617201287375,0,24,0 +m_28,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.15145794185182293,0.15988376274597535,0.04700735563294724,0.035721316288508394,0.8895504549920491,1,0.19846529748477015,0.19560507903448374,0.29859617201287375,0,24,0 +m_28,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.15145794185182293,0.19016115762152075,0.04700735563294724,0.08128990784472812,0.6910332570158375,1,0.19846529748477015,0.27145106546624886,0.29859617201287375,0,24,0 +m_28,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.155109608220695,0.18599397833670897,0.07858952315022624,0.06905927478989204,0.7739749955402874,1,0.23369913137092124,0.255053253126601,0.28055857843926113,0,24,0 +m_28,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.155109608220695,0.13208635489399212,0.07858952315022624,0.05008516745679879,0.8107413423153309,1,0.23369913137092124,0.18217152235079093,0.28055857843926113,0,24,0 +m_28,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.155109608220695,0.1215684705163859,0.07858952315022624,0.05567679156740825,0.7356509502328277,1,0.23369913137092124,0.17724526208379415,0.28055857843926113,0,24,0 +m_28,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.19488383303094184,0.12557355043878685,0.0890468700347171,0.021224686694285,0.4797711022531419,1,0.28393070306565893,0.14679823713307186,0.31232377337222483,0,24,0 +m_28,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.19488383303094184,0.16417426721899453,0.0890468700347171,0.04495656975856881,0.766682148709577,1,0.28393070306565893,0.20913083697756335,0.31232377337222483,0,24,0 +m_28,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.19488383303094184,0.10117798476968083,0.0890468700347171,0.0268469642217259,0.3531906548442218,1,0.28393070306565893,0.12802494899140673,0.31232377337222483,0,24,0 +m_29,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.20101909528177905,0.17067206247517333,0.10796257398885781,0.032393999863128874,0.7991172382383813,1,0.30898166927063686,0.2030660623383022,0.33987983619770057,0,24,0 +m_29,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.20101909528177905,0.17762309260613915,0.10796257398885781,0.09515929043536615,0.8746488055738725,1,0.30898166927063686,0.2727823830415053,0.33987983619770057,0,24,0 +m_29,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.20101909528177905,0.08648155799356176,0.10796257398885781,0.020134982547079468,0.3522855229828779,1,0.30898166927063686,0.10661654054064124,0.33987983619770057,0,24,0 +m_29,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1702486777415717,0.2020063909979816,0.04028685393744921,0.0777173051655974,0.7267671618519408,1,0.21053553167902092,0.279723696163579,0.3076960657799369,0,23,0 +m_29,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1702486777415717,0.12504883576993678,0.04028685393744921,0.07414912397554553,0.6106676567138865,1,0.21053553167902092,0.19919795974548232,0.3076960657799369,0,23,0 +m_29,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1702486777415717,0.18690501909635696,0.04028685393744921,0.04560687355416389,0.7899559249313028,1,0.21053553167902092,0.23251189265052086,0.3076960657799369,0,23,0 +m_29,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14592431123629696,0.1532633637788273,0.06976694569892533,0.07068901712085021,0.9427269395755795,1,0.2156912569352223,0.2239523808996775,0.3285201272478029,0,24,0 +m_29,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14592431123629696,0.18933605422962926,0.06976694569892533,0.10931860690473696,0.7479092949993722,1,0.2156912569352223,0.29865466113436623,0.3285201272478029,0,24,0 +m_29,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14592431123629696,0.18421632072443309,0.06976694569892533,0.07779925661754085,0.7225087985995537,1,0.2156912569352223,0.26201557734197395,0.3285201272478029,0,24,0 +m_29,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14715774567565898,0.0645940021869853,0.05702618251384702,0.016026263066637614,0.22651547950698697,1,0.204183928189506,0.08062026525362291,0.22460232100845662,0,24,0 +m_29,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14715774567565898,0.08889260902623757,0.05702618251384702,0.032118898399060646,0.40544774543131445,1,0.204183928189506,0.1210115074252982,0.22460232100845662,0,24,0 +m_29,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14715774567565898,0.13049130202538084,0.05702618251384702,0.06560093796926691,0.8522055527305239,1,0.204183928189506,0.19609223999464775,0.22460232100845662,0,24,0 +m_29,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07538011298420526,0.08706676500072048,0.026562117948034775,0.02972314802783918,0.7754562328059558,1,0.10194223093224003,0.11678991302855966,0.12846890433141564,0,24,0 +m_29,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07538011298420526,0.05563172364926805,0.026562117948034775,0.008510694460341008,0.5054234506879535,1,0.10194223093224003,0.06414241810960905,0.12846890433141564,0,24,0 +m_29,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07538011298420526,0.06670669712985718,0.026562117948034775,0.020067302824326422,0.8001223172347742,1,0.10194223093224003,0.0867739999541836,0.12846890433141564,0,24,0 +m_29,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.059671214095097756,0.06490760918663296,0.01595673313676756,0.028310841679825654,0.8760427924736751,1,0.07562794723186532,0.09321845086645862,0.11833403030790307,0,24,0 +m_29,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.059671214095097756,0.04488237975930698,0.01595673313676756,0.019219863510865173,0.5674179632914871,1,0.07562794723186532,0.06410224327017215,0.11833403030790307,0,24,0 +m_29,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.059671214095097756,0.08439707884962437,0.01595673313676756,0.02317931233937841,0.40276434610037337,1,0.07562794723186532,0.10757639118900278,0.11833403030790307,0,24,0 +m_29,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09560283723673872,0.08510274069539421,0.05554167298674507,0.047545246723941434,0.8887234897937111,1,0.1511445102234838,0.13264798741933564,0.2145999077815065,0,24,0 +m_29,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09560283723673872,0.13779754455864968,0.05554167298674507,0.0572932806972653,0.6085029711595165,1,0.1511445102234838,0.19509082525591498,0.2145999077815065,0,24,0 +m_29,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09560283723673872,0.12128832052732985,0.05554167298674507,0.03136006425551246,0.6978554330322344,1,0.1511445102234838,0.15264838478284232,0.2145999077815065,0,24,0 +m_29,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1062057672484249,0.09076132947490063,0.06664859629395684,0.057117484306051326,0.8639224581263674,1,0.17285436354238173,0.14787881378095197,0.19013979989661992,0,24,0 +m_29,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1062057672484249,0.07099690789729103,0.06664859629395684,0.024703341549367434,0.6370358931890954,1,0.17285436354238173,0.09570024944665846,0.19013979989661992,0,24,0 +m_29,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1062057672484249,0.07411662226821969,0.06664859629395684,0.027244598595123307,0.6700326860973118,1,0.17285436354238173,0.101361220863343,0.19013979989661992,0,24,0 +m_30,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17825325771894943,0.03946866904232597,0.09822747854289651,0.015565666299406594,0.2321175468597438,1,0.27648073626184594,0.05503433534173256,0.4141689786060495,0,24,0 +m_30,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17825325771894943,0.26577094654262584,0.09822747854289651,0.11074630673560093,0.5689302698814969,1,0.27648073626184594,0.37651725327822677,0.4141689786060495,0,24,0 +m_30,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17825325771894943,0.06656676790895048,0.09822747854289651,0.010623306347664455,0.3201429206671963,1,0.27648073626184594,0.07719007425661494,0.4141689786060495,0,24,0 +m_30,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.056536760011312547,0.06511389574895987,0.026361180795036573,0.03325709405177678,0.8440893586137977,1,0.08289794080634912,0.09837098980073665,0.20472908882177987,0,24,0 +m_30,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.056536760011312547,0.112908936750021,0.026361180795036573,0.07320841672432432,0.4948832174474024,1,0.08289794080634912,0.18611735347434533,0.20472908882177987,0,24,0 +m_30,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.056536760011312547,0.07167339444999166,0.026361180795036573,0.037078675248220484,0.7469473910640207,1,0.08289794080634912,0.10875206969821213,0.20472908882177987,0,24,0 +m_30,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.047785035101195916,0.11933813006210352,0.029517302037291995,0.055061235467234446,0.28725242313609606,1,0.07730233713848791,0.17439936552933796,0.4007914737243476,0,24,0 +m_30,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.047785035101195916,0.24775017654479173,0.029517302037291995,0.11660570865916063,0.16362636560132898,1,0.07730233713848791,0.36435588520395235,0.4007914737243476,0,24,0 +m_30,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.047785035101195916,0.19617761468327874,0.029517302037291995,0.11816291220229141,0.27177006177573404,1,0.07730233713848791,0.3143405268855701,0.4007914737243476,0,24,0 +m_30,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10623563523453358,0.24543194715113761,0.07892267433218814,0.21032589438532442,0.5570717646673475,1,0.18515830956672172,0.45575784153646204,0.6453851507644313,2,24,8.333333333333332 +m_30,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10623563523453358,0.3575474498764221,0.07892267433218814,0.2291663235457881,0.33884544694407975,1,0.18515830956672172,0.5867137734222102,0.6453851507644313,2,24,8.333333333333332 +m_30,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10623563523453358,0.12030314171035801,0.07892267433218814,0.022179174330334707,0.8709937495011298,1,0.18515830956672172,0.14248231604069272,0.6453851507644313,2,24,8.333333333333332 +m_30,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.029654132282743717,0.044086876323491474,0.011344181708318602,0.016798472859911998,0.49494553774651473,1,0.04099831399106232,0.06088534918340347,0.07624214310513067,0,24,0 +m_30,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.029654132282743717,0.023127399282419248,0.011344181708318602,0.008385600703460004,0.6543489698081494,1,0.04099831399106232,0.03151299998587925,0.07624214310513067,0,24,0 +m_30,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.029654132282743717,0.05098852886885644,0.011344181708318602,0.018322510317625974,0.3500203139733665,1,0.04099831399106232,0.06931103918648242,0.07624214310513067,0,24,0 +m_30,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06319937860449414,0.04542454342577629,0.023870940309266692,0.015252759003360827,0.546836569551632,1,0.08707031891376082,0.06067730242913712,0.09577735080513691,0,24,0 +m_30,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06319937860449414,0.016441173144270998,0.023870940309266692,0.0036930266177210257,0.10803629475893856,1,0.08707031891376082,0.020134199761992023,0.09577735080513691,0,24,0 +m_30,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06319937860449414,0.039225534515893314,0.023870940309266692,0.024276187703423453,0.49741167891310023,1,0.08707031891376082,0.06350172221931677,0.09577735080513691,0,24,0 +m_30,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07392796147694931,0.045904612237875675,0.020004056384688197,0.015246551102230489,0.29304820023284883,1,0.09393201786163752,0.06115116334010616,0.10332521964780128,0,24,0 +m_30,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07392796147694931,0.033559778440679956,0.020004056384688197,0.011949633633110626,0.1206687721697237,1,0.09393201786163752,0.045509412073790584,0.10332521964780128,0,24,0 +m_30,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07392796147694931,0.025869825802058728,0.020004056384688197,0.01044144331719646,0.06791627912602902,1,0.09393201786163752,0.03631126911925519,0.10332521964780128,0,24,0 +m_30,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06228651265224102,0.041025391060036366,0.01244795151629839,0.014362065170796785,0.289947670889346,1,0.0747344641685394,0.05538745623083315,0.08220791058539335,0,24,0 +m_30,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06228651265224102,0.040575012487658935,0.01244795151629839,0.009465865406629498,0.19726698044524196,1,0.0747344641685394,0.05004087789428843,0.08220791058539335,0,24,0 +m_30,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06228651265224102,0.032027950469620516,0.01244795151629839,0.003909379789080756,0.05968585297269089,1,0.0747344641685394,0.03593733025870127,0.08220791058539335,0,24,0 +m_31,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.20503237022765425,0.07658679091881186,0.11043550437374351,0.03975141692060731,0.32336117747406307,1,0.31546787460139775,0.11633820783941917,0.3470146620615375,1,24,4.166666666666666 +m_31,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.20503237022765425,0.11586720759701552,0.11043550437374351,0.049109821823844865,0.4905983762378503,1,0.31546787460139775,0.1649770294208604,0.3470146620615375,1,24,4.166666666666666 +m_31,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.20503237022765425,0.08873936404338816,0.11043550437374351,0.017596844922565823,0.3544513718944617,1,0.31546787460139775,0.10633620896595397,0.3470146620615375,1,24,4.166666666666666 +m_31,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.05994199463360206,0.11386447256201455,0.019988328221749632,0.04576441970936187,0.3168396562210713,1,0.07993032285535169,0.15962889227137642,0.2200193056957203,1,24,4.166666666666666 +m_31,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.05994199463360206,0.14990076488660029,0.019988328221749632,0.05011678574587271,0.14232749064666753,1,0.07993032285535169,0.200017550632473,0.2200193056957203,1,24,4.166666666666666 +m_31,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.05994199463360206,0.10892339136347706,0.019988328221749632,0.024594855997370584,0.15452856234678264,1,0.07993032285535169,0.13351824736084764,0.2200193056957203,1,24,4.166666666666666 +m_31,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1985805506634227,0.1524273695741546,0.11042415783959482,0.04072973651520135,0.710847539830793,1,0.30900470850301753,0.19315710608935593,0.3399051793533193,2,24,8.333333333333332 +m_31,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1985805506634227,0.11217141128666319,0.11042415783959482,0.06466142029976332,0.5229508425685043,1,0.30900470850301753,0.17683283158642651,0.3399051793533193,2,24,8.333333333333332 +m_31,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1985805506634227,0.14665975965182776,0.11042415783959482,0.0353318466313575,0.6736820423865445,1,0.30900470850301753,0.18199160628318525,0.3399051793533193,2,24,8.333333333333332 +m_31,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11163119064708696,0.15012826615063943,0.0536373893853639,0.0925301601226533,0.7284132926131235,1,0.16526858003245087,0.24265842627329273,0.31064231425387917,2,24,8.333333333333332 +m_31,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11163119064708696,0.20649219291720367,0.0536373893853639,0.07590991094995919,0.33539859527362137,1,0.16526858003245087,0.28240210386716286,0.31064231425387917,2,24,8.333333333333332 +m_31,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11163119064708696,0.20991955651793748,0.0536373893853639,0.06402830331797514,0.2696049388052985,1,0.16526858003245087,0.27394785983591263,0.31064231425387917,2,24,8.333333333333332 +m_31,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10339156389680275,0.0801967287527751,0.04639029661765572,0.02223710721076945,0.6653804579361622,1,0.14978186051445846,0.10243383596354455,0.1791546123861466,0,24,0 +m_31,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10339156389680275,0.058886506527054516,0.04639029661765572,0.025737254217511368,0.4264483499981503,1,0.14978186051445846,0.08462376074456589,0.1791546123861466,0,24,0 +m_31,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10339156389680275,0.0944018559285753,0.04639029661765572,0.06846597351337615,0.9158809789794078,1,0.14978186051445846,0.16286782944195144,0.1791546123861466,0,24,0 +m_31,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04272939180223053,0.021718128536674024,0.00802746992052432,0.005394521479499375,0.05872167762189844,1,0.05075686172275485,0.027112650016173398,0.12601749499248227,0,24,0 +m_31,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04272939180223053,0.07218433537317319,0.00802746992052432,0.042377023710901594,0.523062488413002,1,0.05075686172275485,0.11456135908407478,0.12601749499248227,0,24,0 +m_31,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04272939180223053,0.05869050285400471,0.00802746992052432,0.045839163282928176,0.744787402927555,1,0.05075686172275485,0.10452966613693289,0.12601749499248227,0,24,0 +m_31,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.007001773392423767,0.0321063754937263,0.0028390166591205513,0.008139451989073457,0.025912258517433003,0.621894204418392,0.00984079005154432,0.040245827482799756,0.14273691375456993,0,24,0 +m_31,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.007001773392423767,0.02350817758248162,0.0028390166591205513,0.010308294127750505,0.17567290757818105,1,0.00984079005154432,0.033816471710232124,0.14273691375456993,0,24,0 +m_31,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.007001773392423767,0.07637791309108517,0.0028390166591205513,0.05338291759488749,0.2507111141488967,1,0.00984079005154432,0.12976083068597266,0.14273691375456993,0,24,0 +m_31,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.026335820089175305,0.024099565832326864,0.01126913143273125,0.01079526135744987,0.8889054031874082,1,0.03760495152190656,0.03489482718977673,0.0659502703416424,0,24,0 +m_31,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.026335820089175305,0.022886449693604982,0.01126913143273125,0.00528943871460572,0.7896071539546359,1,0.03760495152190656,0.0281758884082107,0.0659502703416424,0,24,0 +m_31,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.026335820089175305,0.037939245719859814,0.01126913143273125,0.022015545499815097,0.6523708800424783,1,0.03760495152190656,0.05995479121967491,0.0659502703416424,0,24,0 +m_32,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1340384675578256,0.02647395141813184,0.049157034585852695,0.01893645590897297,0.0946288481051499,1,0.1831955021436783,0.045410407327104815,0.20151505235804615,0,24,0 +m_32,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1340384675578256,0.12073043414434659,0.049157034585852695,0.056196269892419735,0.8624812770945329,1,0.1831955021436783,0.17692670403676633,0.20151505235804615,0,24,0 +m_32,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1340384675578256,0.08815409750406167,0.049157034585852695,0.03341363903545948,0.4643764959047114,1,0.1831955021436783,0.12156773653952115,0.20151505235804615,0,24,0 +m_32,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13198219853501836,0.25807248670891053,0.03885543154197939,0.05271572294938449,0.08562089502362168,1,0.17083763007699776,0.310788209658295,0.34186703062412455,0,24,0 +m_32,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13198219853501836,0.09020189879723887,0.03885543154197939,0.012822935497271516,0.3461243988077627,1,0.17083763007699776,0.1030248342945104,0.34186703062412455,0,24,0 +m_32,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13198219853501836,0.09617033102432208,0.03885543154197939,0.04646362968451177,0.5678748724011244,1,0.17083763007699776,0.14263396070883386,0.34186703062412455,0,24,0 +m_32,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09202313544478677,0.19464560551144852,0.032996978862271424,0.08534152485687223,0.3021905285486365,1,0.1250201143070582,0.27998713036832074,0.4751619922269197,0,24,0 +m_32,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09202313544478677,0.2736432582284342,0.032996978862271424,0.15832218925058367,0.31959524050899074,1,0.1250201143070582,0.4319654474790179,0.4751619922269197,0,24,0 +m_32,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09202313544478677,0.12474086124263262,0.032996978862271424,0.04511426107878287,0.5732139765790756,1,0.1250201143070582,0.16985512232141547,0.4751619922269197,0,24,0 +m_32,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.15856157205621652,0.1078984819409942,0.05661990360046649,0.031371108565915004,0.4619789414012708,1,0.215181475656683,0.1392695905069092,0.2366996232223513,0,24,0 +m_32,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.15856157205621652,0.08723293299052919,0.05661990360046649,0.030654130430392425,0.30868301024913447,1,0.215181475656683,0.11788706342092162,0.2366996232223513,0,24,0 +m_32,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.15856157205621652,0.09579310165560202,0.05661990360046649,0.04572204404974647,0.41308610641915,1,0.215181475656683,0.14151514570534848,0.2366996232223513,0,24,0 +m_32,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08001429700552702,0.03332714566933448,0.03387113931623028,0.014099755016745512,0.24567233475695596,1,0.1138854363217573,0.04742690068607999,0.12527397995393302,0,24,0 +m_32,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08001429700552702,0.04871761192309765,0.03387113931623028,0.013391269091243089,0.4206290783331398,1,0.1138854363217573,0.062108881014340735,0.12527397995393302,0,24,0 +m_32,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08001429700552702,0.06237438121246974,0.03387113931623028,0.02180806135340468,0.6723394186611964,1,0.1138854363217573,0.08418244256587443,0.12527397995393302,0,24,0 +m_32,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.10163678929171738,0.03374731876906371,0.025214006687667986,0.01103329833105334,0.04378743562169045,1,0.12685079597938537,0.04478061710011705,0.13953587557732391,0,24,0 +m_32,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10163678929171738,0.04186961015240972,0.025214006687667986,0.013854130370405303,0.07244107049429663,1,0.12685079597938537,0.05572374052281502,0.13953587557732391,0,24,0 +m_32,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10163678929171738,0.09319846017894677,0.025214006687667986,0.023732138429743775,0.8124082344428353,1,0.12685079597938537,0.11693059860869054,0.13953587557732391,0,24,0 +m_32,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06425509605310409,0.030400493164011538,0.02967254411637347,0.00755097337916009,0.3137396991466784,1,0.09392764016947755,0.03795146654317163,0.15588461920835595,0,24,0 +m_32,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06425509605310409,0.09382657663129534,0.02967254411637347,0.04788671355811914,0.6132903243976663,1,0.09392764016947755,0.14171329018941448,0.15588461920835595,0,24,0 +m_32,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06425509605310409,0.04231406040042788,0.02967254411637347,0.019164272232628628,0.5506926923150584,1,0.09392764016947755,0.06147833263305651,0.15588461920835595,0,24,0 +m_32,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06276397796384277,0.039408210682708576,0.016033934315745617,0.01899529400411029,0.3701829536341086,1,0.07879791227958838,0.05840350468681887,0.13452342199036066,0,24,0 +m_32,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06276397796384277,0.036144605720073164,0.016033934315745617,0.01005287697965983,0.1954308727359458,1,0.07879791227958838,0.04619748269973299,0.13452342199036066,0,24,0 +m_32,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06276397796384277,0.0785393492476502,0.016033934315745617,0.04375467074358676,0.7459324879592566,1,0.07879791227958838,0.12229401999123696,0.13452342199036066,0,24,0 +m_33,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.4382935119543001,0.14640882092863453,0.22484634095022885,0.04104234511010304,0.26664924320547756,1,0.6631398529045289,0.18745116603873757,0.7294538381949819,0,24,0 +m_33,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.4382935119543001,0.30533463052232807,0.22484634095022885,0.11943712125282054,0.6196907191505758,1,0.6631398529045289,0.4247717517751486,0.7294538381949819,0,24,0 +m_33,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.4382935119543001,0.35930919934371364,0.22484634095022885,0.1684148757407513,0.785916226395656,1,0.6631398529045289,0.527724075084465,0.7294538381949819,0,24,0 +m_33,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13842699534370725,0.10297938555326569,0.05016724910189886,0.03755651693046861,0.5850728063347947,1,0.18859424444560613,0.1405359024837343,0.24350387113876998,0,24,0 +m_33,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13842699534370725,0.18503226328522196,0.05016724910189886,0.036334892295478004,0.4708045614049743,1,0.18859424444560613,0.22136715558069997,0.24350387113876998,0,24,0 +m_33,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13842699534370725,0.12708296170471448,0.05016724910189886,0.04241450217310087,0.8664423442666774,1,0.18859424444560613,0.16949746387781534,0.24350387113876998,0,24,0 +m_33,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.05921539751376712,0.5037170232447771,0.038827317047974395,0.22452147471247275,0.10532346856415226,1,0.09804271456174152,0.7282384979572498,0.8010623477529749,0,24,0 +m_33,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.05921539751376712,0.16352795874283665,0.038827317047974395,0.051527158732507614,0.1474481134930352,1,0.09804271456174152,0.21505511747534428,0.8010623477529749,0,24,0 +m_33,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,0.05921539751376712,0.25851251028466876,0.038827317047974395,0.057951610858344715,0.0202548016495763,0.48611523958983116,0.09804271456174152,0.3164641211430135,0.8010623477529749,0,24,0 +m_33,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.28008608355820624,0.19970569319927192,0.1395614126136793,0.10931579564484212,0.6622900953887203,1,0.41964749617188557,0.30902148884411407,0.6853124403091837,0,24,0 +m_33,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.28008608355820624,0.13587452656864593,0.1395614126136793,0.07569896378240704,0.39730339815725463,1,0.41964749617188557,0.21157349035105297,0.6853124403091837,0,24,0 +m_33,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.28008608355820624,0.442299171313535,0.1395614126136793,0.18071213805845004,0.49578729074558403,1,0.41964749617188557,0.6230113093719851,0.6853124403091837,0,24,0 +m_33,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10615316040014822,0.139999629754772,0.04503216604409612,0.0683668229091906,0.6893429026872193,1,0.15118532644424434,0.20836645266396261,0.25246432138087765,0,24,0 +m_33,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10615316040014822,0.037592972632353096,0.04503216604409612,0.011162131855360899,0.19327649015633175,1,0.15118532644424434,0.048755104487713995,0.25246432138087765,0,24,0 +m_33,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10615316040014822,0.18983984060810424,0.04503216604409612,0.039673178829057236,0.19386115406237206,1,0.15118532644424434,0.2295130194371615,0.25246432138087765,0,24,0 +m_33,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11677467600074021,0.07300904758251248,0.03971740251902804,0.019496901972599495,0.3543210179355677,1,0.15649207851976826,0.09250594955511197,0.1721412863717451,0,24,0 +m_33,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11677467600074021,0.07248976144851316,0.03971740251902804,0.019457187169464464,0.34883979596676207,1,0.15649207851976826,0.09194694861797761,0.1721412863717451,0,24,0 +m_33,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11677467600074021,0.10430350983754615,0.03971740251902804,0.02152541915740461,0.7897614481886075,1,0.15649207851976826,0.12582892899495077,0.1721412863717451,0,24,0 +m_33,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10789131569811257,0.07378261680625475,0.05271332365285973,0.0243394925845229,0.5752456797955242,1,0.1606046393509723,0.09812210939077765,0.17666510328606955,0,24,0 +m_33,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10789131569811257,0.1071240870405455,0.05271332365285973,0.03956302371785435,0.990958708117743,1,0.1606046393509723,0.14668711075839985,0.17666510328606955,0,24,0 +m_33,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10789131569811257,0.06196297843690054,0.05271332365285973,0.03724987482280777,0.494775341144852,1,0.1606046393509723,0.0992128532597083,0.17666510328606955,0,24,0 +m_33,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13667558070591398,0.10867213327011578,0.050585069444526766,0.03431179625349634,0.6579572829099014,1,0.18726065015044074,0.1429839295236121,0.20598671516548483,0,24,0 +m_33,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13667558070591398,0.08552656849849367,0.050585069444526766,0.04764334084515035,0.47865641783121504,1,0.18726065015044074,0.13316990934364403,0.20598671516548483,0,24,0 +m_33,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13667558070591398,0.0779485754182266,0.050585069444526766,0.05258843169229585,0.4396624694242245,1,0.18726065015044074,0.13053700711052246,0.20598671516548483,0,24,0 +m_34,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03007629176194948,0.025430131008682782,0.015002115490267092,0.007812977108910242,0.7926198665922944,1,0.045078407252216575,0.033243108117593026,0.10545746619352951,0,24,0 +m_34,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03007629176194948,0.06310403556018462,0.015002115490267092,0.02621351306125742,0.3069007235929633,1,0.045078407252216575,0.08931754862144205,0.10545746619352951,0,24,0 +m_34,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03007629176194948,0.05998591649856796,0.015002115490267092,0.03588450731373159,0.468332439028069,1,0.045078407252216575,0.09587042381229954,0.10545746619352951,0,24,0 +m_34,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.025781696504436402,0.012444717979746075,0.0061688269307809025,0.006833831027960014,0.1783576117992439,1,0.0319505234352173,0.019278549007706088,0.06892851209711615,0,24,0 +m_34,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.025781696504436402,0.02718716989433882,0.0061688269307809025,0.0033051686551738317,0.846069398627854,1,0.0319505234352173,0.03049233854951265,0.06892851209711615,0,24,0 +m_34,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.025781696504436402,0.04951556675295669,0.0061688269307809025,0.013146716971694348,0.1456023914961636,1,0.0319505234352173,0.06266228372465103,0.06892851209711615,0,24,0 +m_34,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.11427202097748443,0.020779616385207866,0.033025569185571535,0.00694372737914158,0.04578074240843348,1,0.14729759016305596,0.027723343764349446,0.16202734917936157,0,24,0 +m_34,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11427202097748443,0.08268210154824569,0.033025569185571535,0.03144115109557046,0.5081004020983155,1,0.14729759016305596,0.11412325264381615,0.16202734917936157,0,24,0 +m_34,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11427202097748443,0.05086203670059275,0.033025569185571535,0.009063280208473967,0.1282920202766295,1,0.14729759016305596,0.05992531690906672,0.16202734917936157,0,24,0 +m_34,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.04467345875911803,0.03807396228783063,0.014700162308385462,0.01726782349498864,0.7776510355821127,1,0.05937362106750349,0.05534178578281927,0.07863373837153662,0,24,0 +m_34,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04467345875911803,0.024091772112373677,0.014700162308385462,0.006779862701053342,0.25318970446788747,1,0.05937362106750349,0.03087163481342702,0.07863373837153662,0,24,0 +m_34,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04467345875911803,0.056195901703397055,0.014700162308385462,0.015289314997999856,0.6002136311589978,1,0.05937362106750349,0.07148521670139692,0.07863373837153662,0,24,0 +m_34,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05415014566247223,0.07842157294448793,0.0186966125257045,0.025142267249763282,0.4579197273087877,1,0.07284675818817672,0.10356384019425122,0.1768731281448666,0,24,0 +m_34,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05415014566247223,0.039575600748433803,0.0186966125257045,0.017739877728211353,0.584239107390803,1,0.07284675818817672,0.05731547847664516,0.1768731281448666,0,24,0 +m_34,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05415014566247223,0.1191059595042659,0.0186966125257045,0.04168779335470373,0.19849542460467326,1,0.07284675818817672,0.16079375285896963,0.1768731281448666,0,24,0 +m_34,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07100965806035416,0.027337368645779254,0.04280426687831491,0.00464743956707438,0.35595806665028096,1,0.11381392493866907,0.031984808212853634,0.12519531743253598,0,24,0 +m_34,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07100965806035416,0.04617340160070249,0.04280426687831491,0.007573215897120695,0.59108484207473,1,0.11381392493866907,0.05374661749782318,0.12519531743253598,0,24,0 +m_34,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07100965806035416,0.0733460476271713,0.04280426687831491,0.02067879610987101,0.9621343957704214,1,0.11381392493866907,0.09402484373704231,0.12519531743253598,0,24,0 +m_34,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.054629375893454846,0.03718358200693217,0.026998066519273754,0.009480187737025362,0.5636802084618291,1,0.0816274424127286,0.04666376974395753,0.08979018665400146,0,24,0 +m_34,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.054629375893454846,0.05621701966264592,0.026998066519273754,0.017053544027009142,0.9615035001037235,1,0.0816274424127286,0.07327056368965507,0.08979018665400146,0,24,0 +m_34,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.054629375893454846,0.04390885840830908,0.026998066519273754,0.020865441484556574,0.7602376967724847,1,0.0816274424127286,0.06477429989286565,0.08979018665400146,0,24,0 +m_34,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10149376786851771,0.07184171231713436,0.04589780693828741,0.01531827630560835,0.5621331295758689,1,0.14739157480680512,0.08715998862274271,0.16213073228748565,0,24,0 +m_34,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10149376786851771,0.11374671638191562,0.04589780693828741,0.02630053706136647,0.8226673242937984,1,0.14739157480680512,0.1400472534432821,0.16213073228748565,0,24,0 +m_34,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10149376786851771,0.07850495370879311,0.04589780693828741,0.02672987276477941,0.6765189975496271,1,0.14739157480680512,0.10523482647357252,0.16213073228748565,0,24,0 +m_35,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.37521236318114404,0.346624799388655,0.10961256955429524,0.0986956427184638,0.8508224012163169,1,0.48482493273543925,0.4453204421071188,0.5333074260089832,0,24,0 +m_35,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.37521236318114404,0.24077574110338873,0.10961256955429524,0.07706010218503843,0.3470822476479686,1,0.48482493273543925,0.3178358432884272,0.5333074260089832,0,24,0 +m_35,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.37521236318114404,0.23748308926666942,0.10961256955429524,0.02647909170390983,0.2824415170033232,1,0.48482493273543925,0.2639621809705792,0.5333074260089832,0,24,0 +m_35,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2963948317515479,0.4607608582728469,0.061942982265268696,0.1630723623147591,0.3801920202147248,1,0.3583378140168166,0.623833220587606,0.6862165426463667,0,24,0 +m_35,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2963948317515479,0.2626835565024962,0.061942982265268696,0.12278290001084174,0.813022772987568,1,0.3583378140168166,0.38546645651333794,0.6862165426463667,0,24,0 +m_35,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2963948317515479,0.36923259697458644,0.061942982265268696,0.13677894701851925,0.6424868847294284,1,0.3583378140168166,0.5060115439931057,0.6862165426463667,0,24,0 +m_35,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03395168674726654,0.36021046157854253,0.014320607083185768,0.15962963791528048,0.09650940715290893,1,0.04827229383045231,0.519840099493823,0.5718241094432054,0,24,0 +m_35,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03395168674726654,0.1911315700813776,0.014320607083185768,0.07498533090389228,0.10383438230051562,1,0.04827229383045231,0.26611690098526986,0.5718241094432054,0,24,0 +m_35,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03395168674726654,0.24852142304870506,0.014320607083185768,0.1250721187036593,0.1475267449918641,1,0.04827229383045231,0.37359354175236437,0.5718241094432054,0,24,0 +m_35,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.35055398399271603,0.2247257881844459,0.17674003151148188,0.09596188019083415,0.5536131520227949,1,0.5272940155041979,0.32068766837528007,0.664033811031603,0,24,0 +m_35,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.35055398399271603,0.36729792584358,0.17674003151148188,0.1580679633463956,0.9453235007320281,1,0.5272940155041979,0.5253658891899756,0.664033811031603,0,24,0 +m_35,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.35055398399271603,0.4367052369329124,0.17674003151148188,0.16696186400490845,0.7314737032368879,1,0.5272940155041979,0.6036671009378208,0.664033811031603,0,24,0 +m_35,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.22613208608320137,0.24599072131350988,0.05055851662280259,0.07815428943073381,0.8360509251704792,1,0.276690602706004,0.3241450107442437,0.5252959440327046,0,24,0 +m_35,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.22613208608320137,0.2014656670638606,0.05055851662280259,0.06143804155568769,0.7631485698882952,1,0.276690602706004,0.26290370861954826,0.5252959440327046,0,24,0 +m_35,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.22613208608320137,0.329325945829032,0.05055851662280259,0.14821582147342666,0.5338116017572141,1,0.276690602706004,0.4775417673024587,0.5252959440327046,0,24,0 +m_35,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1900352870588161,0.09281248630847472,0.09114296498684601,0.04261384618360895,0.36570460393245496,1,0.2811782520456621,0.13542633249208366,0.33872071831747486,0,24,0 +m_35,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1900352870588161,0.08083149148360717,0.09114296498684601,0.029672220707415615,0.29768027085539345,1,0.2811782520456621,0.11050371219102278,0.33872071831747486,0,24,0 +m_35,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1900352870588161,0.21606331056552408,0.09114296498684601,0.09186461517763483,0.8446268324004588,1,0.2811782520456621,0.3079279257431589,0.33872071831747486,0,24,0 +m_35,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1471311449044003,0.13314615834643329,0.0493909748209646,0.04606320520152346,0.8401303122261768,1,0.1965221197253649,0.17920936354795675,0.2161743316979014,0,24,0 +m_35,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1471311449044003,0.11203516357368248,0.0493909748209646,0.020943298179844888,0.5346582260556085,1,0.1965221197253649,0.13297846175352737,0.2161743316979014,0,24,0 +m_35,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1471311449044003,0.11394601562634284,0.0493909748209646,0.062111503131891024,0.685092174236428,1,0.1965221197253649,0.17605751875823386,0.2161743316979014,0,24,0 +m_35,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.24124670352884073,0.15363900663246324,0.0884779301268241,0.045610282164468566,0.4061810113541635,1,0.32972463365566484,0.19924928879693182,0.3626970970212314,0,24,0 +m_35,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.24124670352884073,0.16218635413169027,0.0884779301268241,0.07868350719316704,0.51962700670631,1,0.32972463365566484,0.24086986132485733,0.3626970970212314,0,24,0 +m_35,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.24124670352884073,0.1937008615113772,0.0884779301268241,0.05075179427301777,0.6535960420630834,1,0.32972463365566484,0.24445265578439496,0.3626970970212314,0,24,0 +m_36,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17729973585257514,0.12026354862622608,0.05092640284951128,0.05216362624662485,0.45423356934573156,1,0.2282261387020864,0.17242717487285092,0.2510487525722951,0,24,0 +m_36,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17729973585257514,0.10035483667275558,0.05092640284951128,0.035847610177581674,0.25404790413943906,1,0.2282261387020864,0.13620244685033725,0.2510487525722951,0,24,0 +m_36,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17729973585257514,0.12088018814194908,0.05092640284951128,0.04101206682470438,0.412935290631373,1,0.2282261387020864,0.16189225496665346,0.2510487525722951,0,24,0 +m_36,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07880244782661909,0.12632824733358242,0.03479056249198401,0.03467626059476475,0.35609430643475526,1,0.11359301031860311,0.16100450792834717,0.1771049587211819,0,24,0 +m_36,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07880244782661909,0.0706013625768845,0.03479056249198401,0.04170365679271165,0.8830693927510934,1,0.11359301031860311,0.11230501936959615,0.1771049587211819,0,24,0 +m_36,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07880244782661909,0.09101767144803234,0.03479056249198401,0.03566848952348671,0.8112948819830229,1,0.11359301031860311,0.12668616097151905,0.1771049587211819,0,24,0 +m_36,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11590407850864093,0.06209327884864605,0.04486296575855532,0.027245230936440008,0.34055158413929437,1,0.16076704426719624,0.08933850978508606,0.17684374869391586,0,24,0 +m_36,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11590407850864093,0.10562496125012792,0.04486296575855532,0.03181995383980931,0.8568984543846566,1,0.16076704426719624,0.13744491508993723,0.17684374869391586,0,24,0 +m_36,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11590407850864093,0.10089235230905376,0.04486296575855532,0.05923878424853708,0.8445109437291186,1,0.16076704426719624,0.16013113655759084,0.17684374869391586,0,24,0 +m_36,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.044860267518614896,0.06685365383809083,0.02471424219583145,0.034911545682080145,0.6201147215172177,1,0.06957450971444634,0.10176519952017098,0.1153439942099573,0,24,0 +m_36,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.044860267518614896,0.05888070923604275,0.02471424219583145,0.017697506080185586,0.6576000202369248,1,0.06957450971444634,0.07657821531622834,0.1153439942099573,0,24,0 +m_36,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.044860267518614896,0.08066977559233002,0.02471424219583145,0.02418840096217662,0.32791643941012383,1,0.06957450971444634,0.10485817655450663,0.1153439942099573,0,24,0 +m_36,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1700566637906559,0.18388214834948044,0.057150171790327955,0.047623748049470664,0.8563997000456995,1,0.22720683558098387,0.2315058963989511,0.4716110213856921,0,24,0 +m_36,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1700566637906559,0.14963979306236927,0.057150171790327955,0.05021188155132578,0.7939516389561487,1,0.22720683558098387,0.19985167461369505,0.4716110213856921,0,24,0 +m_36,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1700566637906559,0.3022710897276805,0.057150171790327955,0.12646620244113047,0.37264980073865656,1,0.22720683558098387,0.42873729216881096,0.4716110213856921,0,24,0 +m_36,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.20585855407721687,0.08537697816705887,0.09186589072874689,0.032413148210649105,0.26078453599304113,1,0.2977244448059638,0.11779012637770797,0.3274968892865602,0,24,0 +m_36,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.20585855407721687,0.07838716635954752,0.09186589072874689,0.02317317541190883,0.2301037939776849,1,0.2977244448059638,0.10156034177145636,0.3274968892865602,0,24,0 +m_36,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.20585855407721687,0.17262090799340793,0.09186589072874689,0.070884284159778,0.7807520467900595,1,0.2977244448059638,0.24350519215318595,0.3274968892865602,0,24,0 +m_36,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1797851154518543,0.09351667771395733,0.07140063176986697,0.038587072135033165,0.32004193044714885,1,0.25118574722172127,0.13210374984899048,0.2763043219438934,0,24,0 +m_36,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1797851154518543,0.07049959051832884,0.07140063176986697,0.018856835153682413,0.19199480069602837,1,0.25118574722172127,0.08935642567201126,0.2763043219438934,0,24,0 +m_36,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1797851154518543,0.18515673397471347,0.07140063176986697,0.0392784893075804,0.9491082705014848,1,0.25118574722172127,0.22443522328229387,0.2763043219438934,0,24,0 +m_36,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.21873454023665242,0.0921270006224512,0.06481289647906155,0.04105052213759196,0.13545718900901887,1,0.283547436715714,0.13317752276004316,0.3119021803872854,0,24,0 +m_36,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.21873454023665242,0.13437777804638476,0.06481289647906155,0.058944381255765746,0.35850676116050595,1,0.283547436715714,0.19332215930215052,0.3119021803872854,0,24,0 +m_36,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.21873454023665242,0.161607500405513,0.06481289647906155,0.039101008216054514,0.4715059943511202,1,0.283547436715714,0.20070850862156753,0.3119021803872854,0,24,0 +m_37,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.15617795545329657,0.1294120393494634,0.04362513471839766,0.05307450929816575,0.7059590315493207,1,0.19980309017169423,0.18248654864762914,0.21978339918886367,0,24,0 +m_37,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.15617795545329657,0.11603217201433196,0.04362513471839766,0.03982885957953131,0.5145387153683927,1,0.19980309017169423,0.15586103159386328,0.21978339918886367,0,24,0 +m_37,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.15617795545329657,0.13005806006467333,0.04362513471839766,0.029704031832266987,0.6351929153033207,1,0.19980309017169423,0.15976209189694032,0.21978339918886367,0,24,0 +m_37,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08938303289074952,0.10702661619563318,0.030521793123879107,0.02794797278256053,0.6789645140321589,1,0.11990482601462862,0.1349745889781937,0.1484720478760131,0,24,0 +m_37,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08938303289074952,0.05480710749376039,0.030521793123879107,0.021819082543322585,0.38066097964896906,1,0.11990482601462862,0.07662619003708297,0.1484720478760131,0,24,0 +m_37,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08938303289074952,0.07192171993892875,0.030521793123879107,0.017100736244016028,0.6313831399678044,1,0.11990482601462862,0.08902245618294477,0.1484720478760131,0,24,0 +m_37,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11584417132348195,0.06947285305168349,0.045347748899772104,0.013844430433418835,0.37523817121695474,1,0.16119192022325404,0.08331728348510233,0.17731111224557947,0,24,0 +m_37,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11584417132348195,0.09732982157655057,0.045347748899772104,0.03231331412108069,0.7489478383036599,1,0.16119192022325404,0.12964313569763125,0.17731111224557947,0,24,0 +m_37,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11584417132348195,0.10595336786323946,0.045347748899772104,0.052143813548511594,0.8893441608318882,1,0.16119192022325404,0.15809718141175105,0.17731111224557947,0,24,0 +m_37,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.04847730710702693,0.04977296853182726,0.024890610700314564,0.019267140185789778,0.9681813724642918,1,0.0733679178073415,0.06904010871761704,0.10566954975617653,0,24,0 +m_37,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04847730710702693,0.05145622364425736,0.024890610700314564,0.01135419408221823,0.9170607273511259,1,0.0733679178073415,0.06281041772647558,0.10566954975617653,0,24,0 +m_37,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04847730710702693,0.07767845291505508,0.024890610700314564,0.018384774136014484,0.3739371928119195,1,0.0733679178073415,0.09606322705106957,0.10566954975617653,0,24,0 +m_37,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14591821695077742,0.16259358399785082,0.057403017383879595,0.06354372941041958,0.8495415121653156,1,0.20332123433465701,0.2261373134082704,0.3402276366579358,0,24,0 +m_37,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14591821695077742,0.09784281087561945,0.057403017383879595,0.03131533459445266,0.48390173307185136,1,0.20332123433465701,0.12915814547007212,0.3402276366579358,0,24,0 +m_37,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14591821695077742,0.22019012500192106,0.057403017383879595,0.08910772650529329,0.5021317513498792,1,0.20332123433465701,0.30929785150721434,0.3402276366579358,0,24,0 +m_37,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16618529251313507,0.11137946894383144,0.06576464932920174,0.06541442880681636,0.5677359999299629,1,0.2319499418423368,0.1767938977506478,0.2551449360265705,0,24,0 +m_37,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16618529251313507,0.08158301209836627,0.06576464932920174,0.02911074375089128,0.27851153374616316,1,0.2319499418423368,0.11069375584925756,0.2551449360265705,0,24,0 +m_37,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16618529251313507,0.10078709480379788,0.06576464932920174,0.03318754412996521,0.40261747742178833,1,0.2319499418423368,0.1339746389337631,0.2551449360265705,0,24,0 +m_37,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.12038838516734929,0.054090421274299416,0.052844271791803676,0.01463451690165136,0.27389006661903487,1,0.17323265695915296,0.06872493817595078,0.4247799586127826,0,24,0 +m_37,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.12038838516734929,0.09615721418515943,0.052844271791803676,0.032128287940876514,0.7051246692881636,1,0.17323265695915296,0.12828550212603596,0.4247799586127826,0,24,0 +m_37,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.12038838516734929,0.2544883294204025,0.052844271791803676,0.13167526931849077,0.37803701641515364,1,0.17323265695915296,0.3861635987388933,0.4247799586127826,0,24,0 +m_37,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1990981273595198,0.3618097670438633,0.07790435496451564,0.14996673816542858,0.3655872858623154,1,0.27700248232403546,0.5117765052092919,0.5973503893810763,0,24,0 +m_37,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1990981273595198,0.42085975662190217,0.07790435496451564,0.12218605190634892,0.16230089248613394,1,0.27700248232403546,0.5430458085282511,0.5973503893810763,0,24,0 +m_37,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1990981273595198,0.06387249759293138,0.07790435496451564,0.027021963250056447,0.15064020999066557,1,0.27700248232403546,0.09089446084298783,0.5973503893810763,0,24,0 +m_38,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3443978425598105,0.2731916940453773,0.23014584610595623,0.14416191446226778,0.8008157126380696,1,0.5745436886657667,0.4173536085076451,0.6319980575323434,0,24,0 +m_38,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3443978425598105,0.17503923944790592,0.23014584610595623,0.060630280772859806,0.5114627323696518,1,0.5745436886657667,0.23566952022076573,0.6319980575323434,0,24,0 +m_38,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3443978425598105,0.21389451627581388,0.23014584610595623,0.10012060597850068,0.623333163365816,1,0.5745436886657667,0.31401512225431455,0.6319980575323434,0,24,0 +m_38,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.41562243038150243,0.428692661063342,0.16987365883807817,0.13804320837221715,0.9536104299265163,1,0.5854960892195806,0.5667358694355591,0.6440456981415388,0,24,0 +m_38,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.41562243038150243,0.34987163502193175,0.16987365883807817,0.157185368931859,0.7821675075101968,1,0.5854960892195806,0.5070570039537907,0.6440456981415388,0,24,0 +m_38,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.41562243038150243,0.2235312870223087,0.16987365883807817,0.08143439899496246,0.34099148335466406,1,0.5854960892195806,0.30496568601727114,0.6440456981415388,0,24,0 +m_38,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1812850401655158,0.5597062965994246,0.0708862505937082,0.24428304861253022,0.18882957567115383,1,0.252171290759224,0.8039893452119549,0.8843882797331504,0,24,0 +m_38,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1812850401655158,0.4208117423085404,0.0708862505937082,0.14589494447579762,0.1919782532132751,1,0.252171290759224,0.566706686784338,0.8843882797331504,0,24,0 +m_38,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1812850401655158,0.2717306898967731,0.0708862505937082,0.09267662910727494,0.4585660331531647,1,0.252171290759224,0.36440731900404805,0.8843882797331504,0,24,0 +m_38,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.19553434598918623,0.4260932814555854,0.1355094210938971,0.160385605222829,0.30076811972917034,1,0.33104376708308336,0.5864788866784144,0.9420372258418412,0,24,0 +m_38,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.19553434598918623,0.613750337024133,0.1355094210938971,0.2426471410139045,0.17238036285662733,1,0.33104376708308336,0.8563974780380375,0.9420372258418412,0,24,0 +m_38,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.19553434598918623,0.20542103017057825,0.1355094210938971,0.10834681658588717,0.955938377908429,1,0.33104376708308336,0.3137678467564654,0.9420372258418412,0,24,0 +m_38,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2772677295136325,0.3074020464016017,0.09205644457702311,0.1371688748590305,0.859415292859454,1,0.3693241740906556,0.4445709212606322,0.8830075169681465,0,24,0 +m_38,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2772677295136325,0.41309005329310544,0.09205644457702311,0.12760549927192888,0.41020580003799467,1,0.3693241740906556,0.5406955525650343,0.8830075169681465,0,24,0 +m_38,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2772677295136325,0.5424659443643322,0.09205644457702311,0.2602681619703464,0.3725172451719827,1,0.3693241740906556,0.8027341063346786,0.8830075169681465,0,24,0 +m_38,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.4110583574795691,0.2994398871467102,0.23864810377698692,0.05563164679732046,0.6660476223941709,1,0.649706461256556,0.3550715339440307,0.7146771073822116,0,24,0 +m_38,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.4110583574795691,0.12408523172769566,0.23864810377698692,0.044477128707354735,0.28703971412545976,1,0.649706461256556,0.1685623604350504,0.7146771073822116,0,24,0 +m_38,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.4110583574795691,0.18102613891108346,0.23864810377698692,0.07078412981509619,0.3918184761664521,1,0.649706461256556,0.2518102687261796,0.7146771073822116,0,24,0 +m_38,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.21291635920975596,0.2772098629834692,0.09513036959574658,0.07641611747725464,0.6102727655067135,1,0.30804672880550255,0.35362598046072385,0.43889160453750514,0,24,0 +m_38,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.21291635920975596,0.25823002983778376,0.09513036959574658,0.1407623379235845,0.7958452287728831,1,0.30804672880550255,0.39899236776136826,0.43889160453750514,0,24,0 +m_38,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.21291635920975596,0.2094197504917511,0.09513036959574658,0.04835214226430252,0.9747247833780057,1,0.30804672880550255,0.2577718927560536,0.43889160453750514,0,24,0 +m_38,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.44290557279658127,0.1730175308520321,0.18733140111920207,0.06020894604892011,0.21909637085494324,1,0.6302369739157834,0.2332264769009522,0.9216810707638364,0,24,0 +m_38,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.44290557279658127,0.5019378379929359,0.18733140111920207,0.13195200032283005,0.802500316102702,1,0.6302369739157834,0.633889838315766,0.9216810707638364,0,24,0 +m_38,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.44290557279658127,0.6315115511279644,0.18733140111920207,0.20638033138461406,0.5140951588793646,1,0.6302369739157834,0.8378918825125785,0.9216810707638364,0,24,0 +m_39,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.7747688198130576,0.13845131633943208,0.26919092084029383,0.03257465738914725,0.07694211566905569,1,1.0439597406533514,0.17102597372857933,1.2291398361096748,0,24,0 +m_39,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.7747688198130576,0.5267331592640738,0.26919092084029383,0.14601881604344868,0.44763951201041563,1,1.0439597406533514,0.6727519753075225,1.2291398361096748,0,24,0 +m_39,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.7747688198130576,0.7071402680756742,0.26919092084029383,0.4102595829331211,0.8936623296574107,1,1.0439597406533514,1.1173998510087952,1.2291398361096748,0,24,0 +m_39,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3177368198051252,0.4378328160317237,0.20058651571703193,0.2153640250256072,0.691869404815321,1,0.5183233355221571,0.6531968410573309,0.7185165251630641,0,24,0 +m_39,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3177368198051252,0.2755306567559976,0.20058651571703193,0.1447976297165573,0.8682669973692505,1,0.5183233355221571,0.4203282864725549,0.7185165251630641,0,24,0 +m_39,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3177368198051252,0.20730417047683705,0.20058651571703193,0.13912981858831375,0.6618118657905636,1,0.5183233355221571,0.34643398906515077,0.7185165251630641,0,24,0 +m_39,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08210717606038731,0.5187367718057797,0.022670543497279944,0.2278241751531394,0.11368955036936503,1,0.10477771955766725,0.7465609469589192,0.8212170416548111,0,24,0 +m_39,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08210717606038731,0.10465824038104339,0.022670543497279944,0.045095481845478666,0.6709558849945766,1,0.10477771955766725,0.14975372222652206,0.8212170416548111,0,24,0 +m_39,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08210717606038731,0.4127225776320232,0.022670543497279944,0.28614866048061016,0.30087976054855775,1,0.10477771955766725,0.6988712381126334,0.8212170416548111,0,24,0 +m_39,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.47008026673640607,0.185672043301487,0.20485960744055684,0.06849126883965892,0.2462185187193259,1,0.6749398741769629,0.25416331214114596,0.7974830857761481,0,24,0 +m_39,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.47008026673640607,0.36699724901631364,0.20485960744055684,0.23040302741820745,0.7457737460451106,1,0.6749398741769629,0.5974002764345211,0.7974830857761481,0,24,0 +m_39,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.47008026673640607,0.5594391790478432,0.20485960744055684,0.16554544438501861,0.7429848469095494,1,0.6749398741769629,0.7249846234328619,0.7974830857761481,0,24,0 +m_39,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11744758851005432,0.04526141563796885,0.03822544200098619,0.020809748127955743,0.13713175207423334,1,0.1556730305110405,0.06607116376592459,0.17124033356214458,0,24,0 +m_39,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11744758851005432,0.04901429936629276,0.03822544200098619,0.01402159285257676,0.14128560491982425,1,0.1556730305110405,0.06303589221886952,0.17124033356214458,0,24,0 +m_39,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11744758851005432,0.07470693334553642,0.03822544200098619,0.028468616497044418,0.39261339698772124,1,0.1556730305110405,0.10317554984258084,0.17124033356214458,0,24,0 +m_39,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05990805682544309,0.07195122784927872,0.018752265716653886,0.011072900281671289,0.5951687622724089,1,0.07866032254209698,0.08302412813095002,0.18845130282983458,0,24,0 +m_39,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05990805682544309,0.07695170297556968,0.018752265716653886,0.051931507018525405,0.7675420776391506,1,0.07866032254209698,0.12888320999409508,0.18845130282983458,0,24,0 +m_39,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05990805682544309,0.10049672273552224,0.018752265716653886,0.07082264347341828,0.6006189671960254,1,0.07866032254209698,0.1713193662089405,0.18845130282983458,0,24,0 +m_39,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.057276324271923716,0.05435475422664885,0.0217060012242127,0.017711433450611526,0.9190863142369889,1,0.07898232549613642,0.07206618767726038,0.18476793508916686,0,24,0 +m_39,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.057276324271923716,0.12507268568740412,0.0217060012242127,0.04289816439365664,0.19909769655423137,1,0.07898232549613642,0.16797085008106077,0.18476793508916686,0,24,0 +m_39,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.057276324271923716,0.057658425001020884,0.0217060012242127,0.0201367084196498,0.9899585936613109,1,0.07898232549613642,0.07779513342067068,0.18476793508916686,0,24,0 +m_39,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06029159292349876,0.03820063320855501,0.019219568762399573,0.011434632715156852,0.35168249352249414,1,0.079511161685898335,0.04963526592371186,0.1783860844096059,0,24,0 +m_39,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06029159292349876,0.04272592418614011,0.019219568762399573,0.020640016206922487,0.547403784941801,1,0.079511161685898335,0.06336594039306259,0.1783860844096059,0,24,0 +m_39,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06029159292349876,0.10423630030239517,0.019219568762399573,0.05793286734270109,0.49824909898428127,1,0.079511161685898335,0.16216916764509626,0.1783860844096059,0,24,0 +m_40,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.16116027733743604,0.06611912950638914,0.06997717368609377,0.0219346455304921,0.25393081885887775,1,0.2311374510235298,0.08805377503688123,0.2750495499289453,1,24,4.166666666666666 +m_40,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.16116027733743604,0.1856407619517192,0.06997717368609377,0.06440428343823107,0.8028684696387156,1,0.2311374510235298,0.25004504538995026,0.2750495499289453,1,24,4.166666666666666 +m_40,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.16116027733743604,0.10209816418569122,0.06997717368609377,0.03793200610909262,0.4849629639218006,1,0.2311374510235298,0.14003017029478385,0.2750495499289453,1,24,4.166666666666666 +m_40,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.04970488345710922,0.0904022651156519,0.012473473266923297,0.035728970084358706,0.32224476519897693,1,0.06217835672403251,0.1261312352000106,0.13874435872001167,1,24,4.166666666666666 +m_40,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04970488345710922,0.05458733844868754,0.012473473266923297,0.02296440064942076,0.856614693372965,1,0.06217835672403251,0.0775517390981083,0.13874435872001167,1,24,4.166666666666666 +m_40,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04970488345710922,0.0417348459195482,0.012473473266923297,0.01376712168785493,0.6770926315024619,1,0.06217835672403251,0.05550196760740313,0.13874435872001167,1,24,4.166666666666666 +m_40,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09082178661311957,0.051098614286874344,0.0297151263694804,0.027475930049355033,0.35288674781370954,1,0.12053691298259997,0.07857454433622937,0.13474447354038532,4,24,16.666666666666664 +m_40,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09082178661311957,0.08775222698353122,0.0297151263694804,0.03474274896227361,0.948154694624207,1,0.12053691298259997,0.12249497594580483,0.13474447354038532,4,24,16.666666666666664 +m_40,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09082178661311957,0.06126632938724511,0.0297151263694804,0.024873156104080214,0.46674923443989047,1,0.12053691298259997,0.08613948549132533,0.13474447354038532,4,24,16.666666666666664 +m_40,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09275599788030106,0.07761487348899969,0.048115984807762587,0.03486747257677656,0.8056093146626637,1,0.14087198268806364,0.11248234606577626,0.15495918095687003,7,24,29.166666666666668 +m_40,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09275599788030106,0.10747028110587949,0.048115984807762587,0.013944565956882642,0.7815620976934895,1,0.14087198268806364,0.12141484706276212,0.15495918095687003,7,24,29.166666666666668 +m_40,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09275599788030106,0.07560941801264653,0.048115984807762587,0.020975072708641237,0.7559754435255193,1,0.14087198268806364,0.09658449072128777,0.15495918095687003,7,24,29.166666666666668 +m_40,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.012132654321115988,0.014360455847593897,0.005764889698567512,0.007178369391583132,0.8139122673187572,1,0.0178975440196835,0.02153882523917703,0.03836636478292668,0,24,0 +m_40,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.012132654321115988,0.009051359841783105,0.005764889698567512,0.00302708967048477,0.6494121791579301,1,0.0178975440196835,0.012078449512267875,0.03836636478292668,0,24,0 +m_40,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.012132654321115988,0.026219710213308007,0.005764889698567512,0.00865880322571625,0.20977246562912216,1,0.0178975440196835,0.034878513439024254,0.03836636478292668,0,24,0 +m_40,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.018078492704062993,0.017067137383293202,0.006546829545105946,0.00460553016616916,0.9022412468784309,1,0.02462532224916894,0.021672667549462364,0.03089119905812755,0,24,0 +m_40,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.018078492704062993,0.019195340032445756,0.006546829545105946,0.008887568202215647,0.9215827050364549,1,0.02462532224916894,0.028082908234661405,0.03089119905812755,0,24,0 +m_40,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.018078492704062993,0.014834099298260739,0.006546829545105946,0.007741191455457959,0.755724725309255,1,0.02462532224916894,0.022575290753718696,0.03089119905812755,0,24,0 +m_40,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.014991181659005667,0.013520035817984924,0.004425678105678528,0.0013623009522029366,0.7615849031562245,1,0.019416859764684196,0.014882336770187861,0.026222389432385005,0,24,0 +m_40,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.014991181659005667,0.015503169935477215,0.004425678105678528,0.008335365912145513,0.9581320571309724,1,0.019416859764684196,0.02383853584762273,0.026222389432385005,0,24,0 +m_40,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.014991181659005667,0.014092709997829264,0.004425678105678528,0.004256941633594513,0.8865851550757159,1,0.019416859764684196,0.018349651631423776,0.026222389432385005,0,24,0 +m_40,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.011205041868716329,0.007457068329928207,0.004500681858937313,0.0018764424885753237,0.46838347195487273,1,0.015705723727653643,0.00933351081850353,0.040479295512273666,0,24,0 +m_40,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.011205041868716329,0.01266009295272282,0.004500681858937313,0.0053627107884184734,0.839654407536421,1,0.015705723727653643,0.018022803741141295,0.040479295512273666,0,24,0 +m_40,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.011205041868716329,0.030130936610411663,0.004500681858937313,0.006668422946200755,0.04382595446294489,1,0.015705723727653643,0.03679935955661242,0.040479295512273666,0,24,0 +m_41,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09246065074214105,0.033124405877616336,0.03606199540340797,0.011616553472312403,0.18010796812079255,1,0.12852264614554904,0.044740959349928736,0.14735198732731136,0,24,0 +m_41,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09246065074214105,0.08631913262311348,0.03606199540340797,0.04118847544624944,0.9131399721413604,1,0.12852264614554904,0.12750760806936293,0.14735198732731136,0,24,0 +m_41,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09246065074214105,0.10098712636706926,0.03606199540340797,0.03296922574866831,0.8654866628629574,1,0.12852264614554904,0.1339563521157376,0.14735198732731136,0,24,0 +m_41,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09805111127586441,0.079537313050803915,0.05499845295055051,0.022009399792933794,0.7643362076607854,1,0.1530495642264149,0.1015467128437377,0.16835452064905643,0,24,0 +m_41,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09805111127586441,0.09684524441985509,0.05499845295055051,0.034670037221805713,0.9856333096885872,1,0.1530495642264149,0.13151528164166082,0.16835452064905643,0,24,0 +m_41,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09805111127586441,0.027005465264438627,0.05499845295055051,0.006212979241997429,0.2542240317353529,1,0.1530495642264149,0.03321844450643605,0.16835452064905643,0,24,0 +m_41,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1215052977767301,0.12300891523227027,0.06327047805865221,0.03553254883789097,0.9840982938330008,1,0.1847757758353823,0.15854146407016123,0.20325335341892053,0,24,0 +m_41,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1215052977767301,0.07670676514903371,0.06327047805865221,0.03829944828132064,0.5649868801825507,1,0.1847757758353823,0.11500621343035436,0.20325335341892053,0,24,0 +m_41,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1215052977767301,0.08667230639332146,0.06327047805865221,0.028559113697784442,0.6348924658222385,1,0.1847757758353823,0.1152314200911059,0.20325335341892053,0,24,0 +m_41,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1458503930272182,0.08272723248206397,0.04922337351131039,0.025139408236986377,0.29673842866208666,1,0.1950737665385286,0.10786664071905035,0.21458114319238147,0,24,0 +m_41,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1458503930272182,0.05178191768774454,0.04922337351131039,0.01793945244535213,0.13180515255762784,1,0.1950737665385286,0.06972137013309666,0.21458114319238147,0,24,0 +m_41,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1458503930272182,0.04955272967861809,0.04922337351131039,0.01846118942492474,0.12507677762446623,1,0.1950737665385286,0.06801391910354283,0.21458114319238147,0,24,0 +m_41,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08984424186010753,0.09647399840866437,0.029087127725133752,0.04132088578398481,0.8985104368436744,1,0.11893136958524128,0.13779488419264918,0.23514229708191434,0,24,0 +m_41,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08984424186010753,0.06528544174924418,0.029087127725133752,0.018699209460910235,0.49652445407857826,1,0.11893136958524128,0.08398465121015442,0.23514229708191434,0,24,0 +m_41,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08984424186010753,0.16346018079922398,0.029087127725133752,0.05030554382069813,0.24081405640286693,1,0.11893136958524128,0.2137657246199221,0.23514229708191434,0,24,0 +m_41,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13029764454798176,0.0659854634815018,0.03269299091810412,0.023721198132856013,0.14535345736476446,1,0.1629906354660859,0.08970666161435782,0.17928969901269448,0,24,0 +m_41,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13029764454798176,0.05962814441989561,0.03269299091810412,0.0133596758631365,0.08780889524171233,1,0.1629906354660859,0.0729878202830321,0.17928969901269448,0,24,0 +m_41,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13029764454798176,0.05425945408329554,0.03269299091810412,0.02740641167700991,0.1059374501612568,1,0.1629906354660859,0.08166586576030545,0.17928969901269448,0,24,0 +m_41,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05393589170302452,0.060973189988720033,0.011184361689773775,0.012275676349682128,0.6807852978751519,1,0.0651202533927983,0.07324886633840216,0.1229410632183839,0,24,0 +m_41,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05393589170302452,0.06607852356359774,0.011184361689773775,0.0404849434246919,0.7826282958584838,1,0.0651202533927983,0.10656346698828964,0.1229410632183839,0,24,0 +m_41,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05393589170302452,0.08516933186868518,0.011184361689773775,0.02659527105711835,0.3163368354744939,1,0.0651202533927983,0.11176460292580354,0.1229410632183839,0,24,0 +m_41,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0768419330391239,0.07823252847661262,0.03507742824926539,0.01633231519061391,0.972324664045164,1,0.11191936128838928,0.09456484366722653,0.12311129741722822,0,24,0 +m_41,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0768419330391239,0.07662235000845834,0.03507742824926539,0.021869381619732307,0.9958859150263144,1,0.11191936128838928,0.09849173162819064,0.12311129741722822,0,24,0 +m_41,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0768419330391239,0.0606665770786489,0.03507742824926539,0.018816556954000176,0.695597888361045,1,0.11191936128838928,0.07948313403264907,0.12311129741722822,0,24,0 +m_42,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03427873652172671,0.05960631057595511,0.01660561232163584,0.018445786299067783,0.33414711263351654,1,0.05088434884336255,0.0780520968750229,0.1020501248070422,0,24,0 +m_42,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03427873652172671,0.03732745769155806,0.01660561232163584,0.011422901726259945,0.8838301189023012,1,0.05088434884336255,0.04875035941781801,0.1020501248070422,0,24,0 +m_42,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03427873652172671,0.06417372760371938,0.01660561232163584,0.02859911312995535,0.3929772176429458,1,0.05088434884336255,0.09277284073367473,0.1020501248070422,0,24,0 +m_42,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03148431083745514,0.019609947729075133,0.008692770096100928,0.010570460390969571,0.40666688669583506,1,0.04017708093355607,0.030180408120044702,0.04419478902691168,0,24,0 +m_42,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03148431083745514,0.023536183751052337,0.008692770096100928,0.013675234827899369,0.6362314535237799,1,0.04017708093355607,0.0372114185789517,0.04419478902691168,0,24,0 +m_42,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03148431083745514,0.016969361026884733,0.008692770096100928,0.007210367789539124,0.22865232483009723,1,0.04017708093355607,0.024179728816423857,0.04419478902691168,0,24,0 +m_42,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.01227902336059299,0.025478965645630902,0.006488335053818382,0.00808666031670941,0.23521070695845658,1,0.01876735841441137,0.03356562596234031,0.10348959565715424,0,24,0 +m_42,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.01227902336059299,0.06261689779616045,0.006488335053818382,0.03146455280125248,0.1866709936428214,1,0.01876735841441137,0.09408145059741294,0.10348959565715424,0,24,0 +m_42,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.01227902336059299,0.033365868779447215,0.006488335053818382,0.010466786798953224,0.12478183575168278,1,0.01876735841441137,0.04383265557840044,0.10348959565715424,0,24,0 +m_42,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0480788671519901,0.037611363656101515,0.017612820984221803,0.019493643740223464,0.699601505874502,1,0.0656916881362119,0.05710500739632498,0.0722608569498331,0,24,0 +m_42,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0480788671519901,0.014303998496407289,0.017612820984221803,0.008453201488806718,0.1362044392645777,1,0.0656916881362119,0.022757199985214006,0.0722608569498331,0,24,0 +m_42,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0480788671519901,0.030274726297341254,0.017612820984221803,0.011661650132917041,0.42651721388817443,1,0.0656916881362119,0.0419363764302583,0.0722608569498331,0,24,0 +m_42,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.030101120844882773,0.03770705927391408,0.01034122499411787,0.012588684001646805,0.6509739690302685,1,0.040442345839000644,0.050295743275560884,0.05532531760311698,0,24,0 +m_42,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.030101120844882773,0.010803967243913673,0.01034122499411787,0.004898403718767507,0.13475979556580067,1,0.040442345839000644,0.01570237096268118,0.05532531760311698,0,24,0 +m_42,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.030101120844882773,0.034295355456936814,0.01034122499411787,0.012667013502525632,0.8029740238071317,1,0.040442345839000644,0.046962368959462444,0.05532531760311698,0,24,0 +m_42,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.037076577975972226,0.030096268674848048,0.013186234708082055,0.01434691842097369,0.7276779222337206,1,0.05026281268405428,0.044443187095821735,0.05528909395245971,0,24,0 +m_42,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.037076577975972226,0.029611050788484066,0.013186234708082055,0.01034121511481283,0.6659765592036269,1,0.05026281268405428,0.039952265903296896,0.05528909395245971,0,24,0 +m_42,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.037076577975972226,0.012353836920090696,0.013186234708082055,0.003178204023468389,0.12188315088509363,1,0.05026281268405428,0.015532040943559085,0.05528909395245971,0,24,0 +m_42,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.016071932313528253,0.0148701828755049,0.0036441050026658805,0.005088823043768579,0.8519749062718902,1,0.019716037316194132,0.01995900591927348,0.04033470346880649,0,24,0 +m_42,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.016071932313528253,0.01230976502901641,0.0036441050026658805,0.0031708411839939314,0.4544483614895246,1,0.019716037316194132,0.015480606213010341,0.04033470346880649,0,24,0 +m_42,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.016071932313528253,0.02903938635883052,0.0036441050026658805,0.007628525885539015,0.16793718765449137,1,0.019716037316194132,0.036667912244369535,0.04033470346880649,0,24,0 +m_42,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.034097786207656355,0.02926785561854735,0.006755680159625211,0.010602295206786702,0.7102867689040535,1,0.040853466367281564,0.03987015082533405,0.05470115510054855,0,24,0 +m_42,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.034097786207656355,0.02120600431040957,0.006755680159625211,0.008066811498880253,0.2494068227287898,1,0.040853466367281564,0.029272815809289823,0.05470115510054855,0,24,0 +m_42,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.034097786207656355,0.036922053256229916,0.006755680159625211,0.012806269562450581,0.8504702191030415,1,0.040853466367281564,0.0497283228186805,0.05470115510054855,0,24,0 +m_43,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.46761950511822076,0.30624671799788156,0.20978215798329036,0.09174347949813198,0.5095914737545653,1,0.6774016631015112,0.39799019749601355,0.7451418294116624,0,24,0 +m_43,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.46761950511822076,0.3611447790819684,0.20978215798329036,0.1628211892444689,0.6990027148197906,1,0.6774016631015112,0.5239659683264373,0.7451418294116624,0,24,0 +m_43,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.46761950511822076,0.2299531503699145,0.20978215798329036,0.09355986344391719,0.3436107295159424,1,0.6774016631015112,0.3235130138138317,0.7451418294116624,0,24,0 +m_43,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.6923212793428505,0.7115291748535558,0.46826819693755645,0.4373212316606263,0.9766767722427313,1,1.160589476280407,1.1488504065141822,1.2766484239084477,3,24,12.5 +m_43,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.6923212793428505,0.7597435845202456,0.46826819693755645,0.30590334172945743,0.9068205670032622,1,1.160589476280407,1.065646926249703,1.2766484239084477,3,24,12.5 +m_43,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.6923212793428505,0.4972198304742091,0.46826819693755645,0.12309812764547359,0.7016886149809551,1,1.160589476280407,0.6203179581196827,1.2766484239084477,3,24,12.5 +m_43,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.5275527222277054,0.3913910043624846,0.14202124638057317,0.1424743125652602,0.5157133767238503,1,0.6695739686082787,0.5338653169277447,0.7365313654691066,0,24,0 +m_43,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.5275527222277054,0.3307323280359496,0.14202124638057317,0.09208281277724951,0.28376179831997034,1,0.6695739686082787,0.4228151408131991,0.7365313654691066,0,24,0 +m_43,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.5275527222277054,0.3614392527627002,0.14202124638057317,0.09894841441709355,0.36741282044706125,1,0.6695739686082787,0.4603876671797938,0.7365313654691066,0,24,0 +m_43,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.8961156917701282,0.3073999915196383,0.4899637418489128,0.09379004048042694,0.2991705874978323,1,1.386079433619041,0.40119003200006526,1.5246873769809453,1,24,4.166666666666666 +m_43,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.8961156917701282,0.3034960133156555,0.4899637418489128,0.11750841090693954,0.2984468700399965,1,1.386079433619041,0.42100442422259504,1.5246873769809453,1,24,4.166666666666666 +m_43,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.8961156917701282,0.6365818043215177,0.4899637418489128,0.1449410837741789,0.6344125598001589,1,1.386079433619041,0.7815228880956966,1.5246873769809453,1,24,4.166666666666666 +m_43,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07523713046590474,0.0927510784335237,0.037647880292001015,0.03396596742088448,0.7370193303893386,1,0.11288501075790576,0.12671704585440818,0.27154703781968165,0,24,0 +m_43,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07523713046590474,0.16842787322923272,0.037647880292001015,0.07843307024320514,0.318744995694604,1,0.11288501075790576,0.24686094347243787,0.27154703781968165,0,24,0 +m_43,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07523713046590474,0.09273671402070612,0.037647880292001015,0.030871045188357826,0.7270268100462902,1,0.11288501075790576,0.12360775920906394,0.27154703781968165,0,24,0 +m_43,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08208846843719304,0.06422173901320138,0.03247961350794258,0.019192230623113607,0.6482762305825339,1,0.11456808194513562,0.08341396963631499,0.1260248901396492,0,24,0 +m_43,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08208846843719304,0.05651021926352473,0.03247961350794258,0.01707075344715016,0.5065891916615312,1,0.11456808194513562,0.07358097271067489,0.1260248901396492,0,24,0 +m_43,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08208846843719304,0.03735228830955665,0.03247961350794258,0.015500303656323343,0.25297766738635646,1,0.11456808194513562,0.05285259196587999,0.1260248901396492,0,24,0 +m_43,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0624044052136569,0.06245271649903309,0.0175219174027978,0.012313157897214032,0.9982494395984622,1,0.0799263226164547,0.07476587439624713,0.16987106122578047,0,24,0 +m_43,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0624044052136569,0.11106093037250246,0.0175219174027978,0.04336730710547976,0.33487041081401236,1,0.0799263226164547,0.15442823747798223,0.16987106122578047,0,24,0 +m_43,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0624044052136569,0.04309691498276617,0.0175219174027978,0.012896934985799198,0.3974802170235672,1,0.0799263226164547,0.055993849968565365,0.16987106122578047,0,24,0 +m_43,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06498724239472746,0.03986559133372514,0.019379111979826415,0.013985113447998234,0.32029520902196085,1,0.08436635437455388,0.05385070478172337,0.12425348910099787,0,24,0 +m_43,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06498724239472746,0.07902960145812443,0.019379111979826415,0.013425992786019292,0.5662557241056616,1,0.08436635437455388,0.09245559424414372,0.12425348910099787,0,24,0 +m_43,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06498724239472746,0.07656284362995895,0.019379111979826415,0.036394873734584554,0.7863779745210695,1,0.08436635437455388,0.1129577173645435,0.12425348910099787,0,24,0 +m_44,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1645863639419119,0.10647491953143362,0.11366212052045603,0.030495560638581585,0.6442163905767493,1,0.27824848446236794,0.1369704801700152,0.3060733329086048,0,24,0 +m_44,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1645863639419119,0.15121333960847183,0.11366212052045603,0.058508249629480626,0.9200617235769897,1,0.27824848446236794,0.20972158923795245,0.3060733329086048,0,24,0 +m_44,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1645863639419119,0.11124105156796975,0.11366212052045603,0.02881999509819376,0.6701801991859844,1,0.27824848446236794,0.1400610466661635,0.3060733329086048,0,24,0 +m_44,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.15778253849189813,0.2505692951222194,0.03928361360166324,0.1069990706203107,0.4451839960168186,1,0.19706615209356138,0.35756836574253015,1.2306627352856907,0,23,0 +m_44,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.15778253849189813,0.6045775796702022,0.03928361360166324,0.514206725134971,0.43463174055819787,1,0.19706615209356138,1.1187843048051733,1.2306627352856907,0,23,0 +m_44,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.15778253849189813,0.2379818244103089,0.03928361360166324,0.06356732118701056,0.3132568789453505,1,0.19706615209356138,0.3015491455973195,1.2306627352856907,0,23,0 +m_44,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.16188362609342039,0.1740778879846682,0.07811576497968702,0.07896403170422912,0.9150128206650396,1,0.23999939107310742,0.25304191968889733,0.43858692731184773,0,24,0 +m_44,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.16188362609342039,0.21971970862183793,0.07811576497968702,0.17899567984347814,0.778038782687186,1,0.23999939107310742,0.39871538846531607,0.43858692731184773,0,24,0 +m_44,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.16188362609342039,0.16555512141556816,0.07811576497968702,0.04811952397961226,0.9692244889076087,1,0.23999939107310742,0.2136746453951804,0.43858692731184773,0,24,0 +m_44,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11756690284059576,0.11669546232798107,0.04797247693593476,0.013707417181259876,0.9867881678492472,1,0.16553937977653052,0.13040287950924095,0.1991421248604334,0,24,0 +m_44,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11756690284059576,0.07880430800629441,0.04797247693593476,0.031993804019704565,0.5223915746063977,1,0.16553937977653052,0.11079811202599898,0.1991421248604334,0,24,0 +m_44,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11756690284059576,0.11921255926668017,0.04797247693593476,0.06182573606098654,0.9836895564807064,1,0.16553937977653052,0.18103829532766672,0.1991421248604334,0,24,0 +m_44,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09824393385900117,0.10647750216037737,0.025819822134466076,0.05032013468320674,0.8881094324649657,1,0.12406375599346725,0.1567976368435841,0.17247740052794253,0,24,0 +m_44,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09824393385900117,0.09501160598175096,0.025819822134466076,0.02523728434811944,0.9304330030206408,1,0.12406375599346725,0.1202488903298704,0.17247740052794253,0,24,0 +m_44,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09824393385900117,0.07352147908341526,0.025819822134466076,0.056877870973269996,0.7040861819943949,1,0.12406375599346725,0.13039935005668526,0.17247740052794253,0,24,0 +m_44,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09877785231073322,0.09412087297272158,0.02213038684979697,0.041301243360610314,0.9233844246535736,1,0.12090823916053019,0.1354221163333319,0.17209443217542056,0,24,0 +m_44,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09877785231073322,0.07144872136195213,0.02213038684979697,0.018148872974430925,0.3629918868419695,1,0.12090823916053019,0.08959759433638305,0.17209443217542056,0,24,0 +m_44,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09877785231073322,0.09270910224249522,0.02213038684979697,0.06374038155334165,0.9311729180961007,1,0.12090823916053019,0.15644948379583687,0.17209443217542056,0,24,0 +m_44,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16517223104994283,0.1467247994523874,0.08128044244529009,0.04584574784673715,0.8482919283111525,1,0.24645267349523292,0.19257054729912454,0.27109794084475625,0,24,0 +m_44,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16517223104994283,0.1294252783342348,0.08128044244529009,0.04070137193606579,0.7052807628037161,1,0.24645267349523292,0.1701266502703006,0.27109794084475625,0,24,0 +m_44,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16517223104994283,0.10890687447831926,0.08128044244529009,0.03970657599032217,0.5529804292247615,1,0.24645267349523292,0.14861345046864144,0.27109794084475625,0,24,0 +m_44,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.22296203069198262,0.1427306640839522,0.06234414332222433,0.06259441087593239,0.38515800572073144,1,0.28530617401420694,0.2053250749598846,0.31383679141562765,0,24,0 +m_44,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.22296203069198262,0.10297334425489717,0.06234414332222433,0.03814657646636033,0.13798725720946378,1,0.28530617401420694,0.1411199207212575,0.31383679141562765,0,24,0 +m_44,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.22296203069198262,0.0859890429717763,0.06234414332222433,0.03283215171386146,0.08984283122569807,1,0.28530617401420694,0.11882119468563776,0.31383679141562765,0,24,0 +m_45,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.15986125165718884,0.16106349926936936,0.10574374002497908,0.02523664520987244,0.9916540973306853,1,0.2656049916821679,0.1863001444792418,0.2921654908503847,0,24,0 +m_45,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.15986125165718884,0.12301329057779853,0.10574374002497908,0.07016589820688347,0.7797461465229937,1,0.2656049916821679,0.193179188784682,0.2921654908503847,0,24,0 +m_45,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.15986125165718884,0.07407932865845297,0.10574374002497908,0.021099056442369254,0.4677366739893454,1,0.2656049916821679,0.09517838510082223,0.2921654908503847,0,24,0 +m_45,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17668433724141627,0.20641683276923053,0.03719806463448082,0.09518492426928192,0.7801713017357952,1,0.21388240187589708,0.30160175703851244,0.3886086903557368,0,23,0 +m_45,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17668433724141627,0.21374340851959558,0.03719806463448082,0.13953721907652872,0.808615991274709,1,0.21388240187589708,0.35328062759612433,0.3886086903557368,0,23,0 +m_45,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17668433724141627,0.21600305471878403,0.03719806463448082,0.04310929371694457,0.5058986645673382,1,0.21388240187589708,0.2591123484357286,0.3886086903557368,0,23,0 +m_45,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14880337596925006,0.17508783003344108,0.07658039341310502,0.08012979383544515,0.8178806778955736,1,0.22538376938235508,0.25521762386888625,0.3672837558691635,0,24,0 +m_45,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14880337596925006,0.1942792899298736,0.07658039341310502,0.13961503358754773,0.7844886776067147,1,0.22538376938235508,0.3338943235174213,0.3672837558691635,0,24,0 +m_45,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14880337596925006,0.1787601211502854,0.07658039341310502,0.0492916500426367,0.7517822698854316,1,0.22538376938235508,0.22805177119292208,0.3672837558691635,0,24,0 +m_45,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10675222507941626,0.07230852308713587,0.06942522472728922,0.031337764750952964,0.6680852021425596,1,0.17617744980670547,0.10364628783808882,0.22761218283169665,0,24,0 +m_45,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10675222507941626,0.08243794523556398,0.06942522472728922,0.03032533722372343,0.7600723631236762,1,0.17617744980670547,0.1127632824592874,0.22761218283169665,0,24,0 +m_45,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10675222507941626,0.14610025626791204,0.06942522472728922,0.060819909942721274,0.68047820236937,1,0.17617744980670547,0.2069201662106333,0.22761218283169665,0,24,0 +m_45,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.12630208239510207,0.1236755917607617,0.03409483726284535,0.05684353786916003,0.9693419924396073,1,0.16039691965794742,0.18051912962992173,0.19857104259291392,0,24,0 +m_45,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.12630208239510207,0.12106618984226018,0.03409483726284535,0.04254656357585117,0.9254807466245105,1,0.16039691965794742,0.16361275341811135,0.19857104259291392,0,24,0 +m_45,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.12630208239510207,0.10761149021645637,0.03409483726284535,0.07069623664141757,0.8184082448105537,1,0.16039691965794742,0.17830772685787394,0.19857104259291392,0,24,0 +m_45,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.19012491596995926,0.15245622572394066,0.03411973376675788,0.07862995770821246,0.6739104199542534,1,0.22424464973671715,0.23108618343215312,0.25774871872406807,0,24,0 +m_45,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.19012491596995926,0.12291772021887226,0.03411973376675788,0.023226649181952583,0.13861676383278493,1,0.22424464973671715,0.14614436940082484,0.25774871872406807,0,24,0 +m_45,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.19012491596995926,0.12989517502284778,0.03411973376675788,0.10442184199903229,0.6031182684744731,1,0.22424464973671715,0.23431701702188007,0.25774871872406807,0,24,0 +m_45,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1904850724017663,0.16690840993597877,0.10162787839699951,0.05092068859529332,0.8413103390219412,1,0.2921129507987658,0.21782909853127208,0.32132424587864244,0,24,0 +m_45,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1904850724017663,0.14669245742077486,0.10162787839699951,0.04775065466395496,0.7079599540122119,1,0.2921129507987658,0.1944431120847298,0.32132424587864244,0,24,0 +m_45,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1904850724017663,0.11036719659274279,0.10162787839699951,0.05984445386191397,0.5158864694480528,1,0.2921129507987658,0.17021165045465675,0.32132424587864244,0,24,0 +m_45,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1998811100617862,0.11422263001634825,0.061702076884850444,0.05118762418663826,0.3112616575452748,1,0.2615831869466366,0.1654102542029865,0.2877415056413003,0,24,0 +m_45,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1998811100617862,0.12901265618198524,0.061702076884850444,0.05149564715873301,0.39922814776328575,1,0.2615831869466366,0.18050830334071824,0.2877415056413003,0,24,0 +m_45,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1998811100617862,0.08640939910175509,0.061702076884850444,0.03172797453301142,0.14325668352803622,1,0.2615831869466366,0.11813737363476651,0.2877415056413003,0,24,0 +m_46,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14349876539092943,0.15698771388309588,0.04841546115276568,0.04032561170897308,0.8356615941362319,1,0.1919142265436951,0.19731332559206896,0.21704465815127588,0,24,0 +m_46,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14349876539092943,0.12527806432457758,0.04841546115276568,0.050129817900165186,0.7996689481815352,1,0.1919142265436951,0.17540788222474277,0.21704465815127588,0,24,0 +m_46,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14349876539092943,0.12698981021748645,0.04841546115276568,0.0543003685000217,0.8255513930254629,1,0.1919142265436951,0.18129017871750816,0.21704465815127588,0,24,0 +m_46,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1752164653906858,0.19269214244754673,0.06326589872958642,0.0778290111953522,0.8652999071849916,1,0.23848236412027224,0.2705211536428989,0.29757326900718883,0,23,0 +m_46,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1752164653906858,0.15320338554489724,0.06326589872958642,0.06919994911616881,0.8198456429432361,1,0.23848236412027224,0.22240333466106604,0.29757326900718883,0,23,0 +m_46,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1752164653906858,0.17326140135286763,0.06326589872958642,0.028756983836294017,0.9783437586140382,1,0.23848236412027224,0.20201838518916165,0.29757326900718883,0,23,0 +m_46,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2774793402120622,0.22538544669401803,0.12439477388468409,0.07720487598137778,0.7326653654220274,1,0.40187411409674634,0.3025903226753958,0.5925359738762941,0,24,0 +m_46,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2774793402120622,0.38183529029505997,0.12439477388468409,0.1568337768652073,0.6169785681466446,1,0.40187411409674634,0.5386690671602673,0.5925359738762941,0,24,0 +m_46,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2774793402120622,0.1412505808390819,0.12439477388468409,0.06402115539697233,0.3674385978099713,1,0.40187411409674634,0.20527173623605421,0.5925359738762941,0,24,0 +m_46,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.20475518990937153,0.18307194530184026,0.09198238288700905,0.03323109401014151,0.8332392049964743,1,0.2967375727963806,0.21630303931198178,0.3455768518401945,0,24,0 +m_46,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.20475518990937153,0.20142369454613748,0.09198238288700905,0.0749158751980375,0.9782685971311955,1,0.2967375727963806,0.27633956974417495,0.3455768518401945,0,24,0 +m_46,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.20475518990937153,0.24848758441912575,0.09198238288700905,0.06567318998105104,0.7094793972680351,1,0.2967375727963806,0.31416077440017676,0.3455768518401945,0,24,0 +m_46,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15484607421015228,0.16809718133795024,0.05265037273245844,0.04725564896129752,0.8552120197151953,1,0.2074964469426107,0.21535283029924776,0.3183395016834203,0,24,0 +m_46,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.15484607421015228,0.10703911844864071,0.05265037273245844,0.0572058048272494,0.5524436223773607,1,0.2074964469426107,0.1642449232758901,0.3183395016834203,0,24,0 +m_46,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.15484607421015228,0.1854202201034867,0.05265037273245844,0.10397932688144088,0.8002169997220454,1,0.2074964469426107,0.28939954698492754,0.3183395016834203,0,24,0 +m_46,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15368579513849415,0.14282007967556787,0.05227536310508508,0.03182568793006601,0.8633610081384535,1,0.20596115824357922,0.17464576760563388,0.22655727406793716,0,24,0 +m_46,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.15368579513849415,0.10152107879084848,0.05227536310508508,0.057959546812194174,0.5192027935810515,1,0.20596115824357922,0.15948062560304266,0.22655727406793716,0,24,0 +m_46,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.15368579513849415,0.07234306898678462,0.05227536310508508,0.03018548543348936,0.21472491485922507,1,0.20596115824357922,0.10252855442027398,0.22655727406793716,0,24,0 +m_46,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11926239323748715,0.068683930152129,0.049170756087890406,0.021148733971260627,0.37709995016392867,1,0.16843314932537756,0.08983266412338962,0.18527646425791533,0,24,0 +m_46,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11926239323748715,0.11030756382763822,0.049170756087890406,0.04338360896735366,0.894129007833494,1,0.16843314932537756,0.1536911727949919,0.18527646425791533,0,24,0 +m_46,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11926239323748715,0.05878293326281292,0.049170756087890406,0.02268083506084275,0.30072492417819957,1,0.16843314932537756,0.08146376832365568,0.18527646425791533,0,24,0 +m_46,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18408916667732989,0.11372082953869533,0.055830139793220525,0.014115557706482379,0.2703539439044992,1,0.2399193064705504,0.1278363872451777,0.26391123711760545,0,24,0 +m_46,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18408916667732989,0.12013225526126929,0.055830139793220525,0.019213710580693277,0.319231921025694,1,0.2399193064705504,0.13934596584196257,0.26391123711760545,0,24,0 +m_46,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18408916667732989,0.0749445198700766,0.055830139793220525,0.03161232810093506,0.12777071695371148,1,0.2399193064705504,0.10655684797101166,0.26391123711760545,0,24,0 +m_47,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08556945509048726,0.09225920912415964,0.05506421073135387,0.03137106719165596,0.9191272059881627,1,0.14063366582184111,0.1236302763158156,0.21920416350773522,0,24,0 +m_47,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08556945509048726,0.08163762255592033,0.05506421073135387,0.021116295055582535,0.9493443851412706,1,0.14063366582184111,0.10275391761150286,0.21920416350773522,0,24,0 +m_47,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08556945509048726,0.153678603435094,0.05506421073135387,0.04559790884466527,0.36780123986515534,1,0.14063366582184111,0.1992765122797593,0.21920416350773522,0,24,0 +m_47,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10804235139803227,0.12743616085016432,0.038009949223729314,0.06070685826688286,0.7931041858556513,1,0.14605230062176158,0.18814301911704717,0.24735944142669666,0,24,0 +m_47,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10804235139803227,0.15010275727571532,0.038009949223729314,0.07476946220309984,0.6305789151348232,1,0.14605230062176158,0.22487221947881514,0.24735944142669666,0,24,0 +m_47,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10804235139803227,0.15909992348377192,0.038009949223729314,0.018423037792751083,0.26481296098667034,1,0.14605230062176158,0.177522961276523,0.24735944142669666,0,24,0 +m_47,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.22195837070213792,0.09421417714575246,0.10918370259540322,0.02600368271077664,0.3125324999288232,1,0.33114207329754114,0.12021785985652911,0.397135983475807,0,24,0 +m_47,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.22195837070213792,0.23769286909657494,0.10918370259540322,0.12333984315415862,0.926284459530818,1,0.33114207329754114,0.3610327122507336,0.397135983475807,0,24,0 +m_47,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.22195837070213792,0.14337063572024875,0.10918370259540322,0.02923926750075651,0.5205930158340877,1,0.33114207329754114,0.17260990322100525,0.397135983475807,0,24,0 +m_47,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.20329927738744766,0.12646076976281728,0.05934520245619116,0.040832763569719856,0.3198400301520063,1,0.2626444798436388,0.16729353333253713,0.2889089278280027,0,24,0 +m_47,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.20329927738744766,0.060870741249395656,0.05934520245619116,0.019510827997953485,0.07299652293983232,1,0.2626444798436388,0.08038156924734914,0.2889089278280027,0,24,0 +m_47,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.20329927738744766,0.13986050415910223,0.05934520245619116,0.056277173840082795,0.4583713041674453,1,0.2626444798436388,0.19613767799918502,0.2889089278280027,0,24,0 +m_47,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1746390842736786,0.1474799344976346,0.055511902346936856,0.050590986642149366,0.7252324166440616,1,0.23015098662061545,0.19807092113978397,0.30076647094939074,0,24,0 +m_47,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1746390842736786,0.07293890706276618,0.055511902346936856,0.021508859588443868,0.13485102994144585,1,0.23015098662061545,0.09444776665121005,0.30076647094939074,0,24,0 +m_47,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1746390842736786,0.18590989399226462,0.055511902346936856,0.08751417050718147,0.9159319362534787,1,0.23015098662061545,0.2734240644994461,0.30076647094939074,0,24,0 +m_47,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.17151619589191128,0.043874024435146465,0.050619966955072204,0.01633978599354177,0.05310965976907638,1,0.22213616284698348,0.06021381042868823,0.24434977913168185,0,24,0 +m_47,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.17151619589191128,0.04793398546341421,0.050619966955072204,0.02119794795376269,0.06069422938205608,1,0.22213616284698348,0.0691319334171769,0.24434977913168185,0,24,0 +m_47,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.17151619589191128,0.05630056738890232,0.050619966955072204,0.020165694139459258,0.07502755957331965,1,0.22213616284698348,0.07646626152836158,0.24434977913168185,0,24,0 +m_47,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0615593584168197,0.10713807305308465,0.020505835165396245,0.040549339228471155,0.34749356194140807,1,0.08206519358221595,0.1476874122815558,0.3477398923014833,0,24,0 +m_47,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0615593584168197,0.13799436718211355,0.020505835165396245,0.05408535134551827,0.23157346318449343,1,0.08206519358221595,0.19207971852763184,0.3477398923014833,0,24,0 +m_47,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0615593584168197,0.19630266296170393,0.020505835165396245,0.11982451185782633,0.31550215670353343,1,0.08206519358221595,0.31612717481953023,0.3477398923014833,0,24,0 +m_47,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14594873060481076,0.07841182168371945,0.04981917954043253,0.0470675912520633,0.3477374288551218,1,0.19576791014524328,0.12547941293578274,0.21534470115976762,0,24,0 +m_47,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14594873060481076,0.06367994388326885,0.04981917954043253,0.03483043451918913,0.20913927991436643,1,0.19576791014524328,0.09851037840245798,0.21534470115976762,0,24,0 +m_47,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14594873060481076,0.10991576014785938,0.04981917954043253,0.0559685612379525,0.6410780246035566,1,0.19576791014524328,0.16588432138581188,0.21534470115976762,0,24,0 +m_48,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.18620021907815146,0.18717760740616607,0.06437945662850342,0.05059556476430606,0.9907678211687376,1,0.25057967570665485,0.2377731721704721,0.4879726779449273,0,24,0 +m_48,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.18620021907815146,0.08614138120656101,0.06437945662850342,0.04386861360477317,0.23818899505024868,1,0.25057967570665485,0.13000999481133418,0.4879726779449273,0,24,0 +m_48,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.18620021907815146,0.31721962447594443,0.06437945662850342,0.12639190092853492,0.3851022627738184,1,0.25057967570665485,0.44361152540447935,0.4879726779449273,0,24,0 +m_48,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.40337607263751674,0.17215463712844095,0.2162515535940259,0.0367585257806126,0.33759174159494826,1,0.6196276262315427,0.20891316290905354,0.681590388854697,0,24,0 +m_48,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.40337607263751674,0.1510715014083269,0.2162515535940259,0.030881104162894468,0.2983554468985359,1,0.6196276262315427,0.18195260557122137,0.681590388854697,0,24,0 +m_48,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.40337607263751674,0.10867803792312491,0.2162515535940259,0.01941478060422777,0.2318681760884266,1,0.6196276262315427,0.1280928185273527,0.681590388854697,0,24,0 +m_48,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14043589357999395,0.16653090395431536,0.07676550089939994,0.0636624739653743,0.7999862135282181,1,0.2172013944793939,0.23019337791968966,0.42595212274969624,0,24,0 +m_48,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14043589357999395,0.20728820715368082,0.07676550089939994,0.17994099534604296,0.7454369116730005,1,0.2172013944793939,0.3872292024997238,0.42595212274969624,0,24,0 +m_48,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14043589357999395,0.2021407209834489,0.07676550089939994,0.10589576551815749,0.6487609042348172,1,0.2172013944793939,0.3080364865016064,0.42595212274969624,0,24,0 +m_48,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08781808638090353,0.10934526540059823,0.037932812204153156,0.03622571319272006,0.6913332568315749,1,0.1257508985850567,0.1455709785933183,0.3398998773384741,0,24,0 +m_48,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08781808638090353,0.14838215122367937,0.037932812204153156,0.04373287031005823,0.3227943355055003,1,0.1257508985850567,0.1921150215337376,0.3398998773384741,0,24,0 +m_48,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08781808638090353,0.21576836138848174,0.037932812204153156,0.0932315271010401,0.2468241727444908,1,0.1257508985850567,0.30899988848952187,0.3398998773384741,0,24,0 +m_48,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14994247261485927,0.0902271874411517,0.031487173885944075,0.01952105603539219,0.14407889942672547,1,0.18142964650080334,0.10974824347654388,0.1995726111508837,0,24,0 +m_48,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.14994247261485927,0.040098081520377006,0.031487173885944075,0.01568448921183743,0.015802846931347467,0.3792683263523392,0.18142964650080334,0.05578257073221443,0.1995726111508837,0,24,0 +m_48,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.14994247261485927,0.05340218852803239,0.031487173885944075,0.017565794157384605,0.02855026844374136,0.6566561742060513,0.18142964650080334,0.070967982685417,0.1995726111508837,0,24,0 +m_48,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.048988588485709604,0.06276795123630723,0.027963329287602954,0.020332198372316097,0.6993835015675305,1,0.07695191777331256,0.08310014960862333,0.12104047467834551,0,24,0 +m_48,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.048988588485709604,0.04561031771836636,0.027963329287602954,0.01441452201602985,0.9173081056171527,1,0.07695191777331256,0.06002483973439621,0.12104047467834551,0,24,0 +m_48,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.048988588485709604,0.07179669637577583,0.027963329287602954,0.03824009878635644,0.6414903997967816,1,0.07695191777331256,0.11003679516213227,0.12104047467834551,0,24,0 +m_48,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16641021477327209,0.09919536663899249,0.031031259556838872,0.03023573926258511,0.15187855499645603,1,0.19744147433011094,0.1294311059015776,0.21718562176312206,0,24,0 +m_48,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16641021477327209,0.10809238096849454,0.031031259556838872,0.023097650042247234,0.16507572175171245,1,0.19744147433011094,0.13119003101074178,0.21718562176312206,0,24,0 +m_48,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16641021477327209,0.08601004254301207,0.031031259556838872,0.02991915622118796,0.09176948924641044,1,0.19744147433011094,0.11592919876420003,0.21718562176312206,0,24,0 +m_48,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13214477646301814,0.052138151735070526,0.04391616699949491,0.02239868189591836,0.14612151446611304,1,0.17606094346251305,0.07453683363098888,0.283939511832893,0,24,0 +m_48,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13214477646301814,0.06160001084512386,0.04391616699949491,0.021031806233040806,0.18963034999726933,1,0.17606094346251305,0.08263181707816467,0.283939511832893,0,24,0 +m_48,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13214477646301814,0.2101247091499064,0.04391616699949491,0.04800211978908721,0.2585351407525703,1,0.17606094346251305,0.25812682893899364,0.283939511832893,0,24,0 +m_49,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.04079424306685109,0.059636047685525995,0.0215657950817677,0.020504076844556792,0.5427745513070562,1,0.06236003814861879,0.08014012453008279,0.08815413698309107,0,24,0 +m_49,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04079424306685109,0.052574176029444884,0.0215657950817677,0.015296647118425093,0.6684859272327168,1,0.06236003814861879,0.06787082314786998,0.08815413698309107,0,24,0 +m_49,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04079424306685109,0.030574916253052604,0.0215657950817677,0.006344876248986253,0.6696401683364822,1,0.06236003814861879,0.036919792502038855,0.08815413698309107,0,24,0 +m_49,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.017047473999013518,0.019333738847446713,0.006523807742310107,0.00786154957610718,0.8275730326064367,1,0.023571281741323627,0.02719528842355389,0.05075190598390139,0,24,0 +m_49,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.017047473999013518,0.029719388130148922,0.006523807742310107,0.01641870821885234,0.4980256806529947,1,0.023571281741323627,0.04613809634900126,0.05075190598390139,0,24,0 +m_49,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.017047473999013518,0.009103551544398977,0.006523807742310107,0.0025064056720376956,0.2961654012821233,1,0.023571281741323627,0.011609957216436673,0.05075190598390139,0,24,0 +m_49,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.014062669723944321,0.019184795534783583,0.00707397717034898,0.009890679962568337,0.6839121350760955,1,0.0211366468942933,0.02907547549735192,0.10552499132745832,0,24,0 +m_49,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.014062669723944321,0.07299042526808952,0.00707397717034898,0.022941385029599852,0.06017317182014116,1,0.0211366468942933,0.09593181029768938,0.10552499132745832,0,24,0 +m_49,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.014062669723944321,0.02886400635248998,0.00707397717034898,0.018149075110643367,0.4741928340321947,1,0.0211366468942933,0.04701308146313335,0.10552499132745832,0,24,0 +m_49,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.02966672179286949,0.020127765293166882,0.014229612162483384,0.010157379986145845,0.6010793141428996,1,0.043896333955352876,0.030285145279312725,0.05524463175420511,0,24,0 +m_49,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.02966672179286949,0.031597756618734284,0.014229612162483384,0.018624635885088538,0.9361829742894185,1,0.043896333955352876,0.05022239250382282,0.05524463175420511,0,24,0 +m_49,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.02966672179286949,0.013574589549538016,0.014229612162483384,0.007218450678834283,0.35208745089165244,1,0.043896333955352876,0.0207930402283723,0.05524463175420511,0,24,0 +m_49,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.012525525808872673,0.006838763760372994,0.003331185895849963,0.0016172924456264938,0.16711995094551765,1,0.015856711704722637,0.008456056205999488,0.02607083224692602,0,24,0 +m_49,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.012525525808872673,0.007439755805644932,0.003331185895849963,0.0017917943729587904,0.2171764620285057,1,0.015856711704722637,0.009231550178603722,0.02607083224692602,0,24,0 +m_49,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.012525525808872673,0.01918695333903146,0.003331185895849963,0.0045138032490831,0.264807018012881,1,0.015856711704722637,0.02370075658811456,0.02607083224692602,0,24,0 +m_49,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.013457504383126725,0.020733624130784906,0.005291316517082652,0.006062060836951407,0.3875040989530666,1,0.01874882090020938,0.026795684967736315,0.039008959227797034,0,24,0 +m_49,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.013457504383126725,0.02554034455696519,0.005291316517082652,0.009922345650123024,0.3153938959489889,1,0.01874882090020938,0.03546269020708821,0.039008959227797034,0,24,0 +m_49,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.013457504383126725,0.020811924227034633,0.005291316517082652,0.007637107029469684,0.44919475879353454,1,0.01874882090020938,0.028449031256504317,0.039008959227797034,0,24,0 +m_49,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.012647067233054568,0.021665846424006707,0.005268801945191248,0.009291777270465484,0.4232741464442348,1,0.017915869178245815,0.03095762369447219,0.034053386063919416,0,24,0 +m_49,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.012647067233054568,0.012110284376787184,0.005268801945191248,0.00294924476544475,0.9313868635818223,1,0.017915869178245815,0.015059529142231933,0.034053386063919416,0,24,0 +m_49,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.012647067233054568,0.011773708130923414,0.005268801945191248,0.0044272325436538,0.901603359906415,1,0.017915869178245815,0.016200940674577214,0.034053386063919416,0,24,0 +m_49,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.01138322506524588,0.01302681835168625,0.0014855524749258428,0.0043875787917386395,0.7346136841836477,1,0.012868777540171723,0.017414397143424888,0.03335808405665822,0,24,0 +m_49,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.01138322506524588,0.015152286040909976,0.0014855524749258428,0.009957377959222257,0.7228469200875125,1,0.012868777540171723,0.02510966400013223,0.03335808405665822,0,24,0 +m_49,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.01138322506524588,0.025354083792603954,0.0014855524749258428,0.004971447167994427,0.03661682978202092,0.8788039147685021,0.012868777540171723,0.030325530960598382,0.03335808405665822,0,24,0 +m_50,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.23414097728566752,0.14656814895252124,0.09742112936570049,0.036841028466111134,0.4378027495846785,1,0.331562106651368,0.18340917741863239,0.36471831731650484,0,24,0 +m_50,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.23414097728566752,0.04972035505368614,0.09742112936570049,0.015156166003922637,0.13143696035813324,1,0.331562106651368,0.06487652105760877,0.36471831731650484,0,24,0 +m_50,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.23414097728566752,0.19945170095438414,0.09742112936570049,0.04775435500572944,0.7602254265330367,1,0.331562106651368,0.24720605596011358,0.36471831731650484,0,24,0 +m_50,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09701351803447729,0.06018127907054005,0.03976204083838637,0.019430194434591805,0.4317853397093505,1,0.13677555887286366,0.07961147350513186,0.15045311476015005,0,24,0 +m_50,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09701351803447729,0.05649024237118675,0.03976204083838637,0.02422206654970782,0.4086762325404676,1,0.13677555887286366,0.08071230892089457,0.15045311476015005,0,24,0 +m_50,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09701351803447729,0.06406751537596407,0.03976204083838637,0.025309081958802954,0.5032740410147885,1,0.13677555887286366,0.08937659733476702,0.15045311476015005,0,24,0 +m_50,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1779351621519063,0.15211352712502438,0.06477694018175888,0.03885421911139294,0.7429350322459607,1,0.2427121023336652,0.19096774623641732,0.6139930578213879,0,24,0 +m_50,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1779351621519063,0.10971756550043969,0.06477694018175888,0.049327175657998115,0.42810182036921274,1,0.2427121023336652,0.1590447411584378,0.6139930578213879,0,24,0 +m_50,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1779351621519063,0.33869481115390504,0.06477694018175888,0.21948069595644754,0.5093258470409747,1,0.2427121023336652,0.5581755071103526,0.6139930578213879,0,24,0 +m_50,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0837038705666159,0.07645151262843257,0.036636538489173046,0.041183507751405335,0.898217421209745,1,0.12034040905578895,0.1176350203798379,0.1470618481202957,0,24,0 +m_50,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0837038705666159,0.10498540419704454,0.036636538489173046,0.028707185003224285,0.6596545018927946,1,0.12034040905578895,0.13369258920026883,0.1470618481202957,0,24,0 +m_50,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0837038705666159,0.07013282262277191,0.036636538489173046,0.028701178886456066,0.7780079648470911,1,0.12034040905578895,0.09883400150922798,0.1470618481202957,0,24,0 +m_50,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.061588462136655885,0.0664072086678326,0.026984896581259032,0.030632349005367814,0.9084101151376129,1,0.08857335871791491,0.09703955767320041,0.11669194247072606,0,24,0 +m_50,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.061588462136655885,0.03507507272245817,0.026984896581259032,0.019762571881127795,0.44799417793813234,1,0.08857335871791491,0.054837644603585964,0.11669194247072606,0,24,0 +m_50,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.061588462136655885,0.06955235443661197,0.026984896581259032,0.036531229627684444,0.8646015147391943,1,0.08857335871791491,0.10608358406429641,0.11669194247072606,0,24,0 +m_50,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09447559574865916,0.07301889546228672,0.03840203678784758,0.03598965944489753,0.6921310626171406,1,0.13287763253650675,0.10900855490718425,0.17692732488670848,0,24,0 +m_50,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09447559574865916,0.12465319415105054,0.03840203678784758,0.03618982847322989,0.5800631203998188,1,0.13287763253650675,0.16084302262428044,0.17692732488670848,0,24,0 +m_50,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09447559574865916,0.07019043230668649,0.03840203678784758,0.03356140643396272,0.6443646984106937,1,0.13287763253650675,0.10375183874064922,0.17692732488670848,0,24,0 +m_50,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06565932240961092,0.10550863447307705,0.026076060478993864,0.05075830594652971,0.5061368520817805,1,0.09173538288860478,0.15626694041960676,0.2670529156069944,0,24,0 +m_50,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06565932240961092,0.17950065093669032,0.026076060478993864,0.06327472688785003,0.14242133088727837,1,0.09173538288860478,0.24277537782454034,0.2670529156069944,0,24,0 +m_50,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06565932240961092,0.07016526114862032,0.026076060478993864,0.011213264862382725,0.8784893498802796,1,0.09173538288860478,0.08137852601100304,0.2670529156069944,0,24,0 +m_50,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05529743042008425,0.09972905493902921,0.02330134240533558,0.043530532527589955,0.3956309159165209,1,0.07859877282541983,0.14325958746661915,0.163506222897034,0,24,0 +m_50,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05529743042008425,0.10768276793838871,0.02330134240533558,0.035159546469851435,0.2467565605739483,1,0.07859877282541983,0.14284231440824013,0.163506222897034,0,24,0 +m_50,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05529743042008425,0.09571400545878535,0.02330134240533558,0.05292801535670011,0.5075928669102918,1,0.07859877282541983,0.14864202081548544,0.163506222897034,0,24,0 +m_51,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14607312776150533,0.04700822756464625,0.10494681952573018,0.021492011475654462,0.4036222120538552,1,0.25101994728723553,0.06850023904030071,0.27612194201595913,0,24,0 +m_51,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14607312776150533,0.13052111831713523,0.10494681952573018,0.04663897568607055,0.8970467088029364,1,0.25101994728723553,0.17716009400320576,0.27612194201595913,0,24,0 +m_51,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14607312776150533,0.05760994627473478,0.10494681952573018,0.01914271954628105,0.45084057383215237,1,0.25101994728723553,0.07675266582101584,0.27612194201595913,0,24,0 +m_51,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.05203093452155786,0.07526342339543353,0.024295973803624044,0.028674962726770014,0.5506597358695215,1,0.07632690832518191,0.10393838612220355,0.1143322247344239,0,24,0 +m_51,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.05203093452155786,0.05385697339509824,0.024295973803624044,0.040346503504006405,0.9699991632024827,1,0.07632690832518191,0.09420347689910465,0.1143322247344239,0,24,0 +m_51,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.05203093452155786,0.020611700087251033,0.024295973803624044,0.0038424845634592395,0.2550642949006013,1,0.07632690832518191,0.024454184650710274,0.1143322247344239,0,24,0 +m_51,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07661005892445352,0.04237217585784211,0.038844005280280494,0.012395933718877773,0.4407534171825246,1,0.11545406420473402,0.05476810957671988,0.19650134655055326,0,24,0 +m_51,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07661005892445352,0.12909466123976948,0.038844005280280494,0.04954292653346074,0.4299814480690418,1,0.11545406420473402,0.17863758777323022,0.19650134655055326,0,24,0 +m_51,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07661005892445352,0.08617797068920141,0.038844005280280494,0.06524816807126577,0.9028682693699903,1,0.11545406420473402,0.15142613876046718,0.19650134655055326,0,24,0 +m_51,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07955344307577379,0.06112461343618569,0.04625586178307061,0.0324752594866242,0.7533224442713372,1,0.1258093048588444,0.09359987292280988,0.14752164404917395,0,24,0 +m_51,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07955344307577379,0.08021583281936384,0.04625586178307061,0.0538947526798852,0.9927624901928582,1,0.1258093048588444,0.13411058549924904,0.14752164404917395,0,24,0 +m_51,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07955344307577379,0.04699862757084065,0.04625586178307061,0.011796318503373635,0.5286018729210916,1,0.1258093048588444,0.05879494607421428,0.14752164404917395,0,24,0 +m_51,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.02391517198091068,0.028876921320153404,0.007036145017559501,0.01799888761990738,0.8053160523666678,1,0.03095131699847018,0.046875808940060784,0.09072230243300787,0,24,0 +m_51,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.02391517198091068,0.031010484215714024,0.007036145017559501,0.014032393396576638,0.6642827423396584,1,0.03095131699847018,0.045042877612290665,0.09072230243300787,0,24,0 +m_51,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.02391517198091068,0.05640527558839977,0.007036145017559501,0.026069544805243743,0.2762746043337126,1,0.03095131699847018,0.08247482039364351,0.09072230243300787,0,24,0 +m_51,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0253784178368673,0.03933666773240674,0.006361209367072591,0.009351881917515669,0.249060803930277,1,0.03173962720393989,0.048688549649922405,0.07338701240212538,0,24,0 +m_51,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0253784178368673,0.04322671224728558,0.006361209367072591,0.023488753572828404,0.4921927364522385,1,0.03173962720393989,0.06671546582011398,0.07338701240212538,0,24,0 +m_51,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0253784178368673,0.024710110601917263,0.006361209367072591,0.00991986624860894,0.9560827189921852,1,0.03173962720393989,0.034629976850526205,0.07338701240212538,0,24,0 +m_51,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.060436691441825584,0.037776235559030015,0.005866675771930517,0.006252788817076023,0.024689694543266687,0.5925526690384004,0.0663033672137561,0.044029024376106035,0.07293370393513171,0,24,0 +m_51,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.060436691441825584,0.03667429495272286,0.005866675771930517,0.015432242620165031,0.197015875894176,1,0.0663033672137561,0.05210653757288789,0.07293370393513171,0,24,0 +m_51,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.060436691441825584,0.03276751207003903,0.005866675771930517,0.008945944299882918,0.030377787259305598,0.69868910696402875,0.0663033672137561,0.04171345636992195,0.07293370393513171,0,24,0 +m_51,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.045401606178241107,0.0421815006128187,0.021364244229704663,0.017696755457883174,0.9099699378987848,1,0.06676585040794578,0.05987825607070188,0.07344243544874036,0,24,0 +m_51,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.045401606178241107,0.03232285355373565,0.021364244229704663,0.008342037021390115,0.5876949972861977,1,0.06676585040794578,0.04066489057512577,0.07344243544874036,0,24,0 +m_51,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.045401606178241107,0.0456686985407165,0.021364244229704663,0.018431298398430215,0.9926374714968684,1,0.06676585040794578,0.06409999693914671,0.07344243544874036,0,24,0 +m_52,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.027948431491772396,0.04948164554123924,0.016802994160084978,0.012843794702309626,0.3388265969795805,1,0.04475142565185737,0.062325440243548864,0.07604162081313526,0,24,0 +m_52,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.027948431491772396,0.05645689697813413,0.016802994160084978,0.004508607154993481,0.16757100829272376,1,0.04475142565185737,0.06096550413312761,0.07604162081313526,0,24,0 +m_52,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.027948431491772396,0.045964531440352875,0.016802994160084978,0.023164214753406444,0.5452433155317394,1,0.04475142565185737,0.06912874619375932,0.07604162081313526,0,24,0 +m_52,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.041354766407492694,0.051441124204751,0.020428947363079715,0.035418077891604595,0.8113669275218318,1,0.06178371377057241,0.08685920209635559,0.10246021706778145,0,24,0 +m_52,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.041354766407492694,0.06414465629655323,0.020428947363079715,0.02900099558324808,0.5366390373323755,1,0.06178371377057241,0.09314565187980131,0.10246021706778145,0,24,0 +m_52,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.041354766407492694,0.03183301204857525,0.020428947363079715,0.0056154475925694804,0.669565431110114,1,0.06178371377057241,0.03744845964114473,0.10246021706778145,0,24,0 +m_52,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.013652698697211463,0.07281132937640655,0.007469124874288347,0.012220664545893264,0.0032677782593851586,0.07842667822524381,0.02112182357149981,0.08503199392229982,0.13249284517981583,0,24,0 +m_52,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.013652698697211463,0.08611267251921388,0.007469124874288347,0.034335368553345944,0.10215639759384776,1,0.02112182357149981,0.12044804107255982,0.13249284517981583,0,24,0 +m_52,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.013652698697211463,0.043542449890898505,0.007469124874288347,0.021996797716557936,0.24474969114850276,1,0.02112182357149981,0.06553924760745644,0.13249284517981583,0,24,0 +m_52,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03033034762129354,0.06645588936792408,0.00903746539238976,0.04278088676527201,0.4433914127366538,1,0.0393678130136833,0.1092367761331961,0.12199419846466165,0,24,0 +m_52,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03033034762129354,0.07453117347092401,0.00903746539238976,0.03637264331513203,0.2858415837742867,1,0.0393678130136833,0.11090381678605604,0.12199419846466165,0,24,0 +m_52,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03033034762129354,0.06625911618336255,0.00903746539238976,0.023057969097626467,0.19359059666932177,1,0.0393678130136833,0.08931708528098903,0.12199419846466165,0,24,0 +m_52,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07839211013563278,0.027261075783177862,0.025138053580070912,0.013932240158757702,0.1140426895441765,1,0.1035301637157037,0.041193315941935565,0.11509600374680479,0,24,0 +m_52,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07839211013563278,0.045834395696528286,0.025138053580070912,0.013038444743552086,0.28556301502884096,1,0.1035301637157037,0.05887284044008037,0.11509600374680479,0,24,0 +m_52,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07839211013563278,0.07985251020278235,0.025138053580070912,0.024780220476131085,0.9678131689649799,1,0.1035301637157037,0.10463273067891343,0.11509600374680479,0,24,0 +m_52,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04282428468823148,0.041355216725670475,0.026517037706087633,0.011850997305147803,0.9610894731712463,1,0.06934132239431912,0.05320621403081828,0.14305718182499305,0,24,0 +m_52,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04282428468823148,0.04247304005660638,0.026517037706087633,0.02432630020820842,0.9924054696741452,1,0.06934132239431912,0.06679934026481481,0.14305718182499305,0,24,0 +m_52,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04282428468823148,0.08473876219641181,0.026517037706087633,0.04531322128085459,0.44753962715006823,1,0.06934132239431912,0.1300519834772664,0.14305718182499305,0,24,0 +m_52,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.01748178073608601,0.021836536434269044,0.010881757916284556,0.006110287135938244,0.7362874535637212,1,0.028363538652370568,0.027946823570207287,0.2013603570272245,0,24,0 +m_52,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.01748178073608601,0.0994902899005657,0.010881757916284556,0.08356458012418383,0.37377905592744526,1,0.028363538652370568,0.18305487002474952,0.2013603570272245,0,24,0 +m_52,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.01748178073608601,0.02035007776181567,0.010881757916284556,0.005474270407611493,0.8202465844043608,1,0.028363538652370568,0.025824348169427164,0.2013603570272245,0,24,0 +m_52,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.042447114236983184,0.03793038447719269,0.014218410426570502,0.013703682893788757,0.8236969914050096,1,0.056665524663553686,0.051634067370981446,0.10933139939605097,0,24,0 +m_52,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.042447114236983184,0.042527575821626064,0.014218410426570502,0.01863227928689502,0.9973330122278667,1,0.056665524663553686,0.06115985510852108,0.10933139939605097,0,24,0 +m_52,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.042447114236983184,0.07331558594418992,0.014218410426570502,0.02607659532494732,0.3300691428889463,1,0.056665524663553686,0.09939218126913724,0.10933139939605097,0,24,0 +m_53,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1393712514771968,0.1195986072387949,0.0533080984284888,0.04499552825134143,0.7837459799527164,1,0.1926793499056856,0.16459413549013632,0.4989340720437049,0,24,0 +m_53,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1393712514771968,0.27230415185398155,0.0533080984284888,0.1812722772766592,0.5087473106971009,1,0.1926793499056856,0.4535764291306408,0.4989340720437049,0,24,0 +m_53,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1393712514771968,0.11259643251409812,0.0533080984284888,0.04082529346829511,0.7006366307500577,1,0.1926793499056856,0.15342172598239323,0.4989340720437049,0,24,0 +m_53,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11994828451220625,0.13627827705091036,0.03659350255174859,0.0441490536976741,0.7818218265303978,1,0.15654178706395483,0.18042733074858447,0.28985245103378393,0,24,0 +m_53,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11994828451220625,0.19090746525178515,0.03659350255174859,0.0725947629607457,0.4102206504347661,1,0.15654178706395483,0.26350222821253083,0.28985245103378393,0,24,0 +m_53,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11994828451220625,0.14986282945865714,0.03659350255174859,0.03644123200146333,0.5752353922816928,1,0.15654178706395483,0.18630406146012046,0.28985245103378393,0,24,0 +m_53,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09262120839268735,0.3273322596097822,0.07099555781550461,0.12363820296522926,0.13937855852757391,1,0.16361676620819196,0.45097046257501144,0.4960675088325126,0,24,0 +m_53,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09262120839268735,0.20346379461253655,0.07099555781550461,0.08638525203177254,0.35162482579204707,1,0.16361676620819196,0.2898490466443091,0.4960675088325126,0,24,0 +m_53,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09262120839268735,0.1847296539822374,0.07099555781550461,0.07404163195348366,0.39272370602692797,1,0.16361676620819196,0.2587712859357211,0.4960675088325126,0,24,0 +m_53,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.15098090221311722,0.20839503843140075,0.08620129565257609,0.08763055182604922,0.6516436893320574,1,0.2371821978656933,0.29602559025744996,0.325628149283195,0,24,0 +m_53,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.15098090221311722,0.23787346722160238,0.08620129565257609,0.056985439878159835,0.42757810382388106,1,0.2371821978656933,0.2948589070997622,0.325628149283195,0,24,0 +m_53,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.15098090221311722,0.1794898733015046,0.08620129565257609,0.09400980640164584,0.8281282992994022,1,0.2371821978656933,0.2734996797031504,0.325628149283195,0,24,0 +m_53,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11405379060126486,0.102710873617476,0.05485342688641327,0.024676196759795595,0.8558127945038096,1,0.16890721748767812,0.1273870703772716,0.18579793923644594,0,24,0 +m_53,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11405379060126486,0.08354299054789897,0.05485342688641327,0.04131638655541853,0.6669986006834769,1,0.16890721748767812,0.1248593771033175,0.18579793923644594,0,24,0 +m_53,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11405379060126486,0.09390579119760245,0.05485342688641327,0.0431734801926155,0.7790792334793359,1,0.16890721748767812,0.13707927139021794,0.18579793923644594,0,24,0 +m_53,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13802270666114178,0.12214114404354907,0.052249044981007485,0.028167669942566694,0.796086131257153,1,0.19027175164214927,0.15030881398611576,0.25064497416233383,0,24,0 +m_53,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13802270666114178,0.15060862761104543,0.052249044981007485,0.07725043980925804,0.8956903473829222,1,0.19027175164214927,0.22785906742030348,0.25064497416233383,0,24,0 +m_53,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13802270666114178,0.08589691138992143,0.052249044981007485,0.030951051372967747,0.4153065439320567,1,0.19027175164214927,0.11684796276288918,0.25064497416233383,0,24,0 +m_53,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06735163149165424,0.1478382302228821,0.03498791407168243,0.043614227207512096,0.1819741597091893,1,0.10233954556333667,0.19145245743039419,0.21585195135050897,0,24,0 +m_53,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06735163149165424,0.1537854547871483,0.03498791407168243,0.04244359189513255,0.14827964320747317,1,0.10233954556333667,0.19622904668228086,0.21585195135050897,0,24,0 +m_53,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06735163149165424,0.08872333697452284,0.03498791407168243,0.029403191826841563,0.6503663352881699,1,0.10233954556333667,0.1181265288013644,0.21585195135050897,0,24,0 +m_53,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10704920174003447,0.11366595045674203,0.0240640082166217,0.042030260542158,0.8947229670401242,1,0.13111320995665618,0.15569621099890002,0.25452730494241754,0,24,0 +m_53,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10704920174003447,0.12549059113950856,0.0240640082166217,0.045894973040139724,0.7316704217561087,1,0.13111320995665618,0.1713855641796483,0.25452730494241754,0,24,0 +m_53,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10704920174003447,0.17025058263474802,0.0240640082166217,0.06113787640381335,0.3704304795834999,1,0.13111320995665618,0.23138845903856137,0.25452730494241754,0,24,0 +m_54,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0951186195274408,0.10627512729824184,0.053179814701399354,0.03916013089409693,0.8702039711531121,1,0.14829843422884015,0.14543525819233877,0.19099607695367912,0,24,0 +m_54,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0951186195274408,0.14076543983233814,0.053179814701399354,0.03286735739827922,0.4895393112720927,1,0.14829843422884015,0.17363279723061736,0.19099607695367912,0,24,0 +m_54,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0951186195274408,0.09430935236066691,0.053179814701399354,0.020169988875478877,0.9891826505868048,1,0.14829843422884015,0.11447934123614578,0.19099607695367912,0,24,0 +m_54,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.05368738085634458,0.17878738928930202,0.00947815322071498,0.06749894414167186,0.1236820067271333,1,0.06316553407705956,0.2462863334309739,0.2709149667740713,0,24,0 +m_54,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.05368738085634458,0.06511050402890255,0.00947815322071498,0.024803123763529167,0.6810909115805639,1,0.06316553407705956,0.08991362779243171,0.2709149667740713,0,24,0 +m_54,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.05368738085634458,0.0856846429032266,0.00947815322071498,0.038714586788729764,0.45482596180179286,1,0.06316553407705956,0.12439922969195635,0.2709149667740713,0,24,0 +m_54,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14241437308536647,0.11462587035215248,0.10034762124130883,0.05162391374495975,0.8136225611603979,1,0.2427619943266753,0.16624978409711222,0.26703819375934285,0,24,0 +m_54,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14241437308536647,0.13177270768319627,0.10034762124130883,0.05317758436240554,0.928355107719326,1,0.2427619943266753,0.18495029204560182,0.26703819375934285,0,24,0 +m_54,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14241437308536647,0.10512689995081015,0.10034762124130883,0.02785840643669865,0.7360888000110353,1,0.2427619943266753,0.1329853063875088,0.26703819375934285,0,24,0 +m_54,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.19164447038742133,0.10283977817521757,0.04893770134980513,0.03968531086460828,0.19562908107978585,1,0.24058217173722646,0.14252508903982586,0.30696395111090563,0,24,0 +m_54,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.19164447038742133,0.13084409428991198,0.04893770134980513,0.021021226015230605,0.3011945139147424,1,0.24058217173722646,0.15186532030514258,0.30696395111090563,0,24,0 +m_54,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.19164447038742133,0.2190139491082744,0.04893770134980513,0.060044188265276174,0.7320405109367322,1,0.24058217173722646,0.27905813737355056,0.30696395111090563,0,24,0 +m_54,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10388772985290196,0.04551045367120551,0.041387441915308465,0.01889372280554313,0.24030841023985483,1,0.14527517176821042,0.06440417647674863,0.21460445225273492,0,24,0 +m_54,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10388772985290196,0.07918462231910928,0.041387441915308465,0.014391073037830854,0.5927319605008623,1,0.14527517176821042,0.09357569535694013,0.21460445225273492,0,24,0 +m_54,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10388772985290196,0.11326190465603636,0.041387441915308465,0.08183305193735903,0.9212950729798864,1,0.14527517176821042,0.19509495659339537,0.21460445225273492,0,24,0 +m_54,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.12733273908578524,0.06928326520836985,0.023489717103519082,0.022482136216428538,0.1045767265617704,1,0.15082245618930432,0.09176540142479839,0.16590470180823477,0,24,0 +m_54,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.12733273908578524,0.06867884337489179,0.023489717103519082,0.023908529999853347,0.11069432005133512,1,0.15082245618930432,0.09258737337474514,0.16590470180823477,0,24,0 +m_54,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.12733273908578524,0.07301524381023568,0.023489717103519082,0.05055187401503418,0.362026629816867,1,0.15082245618930432,0.12356711782526986,0.16590470180823477,0,24,0 +m_54,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0477580614000952,0.043261372757403826,0.006796845418001873,0.02215607686820449,0.8526248695482816,1,0.05455490681809707,0.06541744962560832,0.09724716655338111,0,24,0 +m_54,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0477580614000952,0.06529099381791292,0.006796845418001873,0.02311552123061536,0.49484836994142356,1,0.05455490681809707,0.08840651504852828,0.09724716655338111,0,24,0 +m_54,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0477580614000952,0.03117072800307885,0.006796845418001873,0.0163811565178864,0.38225117189981933,1,0.05455490681809707,0.04755188452096525,0.09724716655338111,0,24,0 +m_54,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.054914710791510966,0.03349166459677422,0.015794771961399327,0.01944640687728489,0.41332422140421954,1,0.0707094827529103,0.05293807147405911,0.10367961073490992,0,24,0 +m_54,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.054914710791510966,0.07241844462419837,0.015794771961399327,0.021835746952992455,0.5320508351159254,1,0.0707094827529103,0.09425419157719082,0.10367961073490992,0,24,0 +m_54,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.054914710791510966,0.05652115916443501,0.015794771961399327,0.03303805443045107,0.9662055485861459,1,0.0707094827529103,0.08955921359488608,0.10367961073490992,0,24,0 +m_55,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.230182407484722,0.22224968340202536,0.09067952671175628,0.06888696103278705,0.9462048638886542,1,0.32086193419647824,0.2911366444348124,0.5388578851799829,0,24,0 +m_55,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.230182407484722,0.3307603264312144,0.09067952671175628,0.1591104782778609,0.5983268070968741,1,0.32086193419647824,0.4898708047090753,0.5388578851799829,0,24,0 +m_55,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.230182407484722,0.23703873564411757,0.09067952671175628,0.06418774346899674,0.952402142453644,1,0.32086193419647824,0.3012264791131143,0.5388578851799829,0,24,0 +m_55,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3406984094924497,0.3652549639016214,0.16829808367166457,0.11929668303510102,0.9078562273441465,1,0.5089964931641143,0.48455164693672237,0.5598961424805258,0,24,0 +m_55,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3406984094924497,0.18275059120629597,0.16829808367166457,0.06849818252365884,0.4151400788715883,1,0.5089964931641143,0.2512487737299548,0.5598961424805258,0,24,0 +m_55,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3406984094924497,0.2611251443253631,0.16829808367166457,0.15985703203296933,0.7388533695679151,1,0.5089964931641143,0.42098217635833246,0.5598961424805258,0,24,0 +m_55,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.4138743754430867,0.4371865279219318,0.2581837507970658,0.22299288003094309,0.9471118564731558,1,0.6720581262401525,0.6601794079528749,0.7392639388641677,0,24,0 +m_55,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.4138743754430867,0.26693956418639997,0.2581837507970658,0.13264488000234653,0.6308423250330442,1,0.6720581262401525,0.3995844441887465,0.7392639388641677,0,24,0 +m_55,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.4138743754430867,0.3014976357665583,0.2581837507970658,0.12115913918257691,0.7077949400139808,1,0.6720581262401525,0.42265677494913523,0.7392639388641677,0,24,0 +m_55,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1217159368824563,0.08301635181894995,0.0739190542222244,0.03226988135008096,0.6498091743630312,1,0.1956349911046807,0.11528623316903092,0.41141070192276474,0,24,0 +m_55,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1217159368824563,0.2809006601652619,0.0739190542222244,0.09310906885543328,0.21383728254246223,1,0.1956349911046807,0.3740097290206952,0.41141070192276474,0,24,0 +m_55,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1217159368824563,0.18399959542370162,0.0739190542222244,0.059003866540668214,0.52848703447009715,1,0.1956349911046807,0.24300346196436984,0.41141070192276474,0,24,0 +m_55,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.22512476031314774,0.1619611046782965,0.07331625099339453,0.07229198510014333,0.5532724006706613,1,0.29844101130654227,0.23425308977843984,0.5097394466596793,0,24,0 +m_55,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.22512476031314774,0.360529785195334,0.07331625099339453,0.1028697117680108,0.3115536174292627,1,0.29844101130654227,0.4633994969633448,0.5097394466596793,0,24,0 +m_55,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.22512476031314774,0.21828387992224427,0.07331625099339453,0.07717591230111658,0.9500294929531024,1,0.29844101130654227,0.29545979222336083,0.5097394466596793,0,24,0 +m_55,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.17071084592208477,0.12521301506468116,0.0562658146607054,0.04711937524224637,0.5495765544504378,1,0.22697666058279017,0.17233239030692754,0.4561242879652307,0,24,0 +m_55,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.17071084592208477,0.13117752543880265,0.0562658146607054,0.054616927289339375,0.6250816078874708,1,0.22697666058279017,0.18579445272814202,0.4561242879652307,0,24,0 +m_55,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.17071084592208477,0.298248467545875,0.0562658146607054,0.11640997605888015,0.35584807351967757,1,0.22697666058279017,0.4146584436047551,0.4561242879652307,0,24,0 +m_55,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.29058059907067063,0.28687063999934853,0.17689694928825683,0.04330859310850777,0.9844541338443558,1,0.46747754835892746,0.3301792331078563,0.5142253031948203,0,24,0 +m_55,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.29058059907067063,0.15168213852717483,0.17689694928825683,0.07227927030693199,0.49219099202829564,1,0.46747754835892746,0.2239614088341068,0.5142253031948203,0,24,0 +m_55,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.29058059907067063,0.22455962161638796,0.17689694928825683,0.07005146386675246,0.7395026867911515,1,0.46747754835892746,0.2946110854831404,0.5142253031948203,0,24,0 +m_55,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2600180505743243,0.1755302265689079,0.09259462607629906,0.09525706168349427,0.5390763965638941,1,0.35261267665062335,0.27078728825240217,0.5509755486516476,0,24,0 +m_55,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2600180505743243,0.19602012012284112,0.09259462607629906,0.08036165447054372,0.6132647094194665,1,0.35261267665062335,0.27638177459338487,0.5509755486516476,0,24,0 +m_55,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2600180505743243,0.4306373846785499,0.09259462607629906,0.07024947773203882,0.17501793978602578,1,0.35261267665062335,0.5008868624105887,0.5509755486516476,0,24,0 +m_56,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1693908461807459,0.08976233480411426,0.11021489617062817,0.03305245532932631,0.5214616992706841,1,0.2796057423513741,0.12281479013344057,0.3075663165865115,0,24,0 +m_56,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1693908461807459,0.17561290523883033,0.11021489617062817,0.05991274035554838,0.9619830568143344,1,0.2796057423513741,0.23552564559437872,0.3075663165865115,0,24,0 +m_56,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1693908461807459,0.04340649210937205,0.11021489617062817,0.017956947974039617,0.3193549175909794,1,0.2796057423513741,0.06136344008341167,0.3075663165865115,0,24,0 +m_56,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.16341895268578444,0.09681230856442842,0.02668863121139856,0.028619299365916687,0.11971681106015163,1,0.190107583897183,0.1254316079303451,0.30099676789896646,0,24,0 +m_56,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.16341895268578444,0.21775416232405817,0.02668863121139856,0.055879263038638584,0.4086969581390272,1,0.190107583897183,0.27363342536269675,0.30099676789896646,0,24,0 +m_56,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.16341895268578444,0.15204291470970133,0.02668863121139856,0.042929521794227765,0.8273438223618873,1,0.190107583897183,0.1949724365039291,0.30099676789896646,0,24,0 +m_56,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13471541991143016,0.17591136925875564,0.0634766000906644,0.07211220207516095,0.6781436726681433,1,0.19819202000209457,0.2480235713339166,0.27282592846730824,0,24,0 +m_56,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13471541991143016,0.10920382905204926,0.0634766000906644,0.03164323577885089,0.7316590199590975,1,0.19819202000209457,0.14084706483090015,0.27282592846730824,0,24,0 +m_56,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13471541991143016,0.09372382888479829,0.0634766000906644,0.044520730295221786,0.6123775822206504,1,0.19819202000209457,0.13824455918002007,0.27282592846730824,0,24,0 +m_56,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11336641610464956,0.1638671554078943,0.0514930805222428,0.05846235536762573,0.5330307011737874,1,0.16485949662689237,0.22232951077552002,0.41686826090530404,0,24,0 +m_56,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11336641610464956,0.2542639589390388,0.0514930805222428,0.12470718733851029,0.3330236147987832,1,0.16485949662689237,0.3789711462775491,0.41686826090530404,0,24,0 +m_56,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11336641610464956,0.15365038531223543,0.0514930805222428,0.05959061680422339,0.6213270793603722,1,0.16485949662689237,0.21324100211645883,0.41686826090530404,0,24,0 +m_56,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0564852883677985,0.19521532418777196,0.01961615649043646,0.0716978184596165,0.11341692368004903,1,0.07610144485823496,0.26691314264738847,0.29360445691212733,0,24,0 +m_56,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0564852883677985,0.18873294439692398,0.01961615649043646,0.07384122366571484,0.1367621958914437,1,0.07610144485823496,0.26257416806263884,0.29360445691212733,0,24,0 +m_56,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0564852883677985,0.18344213975720072,0.01961615649043646,0.07262783699153524,0.14483118258218217,1,0.07610144485823496,0.256069976748736,0.29360445691212733,0,24,0 +m_56,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2593149522429566,0.3389353749123298,0.09962591639843765,0.07398000552984449,0.5367203860224887,1,0.35894086864139424,0.41291538044217424,0.4542069184863917,0,24,0 +m_56,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2593149522429566,0.2655627247012991,0.09962591639843765,0.1031491990757735,0.9661080601273335,1,0.35894086864139424,0.3687119237770726,0.4542069184863917,0,24,0 +m_56,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2593149522429566,0.20632130262754358,0.09962591639843765,0.03535811778263949,0.6333585919360696,1,0.35894086864139424,0.2416794204101831,0.4542069184863917,0,24,0 +m_56,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13647314975220523,0.21301828314091606,0.09109909308968409,0.07391277651447606,0.5294090782282417,1,0.22757224284188932,0.2869310596553921,0.37538732268954805,0,24,0 +m_56,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13647314975220523,0.25425160078195025,0.09109909308968409,0.07762325212107725,0.34885853311084225,1,0.22757224284188932,0.3318748529030275,0.37538732268954805,0,24,0 +m_56,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13647314975220523,0.2574946448362438,0.09109909308968409,0.08376655760879984,0.3513482826197619,1,0.22757224284188932,0.34126120244504365,0.37538732268954805,0,24,0 +m_56,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2568063739764694,0.270401097096479,0.08105913382326545,0.1359601264178175,0.9336290137812632,1,0.33786550779973484,0.4063612235142965,0.44699734586572615,0,24,0 +m_56,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2568063739764694,0.19243399954672671,0.08105913382326545,0.0606054799963686,0.5401623516134488,1,0.33786550779973484,0.2530394795430953,0.44699734586572615,0,24,0 +m_56,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2568063739764694,0.13715628896909537,0.08105913382326545,0.07609313178193514,0.30721663220489426,1,0.33786550779973484,0.2132494207510305,0.44699734586572615,0,24,0 +m_57,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11035542495562627,0.09760634724345496,0.07284111973098634,0.038659678105385425,0.8820630952104136,1,0.18319654468661262,0.13626602534884039,0.20151619915527388,0,24,0 +m_57,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11035542495562627,0.09791306298974518,0.07284111973098634,0.027743926565557346,0.879237456250251,1,0.18319654468661262,0.12565698955530252,0.20151619915527388,0,24,0 +m_57,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11035542495562627,0.06366555942041059,0.07284111973098634,0.01862144261931174,0.5645246904143159,1,0.18319654468661262,0.08228700203972233,0.20151619915527388,0,24,0 +m_57,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06318125347844816,0.07987920525138496,0.028465128457634003,0.022139723922724487,0.6538370953017265,1,0.09164638193608217,0.10201892917410946,0.11222082209152041,0,24,0 +m_57,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.06318125347844816,0.02659045602781777,0.028465128457634003,0.011574532044331145,0.2747423394887059,1,0.09164638193608217,0.038164988072148916,0.11222082209152041,0,24,0 +m_57,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06318125347844816,0.04350636784815006,0.028465128457634003,0.012959968847539706,0.5493134809951314,1,0.09164638193608217,0.05646633669568977,0.11222082209152041,0,24,0 +m_57,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0884914028528125,0.13503416919033673,0.045679633168751864,0.042388487458355335,0.4748488972110999,1,0.13417103602156435,0.17742265664869206,0.19516492231356128,0,24,0 +m_57,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0884914028528125,0.055930966087549105,0.045679633168751864,0.0240858639440775,0.5513593969607935,1,0.13417103602156435,0.0800168300316266,0.19516492231356128,0,24,0 +m_57,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0884914028528125,0.11355863849786434,0.045679633168751864,0.03526556370643535,0.675586523660987,1,0.13417103602156435,0.14882420220429968,0.19516492231356128,0,24,0 +m_57,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07050424395803585,0.1024243547914691,0.02748091737359266,0.03159238108535954,0.4653905659183498,1,0.09798516133162852,0.13401673587682864,0.16229258810246464,0,24,0 +m_57,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07050424395803585,0.1146979282464901,0.02748091737359266,0.032840788210295915,0.3291035960163864,1,0.09798516133162852,0.147538716456786,0.16229258810246464,0,24,0 +m_57,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07050424395803585,0.09075638087858935,0.02748091737359266,0.031263114659928995,0.6382121598800639,1,0.09798516133162852,0.12201949553851835,0.16229258810246464,0,24,0 +m_57,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15176630149236234,0.17598906459946648,0.055146235306690654,0.0728150163740697,0.7966372324271642,1,0.206912536799053,0.24880408097353618,0.3495073681966313,0,24,0 +m_57,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.15176630149236234,0.09998793657464307,0.055146235306690654,0.04367749748522065,0.47948682815585897,1,0.206912536799053,0.1436654340598637,0.3495073681966313,0,24,0 +m_57,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.15176630149236234,0.2268738273249138,0.055146235306690654,0.0908601437629328,0.4992641362043361,1,0.206912536799053,0.3177339710878466,0.3495073681966313,0,24,0 +m_57,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.12494115392090792,0.1904622213281583,0.03709873427783316,0.05312170448978521,0.3384932232188955,1,0.16203988819874107,0.2435839258179435,0.26794231839973787,0,24,0 +m_57,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.12494115392090792,0.11986296150595817,0.03709873427783316,0.04763407840225356,0.9347278097436469,1,0.16203988819874107,0.16749703990821174,0.26794231839973787,0,24,0 +m_57,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.12494115392090792,0.1308794121473853,0.03709873427783316,0.027676067566585947,0.9006593796207867,1,0.16203988819874107,0.15855547971397124,0.26794231839973787,0,24,0 +m_57,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14535028221779722,0.1147060166975975,0.0637005284837797,0.049683186360371855,0.7128336823342006,1,0.20905081070157694,0.16438920305796936,0.22995589177173464,0,24,0 +m_57,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14535028221779722,0.11667279773660584,0.0637005284837797,0.058549067555706116,0.7471906506954074,1,0.20905081070157694,0.17522186529231196,0.22995589177173464,0,24,0 +m_57,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14535028221779722,0.07229523119534849,0.0637005284837797,0.03564757234709446,0.34676299231978036,1,0.20905081070157694,0.10794280354244296,0.22995589177173464,0,24,0 +m_57,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.143943236476013,0.15262773417652462,0.059366289597964576,0.05974746423288862,0.9199151891470534,1,0.2033095260739776,0.21237519840941324,0.2336127182503546,0,24,0 +m_57,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.143943236476013,0.11767506290040464,0.059366289597964576,0.044338834694891055,0.7308987975604135,1,0.2033095260739776,0.1620138975952957,0.2336127182503546,0,24,0 +m_57,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.143943236476013,0.1415555305984575,0.059366289597964576,0.057157319787763436,0.9774564609631051,1,0.2033095260739776,0.19871285038622094,0.2336127182503546,0,24,0 +m_58,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14885489578595834,0.2174173224494139,0.06824436019717613,0.0660406842997104,0.4890242459785379,1,0.21709925598313445,0.2834580067491243,0.31180380742403674,0,24,0 +m_58,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14885489578595834,0.22338788595869566,0.06824436019717613,0.056967123853854454,0.4252913630002304,1,0.21709925598313445,0.2803550098125501,0.31180380742403674,0,24,0 +m_58,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14885489578595834,0.028960400732130243,0.06824436019717613,0.007927198483667566,0.15401684954655137,1,0.21709925598313445,0.03688759921579781,0.31180380742403674,0,24,0 +m_58,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.18615698843639938,0.2703949602943034,0.05765187890313684,0.11305360320907704,0.5268655893928276,1,0.24380886733953622,0.3834485635033804,0.48827276733331826,0,24,0 +m_58,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.18615698843639938,0.2913153776906638,0.05765187890313684,0.06008063055532925,0.23532378875715199,1,0.24380886733953622,0.35139600824599304,0.48827276733331826,0,24,0 +m_58,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.18615698843639938,0.3213943589990517,0.05765187890313684,0.12248997494032851,0.35058731662411435,1,0.24380886733953622,0.4438843339393802,0.48827276733331826,0,24,0 +m_58,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07284220586870997,0.23462549637236987,0.02743671512818299,0.10487844523524653,0.18898220834816815,1,0.10027892099689296,0.33950394160761643,0.4199983299913424,0,24,0 +m_58,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07284220586870997,0.1391018961593181,0.02743671512818299,0.060178934180538615,0.3577693704135526,1,0.10027892099689296,0.19928083033985672,0.4199983299913424,0,24,0 +m_58,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07284220586870997,0.27963759530244864,0.02743671512818299,0.1021790683260444,0.10087145186308076,1,0.10027892099689296,0.38181666362849304,0.4199983299913424,0,24,0 +m_58,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.28763944163525945,0.3413954722884996,0.08494425229601375,0.10858522060167584,0.7058119571838062,1,0.3725836939312732,0.44998069289017545,0.494978762179193,0,24,0 +m_58,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.28763944163525945,0.13163170416210437,0.08494425229601375,0.07875621861708096,0.21210235873040323,1,0.3725836939312732,0.21038792277918533,0.494978762179193,0,24,0 +m_58,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.28763944163525945,0.32120764077978964,0.08494425229601375,0.09146651181652309,0.7940635635559588,1,0.3725836939312732,0.41267415259631274,0.494978762179193,0,24,0 +m_58,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06770359585792478,0.09331009014412898,0.02103700957012283,0.03644502290976642,0.5597296978974791,1,0.08874060542804761,0.12975511305389542,0.14273062435928496,0,24,0 +m_58,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06770359585792478,0.057586804381700794,0.02103700957012283,0.018925907719707747,0.7282169871635586,1,0.08874060542804761,0.07651271210140854,0.14273062435928496,0,24,0 +m_58,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06770359585792478,0.06038947241884444,0.02103700957012283,0.028608837988413363,0.841309010715525,1,0.08874060542804761,0.08899831040725781,0.14273062435928496,0,24,0 +m_58,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07529198101003853,0.09344202877123357,0.024512674145699874,0.025064782243690138,0.6159286835392753,1,0.09980465515573841,0.11850681101492372,0.16319018191847476,0,24,0 +m_58,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07529198101003853,0.05688372020881438,0.024512674145699874,0.013037941820097024,0.5268630840719849,1,0.09980465515573841,0.06992166202891141,0.16319018191847476,0,24,0 +m_58,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07529198101003853,0.09192354269544707,0.024512674145699874,0.05643116813952995,0.7949079126803649,1,0.09980465515573841,0.14835471083497703,0.16319018191847476,0,24,0 +m_58,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16942582747591262,0.11049378614438465,0.06989464162929564,0.05326080882331945,0.5186857018523896,1,0.23932046910520827,0.16375459496770411,0.26325251601572913,0,24,0 +m_58,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16942582747591262,0.11649423334567836,0.06989464162929564,0.031591011831786135,0.5124804485480077,1,0.23932046910520827,0.1480852451774645,0.26325251601572913,0,24,0 +m_58,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16942582747591262,0.13509382438743125,0.06989464162929564,0.04630727239572573,0.692106662921969,1,0.23932046910520827,0.181401096783157,0.26325251601572913,0,24,0 +m_58,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1951145739817647,0.11610168635188689,0.09084354220617369,0.09399508534199155,0.5590266061009701,1,0.2859581161879384,0.21009677169387844,0.3145539278067323,0,24,0 +m_58,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1951145739817647,0.08844170756014025,0.09084354220617369,0.02803073208941662,0.30511563871129,1,0.2859581161879384,0.11647243964955686,0.3145539278067323,0,24,0 +m_58,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1951145739817647,0.07480282814347221,0.09084354220617369,0.02724855183059323,0.2524114780394164,1,0.2859581161879384,0.10205137997406544,0.3145539278067323,0,24,0 +m_59,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09827555361214975,0.04214771227324432,0.041278745240223624,0.012595225813652343,0.25297536120696384,1,0.13955429885237336,0.05474293808689666,0.1535097287376107,0,24,0 +m_59,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09827555361214975,0.0768192969576269,0.041278745240223624,0.025918290335502515,0.6732155354431522,1,0.13955429885237336,0.10273758729312941,0.1535097287376107,0,24,0 +m_59,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09827555361214975,0.02120131755081404,0.041278745240223624,0.011946194768779228,0.13695199303073982,1,0.13955429885237336,0.03314751231959327,0.1535097287376107,0,24,0 +m_59,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10465387820140266,0.10077387026893048,0.020175225622508022,0.040474896519556575,0.9339235061050484,1,0.12482910382391069,0.14124876678848705,0.19805401869685485,0,24,0 +m_59,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10465387820140266,0.1301641421573115,0.020175225622508022,0.049884965748920145,0.6507407567666813,1,0.12482910382391069,0.18004910790623166,0.19805401869685485,0,24,0 +m_59,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10465387820140266,0.08786621451116261,0.020175225622508022,0.029632484542860826,0.6509370509681968,1,0.12482910382391069,0.11749869905402344,0.19805401869685485,0,24,0 +m_59,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.22084563892002249,0.07313210205571592,0.11650915173233282,0.032501307662643496,0.280589806676399,1,0.3373547906523553,0.10563340971835941,0.37109026971759085,0,24,0 +m_59,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.22084563892002249,0.1539887646653451,0.11650915173233282,0.09717518189490079,0.6714808047883601,1,0.3373547906523553,0.2511639465602459,0.37109026971759085,0,24,0 +m_59,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.22084563892002249,0.04424976840213982,0.11650915173233282,0.011606675052048404,0.2046225070025671,1,0.3373547906523553,0.05585644345418823,0.37109026971759085,0,24,0 +m_59,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.19109605508564878,0.05036622418273651,0.05028763651322697,0.026275589230141356,0.04702456020904283,1,0.24138369159887574,0.07664181341287786,0.26552206075876333,0,24,0 +m_59,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.19109605508564878,0.05592880409065685,0.05028763651322697,0.009385787811522436,0.05361132271026058,1,0.24138369159887574,0.06531459190217928,0.26552206075876333,0,24,0 +m_59,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.19109605508564878,0.08841422108919332,0.05028763651322697,0.024166420937577926,0.11689229351630627,1,0.24138369159887574,0.11258064202677125,0.26552206075876333,0,24,0 +m_59,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1457136470079158,0.06576582283451031,0.06832115729711574,0.024345689909969024,0.3109674353240375,1,0.21403480430503155,0.09011151274447933,0.23543828473553471,0,24,0 +m_59,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1457136470079158,0.032755621210207364,0.06832115729711574,0.01878347809649132,0.16412842192142815,1,0.21403480430503155,0.051539099306698685,0.23543828473553471,0,24,0 +m_59,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1457136470079158,0.1264040466867332,0.06832115729711574,0.056980366289014144,0.8326717875303011,1,0.21403480430503155,0.18338441297574734,0.23543828473553471,0,24,0 +m_59,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.073556722238312,0.10221941837196676,0.04020546174675539,0.022489037419684863,0.5514589914678131,1,0.11376218398506739,0.12470845579165162,0.15020710949799965,0,24,0 +m_59,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.073556722238312,0.09923273911847175,0.04020546174675539,0.037319178606982466,0.6498305866666954,1,0.11376218398506739,0.13655191772545422,0.15020710949799965,0,24,0 +m_59,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.073556722238312,0.060165094516348404,0.04020546174675539,0.040239232076660664,0.8186307321009496,1,0.11376218398506739,0.10040432659300907,0.15020710949799965,0,24,0 +m_59,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13163036434842246,0.13920841080363452,0.046477849312385,0.03847632149257757,0.9026276010798252,1,0.17810821366080745,0.1776847322962121,0.1959190350268882,0,24,0 +m_59,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13163036434842246,0.12229449732279189,0.046477849312385,0.03987187889072749,0.8819293043416718,1,0.17810821366080745,0.16216637621351937,0.1959190350268882,0,24,0 +m_59,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13163036434842246,0.09853242944422365,0.046477849312385,0.036109594722418925,0.587003495016821,1,0.17810821366080745,0.13464202416664256,0.1959190350268882,0,24,0 +m_59,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08353505402577695,0.1235119735005034,0.03580801420375302,0.03199861778560909,0.4248169936399864,1,0.11934306822952997,0.1555105912861125,0.20109939235614127,0,24,0 +m_59,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08353505402577695,0.13149515301415246,0.03580801420375302,0.05132247640052139,0.46321239891252664,1,0.11934306822952997,0.18281762941467386,0.20109939235614127,0,24,0 +m_59,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08353505402577695,0.12417980051053161,0.03580801420375302,0.0367783825784098,0.4468552443243894,1,0.11934306822952997,0.16095818308894141,0.20109939235614127,0,24,0 +m_60,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14588200680257643,0.35313874857689165,0.06952537904432138,0.11708841152741331,0.16689813763268432,1,0.2154073858468978,0.470227160104305,0.5172498761147355,0,24,0 +m_60,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14588200680257643,0.12789834495406457,0.06952537904432138,0.04795444444262622,0.837150472867465,1,0.2154073858468978,0.1758527893966908,0.5172498761147355,0,24,0 +m_60,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14588200680257643,0.14217748119149973,0.06952537904432138,0.05781833662670991,0.9682924723459605,1,0.2154073858468978,0.19999581781820963,0.5172498761147355,0,24,0 +m_60,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.23459252618612392,0.32443684728412997,0.11161594861568207,0.07713107670545785,0.5246326293080004,1,0.346208474801806,0.40156792398958785,0.44172471638854666,0,24,0 +m_60,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.23459252618612392,0.11166078129989276,0.11161594861568207,0.04363670035609251,0.34168269756597824,1,0.346208474801806,0.15529748165598528,0.44172471638854666,0,24,0 +m_60,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.23459252618612392,0.18070463762747332,0.11161594861568207,0.0772620120970447,0.7007439061807508,1,0.346208474801806,0.257966649724518,0.44172471638854666,0,24,0 +m_60,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09602916474519456,0.2088129121992509,0.0449359517685595,0.11151857022676494,0.3815548712318116,1,0.14096511651375407,0.32033148242601583,0.3710872360583589,0,24,0 +m_60,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09602916474519456,0.24609101773344233,0.0449359517685595,0.09126101504688394,0.1920018056694006,1,0.14096511651375407,0.33735203278032627,0.3710872360583589,0,24,0 +m_60,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09602916474519456,0.21451622931311606,0.0449359517685595,0.05771750895667123,0.1403335037454522,1,0.14096511651375407,0.2722337382697873,0.3710872360583589,0,24,0 +m_60,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17012991739347466,0.14393532995577918,0.106646783866427,0.06862229040596064,0.8422103160393011,1,0.27677670125990167,0.2125576203617398,0.401469515545521,0,24,0 +m_60,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17012991739347466,0.12136805375185404,0.106646783866427,0.021134402438267905,0.6753972108452233,1,0.27677670125990167,0.14250245619012195,0.401469515545521,0,24,0 +m_60,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17012991739347466,0.26309681856805694,0.106646783866427,0.10187546829150758,0.5445220220565714,1,0.27677670125990167,0.3649722868595645,0.401469515545521,0,24,0 +m_60,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0977977698855705,0.23380863787559192,0.05392613912630219,0.08449178119374537,0.20976300566075523,1,0.1517239090118727,0.31830041906933726,0.35013046097627104,0,24,0 +m_60,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0977977698855705,0.17484914437343715,0.05392613912630219,0.042875787025771085,0.2908289559652166,1,0.1517239090118727,0.21772493139920823,0.35013046097627104,0,24,0 +m_60,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0977977698855705,0.15901531471449146,0.05392613912630219,0.04806239844245947,0.4168106817741073,1,0.1517239090118727,0.20707771315695092,0.35013046097627104,0,24,0 +m_60,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.058322446534352666,0.372116014585255,0.023214530805275167,0.08881219952911287,0.015441174005271894,0.37058817612652545,0.08153697733962784,0.4609282141143679,0.5070210355258047,2,24,8.333333333333332 +m_60,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.058322446534352666,0.1384165978223416,0.023214530805275167,0.039756570972189334,0.11983713328432842,1,0.08153697733962784,0.17817316879453093,0.5070210355258047,2,24,8.333333333333332 +m_60,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.058322446534352666,0.219318968650457,0.023214530805275167,0.07568680687935203,0.08875606605058872,1,0.08153697733962784,0.295005775529809,0.5070210355258047,2,24,8.333333333333332 +m_60,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.21284975865767894,0.30429219461945317,0.05055877959110548,0.126050995872108,0.5237312544505647,1,0.2634085382487844,0.43034319049156117,0.47337750954071733,2,24,8.333333333333332 +m_60,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.21284975865767894,0.25149836500792766,0.05055877959110548,0.11155692237307703,0.7615792949162559,1,0.2634085382487844,0.3630552873810047,0.47337750954071733,2,24,8.333333333333332 +m_60,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.21284975865767894,0.2658716107730136,0.05055877959110548,0.09138480876328577,0.6257166813429529,1,0.2634085382487844,0.35725641953629933,0.47337750954071733,2,24,8.333333333333332 +m_60,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0922337679407003,0.2339257282018918,0.06305530378735796,0.08241155344033825,0.2040163976925817,1,0.15528907172805828,0.3163372816422301,0.3479710098064531,1,24,4.166666666666666 +m_60,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0922337679407003,0.18506266744217878,0.06305530378735796,0.04209196373451554,0.2528438706740877,1,0.15528907172805828,0.22715463117669432,0.3479710098064531,1,24,4.166666666666666 +m_60,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0922337679407003,0.13763275560989527,0.06305530378735796,0.026928426967879244,0.5297858417433019,1,0.15528907172805828,0.16456118257777452,0.3479710098064531,1,24,4.166666666666666 +m_61,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12855907749570158,0.04581434821103447,0.0557072810790004,0.025152917651554717,0.22779965644578554,1,0.18426635857470197,0.0709672658625892,0.20269299443217217,0,24,0 +m_61,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12855907749570158,0.14734001310531172,0.0557072810790004,0.03422646355573476,0.7824595095207496,1,0.18426635857470197,0.18156647666104647,0.20269299443217217,0,24,0 +m_61,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12855907749570158,0.09726091776405162,0.0557072810790004,0.04065501801538307,0.6625366912768934,1,0.18426635857470197,0.13791593577943467,0.20269299443217217,0,24,0 +m_61,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.16633731378862826,0.07545837964828395,0.0928833017267976,0.03086453553584902,0.38846281992032206,1,0.25922061551542586,0.10632291518413296,0.28514267706696844,0,24,0 +m_61,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.16633731378862826,0.06967100439203437,0.0928833017267976,0.009369549136527495,0.3470125673715869,1,0.25922061551542586,0.07904055352856187,0.28514267706696844,0,24,0 +m_61,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.16633731378862826,0.06187009651409906,0.0928833017267976,0.030358019030036952,0.3257890464064249,1,0.25922061551542586,0.09222811554413601,0.28514267706696844,0,24,0 +m_61,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09494789642131045,0.06273771035038611,0.04544390927205522,0.028716925721027704,0.5680708306613552,1,0.14039180569336568,0.09145463607141381,0.2626549812050197,0,24,0 +m_61,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09494789642131045,0.16065607033618806,0.04544390927205522,0.07812118530473891,0.4928158033763451,1,0.14039180569336568,0.23877725564092697,0.2626549812050197,0,24,0 +m_61,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09494789642131045,0.14849372392029347,0.04544390927205522,0.05776603551382743,0.4850972122564442,1,0.14039180569336568,0.2062597594341209,0.2626549812050197,0,24,0 +m_61,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.05328263921033751,0.12192449799138012,0.03149482853743019,0.06579331916596307,0.37764131502441467,1,0.0847774677477677,0.1877178171573432,0.2462703599381609,0,24,0 +m_61,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.05328263921033751,0.16337449417441238,0.03149482853743019,0.060507651223915694,0.1482740120062455,1,0.0847774677477677,0.22388214539832807,0.2462703599381609,0,24,0 +m_61,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.05328263921033751,0.1138751943691008,0.03149482853743019,0.027142128349752395,0.1812398445142682,1,0.0847774677477677,0.1410173227188532,0.2462703599381609,0,24,0 +m_61,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07166103611180559,0.08904858005390559,0.02544919769392097,0.04416668030456211,0.7418201083356954,1,0.09711023380572656,0.1332152603584677,0.19741067973520876,0,24,0 +m_61,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07166103611180559,0.08452488703879002,0.02544919769392097,0.01671222310703337,0.6829746322032848,1,0.09711023380572656,0.10123711014582339,0.19741067973520876,0,24,0 +m_61,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07166103611180559,0.12185771188117316,0.02544919769392097,0.057606542423562085,0.4520427590775764,1,0.09711023380572656,0.17946425430473523,0.19741067973520876,0,24,0 +m_61,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13091124768012277,0.06452870838830942,0.02769037522795701,0.019605164014581122,0.08207476475794848,1,0.15860162290807978,0.08413387240289054,0.17446178519888778,0,24,0 +m_61,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.13091124768012277,0.05224460721242238,0.02769037522795701,0.01985985542249431,0.04614026492464717,1,0.15860162290807978,0.07210446263491668,0.17446178519888778,0,24,0 +m_61,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.13091124768012277,0.04609351624900045,0.02769037522795701,0.01029274266537945,0.026620260392877435,0.6388862494290585,0.15860162290807978,0.0563862589143799,0.17446178519888778,0,24,0 +m_61,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13719529000194175,0.059619765489401365,0.041559341017030786,0.026818688690358795,0.15300411119114007,1,0.17875463101897254,0.08643845417976016,0.20455133621864316,0,24,0 +m_61,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13719529000194175,0.10025181984861176,0.041559341017030786,0.041984478016387126,0.5457395189477028,1,0.17875463101897254,0.1422362978649989,0.20455133621864316,0,24,0 +m_61,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13719529000194175,0.13986136203529828,0.041559341017030786,0.04609439816346823,0.9665901582843899,1,0.17875463101897254,0.1859557601987665,0.20455133621864316,0,24,0 +m_61,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11158789135766822,0.07954413216496103,0.03686554982808248,0.026159626093443137,0.4963220566740727,1,0.1484534411857507,0.10570375825840417,0.1632987853043258,0,24,0 +m_61,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11158789135766822,0.08914561836085351,0.03686554982808248,0.028364544986467993,0.6405231951712012,1,0.1484534411857507,0.1175101633473215,0.1632987853043258,0,24,0 +m_61,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11158789135766822,0.10865102648146648,0.03686554982808248,0.02161077969183163,0.9468792869865643,1,0.1484534411857507,0.1302618061732981,0.1632987853043258,0,24,0 +m_62,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.038988188802436506,0.09700832479074568,0.01507855939666418,0.050637830579175605,0.3151464470016691,1,0.054066748199100685,0.1476461553699213,0.22257664389860735,0,24,0 +m_62,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.038988188802436506,0.13243869616426532,0.01507855939666418,0.06990370737992316,0.24360628776294913,1,0.054066748199100685,0.20234240354418848,0.22257664389860735,0,24,0 +m_62,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.038988188802436506,0.07538809980783216,0.01507855939666418,0.027878018063695765,0.2858788664550594,1,0.054066748199100685,0.10326611787152792,0.22257664389860735,0,24,0 +m_62,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1322942470910272,0.13330522163243166,0.03512314360126192,0.0594179136085655,0.9886675549638088,1,0.16741739069228911,0.19272313524099716,0.41494043593955504,0,24,0 +m_62,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1322942470910272,0.10795188680964711,0.03512314360126192,0.040656671211485855,0.6603674956786276,1,0.16741739069228911,0.14860855802113296,0.41494043593955504,0,24,0 +m_62,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1322942470910272,0.27349101643757695,0.03512314360126192,0.10372756168929126,0.24378553384811297,1,0.16741739069228911,0.3772185781268682,0.41494043593955504,0,24,0 +m_62,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09050120101976482,0.12830247201438705,0.05442892676515512,0.04068799318681908,0.5936716565749057,1,0.14493012778491993,0.16899046520120614,0.44984223454390243,0,24,0 +m_62,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09050120101976482,0.2660860699562978,0.05442892676515512,0.14286141599270435,0.30140322406423875,1,0.14493012778491993,0.40894748594900215,0.44984223454390243,0,24,0 +m_62,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09050120101976482,0.1609745676486151,0.05442892676515512,0.06885435444282946,0.44298924828011466,1,0.14493012778491993,0.22982892209144457,0.44984223454390243,0,24,0 +m_62,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.18257434236662587,0.07818942096715535,0.059661956784794024,0.03650326617989635,0.18049762545976042,1,0.2422362991514199,0.11469268714705169,0.2664599290665619,0,24,0 +m_62,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.18257434236662587,0.110890585554506,0.059661956784794024,0.044855630457384464,0.3656783236240981,1,0.2422362991514199,0.15574621601189045,0.2664599290665619,0,24,0 +m_62,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.18257434236662587,0.12686409876801283,0.059661956784794024,0.056487424432672115,0.5152467209234128,1,0.2422362991514199,0.18335152320068493,0.2664599290665619,0,24,0 +m_62,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.11103868259688143,0.04042708575746697,0.022728313020769466,0.016199969013527833,0.03214006835103662,0.7713616404248789,0.1337669956176509,0.056627054770994806,0.147143695179416,0,24,0 +m_62,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11103868259688143,0.04597666640929695,0.022728313020769466,0.018097329978887484,0.050332612193836626,1,0.1337669956176509,0.06407399638818444,0.147143695179416,0,24,0 +m_62,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11103868259688143,0.08229312019019093,0.022728313020769466,0.026411396590855653,0.4290474059887297,1,0.1337669956176509,0.10870451678104659,0.147143695179416,0,24,0 +m_62,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0547810011639099,0.0747622364250562,0.019966462613433662,0.02250325722558994,0.5218038165300396,1,0.07474746377734356,0.09726549365064613,0.16361038773891032,0,24,0 +m_62,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0547810011639099,0.07648060483063723,0.019966462613433662,0.020059956059039076,0.4609835083358763,1,0.07474746377734356,0.0965405608896763,0.16361038773891032,0,24,0 +m_62,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0547810011639099,0.10397804397430684,0.019966462613433662,0.04475867215197524,0.3492978710990676,1,0.07474746377734356,0.1487367161262821,0.16361038773891032,0,24,0 +m_62,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.021620002569258112,0.0739273942480813,0.008152200995041232,0.019816477086038224,0.046501798461763305,1,0.029772203564299344,0.09374387133411952,0.10311825846753148,0,24,0 +m_62,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.021620002569258112,0.053763805808942244,0.008152200995041232,0.019794851425589125,0.1791446727073108,1,0.029772203564299344,0.07355865723453137,0.10311825846753148,0,24,0 +m_62,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.021620002569258112,0.05742124156613319,0.008152200995041232,0.019821154593741504,0.14104731412164973,1,0.029772203564299344,0.07724239615987469,0.10311825846753148,0,24,0 +m_62,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0336647677649089,0.06261727151092789,0.008680452659386818,0.019211084354187027,0.21223841788157533,1,0.04234522042429571,0.08182835586511492,0.10004536011095416,0,24,0 +m_62,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0336647677649089,0.036521633011213396,0.008680452659386818,0.015189434893337158,0.8743582933833415,1,0.04234522042429571,0.05171106790455055,0.10004536011095416,0,24,0 +m_62,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0336647677649089,0.07106018001515742,0.008680452659386818,0.019890147358437263,0.12954086011574487,1,0.04234522042429571,0.09095032737359468,0.10004536011095416,0,24,0 +m_63,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1309726307648062,0.23978199037053397,0.06065027631461617,0.11726836196963272,0.43569319537900175,1,0.19162290707942237,0.3570503523401667,0.3927553875741834,0,24,0 +m_63,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1309726307648062,0.12944309323305103,0.06065027631461617,0.034176157433388504,0.9831377441637505,1,0.19162290707942237,0.16361925066643954,0.3927553875741834,0,24,0 +m_63,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1309726307648062,0.05807236996428015,0.06065027631461617,0.02988567668881327,0.32304495396037025,1,0.19162290707942237,0.08795804665309342,0.3927553875741834,0,24,0 +m_63,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.056540517344536946,0.2987646271921173,0.021802283157910524,0.11317388225173763,0.08572618939808649,1,0.07834280050244746,0.41193850944385496,0.4531323603882405,0,24,0 +m_63,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.056540517344536946,0.17550312509608426,0.021802283157910524,0.07290476208745407,0.1699420923756093,1,0.07834280050244746,0.24840788718353835,0.4531323603882405,0,24,0 +m_63,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.056540517344536946,0.21436366861723566,0.021802283157910524,0.08281970713526672,0.11759795531880385,1,0.07834280050244746,0.29718337575250237,0.4531323603882405,0,24,0 +m_63,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.24647162421932575,0.2341255817630119,0.07812598122565961,0.10010757397356447,0.9247157321360465,1,0.3245976054449854,0.33423315573657636,0.5255883655396253,0,24,0 +m_63,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.24647162421932575,0.3439790350835693,0.07812598122565961,0.13382856995245362,0.5508480491505506,1,0.3245976054449854,0.47780760503602293,0.5255883655396253,0,24,0 +m_63,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.24647162421932575,0.12578343322024121,0.07812598122565961,0.01615877179915181,0.19934844413735503,1,0.3245976054449854,0.14194220501939303,0.5255883655396253,0,24,0 +m_63,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.24300359498969798,0.3019830315943394,0.10341987069850292,0.14212314692445324,0.7451935197393171,1,0.3464234656882009,0.44410617851879264,0.6450054013600502,0,24,0 +m_63,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.24300359498969798,0.46734051457441644,0.10341987069850292,0.11902803211653823,0.1885654181463578,1,0.3464234656882009,0.5863685466909547,0.6450054013600502,0,24,0 +m_63,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.24300359498969798,0.29204605970749414,0.10341987069850292,0.0634914261709419,0.6985097846954487,1,0.3464234656882009,0.35553748587843603,0.6450054013600502,0,24,0 +m_63,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1303436448899705,0.08485491741731173,0.0425330368231596,0.011397803287843514,0.3433081134884048,1,0.1728766817131301,0.09625272070515524,0.2507281160108307,0,24,0 +m_63,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1303436448899705,0.061545697807498044,0.0425330368231596,0.0289939164368805,0.21482349475650353,1,0.1728766817131301,0.09053961424437854,0.2507281160108307,0,24,0 +m_63,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1303436448899705,0.14867799861624217,0.0425330368231596,0.07925665230269485,0.8437954765366169,1,0.1728766817131301,0.22793465091893703,0.2507281160108307,0,24,0 +m_63,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0857889180677253,0.07033932871714417,0.04272765635021035,0.02870832622990068,0.771086027078872,1,0.12851657441793565,0.09904765494704484,0.142807650476993,0,24,0 +m_63,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0857889180677253,0.08712704283712973,0.04272765635021035,0.04269809396013665,0.9827621027340734,1,0.12851657441793565,0.12982513679726637,0.142807650476993,0,24,0 +m_63,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0857889180677253,0.07121113970950683,0.04272765635021035,0.020395500723402602,0.7669155725455179,1,0.12851657441793565,0.09160664043290943,0.142807650476993,0,24,0 +m_63,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11157482268826313,0.04501624489183912,0.04997898963829022,0.0113443906888135,0.24570999423722292,1,0.16155381232655336,0.05636063558065262,0.17770919355920872,0,24,0 +m_63,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11157482268826313,0.08858001389375292,0.04997898963829022,0.033719944841490206,0.7119808740795863,1,0.16155381232655336,0.12229995873524313,0.17770919355920872,0,24,0 +m_63,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11157482268826313,0.054304763701011304,0.04997898963829022,0.01071880345705722,0.30939713004692504,1,0.16155381232655336,0.06502356715806852,0.17770919355920872,0,24,0 +m_63,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.153291996055018,0.03966414017645281,0.05495250624425041,0.012014486251774047,0.09442157739699174,1,0.2082445022992684,0.05167862642822686,0.22906895252919526,0,24,0 +m_63,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.153291996055018,0.06130020351207081,0.05495250624425041,0.028772778404497303,0.1785616083210202,1,0.2082445022992684,0.09007298191656811,0.22906895252919526,0,24,0 +m_63,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.153291996055018,0.06415508727180315,0.05495250624425041,0.027984393312073804,0.1891579024219665,1,0.2082445022992684,0.09213948058387696,0.22906895252919526,0,24,0 +m_64,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0719572437673552,0.055259975375008784,0.03117940200319188,0.015139640536976272,0.6474887828860159,1,0.10313664577054707,0.07039961591198506,0.11936198142059215,0,24,0 +m_64,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0719572437673552,0.08223386774135706,0.03117940200319188,0.02627702445918125,0.8071212897765607,1,0.10313664577054707,0.1085108922005383,0.11936198142059215,0,24,0 +m_64,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0719572437673552,0.05039856099759669,0.03117940200319188,0.02549669545991401,0.6066711995253845,1,0.10313664577054707,0.07589525645751069,0.11936198142059215,0,24,0 +m_64,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07294293719374068,0.1766398094482474,0.02443486848454012,0.09198406270880241,0.3198016053557819,1,0.09737780567828079,0.2686238721570498,0.2954862593727548,0,24,0 +m_64,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07294293719374068,0.12453118818074967,0.02443486848454012,0.028478699899260468,0.19989226238586236,1,0.09737780567828079,0.15300988808001015,0.2954862593727548,0,24,0 +m_64,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07294293719374068,0.1809146472512022,0.02443486848454012,0.06533313839527287,0.1697434211042275,1,0.09737780567828079,0.2462477856464751,0.2954862593727548,0,24,0 +m_64,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.24798476838353817,0.1930524714820269,0.12336430622023568,0.08330615134360968,0.7226223307798784,1,0.37134907460377387,0.27635862282563656,0.40848398206415126,0,24,0 +m_64,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.24798476838353817,0.17778439489053594,0.12336430622023568,0.060451745451305355,0.628163377769074,1,0.37134907460377387,0.2382361403418413,0.40848398206415126,0,24,0 +m_64,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.24798476838353817,0.11470175318696112,0.12336430622023568,0.03559597328231698,0.34999620808446624,1,0.37134907460377387,0.15029772646927808,0.40848398206415126,0,24,0 +m_64,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3355810714382311,0.11250083408303047,0.1472671372886569,0.03689821568792927,0.2078915594258953,1,0.48284820872688805,0.14939904977095975,0.5311330295995769,0,24,0 +m_64,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3355810714382311,0.15912355384824953,0.1472671372886569,0.06419570125931068,0.3177313045542834,1,0.48284820872688805,0.2233192551075602,0.5311330295995769,0,24,0 +m_64,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3355810714382311,0.19964131565257257,0.1472671372886569,0.06758200971586033,0.4354774201824906,1,0.48284820872688805,0.2672233253684329,0.5311330295995769,0,24,0 +m_64,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10237817266789799,0.03345343943333449,0.05215838352707608,0.01225556638427932,0.24934438687779886,1,0.15453655619497408,0.04570900581761381,0.1699902118144715,0,24,0 +m_64,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10237817266789799,0.04841695825504518,0.05215838352707608,0.019976079798689227,0.3688672158411082,1,0.15453655619497408,0.06839303805373441,0.1699902118144715,0,24,0 +m_64,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10237817266789799,0.05304725694094555,0.05215838352707608,0.024910659627714923,0.4210104677771842,1,0.15453655619497408,0.07795791656866047,0.1699902118144715,0,24,0 +m_64,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.019734374351902655,0.04436359827860836,0.008044236105344561,0.0228758113421185,0.3476610408189501,1,0.027778610457247215,0.06723940962072686,0.0935484291551649,0,24,0 +m_64,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.019734374351902655,0.062157051286240605,0.008044236105344561,0.02288697521845474,0.12919797159041638,1,0.027778610457247215,0.08504402650469535,0.0935484291551649,0,24,0 +m_64,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.019734374351902655,0.046627908253267236,0.008044236105344561,0.017021689474527642,0.19547757244772254,1,0.027778610457247215,0.06364959772779488,0.0935484291551649,0,24,0 +m_64,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11989209063577588,0.09936909603895787,0.012176415866901739,0.03613298692775566,0.6094079031593715,1,0.13206850650267762,0.13550208296671354,0.17517900683206886,0,24,0 +m_64,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11989209063577588,0.11742994987238482,0.012176415866901739,0.04182369270222321,0.9568088957042631,1,0.13206850650267762,0.15925364257460803,0.17517900683206886,0,24,0 +m_64,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.11989209063577588,0.06082870952976697,0.012176415866901739,0.017656856726205598,0.02261660635662778,0.5427985525590667,0.13206850650267762,0.07848556625597257,0.17517900683206886,0,24,0 +m_64,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10028375944185235,0.06055900108641269,0.023161759081011576,0.015362262872332623,0.18788303955627478,1,0.12344551852286392,0.07592126395874531,0.1801891048741978,0,24,0 +m_64,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10028375944185235,0.12920731979553088,0.023161759081011576,0.03460095736283072,0.505336678642011,1,0.12344551852286392,0.1638082771583616,0.1801891048741978,0,24,0 +m_64,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10028375944185235,0.04981997835308897,0.023161759081011576,0.008470708831362481,0.08435602141919975,1,0.12344551852286392,0.05829068718445145,0.1801891048741978,0,24,0 +m_65,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06160733148044093,0.12971872035106316,0.03075204941982649,0.04030193014589481,0.21273496960934987,1,0.09235938090026742,0.17002065049695797,0.21212921864796855,0,24,0 +m_65,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.06160733148044093,0.13980209719064815,0.03075204941982649,0.04409995593611387,0.18163372723368756,1,0.09235938090026742,0.18390205312676203,0.21212921864796855,0,24,0 +m_65,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06160733148044093,0.14614874455626178,0.03075204941982649,0.046695999669164164,0.16753527579362934,1,0.09235938090026742,0.19284474422542594,0.21212921864796855,0,24,0 +m_65,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1128140194177959,0.22607552824793056,0.023674882709137608,0.08259387675605523,0.23696241398732149,1,0.13648890212693351,0.30866940500398576,0.3395363455043844,0,24,0 +m_65,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1128140194177959,0.14567681841954672,0.023674882709137608,0.024055528295258102,0.35319092166153276,1,0.13648890212693351,0.1697323467148048,0.3395363455043844,0,24,0 +m_65,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1128140194177959,0.17822048830398177,0.023674882709137608,0.030313724853299293,0.12166064007868357,1,0.13648890212693351,0.20853421315728105,0.3395363455043844,0,24,0 +m_65,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10863383382382272,0.08215429565123689,0.04398682966473003,0.019951645294903505,0.6045908904696378,1,0.15262066348855274,0.1021059409461404,0.4098544438497183,0,24,0 +m_65,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10863383382382272,0.259291637011606,0.04398682966473003,0.11330331194268334,0.2683516823666969,1,0.15262066348855274,0.37259494895428935,0.4098544438497183,0,24,0 +m_65,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10863383382382272,0.23757542437225912,0.04398682966473003,0.03913007290470189,0.057770638130370304,1,0.15262066348855274,0.27670549727696103,0.4098544438497183,0,24,0 +m_65,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1318506222631617,0.08993332323640886,0.046000006723284845,0.03439667642961013,0.48691609997777474,1,0.17785062898644655,0.12432999966601899,0.19563569188509122,0,24,0 +m_65,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1318506222631617,0.11382235262989437,0.046000006723284845,0.03670906603625235,0.7670857137814833,1,0.17785062898644655,0.15053141866614672,0.19563569188509122,0,24,0 +m_65,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1318506222631617,0.07280380281852043,0.046000006723284845,0.013076448609510257,0.27568672868776395,1,0.17785062898644655,0.08588025142803069,0.19563569188509122,0,24,0 +m_65,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15032553383490233,0.06822715691240466,0.04846437560774548,0.03820361181568323,0.21450569608416467,1,0.1987899094426478,0.10643076872808789,0.21866890038691258,0,24,0 +m_65,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.15032553383490233,0.09923801101268692,0.04846437560774548,0.05504488463408507,0.5021813510187766,1,0.1987899094426478,0.154282895646772,0.21866890038691258,0,24,0 +m_65,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.15032553383490233,0.10144343412602937,0.04846437560774548,0.046812513551437056,0.4848217257453217,1,0.1987899094426478,0.14825594767746642,0.21866890038691258,0,24,0 +m_65,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10610334767038469,0.11716618455243226,0.03426186395960818,0.08795791285204331,0.9102512759756263,1,0.14036521162999288,0.20512409740447557,0.33710961939689676,0,24,0 +m_65,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10610334767038469,0.0671582577780608,0.03426186395960818,0.02737742708575408,0.39638110960851736,1,0.14036521162999288,0.09453568486381488,0.33710961939689676,0,24,0 +m_65,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.10610334767038469,0.25484148929949596,0.03426186395960818,0.05162180106131928,0.04078685540296488,0.9380976742681922,0.14036521162999288,0.3064632903608152,0.33710961939689676,0,24,0 +m_65,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05424864425966103,0.12811385703334807,0.019325700292935333,0.037516657920605496,0.12079821493611832,1,0.07357434455259636,0.16563051495395356,0.24689239743937716,0,24,0 +m_65,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05424864425966103,0.12948055121522803,0.019325700292935333,0.057389143782248825,0.2595941638979204,1,0.07357434455259636,0.18686969499747685,0.24689239743937716,0,24,0 +m_65,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.05424864425966103,0.18154261351662285,0.019325700292935333,0.042905020519174546,0.030626612035368424,0.7350386888488422,0.07357434455259636,0.2244476340357974,0.24689239743937716,0,24,0 +m_65,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0394867626976508,0.13358693574534128,0.012875678023193724,0.0682126190484944,0.22959796361447818,1,0.052362440720844526,0.20179955479383568,0.22197951027321927,0,24,0 +m_65,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0394867626976508,0.10958903099975655,0.012875678023193724,0.06932543587463424,0.3629803784183695,1,0.052362440720844526,0.17891446687439078,0.22197951027321927,0,24,0 +m_65,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0394867626976508,0.07844306814440986,0.012875678023193724,0.03840811945357164,0.37271267228838206,1,0.052362440720844526,0.1168511875979815,0.22197951027321927,0,24,0 +m_66,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06937549507196587,0.064957130859625,0.02883060152751059,0.024914432688319495,0.9104003393748841,1,0.09820609659947646,0.0898715635479445,0.19978999656510785,0,24,0 +m_66,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.06937549507196587,0.12052773144160533,0.02883060152751059,0.06109953816303814,0.4735471203128758,1,0.09820609659947646,0.18162726960464348,0.19978999656510785,0,24,0 +m_66,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06937549507196587,0.11577706151118054,0.02883060152751059,0.03548967886465918,0.3369286681681486,1,0.09820609659947646,0.15126674037583973,0.19978999656510785,0,24,0 +m_66,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09085931561424883,0.16979826280462365,0.01806139492479125,0.07269577320482548,0.33517652964493955,1,0.10892071053904008,0.24249403600944913,0.26674343961039404,0,24,0 +m_66,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09085931561424883,0.06888125490222315,0.01806139492479125,0.025821217095527847,0.5032269605522834,1,0.10892071053904008,0.09470247199775099,0.26674343961039404,0,24,0 +m_66,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09085931561424883,0.12028992484604466,0.01806139492479125,0.05867841732302168,0.6488205147303818,1,0.10892071053904008,0.17896834216906635,0.26674343961039404,0,24,0 +m_66,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17660631985531722,0.15340446503182506,0.09924252794609757,0.058923962091706514,0.8466827266683119,1,0.2758488478014148,0.21232842712353156,0.30343373258155626,0,24,0 +m_66,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17660631985531722,0.15741851001982363,0.09924252794609757,0.061123628131212214,0.8741294957143744,1,0.2758488478014148,0.21854213815103585,0.30343373258155626,0,24,0 +m_66,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17660631985531722,0.12536017379894124,0.09924252794609757,0.041692026816676275,0.6526616767784994,1,0.2758488478014148,0.1670522006156175,0.30343373258155626,0,24,0 +m_66,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3051585100175737,0.1294141096779536,0.11654358308714469,0.04650622475717387,0.21739826421626926,1,0.4217020931047184,0.17592033443512747,0.4638723024151903,0,24,0 +m_66,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3051585100175737,0.18948456155949436,0.11654358308714469,0.07324218960925091,0.42878102055517975,1,0.4217020931047184,0.2627267511687453,0.4638723024151903,0,24,0 +m_66,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3051585100175737,0.20471350149173273,0.11654358308714469,0.06654427867609981,0.48045396644573213,1,0.4217020931047184,0.27125778016783253,0.4638723024151903,0,24,0 +m_66,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09159955430481286,0.021741890410754028,0.04677226153427937,0.009621230966959429,0.19891234518260692,1,0.13837181583909222,0.03136312137771346,0.15220899742300145,0,24,0 +m_66,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09159955430481286,0.09054823065028177,0.04677226153427937,0.024592652461819405,0.9846415637508928,1,0.13837181583909222,0.11514088311210117,0.15220899742300145,0,24,0 +m_66,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09159955430481286,0.0647201769220281,0.04677226153427937,0.026592968890806746,0.6309381898193607,1,0.13837181583909222,0.09131314581283484,0.15220899742300145,0,24,0 +m_66,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.038769119218665736,0.11217726336180196,0.013766844057152441,0.03057731542102547,0.06505643074828339,1,0.05253596327581818,0.14275457878282743,0.15703003666111018,0,24,0 +m_66,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.038769119218665736,0.05136216399471135,0.013766844057152441,0.01780162277059644,0.5888329667846357,1,0.05253596327581818,0.0691637867653078,0.15703003666111018,0,24,0 +m_66,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.038769119218665736,0.08116523594514187,0.013766844057152441,0.031002124397612227,0.2520931054818865,1,0.05253596327581818,0.1121673603427541,0.15703003666111018,0,24,0 +m_66,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13262178651108072,0.11961918768957773,0.016206753210097954,0.051763240236632,0.8185653681584593,1,0.14882853972117868,0.17138242792620972,0.22094041397042466,0,24,0 +m_66,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13262178651108072,0.1705367407769387,0.016206753210097954,0.030318181014356443,0.3035951565079584,1,0.14882853972117868,0.20085492179129513,0.22094041397042466,0,24,0 +m_66,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13262178651108072,0.09626495538283675,0.016206753210097954,0.013805167782795587,0.11925672766461283,1,0.14882853972117868,0.11007012316563233,0.22094041397042466,0,24,0 +m_66,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10104822576741035,0.10412892343977147,0.027248435757676683,0.014801827815433186,0.9233950315561733,1,0.12829666152508704,0.11893075125520465,0.1744173733300602,0,24,0 +m_66,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10104822576741035,0.12495207544359037,0.027248435757676683,0.03360917303828253,0.593268003054469,1,0.12829666152508704,0.1585612484818729,0.1744173733300602,0,24,0 +m_66,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10104822576741035,0.048881622283497794,0.027248435757676683,0.019279332416564925,0.15251371381327766,1,0.12829666152508704,0.06816095470006273,0.1744173733300602,0,24,0 +m_67,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13020431753143882,0.12067342435174318,0.05767341469646353,0.04160423147913483,0.8968647080037133,1,0.18787773222790236,0.162277655830878,0.20666550545069262,0,24,0 +m_67,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13020431753143882,0.0848751117291165,0.05767341469646353,0.03589861827263743,0.5263616387691644,1,0.18787773222790236,0.12077373000175393,0.20666550545069262,0,24,0 +m_67,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13020431753143882,0.07423194206802737,0.05767341469646353,0.0125007641354593,0.3922569088924323,1,0.18787773222790236,0.08673270620348666,0.20666550545069262,0,24,0 +m_67,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0900863552042123,0.12222620891413001,0.020951365166516526,0.06398753628041956,0.6498446600420071,1,0.11103772037072883,0.18621374519454958,0.20483511971400456,0,24,0 +m_67,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0900863552042123,0.08503095128651794,0.020951365166516526,0.060962878272419745,0.939974728272692,1,0.11103772037072883,0.1459938295589377,0.20483511971400456,0,24,0 +m_67,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0900863552042123,0.10852928939528457,0.020951365166516526,0.03725637805150388,0.6776879614593279,1,0.11103772037072883,0.14578566744678845,0.20483511971400456,0,24,0 +m_67,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11468590790554503,0.0800453535875963,0.0729473041990418,0.02861173197657059,0.67612670088832,1,0.18763321210458683,0.1086570855641669,0.2413397166973808,0,24,0 +m_67,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11468590790554503,0.16124267309669255,0.0729473041990418,0.058157069355471804,0.6318336195373725,1,0.18763321210458683,0.21939974245216434,0.2413397166973808,0,24,0 +m_67,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11468590790554503,0.08250036797420239,0.0729473041990418,0.03035698791957214,0.6994664388883375,1,0.18763321210458683,0.11285735589377453,0.2413397166973808,0,24,0 +m_67,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.23699118057274085,0.06905300095246798,0.08257622169387681,0.036015743568960985,0.11595122162116843,1,0.3195674022666177,0.10506874452142898,0.35152414249327946,0,24,0 +m_67,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.23699118057274085,0.05903694708886439,0.08257622169387681,0.011751132168225665,0.09712449739558299,1,0.3195674022666177,0.07078807925709005,0.35152414249327946,0,24,0 +m_67,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.23699118057274085,0.093099700667586,0.08257622169387681,0.03687293257899608,0.16641638339688086,1,0.3195674022666177,0.12997263324658206,0.35152414249327946,0,24,0 +m_67,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2515186189863339,0.2624992555693604,0.05505455574879765,0.10820670523549494,0.9303253404237999,1,0.3065731747351315,0.3707059608048553,0.6159271463343556,0,24,0 +m_67,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2515186189863339,0.32130340231057253,0.05505455574879765,0.05796923926711933,0.40324724308625404,1,0.3065731747351315,0.37927264157769186,0.6159271463343556,0,24,0 +m_67,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2515186189863339,0.4243009365609493,0.05505455574879765,0.13563283283391941,0.2786175830300138,1,0.3065731747351315,0.5599337693948687,0.6159271463343556,0,24,0 +m_67,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.223751203901058,0.09850660955919947,0.08487227534003194,0.04688314637262718,0.23345469136535119,1,0.3086234792410899,0.14538975593182665,0.3611214908634145,0,24,0 +m_67,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.223751203901058,0.08487711140986735,0.08487227534003194,0.02271772289928362,0.16751424827276404,1,0.3086234792410899,0.10759483430915097,0.3611214908634145,0,24,0 +m_67,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.223751203901058,0.24063158154431127,0.08487227534003194,0.08766068287697464,0.8927155886854317,1,0.3086234792410899,0.3282922644212859,0.3611214908634145,0,24,0 +m_67,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2029101707486557,0.13674766870511182,0.08871972078078359,0.0456884374506271,0.5272347972809577,1,0.2916298915294393,0.1824361061557389,0.32079288068238326,0,24,0 +m_67,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2029101707486557,0.14379034268197363,0.08871972078078359,0.046970426114231995,0.5729980046288433,1,0.2916298915294393,0.19076076879620563,0.32079288068238326,0,24,0 +m_67,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2029101707486557,0.14093639050559106,0.08871972078078359,0.07279735771706129,0.6014478168741116,1,0.2916298915294393,0.21373374822265234,0.32079288068238326,0,24,0 +m_67,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.5345908063807713,0.4815734115900396,0.10224639316488608,0.1568268383223818,0.7837278547242968,1,0.6368371995456573,0.6384002499124214,0.7022402749036636,0,24,0 +m_67,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.5345908063807713,0.22073098285025483,0.10224639316488608,0.10497695773611024,0.05787991359219477,1,0.6368371995456573,0.3257079405863651,0.7022402749036636,0,24,0 +m_67,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.5345908063807713,0.2156543243051312,0.10224639316488608,0.06251771484365161,0.02790177102155946,0.669642504517427,0.6368371995456573,0.2781720391487828,0.7022402749036636,0,24,0 +m_68,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17929878262027196,0.04732627572644418,0.06742882562533924,0.016990634665197173,0.12246064439824951,1,0.24672760824561119,0.06431691039164135,0.27140036907017234,0,24,0 +m_68,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17929878262027196,0.11744415419480614,0.06742882562533924,0.07392181449111637,0.5517681668548715,1,0.24672760824561119,0.1913659686859225,0.27140036907017234,0,24,0 +m_68,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17929878262027196,0.07374638708622605,0.06742882562533924,0.026519835460345732,0.2024362290075332,1,0.24672760824561119,0.10026622254657178,0.27140036907017234,0,24,0 +m_68,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03471794010812087,0.0923843000384726,0.014412144533416387,0.027028338711047244,0.0982970523469247,1,0.04913008464153726,0.11941263874951985,0.13135390262447186,0,24,0 +m_68,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03471794010812087,0.03451087531340624,0.014412144533416387,0.018294612817805974,0.9930904847486455,1,0.04913008464153726,0.05280548813121222,0.13135390262447186,0,24,0 +m_68,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03471794010812087,0.03517724186759227,0.014412144533416387,0.019389792396359525,0.9852365754292047,1,0.04913008464153726,0.05456703426395179,0.13135390262447186,0,24,0 +m_68,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09005786464271433,0.039778417145556556,0.027672919406937006,0.01702028043791455,0.1667704897201486,1,0.11773078404965133,0.05679869758347111,0.12950386245461648,0,24,0 +m_68,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09005786464271433,0.04698970659749646,0.027672919406937006,0.024177669973871652,0.2754948318253166,1,0.11773078404965133,0.07116737657136811,0.12950386245461648,0,24,0 +m_68,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09005786464271433,0.059286679067795424,0.027672919406937006,0.02014968275279634,0.39612340414401703,1,0.11773078404965133,0.07943636182059177,0.12950386245461648,0,24,0 +m_68,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06563205963390298,0.1215801930992979,0.024658334612480272,0.07134387823081315,0.485884654693178,1,0.09029039424638324,0.19292407133011105,0.21221647846312217,0,24,0 +m_68,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.06563205963390298,0.09122916609244285,0.024658334612480272,0.0388890734913833,0.5931725584308241,1,0.09029039424638324,0.13011823958382615,0.21221647846312217,0,24,0 +m_68,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06563205963390298,0.06709482738168937,0.024658334612480272,0.02284899155209621,0.9662760989084962,1,0.09029039424638324,0.08994381893378559,0.21221647846312217,0,24,0 +m_68,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06226323457289921,0.060270544167642624,0.0239230847298159,0.03860022439764545,0.9660318162385448,1,0.08618631930271511,0.09887076856528806,0.10875784542181688,0,24,0 +m_68,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06226323457289921,0.0560978638612993,0.0239230847298159,0.014611468763167237,0.8312485728768704,1,0.08618631930271511,0.07070933262446653,0.10875784542181688,0,24,0 +m_68,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06226323457289921,0.056949720233644786,0.0239230847298159,0.02490830862049613,0.880790193803697,1,0.08618631930271511,0.08185802885414092,0.10875784542181688,0,24,0 +m_68,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11180667841080472,0.07599648812023248,0.04800696659547903,0.029527937302760647,0.5422841003450052,1,0.15981364500628376,0.10552442542299312,0.17579500950691215,0,24,0 +m_68,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11180667841080472,0.04971924287871373,0.04800696659547903,0.016291543332997722,0.2656116143849987,1,0.15981364500628376,0.06601078621171146,0.17579500950691215,0,24,0 +m_68,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11180667841080472,0.06017456085816142,0.04800696659547903,0.025472169357000387,0.37127816408876685,1,0.15981364500628376,0.08564673021516181,0.17579500950691215,0,24,0 +m_68,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08414221037474297,0.08298008596628821,0.03887601238447212,0.03379754191686544,0.9824537454345218,1,0.12301822275921509,0.11677762788315366,0.13532004503513662,0,24,0 +m_68,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08414221037474297,0.08444606481386001,0.03887601238447212,0.014278566373043845,0.9943721259486806,1,0.12301822275921509,0.09872463118690386,0.13532004503513662,0,24,0 +m_68,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08414221037474297,0.06804553569629908,0.03887601238447212,0.028684670589789258,0.7464707091687613,1,0.12301822275921509,0.09673020628608833,0.13532004503513662,0,24,0 +m_68,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09614296538984994,0.07616066436786384,0.02820240028703639,0.036620697609890264,0.6752746757960183,1,0.12434536567688634,0.1127813619777541,0.13677990224457498,0,24,0 +m_68,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09614296538984994,0.044789495180328265,0.02820240028703639,0.022866130361559333,0.1888785900833009,1,0.12434536567688634,0.0676556255418876,0.13677990224457498,0,24,0 +m_68,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09614296538984994,0.0663865630499932,0.02820240028703639,0.021258671066489418,0.42063214767941204,1,0.12434536567688634,0.08764523411648262,0.13677990224457498,0,24,0 +m_69,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3125481718395814,0.5095131099755934,0.11960069171907711,0.3728883542075106,0.6329006142107874,1,0.4321488635586585,0.882401464183104,1.650728886181655,5,24,20.833333333333336 +m_69,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3125481718395814,0.5508420923031172,0.11960069171907711,0.3684700629820502,0.5609731911996753,1,0.4321488635586585,0.9193121552851674,1.650728886181655,5,24,20.833333333333336 +m_69,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,0.3125481718395814,1.1772500750486534,0.11960069171907711,0.3234125487528509,0.04411366746609405,0.9705006842540691,0.4321488635586585,1.5006626238015044,1.650728886181655,5,24,20.833333333333336 +m_69,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1925900730094572,0.23877080185152152,0.12302742136407871,0.043341227211445475,0.7349970577468287,1,0.3156174943735359,0.282112029062967,0.34717924381088955,0,24,0 +m_69,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1925900730094572,0.158498100352908,0.12302742136407871,0.09619434682782727,0.8318367055170148,1,0.3156174943735359,0.25469244718073525,0.34717924381088955,0,24,0 +m_69,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1925900730094572,0.15249498477160695,0.12302742136407871,0.05368559904045784,0.7740401068042164,1,0.3156174943735359,0.20618058381206478,0.34717924381088955,0,24,0 +m_69,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10625916806110883,0.11236338133283874,0.046884266636465353,0.03696766863004698,0.9210725916989293,1,0.1531434346975742,0.1493310499628857,0.41457964749955034,0,24,0 +m_69,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10625916806110883,0.21125459887771494,0.046884266636465353,0.11627794248810097,0.43867295978023585,1,0.1531434346975742,0.3275325413658159,0.41457964749955034,0,24,0 +m_69,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10625916806110883,0.2642899767593462,0.046884266636465353,0.11260061187660862,0.2383512083609346,1,0.1531434346975742,0.3768905886359548,0.41457964749955034,0,24,0 +m_69,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12964242255529027,0.07606711668418194,0.06247351327519086,0.02802821675442439,0.4657946850585668,1,0.19211593583048112,0.10409533343860633,0.32584208868394976,0,24,0 +m_69,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12964242255529027,0.1843884026143837,0.06247351327519086,0.07976520731497704,0.6022928887895069,1,0.19211593583048112,0.2641536099293607,0.32584208868394976,0,24,0 +m_69,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12964242255529027,0.23571633791665433,0.06247351327519086,0.06050374270511811,0.25420870108596333,1,0.19211593583048112,0.29622008062177246,0.32584208868394976,0,24,0 +m_69,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13152915182633618,0.06596044645321515,0.03402132551317283,0.023930535660927708,0.1494895605715049,1,0.165550477339509,0.08989098211414286,0.19253681475667414,0,24,0 +m_69,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13152915182633618,0.13358116861034905,0.03402132551317283,0.041452299350263795,0.970257424113963,1,0.165550477339509,0.17503346796061284,0.19253681475667414,0,24,0 +m_69,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13152915182633618,0.11277571565456708,0.03402132551317283,0.04813497009750183,0.757627248366038,1,0.165550477339509,0.1609106857520689,0.19253681475667414,0,24,0 +m_69,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.11892839863900133,0.27692264819359763,0.02091956908537081,0.041619561535164135,0.010696252669633225,0.2567100640711974,0.13984796772437214,0.3185422097287618,0.350396430701638,0,24,0 +m_69,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11892839863900133,0.1308271078676492,0.02091956908537081,0.05446311330215785,0.8446859000323079,1,0.13984796772437214,0.18529022116980703,0.350396430701638,0,24,0 +m_69,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.11892839863900133,0.053313793531047114,0.02091956908537081,0.014332485219642076,0.029732834775513146,0.6838551998368023,0.13984796772437214,0.0676462787506892,0.350396430701638,0,24,0 +m_69,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.24083593243319748,0.2570542362188223,0.10639928461342724,0.04782163838348575,0.8933732736695065,1,0.34723521704662474,0.30487587460230803,0.3819587387512873,0,24,0 +m_69,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.24083593243319748,0.14667142904776598,0.10639928461342724,0.0406704924215622,0.438013261899868,1,0.34723521704662474,0.18734192146932818,0.3819587387512873,0,24,0 +m_69,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.24083593243319748,0.15074936758436208,0.10639928461342724,0.03883910433045334,0.4552824874746969,1,0.34723521704662474,0.18958847191481543,0.3819587387512873,0,24,0 +m_69,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.28118168349697054,0.19618705731086694,0.15086484417778448,0.04930284170082587,0.6113818495518691,1,0.43204652767475504,0.24548989901169282,0.4752511804422306,0,24,0 +m_69,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.28118168349697054,0.14596045413762396,0.15086484417778448,0.05660319760341047,0.43167864558805635,1,0.43204652767475504,0.2025636517410344,0.4752511804422306,0,24,0 +m_69,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.28118168349697054,0.1641517320333051,0.15086484417778448,0.06358104614843571,0.4987760585761759,1,0.43204652767475504,0.2277327781817408,0.4752511804422306,0,24,0 +m_70,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13266611430716918,0.29019434699678887,0.051072241907351455,0.06909115914013406,0.10105804737729283,1,0.18373835621452064,0.3592855061369229,0.3952140567506152,0,24,0 +m_70,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13266611430716918,0.11331227658829124,0.051072241907351455,0.029783800737967537,0.7535754541361984,1,0.18373835621452064,0.14309607732625879,0.3952140567506152,0,24,0 +m_70,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13266611430716918,0.21746908047645394,0.051072241907351455,0.08807877026477415,0.4295888725152318,1,0.18373835621452064,0.3055478507412281,0.3952140567506152,0,24,0 +m_70,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08184226218823872,0.3524051922059988,0.03393085126140124,0.2434433252352484,0.31937844776193874,1,0.11577311344963995,0.5958485174412472,0.655433369185372,0,23,0 +m_70,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08184226218823872,0.20528055789612426,0.03393085126140124,0.08001539793619943,0.21033933779928837,1,0.11577311344963995,0.2852959558323237,0.655433369185372,0,23,0 +m_70,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08184226218823872,0.17927870797795106,0.03393085126140124,0.10199514985733746,0.3991171988687056,1,0.11577311344963995,0.2812738578352885,0.655433369185372,0,23,0 +m_70,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11052116966050667,0.12606542875002305,0.05310758235296524,0.0765314939870525,0.8713718314016927,1,0.1636287520134719,0.20259692273707555,0.32256573094517127,0,24,0 +m_70,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11052116966050667,0.1532371656172052,0.05310758235296524,0.058230285380126756,0.6027017095329676,1,0.1636287520134719,0.21146745099733197,0.32256573094517127,0,24,0 +m_70,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11052116966050667,0.2257027725177907,0.05310758235296524,0.06753880106872863,0.2134066446437785,1,0.1636287520134719,0.2932415735865193,0.32256573094517127,0,24,0 +m_70,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09816891442591658,0.1596488362485152,0.04510619479850019,0.04922357576124604,0.38116573051027336,1,0.14327510922441677,0.20887241200976123,0.4588845599867868,0,24,0 +m_70,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09816891442591658,0.17639197179305496,0.04510619479850019,0.06741558284359754,0.36186646508822107,1,0.14327510922441677,0.2438075546366525,0.4588845599867868,0,24,0 +m_70,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09816891442591658,0.281333378541579,0.04510619479850019,0.13583440326459076,0.24736633248967183,1,0.14327510922441677,0.41716778180616976,0.4588845599867868,0,24,0 +m_70,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.07162451626449728,0.041857509207654665,0.010499743777588381,0.006198944017283765,0.04009595104437899,0.9222068740207168,0.08212426004208567,0.04805645322493843,0.09033668604629425,0,24,0 +m_70,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.07162451626449728,0.03438325235776718,0.010499743777588381,0.008182979854005847,0.019896062674077813,0.4775055041778675,0.08212426004208567,0.042566232211773025,0.09033668604629425,0,24,0 +m_70,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07162451626449728,0.04935661387796797,0.010499743777588381,0.019705008503855873,0.3491934720511426,1,0.08212426004208567,0.06906162238182384,0.09033668604629425,0,24,0 +m_70,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07350782973503629,0.04603844920478487,0.030826337365432995,0.021045898767459326,0.48085972236078567,1,0.10433416710046929,0.06708434797224419,0.11476758381051623,0,24,0 +m_70,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07350782973503629,0.06685884584442296,0.030826337365432995,0.017837365923052448,0.8565449910705601,1,0.10433416710046929,0.08469621176747541,0.11476758381051623,0,24,0 +m_70,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07350782973503629,0.061574924196871716,0.030826337365432995,0.019296115791140038,0.7508547510436459,1,0.10433416710046929,0.08087103998801176,0.11476758381051623,0,24,0 +m_70,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14965848807393023,0.06419726142070663,0.054818107345408415,0.017587461325490755,0.1880710077661389,1,0.20447659541933866,0.08178472274619739,0.22492425496127255,0,24,0 +m_70,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14965848807393023,0.10909128914776571,0.054818107345408415,0.045752528193254385,0.58285903073206,1,0.20447659541933866,0.1548438173410201,0.22492425496127255,0,24,0 +m_70,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14965848807393023,0.05899466258014222,0.054818107345408415,0.00989103646377783,0.16095985515189437,1,0.20447659541933866,0.06888569904392006,0.22492425496127255,0,24,0 +m_70,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09655300612046809,0.054571400013243565,0.048423954443440734,0.027299472114361453,0.47206940288658905,1,0.14497696056390882,0.08187087212760502,0.15947465662029972,0,24,0 +m_70,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09655300612046809,0.07997416616527205,0.048423954443440734,0.023761262756552187,0.7671814961595862,1,0.14497696056390882,0.10373542892182423,0.15947465662029972,0,24,0 +m_70,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09655300612046809,0.0958729638629922,0.048423954443440734,0.03904505263308953,0.9915019391875672,1,0.14497696056390882,0.13491801649608173,0.15947465662029972,0,24,0 +m_71,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.19055241660007588,0.08705766721465746,0.08754983929811523,0.033423825187783224,0.3182178065031919,1,0.2781022558981911,0.12048149240244069,0.30591248148801026,0,24,0 +m_71,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.19055241660007588,0.08730838494698763,0.08754983929811523,0.030556586425151293,0.31642213852408646,1,0.2781022558981911,0.11786497137213892,0.30591248148801026,0,24,0 +m_71,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.19055241660007588,0.09187359696282082,0.08754983929811523,0.03132536625606573,0.3369150247735941,1,0.2781022558981911,0.12319896321888656,0.30591248148801026,0,24,0 +m_71,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10189582028450173,0.11745340302862028,0.048993910353050715,0.032887372999693396,0.7981559872089363,1,0.15088973063755245,0.1503407760283137,0.1864923636605773,0,24,0 +m_71,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10189582028450173,0.056459293858502534,0.048993910353050715,0.021441719161817797,0.4242563817689784,1,0.15088973063755245,0.07790101302032033,0.1864923636605773,0,24,0 +m_71,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10189582028450173,0.1188823759900195,0.048993910353050715,0.05065613642868714,0.814402427635918,1,0.15088973063755245,0.16953851241870663,0.1864923636605773,0,24,0 +m_71,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12150326899278122,0.09036934217043198,0.07210295659198691,0.030089721101684088,0.7055850877769333,1,0.19360622558476814,0.12045906327211607,0.21296684814324499,0,24,0 +m_71,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12150326899278122,0.12651026671378443,0.07210295659198691,0.05253741877467469,0.9567458177433559,1,0.19360622558476814,0.17904768548845912,0.21296684814324499,0,24,0 +m_71,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12150326899278122,0.06558889039248812,0.07210295659198691,0.04213030373696529,0.5259143639462879,1,0.19360622558476814,0.10771919412945341,0.21296684814324499,0,24,0 +m_71,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0961078239417346,0.03654750926671557,0.041011601904037534,0.013168751668188837,0.22729701527719115,1,0.13711942584577214,0.04971626093490441,0.15083136843034936,0,24,0 +m_71,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0961078239417346,0.05451759632639227,0.041011601904037534,0.007410019264371766,0.3715406917312004,1,0.13711942584577214,0.06192761559076403,0.15083136843034936,0,24,0 +m_71,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0961078239417346,0.05921363763387218,0.041011601904037534,0.03296306497127205,0.5027708895774221,1,0.13711942584577214,0.09217670260514424,0.15083136843034936,0,24,0 +m_71,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04391117519955645,0.05648334968570393,0.016280610423546248,0.017488816362085446,0.6102995066255164,1,0.0601917856231027,0.07397216604778938,0.08136938265256832,0,24,0 +m_71,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04391117519955645,0.04796091373222559,0.016280610423546248,0.015351158993363225,0.8600107963850427,1,0.0601917856231027,0.06331207272558881,0.08136938265256832,0,24,0 +m_71,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04391117519955645,0.04011906578110628,0.016280610423546248,0.010942022266678416,0.8511222930854496,1,0.0601917856231027,0.0510610880477847,0.08136938265256832,0,24,0 +m_71,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06953234680544733,0.015221227969827241,0.021296871729988304,0.009045647591390081,0.052630794843513566,1,0.09082921853543563,0.024266875561217323,0.0999121403889792,0,24,0 +m_71,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06953234680544733,0.05487072240164936,0.021296871729988304,0.025305123018080834,0.6672595994531514,1,0.09082921853543563,0.08017584541973019,0.0999121403889792,0,24,0 +m_71,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06953234680544733,0.04442206688213971,0.021296871729988304,0.013863955623377526,0.3500948742734344,1,0.09082921853543563,0.05828602250551724,0.0999121403889792,0,24,0 +m_71,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04055850360431834,0.06700005628847139,0.015204022056113582,0.015856936120528964,0.25650064306232,1,0.055762525660431925,0.08285699240900035,0.10248169142901008,0,24,0 +m_71,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04055850360431834,0.06868189497170252,0.015204022056113582,0.024483279054670282,0.35654723273938754,1,0.055762525660431925,0.0931651740263728,0.10248169142901008,0,24,0 +m_71,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04055850360431834,0.04063486173330758,0.015204022056113582,0.015430075633090805,0.9972568433988602,1,0.055762525660431925,0.056064937366398386,0.10248169142901008,0,24,0 +m_71,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05066094789297434,0.10271804387873555,0.01688658852785664,0.01651644706489924,0.05211301737410439,1,0.06754753642083097,0.1192344909436348,0.13115794003799827,0,24,0 +m_71,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05066094789297434,0.06491153996383596,0.01688658852785664,0.02802131366069574,0.6743677675224697,1,0.06754753642083097,0.0929328536245317,0.13115794003799827,0,24,0 +m_71,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05066094789297434,0.07771704778164105,0.01688658852785664,0.027317333919169344,0.42304232806456443,1,0.06754753642083097,0.10503438170081039,0.13115794003799827,0,24,0 +m_72,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.19770112681657775,0.1324125580049449,0.06973484804874767,0.057477927085930684,0.49000698316797986,1,0.26743597486532544,0.18989048509087558,0.294179572351858,0,24,0 +m_72,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.19770112681657775,0.08912956232383899,0.06973484804874767,0.038340187917031573,0.21904284668630436,1,0.26743597486532544,0.12746975024087057,0.294179572351858,0,24,0 +m_72,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.19770112681657775,0.1581231681429728,0.06973484804874767,0.04017750380725195,0.6389995096975658,1,0.26743597486532544,0.19830067195022477,0.294179572351858,0,24,0 +m_72,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.21700634366041416,0.14311195960122736,0.05547442127002331,0.02121152932202146,0.2568545513293249,1,0.2724807649304375,0.16432348892324883,0.2997288414234813,0,24,0 +m_72,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.21700634366041416,0.10785077472269496,0.05547442127002331,0.030636493234794792,0.12429906847568897,1,0.2724807649304375,0.13848726795748975,0.2997288414234813,0,24,0 +m_72,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,0.21700634366041416,0.07096335794637894,0.05547442127002331,0.029132118576079072,0.049896212217388866,1,0.2724807649304375,0.10009547652245801,0.2997288414234813,0,24,0 +m_72,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.15089778392263695,0.16021137914587713,0.07410101391551811,0.054184156444837595,0.921790118454117,1,0.22499879783815507,0.21439553559071473,0.35106296258927666,0,24,0 +m_72,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.15089778392263695,0.2421309245288402,0.07410101391551811,0.07701722327959314,0.41817057035820127,1,0.22499879783815507,0.3191481478084333,0.35106296258927666,0,24,0 +m_72,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.15089778392263695,0.1249658284726531,0.07410101391551811,0.04536922630979503,0.7742717759283582,1,0.22499879783815507,0.17033505478244812,0.35106296258927666,0,24,0 +m_72,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10366427735030861,0.11032886621204492,0.035701295653288785,0.05963546911378371,0.925983994337956,1,0.1393655730035974,0.16996433532582864,0.21032131697500595,0,24,0 +m_72,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10366427735030861,0.1561414743307117,0.035701295653288785,0.03505972291929369,0.32208516806224285,1,0.1393655730035974,0.1912011972500054,0.21032131697500595,0,24,0 +m_72,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10366427735030861,0.12327795749937287,0.035701295653288785,0.06073601395846239,0.7878747508293835,1,0.1393655730035974,0.18401397145783527,0.21032131697500595,0,24,0 +m_72,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09343655320546973,0.06839450167261878,0.022632139212774283,0.02904128337324196,0.5127508078336334,1,0.11606869241824401,0.09743578504586073,0.2620011453989715,0,24,0 +m_72,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09343655320546973,0.1215310775824318,0.022632139212774283,0.048002785378941065,0.6126439645450402,1,0.11606869241824401,0.16953386296137285,0.2620011453989715,0,24,0 +m_72,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09343655320546973,0.1811114072556661,0.022632139212774283,0.057071452197944336,0.1992797365506823,1,0.11606869241824401,0.23818285945361045,0.2620011453989715,0,24,0 +m_72,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10585233352388405,0.05945657112213761,0.038842232442950625,0.025336348342005478,0.34440229490221724,1,0.14469456596683467,0.0847929194641431,0.18616573968040778,0,24,0 +m_72,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10585233352388405,0.08523993919291646,0.038842232442950625,0.02330691766374576,0.6609064965064482,1,0.14469456596683467,0.10854685685666222,0.18616573968040778,0,24,0 +m_72,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10585233352388405,0.11657634717352972,0.038842232442950625,0.05266523435411371,0.8733731569121002,1,0.14469456596683467,0.16924158152764343,0.18616573968040778,0,24,0 +m_72,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08166574411791398,0.12086426891141862,0.030122912401888864,0.05454647698344261,0.547298742865433,1,0.11178865651980285,0.17541074589486122,0.22877882122994894,0,24,0 +m_72,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08166574411791398,0.13469651052172038,0.030122912401888864,0.04062867529245985,0.32110799960972014,1,0.11178865651980285,0.17532518581418022,0.22877882122994894,0,24,0 +m_72,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08166574411791398,0.14650681837052884,0.030122912401888864,0.06147392820215201,0.37396262927013546,1,0.11178865651980285,0.20798074657268084,0.22877882122994894,0,24,0 +m_72,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05205082283474153,0.043351570018781795,0.018282744481210693,0.027274374420270288,0.7972012777645026,1,0.07033356731595222,0.07062594443905208,0.10932459535818084,0,24,0 +m_72,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05205082283474153,0.06445991209894664,0.018282744481210693,0.01954344417285671,0.6528465460616477,1,0.07033356731595222,0.08400335627180334,0.10932459535818084,0,24,0 +m_72,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05205082283474153,0.07355849108024433,0.018282744481210693,0.025827504699920064,0.5137949186510788,1,0.07033356731595222,0.0993859957801644,0.10932459535818084,0,24,0 +m_73,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1095289883050973,0.0597640790063656,0.04156083322383391,0.0233854800752945,0.33439461091177,1,0.15108982152893122,0.08314955908166011,0.1928448337258725,0,24,0 +m_73,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1095289883050973,0.1279493796016525,0.04156083322383391,0.047364105603686105,0.7766666863603717,1,0.15108982152893122,0.17531348520533863,0.1928448337258725,0,24,0 +m_73,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1095289883050973,0.10297971538428359,0.04156083322383391,0.03504593565128794,0.9069639857127888,1,0.15108982152893122,0.13802565103557152,0.1928448337258725,0,24,0 +m_73,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.03363002285169103,0.12061138377196978,0.011115599286761087,0.03372325328317919,0.04932758420105989,1,0.044745622138452124,0.15433463705514897,0.16976810076066387,2,24,8.333333333333332 +m_73,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03363002285169103,0.0460240929380078,0.011115599286761087,0.017043320484214225,0.558191456755509,1,0.044745622138452124,0.06306741342222202,0.16976810076066387,2,24,8.333333333333332 +m_73,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03363002285169103,0.08356070054472957,0.011115599286761087,0.039243935672730115,0.2683012993426718,1,0.044745622138452124,0.12280463621745968,0.16976810076066387,2,24,8.333333333333332 +m_73,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07635979215522996,0.07710169079942512,0.023976251208287978,0.018038156636607783,0.9808931534405256,1,0.10033604336351794,0.0951398474360329,0.285020674847767,3,24,12.5 +m_73,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07635979215522996,0.15037905299005389,0.023976251208287978,0.108730651417007,0.539507189088391,1,0.10033604336351794,0.2591097044070609,0.285020674847767,3,24,12.5 +m_73,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07635979215522996,0.09707286368059298,0.023976251208287978,0.04998418190207099,0.7195916099996778,1,0.10033604336351794,0.14705704558266397,0.285020674847767,3,24,12.5 +m_73,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.071742430957309,0.04012755374322141,0.03166226853157928,0.02473228684111458,0.45404894894435943,1,0.10340469948888828,0.064859840584336,0.11374516943777711,9,24,37.5 +m_73,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.071742430957309,0.03825632356688391,0.03166226853157928,0.014171605552725652,0.37430820468142795,1,0.10340469948888828,0.05242792911960956,0.11374516943777711,9,24,37.5 +m_73,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.071742430957309,0.0421406022854696,0.03166226853157928,0.014512924523659472,0.42987377081676575,1,0.10340469948888828,0.05665352680912907,0.11374516943777711,9,24,37.5 +m_73,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.062880609415227,0.039931126455479214,0.010510129396892555,0.013794271434632237,0.21719134739854737,1,0.07339073881211955,0.05372539789011145,0.09486202894818886,0,24,0 +m_73,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.062880609415227,0.05775326564587243,0.010510129396892555,0.02457916039244768,0.8535205788107304,1,0.07339073881211955,0.08233242603832011,0.09486202894818886,0,24,0 +m_73,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.062880609415227,0.05862291164627679,0.010510129396892555,0.02761529648844034,0.8898435777955572,1,0.07339073881211955,0.08623820813471714,0.09486202894818886,0,24,0 +m_73,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.027268468635539556,0.024375719932793416,0.012374136143313015,0.008372455730110145,0.8508772995345806,1,0.03964260477885257,0.03274817566290356,0.0687954056397413,0,24,0 +m_73,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.027268468635539556,0.044400251134655656,0.012374136143313015,0.018141026719654618,0.45571336176684796,1,0.03964260477885257,0.06254127785431027,0.0687954056397413,0,24,0 +m_73,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.027268468635539556,0.0370331317324899,0.012374136143313015,0.018329791540235937,0.6695117122714188,1,0.03964260477885257,0.055362923272725836,0.0687954056397413,0,24,0 +m_73,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.01858818896528221,0.024951537330597,0.011397256321110555,0.007988695782125878,0.6584161001992139,1,0.029985445286392763,0.03294023311272288,0.03675204392223415,0,24,0 +m_73,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.01858818896528221,0.023308699477377903,0.011397256321110555,0.010102249542834956,0.7630532902141426,1,0.029985445286392763,0.03341094902021286,0.03675204392223415,0,24,0 +m_73,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.01858818896528221,0.010322285741091694,0.011397256321110555,0.0023928758524109747,0.5071049799289444,1,0.029985445286392763,0.012715161593502668,0.03675204392223415,0,24,0 +m_73,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.021527310200877132,0.024127225713282,0.00604341470177839,0.007979095434354823,0.8007087745500692,1,0.02757072490265552,0.03210632114763683,0.07682933679978288,0,24,0 +m_73,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.021527310200877132,0.02055172252221545,0.00604341470177839,0.008202702675352001,0.925771665560049,1,0.02757072490265552,0.02875442519756745,0.07682933679978288,0,24,0 +m_73,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.021527310200877132,0.04612646670356405,0.00604341470177839,0.023718384932602195,0.3559927623531666,1,0.02757072490265552,0.06984485163616624,0.07682933679978288,0,24,0 +m_74,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03971175781243712,0.020497702344637696,0.012444954892786167,0.008942322041829114,0.2471960064126303,1,0.052156712705223283,0.029440024386466812,0.1274920953153361,0,24,0 +m_74,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03971175781243712,0.0801074025536858,0.012444954892786167,0.035794502278437904,0.3263737579821464,1,0.052156712705223283,0.1159019048321237,0.1274920953153361,0,24,0 +m_74,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03971175781243712,0.0823145521996788,0.012444954892786167,0.026458909350489723,0.18829589534713423,1,0.052156712705223283,0.10877346155016852,0.1274920953153361,0,24,0 +m_74,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.057340366146959885,0.12492703888726371,0.02537501938730938,0.031075611012987555,0.12418137277494423,1,0.08271538553426927,0.15600264990025126,0.1716029148902764,0,24,0 +m_74,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.057340366146959885,0.034529738586247305,0.02537501938730938,0.02616354223374396,0.5454456462247503,1,0.08271538553426927,0.060693280819991265,0.1716029148902764,0,24,0 +m_74,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.057340366146959885,0.06442141126979606,0.02537501938730938,0.015995640110733695,0.8190142455504552,1,0.08271538553426927,0.08041705138052975,0.1716029148902764,0,24,0 +m_74,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1829980328200948,0.09568305301260553,0.09115234083738316,0.026794184899983694,0.40285068031383,1,0.27415037365747796,0.12247723791258923,0.30156541102322576,0,24,0 +m_74,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1829980328200948,0.1209060487475587,0.09115234083738316,0.06951145479378322,0.6038123836174534,1,0.27415037365747796,0.1904175035413419,0.30156541102322576,0,24,0 +m_74,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1829980328200948,0.06065642139595092,0.09115234083738316,0.019825034147525542,0.254221138196679,1,0.27415037365747796,0.08048145554347647,0.30156541102322576,0,24,0 +m_74,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13642161824848792,0.021446279023116983,0.05447820979775522,0.007837213869770453,0.1021842795400224,1,0.19089982804624314,0.029283492892887435,0.2099898108508675,0,24,0 +m_74,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13642161824848792,0.04730046790814705,0.05447820979775522,0.025839965111897515,0.19180001238302608,1,0.19089982804624314,0.07314043302004457,0.2099898108508675,0,24,0 +m_74,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13642161824848792,0.07653652924879384,0.05447820979775522,0.02383644787546433,0.3560126325449076,1,0.19089982804624314,0.10037297712425816,0.2099898108508675,0,24,0 +m_74,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08108753873653285,0.024693271813822564,0.04740718806557209,0.011666713582125576,0.2949156564715565,1,0.12849472680210494,0.03635998539594814,0.14273258363955169,0,24,0 +m_74,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08108753873653285,0.05990311286361183,0.04740718806557209,0.03292502182598276,0.722162061946015,1,0.12849472680210494,0.09282813468959458,0.14273258363955169,0,24,0 +m_74,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08108753873653285,0.10102451587763528,0.04740718806557209,0.02873237834013896,0.7281568942383592,1,0.12849472680210494,0.12975689421777425,0.14273258363955169,0,24,0 +m_74,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05041781856873473,0.020829993072548625,0.02189826228568773,0.00935897403811133,0.2553967746137883,1,0.07231608085442245,0.030188967110659954,0.10761708188437263,0,24,0 +m_74,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05041781856873473,0.04105197918465383,0.02189826228568773,0.015028340715545653,0.7326052729062447,1,0.07231608085442245,0.05608031990019948,0.10761708188437263,0,24,0 +m_74,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05041781856873473,0.08489069138151291,0.02189826228568773,0.012943019422462206,0.2118714690774729,1,0.07231608085442245,0.09783371080397511,0.10761708188437263,0,24,0 +m_74,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08102123797535572,0.07264072452835706,0.024691074617422818,0.029968453095679613,0.8336177465697686,1,0.10571231259277854,0.10260917762403667,0.23094178561184703,0,24,0 +m_74,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08102123797535572,0.13956418670154802,0.024691074617422818,0.07038289112740381,0.4613971322259347,1,0.10571231259277854,0.20994707782895183,0.23094178561184703,0,24,0 +m_74,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08102123797535572,0.028769066334347764,0.024691074617422818,0.02153881881237299,0.14241684124258963,1,0.10571231259277854,0.05030788514672076,0.23094178561184703,0,24,0 +m_74,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06797283289463414,0.03880354725389242,0.022946318299523573,0.01155761954107748,0.29174926669565343,1,0.09091915119415772,0.0503611667949699,0.10471286933148335,0,24,0 +m_74,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06797283289463414,0.049605606906749346,0.022946318299523573,0.01890547916118869,0.5510281692378896,1,0.09091915119415772,0.06851108606793804,0.10471286933148335,0,24,0 +m_74,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06797283289463414,0.0735258866747494,0.022946318299523573,0.021667630899326367,0.8638539147585964,1,0.09091915119415772,0.09519351757407576,0.10471286933148335,0,24,0 +m_75,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03324928077098388,0.021273777805051502,0.015572650893260868,0.006832569396123656,0.5098789886080781,1,0.04882193166424475,0.028106347201175157,0.07782122431589689,0,24,0 +m_75,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03324928077098388,0.02997827197929463,0.015572650893260868,0.007514100390030037,0.8563709095051184,1,0.04882193166424475,0.037492372369324664,0.07782122431589689,0,24,0 +m_75,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03324928077098388,0.06300907713738331,0.015572650893260868,0.007737490422522948,0.13843628327146115,1,0.04882193166424475,0.07074656755990626,0.07782122431589689,0,24,0 +m_75,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.058155979090647035,0.05732029800753299,0.03367564463130526,0.040852270025921934,0.9877278768717598,1,0.0918316237219523,0.09817256803345492,0.10798982483680042,0,24,0 +m_75,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.058155979090647035,0.04250457505255693,0.03367564463130526,0.0176934552323793,0.6921604541104527,1,0.0918316237219523,0.06019803028493623,0.10798982483680042,0,24,0 +m_75,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.058155979090647035,0.0132269818909266,0.03367564463130526,0.006692177319658654,0.24365644723855023,1,0.0918316237219523,0.019919159210585256,0.10798982483680042,0,24,0 +m_75,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03209526316197318,0.049731866552879055,0.010830173454577128,0.018435093112770178,0.4337177397479828,1,0.04292543661655031,0.06816695966564923,0.09886406979379601,0,24,0 +m_75,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03209526316197318,0.04609521115868596,0.010830173454577128,0.02424054770887626,0.6184296721051972,1,0.04292543661655031,0.07033575886756221,0.09886406979379601,0,24,0 +m_75,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03209526316197318,0.06499138500766939,0.010830173454577128,0.024885042077599704,0.26607116852700335,1,0.04292543661655031,0.08987642708526909,0.09886406979379601,0,24,0 +m_75,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.014506362363759883,0.05810503090573297,0.007695622799920415,0.029663734248491794,0.20749914466237646,1,0.0222019851636803,0.08776876515422477,0.09654564166964726,0,24,0 +m_75,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.014506362363759883,0.029488838170038223,0.007695622799920415,0.012504675950640351,0.33718928902880063,1,0.0222019851636803,0.041993514120678574,0.09654564166964726,0,24,0 +m_75,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.014506362363759883,0.05329483061055466,0.007695622799920415,0.024424390939510727,0.18088154419865696,1,0.0222019851636803,0.07771922155006539,0.09654564166964726,0,24,0 +m_75,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.040602977454809265,0.020441289293746,0.010126727346222556,0.006919803106040796,0.13526290080585338,1,0.050729704801031825,0.027361092399786797,0.07234936467582333,0,24,0 +m_75,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.040602977454809265,0.04515504374935627,0.010126727346222556,0.011777578643865924,0.7755960675834244,1,0.050729704801031825,0.05693262239322219,0.07234936467582333,0,24,0 +m_75,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.040602977454809265,0.049818132430174154,0.010126727346222556,0.015954017275119765,0.6381671499671955,1,0.050729704801031825,0.06577214970529392,0.07234936467582333,0,24,0 +m_75,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.025800669838152695,0.051267276711297015,0.006448192647796742,0.03776932327202124,0.534145184027965,1,0.03224886248594944,0.08903659998331825,0.09794025998165008,0,24,0 +m_75,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.025800669838152695,0.03618733177394954,0.006448192647796742,0.017418994705858507,0.5951999820468414,1,0.03224886248594944,0.05360632647980805,0.09794025998165008,0,24,0 +m_75,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.025800669838152695,0.03939420784437453,0.006448192647796742,0.020739581932762152,0.5545938610389252,1,0.03224886248594944,0.06013378977713668,0.09794025998165008,0,24,0 +m_75,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.025695816331535875,0.05590109562434812,0.012504832515921148,0.01687611177368014,0.18348332991900343,1,0.038200648847457025,0.07277720739802826,0.08005492813783109,0,24,0 +m_75,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.025695816331535875,0.04805378014091155,0.012504832515921148,0.012568586001698533,0.2359170028473166,1,0.038200648847457025,0.06062236614261009,0.08005492813783109,0,24,0 +m_75,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.025695816331535875,0.03937468234313949,0.012504832515921148,0.012483448053999997,0.4567510224923911,1,0.038200648847457025,0.05185813039713949,0.08005492813783109,0,24,0 +m_75,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.02726023766493202,0.03897504084639055,0.012735977417317919,0.008100572751751073,0.4587785599286571,1,0.03999621508224994,0.04707561359814162,0.11438790543536084,0,24,0 +m_75,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.02726023766493202,0.01841581227887712,0.012735977417317919,0.00743812406726668,0.565210896696868,1,0.03999621508224994,0.0258539363461438,0.11438790543536084,0,24,0 +m_75,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.02726023766493202,0.0824856711332705,0.012735977417317919,0.021503333807966627,0.05760611411134659,1,0.03999621508224994,0.10398900494123713,0.11438790543536084,0,24,0 +m_76,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.16681581723838015,0.18579887774662576,0.09135991426463541,0.06349035385186139,0.869081429613789,1,0.25817573150301554,0.24928923159848715,0.37572102131501584,0,24,0 +m_76,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.16681581723838015,0.21950274769473435,0.09135991426463541,0.12206181713709821,0.7378383596790377,1,0.25817573150301554,0.34156456483183256,0.37572102131501584,0,24,0 +m_76,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.16681581723838015,0.14982152363534254,0.09135991426463541,0.06487670841934082,0.8834401723182264,1,0.25817573150301554,0.21469823205468336,0.37572102131501584,0,24,0 +m_76,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.24237004038575363,0.3756705330398472,0.0844817933758002,0.15182113871068392,0.46546253100870805,1,0.3268518337615538,0.5274916717505311,0.5802408389255843,0,24,0 +m_76,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.24237004038575363,0.24423046444651308,0.0844817933758002,0.07064134922555829,0.9868638590616622,1,0.3268518337615538,0.3148718136720714,0.5802408389255843,0,24,0 +m_76,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.24237004038575363,0.24318143222146305,0.0844817933758002,0.0833168056989593,0.9946784075435493,1,0.3268518337615538,0.3264982379204223,0.5802408389255843,0,24,0 +m_76,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.19697061469198598,0.2988391534442403,0.09747763514551074,0.05864290193732722,0.4014836737916743,1,0.29444824983749673,0.3574820553815675,0.6090616043791411,0,24,0 +m_76,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.19697061469198598,0.38377455292408047,0.09747763514551074,0.16991781469332057,0.37502764384431764,1,0.29444824983749673,0.553692367617401,0.6090616043791411,0,24,0 +m_76,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.19697061469198598,0.21000769567009359,0.09747763514551074,0.06467887729858923,0.9143149596049843,1,0.29444824983749673,0.2746865729686828,0.6090616043791411,0,24,0 +m_76,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3404703191557905,0.22422851640028466,0.22356896256434175,0.11299277234323114,0.6590008001360732,1,0.5640392817201323,0.3372212887435158,0.6204432098921455,0,24,0 +m_76,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3404703191557905,0.2487344221337621,0.22356896256434175,0.09035074508270421,0.7183970752507961,1,0.5640392817201323,0.3390851672164663,0.6204432098921455,0,24,0 +m_76,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3404703191557905,0.2469313746573931,0.22356896256434175,0.05132213874948273,0.7024102907942621,1,0.5640392817201323,0.29825351340687584,0.6204432098921455,0,24,0 +m_76,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.31116439514593425,0.09326727553808907,0.13294037009959886,0.029571332004010537,0.16525387436577457,1,0.4441047652455331,0.1228386075420996,0.649102000931895,0,24,0 +m_76,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.31116439514593425,0.22589321900682943,0.13294037009959886,0.07248591980098953,0.5892848949697409,1,0.4441047652455331,0.29837913880781897,0.649102000931895,0,24,0 +m_76,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.31116439514593425,0.3762107416746784,0.13294037009959886,0.21388198644522607,0.802424466672255,1,0.4441047652455331,0.5900927281199044,0.649102000931895,0,24,0 +m_76,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13072548643465887,0.08958367193392203,0.039871823920033404,0.04466051224124023,0.5077784304469574,1,0.17059731035469228,0.13424418417516226,0.29892995700292563,0,24,0 +m_76,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13072548643465887,0.14895973364802004,0.039871823920033404,0.053307896343327395,0.7901631382803751,1,0.17059731035469228,0.20226762999134743,0.29892995700292563,0,24,0 +m_76,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13072548643465887,0.1982263958095082,0.039871823920033404,0.07352811055678779,0.4438499615704967,1,0.17059731035469228,0.271754506366296,0.29892995700292563,0,24,0 +m_76,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.19157309931770003,0.10168784538395877,0.12756356790992465,0.043672901350160324,0.5291783284200788,1,0.3191366672276247,0.14536074673411908,0.3510503339503872,0,24,0 +m_76,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.19157309931770003,0.158895571186537,0.12756356790992465,0.06828204480154261,0.8272387377033019,1,0.3191366672276247,0.22717761598807962,0.3510503339503872,0,24,0 +m_76,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.19157309931770003,0.12470506390912368,0.12756356790992465,0.04807399830964433,0.6401529308758993,1,0.3191366672276247,0.17277906221876801,0.3510503339503872,0,24,0 +m_76,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15695207718029924,0.311352861503072,0.050799208933724874,0.11995250446067812,0.27602406557751125,1,0.2077512861140241,0.43130536596375013,0.4744359025601252,0,24,0 +m_76,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.15695207718029924,0.16551334830168998,0.050799208933724874,0.046360699660461586,0.9034190528404134,1,0.2077512861140241,0.21187404796215156,0.4744359025601252,0,24,0 +m_76,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.15695207718029924,0.08793223934630016,0.050799208933724874,0.04063685782065884,0.31482154691348324,1,0.2077512861140241,0.128569097166959,0.4744359025601252,0,24,0 +m_77,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.043422179926086636,0.048389343621540126,0.020642451037720905,0.021917836557269674,0.8726174970663094,1,0.06406463096380755,0.0703071801788098,0.10722224602986676,0,24,0 +m_77,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.043422179926086636,0.012911258819221061,0.020642451037720905,0.006928744478546465,0.22116315157639957,1,0.06406463096380755,0.019840003297767528,0.10722224602986676,0,24,0 +m_77,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.043422179926086636,0.07223439532404934,0.020642451037720905,0.02524037379401134,0.4000553862514701,1,0.06406463096380755,0.09747476911806068,0.10722224602986676,0,24,0 +m_77,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03915671983925143,0.01956187260816226,0.015055375948102483,0.004035265217881337,0.25763575720872345,1,0.05421209578735391,0.0235971378260436,0.05963330536608931,0,24,0 +m_77,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03915671983925143,0.04212965621782083,0.015055375948102483,0.009665747537974079,0.8718989247279073,1,0.05421209578735391,0.05179540375579491,0.05963330536608931,0,24,0 +m_77,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03915671983925143,0.037567179089160296,0.015055375948102483,0.014903505636261824,0.9416679887852955,1,0.05421209578735391,0.05247068472542212,0.05963330536608931,0,24,0 +m_77,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.02883128750841557,0.05331574483709985,0.0136869484778368,0.009979161462158876,0.18799632511149755,1,0.04251823598625237,0.06329490629925873,0.08840747957532558,0,24,0 +m_77,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.02883128750841557,0.05765559181619073,0.0136869484778368,0.022714844161377964,0.31536106190146995,1,0.04251823598625237,0.0803704359775687,0.08840747957532558,0,24,0 +m_77,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.02883128750841557,0.056617284970020165,0.0136869484778368,0.016340091825024234,0.22486272160203075,1,0.04251823598625237,0.0729573767950444,0.08840747957532558,0,24,0 +m_77,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0519304053073034,0.028855220776190293,0.016243136695670467,0.00982915358358151,0.2650484543983627,1,0.06817354200297386,0.0386843743597718,0.10412393929332922,0,24,0 +m_77,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0519304053073034,0.04873955337067234,0.016243136695670467,0.01832224699096186,0.8991832730946328,1,0.06817354200297386,0.0670618003616342,0.10412393929332922,0,24,0 +m_77,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0519304053073034,0.05845037432758304,0.016243136695670467,0.03620775230271624,0.8742289935506924,1,0.06817354200297386,0.09465812663029928,0.10412393929332922,0,24,0 +m_77,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04147828362657421,0.04120179700644311,0.014472127235453845,0.01669128184159855,0.9902654254035911,1,0.05595041086202805,0.05789307884804166,0.10449167400330232,0,24,0 +m_77,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04147828362657421,0.033135101461974514,0.014472127235453845,0.017193052391495982,0.7184167983705392,1,0.05595041086202805,0.050328153853470496,0.10449167400330232,0,24,0 +m_77,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04147828362657421,0.0748913223401549,0.014472127235453845,0.020101108571938114,0.20999562185228893,1,0.05595041086202805,0.09499243091209301,0.10449167400330232,0,24,0 +m_77,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07315016682358773,0.029629947943309382,0.008522893000756765,0.025674597416794533,0.15807713889477618,1,0.08167305982434449,0.055304545360103916,0.11812384427803467,0,24,0 +m_77,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.07315016682358773,0.03579970165434402,0.008522893000756765,0.009804774054606833,0.01683433539094586,0.38718971399175484,0.08167305982434449,0.045604475708950855,0.11812384427803467,0,24,0 +m_77,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07315016682358773,0.07998438486039294,0.008522893000756765,0.02740092811963857,0.8197350131221598,1,0.08167305982434449,0.10738531298003151,0.11812384427803467,0,24,0 +m_77,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.011881105393994229,0.05188568015340674,0.003502615550089463,0.021485596955393562,0.12257717432019039,1,0.015383720944083691,0.0733712771088003,0.13663882496479415,0,24,0 +m_77,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.011881105393994229,0.061281175862744064,0.003502615550089463,0.025232416780944362,0.10804450572406053,1,0.015383720944083691,0.08651359264368842,0.13663882496479415,0,24,0 +m_77,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.011881105393994229,0.10424468255761576,0.003502615550089463,0.019972431046742557,0.005255004195179201,0.12612010068430082,0.015383720944083691,0.12421711360435832,0.13663882496479415,0,24,0 +m_77,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.03709575079862123,0.0692866868592071,0.013928334017556736,0.024654912634647013,0.2889411900477877,1,0.05102408481617796,0.09394159949385411,0.11279723186924129,0,24,0 +m_77,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.03709575079862123,0.020903871291711635,0.013928334017556736,0.007813653560019531,0.34082003517635984,1,0.05102408481617796,0.028717524851731166,0.11279723186924129,0,24,0 +m_77,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.03709575079862123,0.0787769700977455,0.013928334017556736,0.02376596796520113,0.16837319985270202,1,0.05102408481617796,0.10254293806294662,0.11279723186924129,0,24,0 +m_78,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.23271646621469572,0.024161944583967736,0.22996104786412394,0.004733867499292316,0.41579638889803927,1,0.46267751407881963,0.02889581208326005,0.5525381747655739,0,24,0 +m_78,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.23271646621469572,0.2573950288769259,0.22996104786412394,0.2449124027281412,0.943051725852018,1,0.46267751407881963,0.5023074316050671,0.5525381747655739,0,24,0 +m_78,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.23271646621469572,0.007558326087716487,0.22996104786412394,0.00292524596512372,0.3829796659028286,1,0.46267751407881963,0.010483572052840206,0.5525381747655739,0,24,0 +m_78,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.014551967296953886,0.24071182932990287,0.003922951494491876,0.23317893851762864,0.37668091344224663,1,0.018474918791445763,0.4738907678475315,0.5212798446322847,0,24,0 +m_78,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.014551967296953886,0.013002429487264081,0.003922951494491876,0.003718922550483333,0.7802427250067191,1,0.018474918791445763,0.016721352037747415,0.5212798446322847,0,24,0 +m_78,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.014551967296953886,0.011147322815502125,0.003922951494491876,0.004126313697261751,0.5631786850605358,1,0.018474918791445763,0.015273636512763877,0.5212798446322847,0,24,0 +m_78,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.011604200476255854,0.005624681544622885,0.008017570415442783,0.0027354979640116074,0.5122160464656327,1,0.019621770891698635,0.008360179508634493,0.5065826152895269,0,24,0 +m_78,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.011604200476255854,0.23892553815043574,0.008017570415442783,0.2216041121127705,0.36310711751853536,1,0.019621770891698635,0.46052965026320625,0.5065826152895269,0,24,0 +m_78,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.011604200476255854,0.008588430938595848,0.008017570415442783,0.0019526368869621058,0.7313918306222651,1,0.019621770891698635,0.010541067825557953,0.5065826152895269,0,24,0 +m_78,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.017418657465792096,0.02966501578542476,0.004785871866149621,0.010175044966582664,0.31204009188412873,1,0.022204529331941718,0.039840060752007425,0.04382406682720817,0,24,0 +m_78,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.017418657465792096,0.016385078399017743,0.004785871866149621,0.004652465040505203,0.8804202916024071,1,0.022204529331941718,0.021037543439522945,0.04382406682720817,0,24,0 +m_78,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.017418657465792096,0.01175571246222451,0.004785871866149621,0.007250930038752222,0.5320903961266379,1,0.022204529331941718,0.019006642500976733,0.04382406682720817,0,24,0 +m_78,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.011145751089320477,0.005724673238139559,0.004376302578822998,0.001469486498381217,0.28398152044868696,1,0.015522053668143476,0.007194159736520776,0.030148067076334086,0,24,0 +m_78,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.011145751089320477,0.004333790649345581,0.004376302578822998,5.551587197143616e-4,0.18139651968024145,1,0.015522053668143476,0.004888949369059943,0.030148067076334086,0,24,0 +m_78,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.011145751089320477,0.020694162475536498,0.004376302578822998,0.00671317123022176,0.2652949245248901,1,0.015522053668143476,0.027407333705758256,0.030148067076334086,0,24,0 +m_78,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.021973650259355677,0.019807440763176604,0.006545704143694541,0.0053920267352418885,0.803753166758441,1,0.02851935440305022,0.025199467498418494,0.03243583311772094,0,24,0 +m_78,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.021973650259355677,0.02114563876937514,0.006545704143694541,0.008341482246734803,0.9393816661699196,1,0.02851935440305022,0.029487121016109945,0.03243583311772094,0,24,0 +m_78,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.021973650259355677,0.017352464914005217,0.006545704143694541,0.0058667548774903825,0.6106694924074463,1,0.02851935440305022,0.023219219791495598,0.03243583311772094,0,24,0 +m_78,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.010127686826801393,0.015293549177679925,0.0046338105475461685,0.004873104735982317,0.46016195365718926,1,0.014761497374347562,0.020166653913662243,0.022183319305028468,0,24,0 +m_78,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.010127686826801393,0.00942536662748709,0.0046338105475461685,0.0029958342427058885,0.9016586987127343,1,0.014761497374347562,0.012421200870192977,0.022183319305028468,0,24,0 +m_78,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.010127686826801393,0.008084942084538064,0.0046338105475461685,0.0028776696928231355,0.7173599044263768,1,0.014761497374347562,0.010962611777361199,0.022183319305028468,0,24,0 +m_78,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.01146553927641177,0.012701241632475399,0.0030918741656739486,0.003852266092342032,0.8077591856011441,1,0.014557413442085719,0.01655350772481743,0.03090874911049766,0,24,0 +m_78,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.01146553927641177,0.015766339735567552,0.0030918741656739486,0.012332523092157587,0.747424959416868,1,0.014557413442085719,0.02809886282772514,0.03090874911049766,0,24,0 +m_78,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.01146553927641177,0.024057102650163326,0.0030918741656739486,0.003951800559939808,0.03218438278424097,0.7724251868217833,0.014557413442085719,0.028008903210103134,0.03090874911049766,0,24,0 +m_79,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.029315864834175098,0.012115110228032503,0.013651030940597107,0.0029578660053692723,0.28018827870413593,1,0.0429668957747722,0.015072976233401775,0.05467244567874102,0,24,0 +m_79,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.029315864834175098,0.017538717347605665,0.013651030940597107,0.004907134050652709,0.4535355377701886,1,0.0429668957747722,0.022445851398258373,0.05467244567874102,0,24,0 +m_79,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.029315864834175098,0.04221480920794115,0.013651030940597107,0.0074874141363688645,0.4376042638931448,1,0.0429668957747722,0.049702223344310015,0.05467244567874102,0,24,0 +m_79,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.01448806296456584,0.024757843240929223,0.004998237791570115,0.011606612044750294,0.4439512513156384,1,0.019486300756135954,0.03636445528567952,0.04446869278798844,0,24,0 +m_79,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.01448806296456584,0.030280798622369726,0.004998237791570115,0.010145285730347037,0.20363234169769306,1,0.019486300756135954,0.04042608435271676,0.04446869278798844,0,24,0 +m_79,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.01448806296456584,0.02737096651068797,0.004998237791570115,0.011780700060697787,0.34882615001310685,1,0.019486300756135954,0.03915166657138576,0.04446869278798844,0,24,0 +m_79,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06269377904916125,0.015313177158589708,0.035509564774832685,0.0051945415716997765,0.2545350221178026,1,0.09820334382399393,0.020507718730289483,0.10802367820639333,0,24,0 +m_79,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.06269377904916125,0.037998031220233396,0.035509564774832685,0.033264285912371426,0.6255164941674151,1,0.09820334382399393,0.07126231713260482,0.10802367820639333,0,24,0 +m_79,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06269377904916125,0.007353742139148078,0.035509564774832685,0.003888280668286961,0.19461233831073174,1,0.09820334382399393,0.01124202280743504,0.10802367820639333,0,24,0 +m_79,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.037041837912328825,0.03364174361831973,0.019126274073703486,0.011081052306621183,0.8823856299885475,1,0.05616811198603231,0.04472279592494091,0.06178492318463555,0,24,0 +m_79,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.037041837912328825,0.032312977182413626,0.019126274073703486,0.010559123222612675,0.8354363772087358,1,0.05616811198603231,0.0428721004050263,0.06178492318463555,0,24,0 +m_79,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.037041837912328825,0.018395107719813897,0.019126274073703486,0.00708875050239766,0.40180424854726415,1,0.05616811198603231,0.025483858222211556,0.06178492318463555,0,24,0 +m_79,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.013570660502552437,0.027599837537060672,0.00534006218663912,0.009200294923253373,0.22361974709360066,1,0.018910722689191556,0.03680013246031404,0.05696791684784387,0,24,0 +m_79,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.013570660502552437,0.009331734670323074,0.00534006218663912,0.001885606206698242,0.4814586670994263,1,0.018910722689191556,0.011217340877021316,0.05696791684784387,0,24,0 +m_79,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.013570660502552437,0.033653952835363134,0.00534006218663912,0.018135062480858565,0.3298877193529028,1,0.018910722689191556,0.051789015316221695,0.05696791684784387,0,24,0 +m_79,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.02834969042046942,0.01854326266623252,0.009289520678991279,0.006069979951011589,0.4008494312132882,1,0.037639211099460695,0.024613242617244107,0.041403132209406765,0,24,0 +m_79,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.02834969042046942,0.011249665358446329,0.009289520678991279,0.006772913544388491,0.1705499045179066,1,0.037639211099460695,0.018022578902834818,0.041403132209406765,0,24,0 +m_79,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.02834969042046942,0.01868880957618117,0.009289520678991279,0.006325787239493749,0.4127718368531006,1,0.037639211099460695,0.025014596815674917,0.041403132209406765,0,24,0 +m_79,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.010569880484622226,0.015361614625952017,0.005582348488961281,0.006338706658963542,0.5832097290504368,1,0.016152228973583507,0.021700321284915558,0.023870353413407115,0,24,0 +m_79,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.010569880484622226,0.011487111905523836,0.005582348488961281,0.0038840916804302995,0.895705059283924,1,0.016152228973583507,0.015371203585954136,0.023870353413407115,0,24,0 +m_79,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.010569880484622226,0.010239337865982709,0.005582348488961281,0.0039234524122645715,0.962423855102336,1,0.016152228973583507,0.014162790278247281,0.023870353413407115,0,24,0 +m_79,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.007425942068723712,0.008610818515805363,0.002928018301683338,0.003528382232848737,0.8014980403686718,1,0.010353960370407051,0.0121392007486541,0.03357949921095915,0,24,0 +m_79,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.007425942068723712,0.014830500699635133,0.002928018301683338,0.010672494917282695,0.5293847767117057,1,0.010353960370407051,0.02550299561691783,0.03357949921095915,0,24,0 +m_79,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.007425942068723712,0.027009126965526004,0.002928018301683338,0.003517690498982314,0.0017381285104638015,0.04171508425113123,0.010353960370407051,0.03052681746450832,0.03357949921095915,0,24,0 +m_80,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.060281752380572054,0.030472250175838028,0.026523107958561623,0.007242339884085904,0.3318147816388257,1,0.08680486033913368,0.03771459005992393,0.1309446240422678,0,24,0 +m_80,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.060281752380572054,0.019614830366066188,0.026523107958561623,0.010001958021969381,0.20936804690077748,1,0.08680486033913368,0.029616788388035567,0.1309446240422678,0,24,0 +m_80,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.060281752380572054,0.07750593267133048,0.026523107958561623,0.04153463463982205,0.7355084833755176,1,0.08680486033913368,0.11904056731115253,0.1309446240422678,0,24,0 +m_80,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.01533920825579608,0.036731328817723084,0.007010407266334538,0.005547612297965033,0.039000901196000026,0.9360216287040006,0.02234961552213062,0.04227894111568812,0.04650683522725693,0,24,0 +m_80,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.01533920825579608,0.019867675176316674,0.007010407266334538,0.00807800611389904,0.6811486374919535,1,0.02234961552213062,0.027945681290215713,0.04650683522725693,0,24,0 +m_80,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.01533920825579608,0.02942532146845474,0.007010407266334538,0.005304628113811017,0.14242175369965573,1,0.02234961552213062,0.03472994958226576,0.04650683522725693,0,24,0 +m_80,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.01660672396494576,0.019880674178513507,0.0066338435835287405,0.009405030633180246,0.7828142055550824,1,0.0232405675484745,0.029285704811693753,0.08149214173682379,0,24,0 +m_80,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.01660672396494576,0.025325193907854704,0.0066338435835287405,0.01165013408004057,0.5383015540801626,1,0.0232405675484745,0.036975327987895275,0.08149214173682379,0,24,0 +m_80,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.01660672396494576,0.05464595672552893,0.0066338435835287405,0.019437808489765417,0.11243325989596563,1,0.0232405675484745,0.07408376521529435,0.08149214173682379,0,24,0 +m_80,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.05051649237098532,0.030855081505384258,0.019871683766864892,0.010765068499604825,0.4164225928856003,1,0.07038817613785021,0.04162015000498909,0.07754072989716215,0,24,0 +m_80,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.05051649237098532,0.04479181471401772,0.019871683766864892,0.025699757919766048,0.864100645610883,1,0.07038817613785021,0.07049157263378376,0.07754072989716215,0,24,0 +m_80,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.05051649237098532,0.039616822358989966,0.019871683766864892,0.009838980006711285,0.6407365895277244,1,0.07038817613785021,0.049455802365701254,0.07754072989716215,0,24,0 +m_80,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.026790862295424118,0.01698366482520434,0.009131618776238332,0.004832778021101028,0.37171092010621243,1,0.035922481071662446,0.02181644284630537,0.042992917645466665,0,24,0 +m_80,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.026790862295424118,0.02808658531943305,0.009131618776238332,0.010997885267354821,0.9296254889312796,1,0.035922481071662446,0.03908447058678787,0.042992917645466665,0,24,0 +m_80,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.026790862295424118,0.030872986624638443,0.009131618776238332,0.002756265164058275,0.6838502501475792,1,0.035922481071662446,0.03362925178869672,0.042992917645466665,0,24,0 +m_80,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.036675484308825355,0.029091324649059985,0.007758578456910189,0.014346397942025677,0.6548055836808884,1,0.04443406276573554,0.043437722591085665,0.0488774690423091,0,24,0 +m_80,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.036675484308825355,0.03054617449596823,0.007758578456910189,0.012349792712345304,0.6848248223466797,1,0.04443406276573554,0.04289596720831353,0.0488774690423091,0,24,0 +m_80,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.036675484308825355,0.015962006491759235,0.007758578456910189,0.005514338176308517,0.057458014911309044,1,0.04443406276573554,0.021476344668067752,0.0488774690423091,0,24,0 +m_80,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.02586846368560658,0.021368225423053167,0.014570261931932532,0.00962025240418544,0.802617845234195,1,0.04043872561753911,0.030988477827238604,0.04448259817929303,0,24,0 +m_80,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.02586846368560658,0.024842722055574622,0.014570261931932532,0.005973760790477913,0.9499834188132069,1,0.04043872561753911,0.030816482846052536,0.04448259817929303,0,24,0 +m_80,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.02586846368560658,0.027452127876667287,0.014570261931932532,0.003891166644533777,0.9199581530814303,1,0.04043872561753911,0.03134329452120106,0.04448259817929303,0,24,0 +m_80,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.03168314924999005,0.030253347297190647,0.01043447981629216,0.008483329731616538,0.9175158467693878,1,0.04211762906628221,0.03873667702880718,0.0650920136440707,0,24,0 +m_80,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.03168314924999005,0.022951540644005803,0.01043447981629216,0.005991920421066017,0.4887897564938405,1,0.04211762906628221,0.02894346106507182,0.0650920136440707,0,24,0 +m_80,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.03168314924999005,0.04364703573574732,0.01043447981629216,0.015527522122498777,0.5388677767784873,1,0.04211762906628221,0.059174557858246095,0.0650920136440707,0,24,0 +m_81,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07815593812816166,0.08118521701535315,0.024997300848133324,0.018962872820417656,0.9255053188063785,1,0.10315323897629498,0.10014808983577081,0.2825240552017299,0,24,0 +m_81,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07815593812816166,0.206481553016014,0.024997300848133324,0.050358497167376795,0.05531262204167125,1,0.10315323897629498,0.2568400501833908,0.2825240552017299,0,24,0 +m_81,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07815593812816166,0.045145480655478964,0.024997300848133324,0.014918152830028439,0.2958611102122239,1,0.10315323897629498,0.0600636334855074,0.2825240552017299,0,24,0 +m_81,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12116204688758787,0.12709103727669083,0.037861037402360485,0.08182039170992558,0.949392489031796,1,0.15902308428994835,0.2089114289866164,0.22980257188527806,0,24,0 +m_81,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12116204688758787,0.1448103895232482,0.037861037402360485,0.04589371182979748,0.6996601193232225,1,0.15902308428994835,0.1907041013530457,0.22980257188527806,0,24,0 +m_81,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12116204688758787,0.13181701952158043,0.037861037402360485,0.026005227773514307,0.8218281657018164,1,0.15902308428994835,0.15782224729509473,0.22980257188527806,0,24,0 +m_81,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.15779102314103124,0.12048320019923131,0.12077360598182325,0.04093841214447935,0.7817962798975464,1,0.2785646291228545,0.16142161234371066,0.30642109203514,0,24,0 +m_81,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.15779102314103124,0.16557432402680536,0.12077360598182325,0.10036703359179376,0.961724542007336,1,0.2785646291228545,0.2659413576185991,0.30642109203514,0,24,0 +m_81,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.15779102314103124,0.05517166839737775,0.12077360598182325,0.02732794697932839,0.4497550156138029,1,0.2785646291228545,0.08249961537670614,0.30642109203514,0,24,0 +m_81,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.23817581914499622,0.07791342415022173,0.08556444664537607,0.030346185542703824,0.13771239017046924,1,0.3237402657903723,0.10825960969292556,0.35611429236940956,0,24,0 +m_81,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.23817581914499622,0.11538685683061733,0.08556444664537607,0.034073188184315255,0.23725092949164944,1,0.3237402657903723,0.1494600450149326,0.35611429236940956,0,24,0 +m_81,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.23817581914499622,0.1296973544484125,0.08556444664537607,0.033660727277721986,0.2889167625370364,1,0.3237402657903723,0.16335808172613447,0.35611429236940956,0,24,0 +m_81,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07681302257466527,0.035491298819860795,0.03296268608977985,0.010456761851876703,0.2772353634839674,1,0.10977570866444511,0.0459480606717375,0.12075327953088963,0,24,0 +m_81,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07681302257466527,0.03984741132631816,0.03296268608977985,0.014786568161513901,0.34057605919399603,1,0.10977570866444511,0.05463397948783206,0.12075327953088963,0,24,0 +m_81,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07681302257466527,0.07483195007446031,0.03296268608977985,0.030933937275143753,0.9659103277445072,1,0.10977570866444511,0.10576588734960406,0.12075327953088963,0,24,0 +m_81,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.03914278161082918,0.02062048266711051,0.0076782876770799015,0.010540052056565982,0.18869192390650655,1,0.04682106928790908,0.031160534723676494,0.06794518277796599,0,24,0 +m_81,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.03914278161082918,0.04602477626226875,0.0076782876770799015,0.01574357171770033,0.7056933002756984,1,0.04682106928790908,0.06176834797996908,0.06794518277796599,0,24,0 +m_81,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.03914278161082918,0.03943023175345339,0.0076782876770799015,0.007516984030461267,0.9791846687650421,1,0.04682106928790908,0.04694721578391466,0.06794518277796599,0,24,0 +m_81,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.024778219267859836,0.04175296662888939,0.01192472611905764,0.012420397477331195,0.34749022123774975,1,0.03670294538691748,0.05417336410622058,0.08874637215051212,0,24,0 +m_81,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.024778219267859836,0.05637092442201815,0.01192472611905764,0.024307595714811045,0.28008913131053176,1,0.03670294538691748,0.08067852013682919,0.08874637215051212,0,24,0 +m_81,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.024778219267859836,0.023399271361698986,0.01192472611905764,0.010490214538557757,0.9325530814318315,1,0.03670294538691748,0.03388948590025674,0.08874637215051212,0,24,0 +m_81,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04441199507293544,0.054183268422457465,0.015218762356639654,0.025196861088138744,0.7482357737055727,1,0.05963075742957509,0.07938012951059621,0.08731814246165584,0,24,0 +m_81,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04441199507293544,0.024875085069699116,0.015218762356639654,0.006640466718798994,0.27868486691532957,1,0.05963075742957509,0.03151555178849811,0.08731814246165584,0,24,0 +m_81,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04441199507293544,0.04761867987872962,0.015218762356639654,0.015034913689990702,0.883828587782237,1,0.05963075742957509,0.06265359356872033,0.08731814246165584,0,24,0 +m_82,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12935869719404192,0.1510125419338971,0.049509489946335104,0.03581200133423855,0.7326701524372491,1,0.17886818714037703,0.18682454326813563,0.20550699759494923,0,24,0 +m_82,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12935869719404192,0.0666257106230268,0.049509489946335104,0.027688922381562127,0.30864375618425305,1,0.17886818714037703,0.09431463300458892,0.20550699759494923,0,24,0 +m_82,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12935869719404192,0.10422542313250431,0.049509489946335104,0.04411248434291086,0.7139032143173235,1,0.17886818714037703,0.14833790747541517,0.20550699759494923,0,24,0 +m_82,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.05065096542065454,0.08648720967494457,0.01953060541445772,0.032171500944374765,0.36807972035722825,1,0.07018157083511226,0.11865871061931933,0.13052458168125128,0,24,0 +m_82,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.05065096542065454,0.051847445404152724,0.01953060541445772,0.02179778157993096,0.9682050886923235,1,0.07018157083511226,0.07364522698408368,0.13052458168125128,0,24,0 +m_82,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.05065096542065454,0.04308491160124187,0.01953060541445772,0.014457877592959556,0.7624532030223572,1,0.07018157083511226,0.05754278919420143,0.13052458168125128,0,24,0 +m_82,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.22520750187675914,0.07004535677515318,0.06736629817467595,0.022952387522088405,0.0818729950260522,1,0.2925738000514351,0.09299774429724159,0.3218311800565786,0,24,0 +m_82,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.22520750187675914,0.10515330501564621,0.06736629817467595,0.03892020000212136,0.1706661056082049,1,0.2925738000514351,0.14407350501776756,0.3218311800565786,0,24,0 +m_82,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.22520750187675914,0.09471877643801034,0.06736629817467595,0.03573033558388211,0.13647576985420748,1,0.2925738000514351,0.13044911202189247,0.3218311800565786,0,24,0 +m_82,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07072073096059181,0.040341678673743386,0.023956670237415954,0.008900112677140226,0.28691890465062225,1,0.09467740119800777,0.049241791350883614,0.10414514131780855,0,24,0 +m_82,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07072073096059181,0.06321312339194278,0.023956670237415954,0.02820170866170417,0.8437458024740706,1,0.09467740119800777,0.09141483205364695,0.10414514131780855,0,24,0 +m_82,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07072073096059181,0.06189239058691361,0.023956670237415954,0.016520333511631246,0.7699859606462257,1,0.09467740119800777,0.07841272409854486,0.10414514131780855,0,24,0 +m_82,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.14314838529615667,0.10810041823482797,0.04021776020408765,0.03262132286209878,0.5145187219717133,1,0.18336614550024433,0.14072174109692676,0.29211481515869125,0,24,0 +m_82,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14314838529615667,0.08546546643525439,0.04021776020408765,0.02155896348437053,0.2433290443041666,1,0.18336614550024433,0.10702442991962492,0.29211481515869125,0,24,0 +m_82,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14314838529615667,0.19393293517856058,0.04021776020408765,0.07162598769297693,0.5538926429270081,1,0.18336614550024433,0.2655589228715375,0.29211481515869125,0,24,0 +m_82,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13836553816848784,0.16357948753604554,0.024568304420365485,0.04864209365041036,0.6568959483593926,1,0.16293384258885332,0.2122215811864559,0.2334437393051015,0,24,0 +m_82,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13836553816848784,0.11251426483748661,0.024568304420365485,0.03617111067391479,0.5692440699765824,1,0.16293384258885332,0.1486853755114014,0.2334437393051015,0,24,0 +m_82,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13836553816848784,0.07513473041002738,0.024568304420365485,0.024426519986841675,0.09795493101495306,1,0.16293384258885332,0.09956125039686906,0.2334437393051015,0,24,0 +m_82,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.19396426580695833,0.11836338984540055,0.08500495450444426,0.029050768643453868,0.43151325850504196,1,0.2789692203114026,0.14741415848885442,0.4061002662711949,0,24,0 +m_82,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.19396426580695833,0.27028383565436026,0.08500495450444426,0.09889822459218053,0.5716494750365929,1,0.2789692203114026,0.36918206024654077,0.4061002662711949,0,24,0 +m_82,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.19396426580695833,0.13752568903056783,0.08500495450444426,0.04390585425581773,0.5726141476863023,1,0.2789692203114026,0.18143154328638555,0.4061002662711949,0,24,0 +m_82,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13903543379077835,0.087935978385552,0.06549428836237549,0.027251391100651452,0.4957359657909336,1,0.20452972215315385,0.11518736948620345,0.25548780584977143,0,24,0 +m_82,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13903543379077835,0.1314917443427035,0.06549428836237549,0.05914634124737288,0.9335823044535777,1,0.20452972215315385,0.1906380855900764,0.25548780584977143,0,24,0 +m_82,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13903543379077835,0.1830059754401748,0.06549428836237549,0.04925566624143557,0.6041873892340182,1,0.20452972215315385,0.23226164168161037,0.25548780584977143,0,24,0 +m_83,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12344679193154873,0.04981432304429786,0.04165573859457676,0.021872290140276345,0.16752141671358803,1,0.1651025305261255,0.0716866131845742,0.18161278357873806,0,24,0 +m_83,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12344679193154873,0.056925452345565564,0.04165573859457676,0.020058892530479624,0.20173702348636322,1,0.1651025305261255,0.07698434487604519,0.18161278357873806,0,24,0 +m_83,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12344679193154873,0.04807124327054028,0.04165573859457676,0.02035688055776833,0.15621604679523454,1,0.1651025305261255,0.06842812382830861,0.18161278357873806,0,24,0 +m_83,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1263772350332554,0.04907870920175713,0.04174052785453706,0.01619684401343524,0.1313918406250205,1,0.16811776288779245,0.06527555321519238,0.2551209622389962,0,24,0 +m_83,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1263772350332554,0.15242543206097828,0.04174052785453706,0.07950271542901827,0.7795434011394143,1,0.16811776288779245,0.23192814748999654,0.2551209622389962,0,24,0 +m_83,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1263772350332554,0.19006636349128772,0.04174052785453706,0.04099457164126283,0.3018727028760104,1,0.16811776288779245,0.23106093513255055,0.2551209622389962,0,24,0 +m_83,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.24406925558945872,0.0674712699237811,0.12296054068459072,0.023438769966648815,0.2265056250133196,1,0.3670297962740494,0.09091003989042991,0.4037327759014544,0,24,0 +m_83,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.24406925558945872,0.17626255385693454,0.12296054068459072,0.05968988883402859,0.6381089083275686,1,0.3670297962740494,0.23595244269096313,0.4037327759014544,0,24,0 +m_83,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.24406925558945872,0.14642196605976224,0.12296054068459072,0.04453377721801706,0.48855289864833484,1,0.3670297962740494,0.1909557432777793,0.4037327759014544,0,24,0 +m_83,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17773604797251727,0.0707773113411454,0.057683947919554224,0.030085651510102885,0.15037648150067487,1,0.2354199958920715,0.10086296285124828,0.2589619954812787,0,24,0 +m_83,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17773604797251727,0.0965934793463578,0.057683947919554224,0.006218215024971726,0.232960700241065,1,0.2354199958920715,0.10281169437132953,0.2589619954812787,0,24,0 +m_83,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17773604797251727,0.1121746296625082,0.057683947919554224,0.043119267191254966,0.38998809403851975,1,0.2354199958920715,0.15529389685376316,0.2589619954812787,0,24,0 +m_83,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09010884469718412,0.0664561961724679,0.04408463224730141,0.032284007993636635,0.6751185577282064,1,0.13419347694448552,0.09874020416610453,0.14761282463893408,0,24,0 +m_83,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09010884469718412,0.04148196955388572,0.04408463224730141,0.012658767243313754,0.3310666601771242,1,0.13419347694448552,0.054140736797199475,0.14761282463893408,0,24,0 +m_83,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09010884469718412,0.0762627914113146,0.04408463224730141,0.035163703890538085,0.8112478997312792,1,0.13419347694448552,0.1114264953018527,0.14761282463893408,0,24,0 +m_83,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09374040706385152,0.076713378802337015,0.04345269301629808,0.02196194971811116,0.7362931579214325,1,0.1371931000801496,0.09867532852044818,0.15949377143189786,0,24,0 +m_83,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09374040706385152,0.07695445913068107,0.04345269301629808,0.026597638933696228,0.7499680587180824,1,0.1371931000801496,0.10355209806437729,0.15949377143189786,0,24,0 +m_83,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09374040706385152,0.1123394978787069,0.04345269301629808,0.032654839786654774,0.7398380119184792,1,0.1371931000801496,0.14499433766536168,0.15949377143189786,0,24,0 +m_83,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.189102072027277,0.05978010885843429,0.05716583785745009,0.021087966298473183,0.07558431784265805,1,0.24626790988472708,0.08086807515690747,0.2708947008731998,0,24,0 +m_83,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.189102072027277,0.1280177589576065,0.05716583785745009,0.04572056906370183,0.4244148073570536,1,0.24626790988472708,0.17373832802130834,0.2708947008731998,0,24,0 +m_83,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.189102072027277,0.1480086459284128,0.05716583785745009,0.05549532375252206,0.6172275009640138,1,0.24626790988472708,0.20350396968093487,0.2708947008731998,0,24,0 +m_83,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.19510001304728575,0.10709081045807693,0.043454206409766834,0.028221719602756132,0.12527389821347001,1,0.23855421945705257,0.13531253006083307,0.26240964140275785,0,24,0 +m_83,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.19510001304728575,0.1478123878513331,0.043454206409766834,0.027013985894583852,0.38128234510884185,1,0.23855421945705257,0.17482637374591695,0.26240964140275785,0,24,0 +m_83,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.19510001304728575,0.13054956408544874,0.043454206409766834,0.06545985207194435,0.4332848978931696,1,0.23855421945705257,0.1960094161573931,0.26240964140275785,0,24,0 +m_84,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.48045431065025423,0.08087030399150841,0.14186513214909358,0.04462214725887828,0.045388001315690533,1,0.6223194427993478,0.1254924512503867,0.6845513870792826,0,24,0 +m_84,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.48045431065025423,0.4323054844173908,0.14186513214909358,0.1430940206250573,0.8165497082144897,1,0.6223194427993478,0.5753995050424481,0.6845513870792826,0,24,0 +m_84,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.48045431065025423,0.18331145633456,0.14186513214909358,0.07414399159408776,0.11185116602339437,1,0.6223194427993478,0.2574554479286478,0.6845513870792826,0,24,0 +m_84,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1273347533495849,0.3017132980752985,0.0457075746165641,0.11043910453822108,0.1900483002238536,1,0.17304232796614902,0.4121524026135196,0.47182307005108143,0,24,0 +m_84,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1273347533495849,0.14321018004268327,0.0457075746165641,0.061010849364846104,0.8395399263382399,1,0.17304232796614902,0.20422102940752937,0.47182307005108143,0,24,0 +m_84,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1273347533495849,0.3131676541030562,0.0457075746165641,0.11576240957974511,0.1821203679069578,1,0.17304232796614902,0.4289300636828013,0.47182307005108143,0,24,0 +m_84,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.41956339750584953,0.16082342539081074,0.25427811020424934,0.10482581129992534,0.3873337611537862,1,0.6738415077100989,0.2656492366907361,0.7412256584811088,0,24,0 +m_84,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.41956339750584953,0.21932190163205156,0.25427811020424934,0.08862101117260139,0.4908226725166804,1,0.6738415077100989,0.30794291280465297,0.7412256584811088,0,24,0 +m_84,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.41956339750584953,0.1671789694436432,0.25427811020424934,0.056657898254141706,0.3828517969583416,1,0.6738415077100989,0.22383686769778488,0.7412256584811088,0,24,0 +m_84,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2961363323377147,0.1356699655672494,0.09051353579269711,0.056532998412903865,0.17704770146307997,1,0.3866498681304118,0.19220296398015324,0.425314854943453,0,24,0 +m_84,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2961363323377147,0.19355566970111782,0.09051353579269711,0.03887198477868932,0.3415893718531562,1,0.3866498681304118,0.23242765447980712,0.425314854943453,0,24,0 +m_84,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2961363323377147,0.17800860211613748,0.09051353579269711,0.07847360683585783,0.3514744927701282,1,0.3866498681304118,0.2564822089519953,0.425314854943453,0,24,0 +m_84,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.06382470604568329,0.07562709638706473,0.025608858777094026,0.029555386853206193,0.7691110306719287,1,0.08943356482277731,0.10518248324027092,0.11570073156429803,0,24,0 +m_84,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.06382470604568329,0.06983209162378934,0.025608858777094026,0.032852350156671636,0.88835988113161,1,0.08943356482277731,0.10268444178046097,0.11570073156429803,0,24,0 +m_84,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.06382470604568329,0.03877080558816829,0.025608858777094026,0.023860493231966165,0.49057948698886233,1,0.08943356482277731,0.06263129882013446,0.11570073156429803,0,24,0 +m_84,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.41035341537363274,0.19862080922575828,0.08977095673542859,0.045093313737073794,0.07105398489449402,1,0.5001243721090614,0.24371412296283207,0.5501368093199676,0,24,0 +m_84,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.41035341537363274,0.3149337786024871,0.08977095673542859,0.10203845869486387,0.49888912742287894,1,0.5001243721090614,0.416972237297351,0.5501368093199676,0,24,0 +m_84,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.41035341537363274,0.19939470757938796,0.08977095673542859,0.11344011763335678,0.17702419879618686,1,0.5001243721090614,0.31283482521274475,0.5501368093199676,0,24,0 +m_84,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16295815741145758,0.07917591797693246,0.060086614001710954,0.04719940565225292,0.2999577412260673,1,0.22304477141316853,0.12637532362918538,0.2831799171453731,0,24,0 +m_84,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16295815741145758,0.10030458516079103,0.060086614001710954,0.03820672953416048,0.4031711294644734,1,0.22304477141316853,0.1385113146949515,0.2831799171453731,0,24,0 +m_84,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16295815741145758,0.20706784548569482,0.060086614001710954,0.05036844282828069,0.58647720763275,1,0.22304477141316853,0.2574362883139755,0.2831799171453731,0,24,0 +m_84,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08159167142636174,0.059338422987487816,0.029035410156919367,0.022587276990992805,0.5594993814417231,1,0.1106270815832811,0.08192569997848062,0.1295961276667225,0,24,0 +m_84,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08159167142636174,0.04786816800658622,0.029035410156919367,0.026203766048394767,0.40896019532326866,1,0.1106270815832811,0.07407193405498098,0.1295961276667225,0,24,0 +m_84,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08159167142636174,0.10033925504742469,0.029035410156919367,0.01747540646777757,0.594872871758285,1,0.1106270815832811,0.11781466151520226,0.1295961276667225,0,24,0 +m_85,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0645788517075799,0.02637115202239119,0.031210392817504044,0.007323907515036346,0.2930891571989065,1,0.09578924452508394,0.03369505953742754,0.15193847386787507,0,24,0 +m_85,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0645788517075799,0.07033627994463006,0.031210392817504044,0.045521131491326625,0.9193486827054429,1,0.09578924452508394,0.11585741143595668,0.15193847386787507,0,24,0 +m_85,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0645788517075799,0.09772610889840945,0.031210392817504044,0.04039977643602241,0.5326873346763507,1,0.09578924452508394,0.13812588533443187,0.15193847386787507,0,24,0 +m_85,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.02293880276609735,0.05281752357277484,0.00816792139610665,0.011027550261599827,0.056737530932602205,1,0.031106724162204002,0.06384507383437467,0.16594674058650216,0,24,0 +m_85,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.02293880276609735,0.08443344014604186,0.00816792139610665,0.041449904212891645,0.2011822871768085,1,0.031106724162204002,0.1258833443589335,0.16594674058650216,0,24,0 +m_85,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.02293880276609735,0.10461546408857121,0.00816792139610665,0.04624520917188528,0.13903635545091828,1,0.031106724162204002,0.1508606732604565,0.16594674058650216,0,24,0 +m_85,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03730009211899539,0.046056659628102646,0.017310553358594757,0.01887906949501533,0.7403028067291162,1,0.05461064547759015,0.06493572912311797,0.12349717783772346,0,24,0 +m_85,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03730009211899539,0.07747589733716316,0.017310553358594757,0.03479426433349451,0.3419590338807255,1,0.05461064547759015,0.11227016167065768,0.12349717783772346,0,24,0 +m_85,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03730009211899539,0.023006027467292262,0.017310553358594757,0.009249309352753846,0.4929878115434029,1,0.05461064547759015,0.03225533682004611,0.12349717783772346,0,24,0 +m_85,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.040431097076059075,0.07026579312554453,0.018509839142993326,0.02745168240436039,0.3926135800820282,1,0.0589409362190524,0.09771747552990492,0.10748922308289542,0,24,0 +m_85,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.040431097076059075,0.055127683448953545,0.018509839142993326,0.018423908406445692,0.587536938080528,1,0.0589409362190524,0.07355159185539924,0.10748922308289542,0,24,0 +m_85,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.040431097076059075,0.045441473474704584,0.018509839142993326,0.0070392577653998626,0.8100434046433365,1,0.0589409362190524,0.052480731240104446,0.10748922308289542,0,24,0 +m_85,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05052473405215648,0.0389172938927301,0.025988843567657068,0.007868756457777144,0.6841766856285314,1,0.07651357761981355,0.046786050350507244,0.15899702553718006,0,24,0 +m_85,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05052473405215648,0.03816729286269904,0.025988843567657068,0.015571744635507192,0.693829844154789,1,0.07651357761981355,0.05373903749820624,0.15899702553718006,0,24,0 +m_85,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05052473405215648,0.1036635038973428,0.025988843567657068,0.040879246591002706,0.30284210469488954,1,0.07651357761981355,0.1445427504883455,0.15899702553718006,0,24,0 +m_85,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10281113172172922,0.08396062153737027,0.023870079011854426,0.02452558155155331,0.5938719510190298,1,0.12668121073358365,0.10848620308892358,0.13934933180694203,0,24,0 +m_85,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10281113172172922,0.09743253002024359,0.023870079011854426,0.014508710614087246,0.8519667780605361,1,0.12668121073358365,0.11194124063433084,0.13934933180694203,0,24,0 +m_85,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10281113172172922,0.07409772624229076,0.023870079011854426,0.03489461708264574,0.5144256149105647,1,0.12668121073358365,0.1089923433249365,0.13934933180694203,0,24,0 +m_85,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.021653142862792112,0.018776464082502182,0.00902794794034845,0.004780181958394359,0.7857635690239506,1,0.030681090803140562,0.02355664604089654,0.05464642294552379,0,24,0 +m_85,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.021653142862792112,0.039557971487999,0.00902794794034845,0.010120594826113535,0.21655408655574482,1,0.030681090803140562,0.049678566314112535,0.05464642294552379,0,24,0 +m_85,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.021653142862792112,0.02444767859255766,0.00902794794034845,0.010509144695385289,0.8442805688948071,1,0.030681090803140562,0.034956823287942945,0.05464642294552379,0,24,0 +m_85,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.02726534313306354,0.03303064142146517,0.009842995611787763,0.006939476248770327,0.6435752753651187,1,0.0371083387448513,0.03997011767023549,0.05711273557632699,0,24,0 +m_85,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.02726534313306354,0.027485253083748534,0.009842995611787763,0.011022417734986538,0.9884232695127937,1,0.0371083387448513,0.038507670818735074,0.05711273557632699,0,24,0 +m_85,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.02726534313306354,0.03947700200534077,0.009842995611787763,0.012443666700411039,0.4602082527494178,1,0.0371083387448513,0.05192066870575181,0.05711273557632699,0,24,0 +m_86,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08051450134771088,0.046985819536129535,0.025428976339583017,0.0158953139950977,0.3009793831111797,1,0.1059434776872939,0.06288113353122723,0.2179841509000128,0,24,0 +m_86,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08051450134771088,0.1266942311244069,0.025428976339583017,0.03677990636156623,0.33021432065928713,1,0.1059434776872939,0.16347413748597311,0.2179841509000128,0,24,0 +m_86,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08051450134771088,0.12710141617515794,0.025428976339583017,0.07106599373394458,0.5589433523054478,1,0.1059434776872939,0.19816740990910253,0.2179841509000128,0,24,0 +m_86,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07372605469077802,0.08542132981880697,0.018160407409061632,0.015606190077712141,0.6360147931659985,1,0.09188646209983965,0.10102751989651912,0.1473656513166248,0,24,0 +m_86,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07372605469077802,0.08932660903357707,0.018160407409061632,0.0354501628950452,0.7062593765464875,1,0.09188646209983965,0.12477677192862227,0.1473656513166248,0,24,0 +m_86,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07372605469077802,0.09723211808155141,0.018160407409061632,0.03673665584265292,0.5834605918531084,1,0.09188646209983965,0.13396877392420434,0.1473656513166248,0,24,0 +m_86,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12456847288138366,0.08295828343571277,0.07288883336016728,0.043240271015590206,0.6392229131225748,1,0.19745730624155095,0.12619855445130296,0.21720303686570605,0,24,0 +m_86,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12456847288138366,0.052627811073572686,0.07288883336016728,0.021766704596159692,0.3902568049269961,1,0.19745730624155095,0.07439451566973238,0.21720303686570605,0,24,0 +m_86,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12456847288138366,0.0631457839110418,0.07288883336016728,0.01538520853202122,0.45239363353996037,1,0.19745730624155095,0.07853099244306301,0.21720303686570605,0,24,0 +m_86,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10283015716026486,0.07225385753765612,0.06870099650832272,0.02125963582688769,0.6892144782696139,1,0.17153115366858757,0.09351349336454381,0.18868426903544633,0,24,0 +m_86,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10283015716026486,0.0654871351764208,0.06870099650832272,0.03609511424773705,0.6470548069835609,1,0.17153115366858757,0.10158224942415785,0.18868426903544633,0,24,0 +m_86,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10283015716026486,0.07730779609285054,0.06870099650832272,0.02714724567810747,0.7431460610560783,1,0.17153115366858757,0.10445504177095802,0.18868426903544633,0,24,0 +m_86,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.070785097842,0.06849446214457518,0.015980630835117464,0.024920618743462873,0.9401122357599638,1,0.08676572867711746,0.09341508088803804,0.18453565857453572,0,24,0 +m_86,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.070785097842,0.07082342174265206,0.015980630835117464,0.03337293434232331,0.9992018037452111,1,0.08676572867711746,0.10419635608497538,0.18453565857453572,0,24,0 +m_86,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.070785097842,0.12065176332516699,0.015980630835117464,0.04710792628804729,0.35400680454038663,1,0.08676572867711746,0.16775968961321427,0.18453565857453572,0,24,0 +m_86,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08332033991327314,0.10778227086011934,0.021852076269839652,0.035062320742622596,0.5694250010394852,1,0.1051724161831128,0.14284459160274193,0.15712905076301614,0,24,0 +m_86,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08332033991327314,0.07573188442200769,0.021852076269839652,0.033872917403297294,0.8550715965924931,1,0.1051724161831128,0.10960480182530499,0.15712905076301614,0,24,0 +m_86,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08332033991327314,0.06575631513414064,0.021852076269839652,0.03994071993510616,0.7100313049827672,1,0.1051724161831128,0.1056970350692468,0.15712905076301614,0,24,0 +m_86,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09608617515799549,0.060061587587083874,0.029065967346509482,0.02371166879083955,0.36040088565251915,1,0.12515214250450496,0.08377325637792342,0.21794126265080316,0,24,0 +m_86,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09608617515799549,0.15085856957007585,0.029065967346509482,0.04726985102156336,0.3514904520823139,1,0.12515214250450496,0.1981284205916392,0.21794126265080316,0,24,0 +m_86,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09608617515799549,0.0640449259845064,0.029065967346509482,0.018984119035257124,0.38117570530130807,1,0.12515214250450496,0.08302904501976352,0.21794126265080316,0,24,0 +m_86,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10162968130868173,0.07950515765344957,0.025753741656861822,0.032865370699001015,0.6084070088316729,1,0.12738342296554356,0.11237052835245058,0.14012176526209794,0,24,0 +m_86,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.10162968130868173,0.03139458679222932,0.025753741656861822,0.0163893021489728,0.048638016516151406,1,0.12738342296554356,0.04778388894120212,0.14012176526209794,0,24,0 +m_86,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10162968130868173,0.053395430225142405,0.025753741656861822,0.016628899981920058,0.15183583919697793,1,0.12738342296554356,0.07002433020706246,0.14012176526209794,0,24,0 +m_87,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1027861075458519,0.07960171831205669,0.032198304598947465,0.03361672683032148,0.6304372437911333,1,0.13498441214479937,0.11321844514237817,0.14848285335927933,0,24,0 +m_87,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1027861075458519,0.08634685037338352,0.032198304598947465,0.03059336651598412,0.7200700560156457,1,0.13498441214479937,0.11694021688936765,0.14848285335927933,0,24,0 +m_87,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1027861075458519,0.058568121702715414,0.032198304598947465,0.02341912157676107,0.30046239034339667,1,0.13498441214479937,0.08198724327947648,0.14848285335927933,0,24,0 +m_87,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.05894356195597431,0.09575234042705039,0.01822745245739623,0.03011357433935947,0.32544068243106233,1,0.07717101441337054,0.12586591476640985,0.13845250624305083,0,24,0 +m_87,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.05894356195597431,0.045393599297465746,0.01822745245739623,0.014333705252727808,0.5726388343011612,1,0.07717101441337054,0.05972730455019355,0.13845250624305083,0,24,0 +m_87,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.05894356195597431,0.055244508132264857,0.01822745245739623,0.020334594280006904,0.8949706233621606,1,0.07717101441337054,0.07557910241227175,0.13845250624305083,0,24,0 +m_87,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08662806906697532,0.05377356051249205,0.0399670742665705,0.029653367883676437,0.528294536023769,1,0.12659514333354582,0.08342692839616848,0.13925465766690043,0,24,0 +m_87,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08662806906697532,0.0482173752606168,0.0399670742665705,0.016338093698316944,0.4122315054993114,1,0.12659514333354582,0.06455546895893374,0.13925465766690043,0,24,0 +m_87,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08662806906697532,0.05100197224280678,0.0399670742665705,0.011377118585046506,0.4332152059654589,1,0.12659514333354582,0.062379090827853284,0.13925465766690043,0,24,0 +m_87,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07931388080016291,0.19072536399278342,0.027494103849534192,0.13699847568681153,0.45886921612204373,1,0.1068079846496971,0.32772383967959495,0.36049622364755446,0,24,0 +m_87,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07931388080016291,0.048452676115486724,0.027494103849534192,0.013316577490470004,0.3524035953372241,1,0.1068079846496971,0.061769253605956725,0.36049622364755446,0,24,0 +m_87,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07931388080016291,0.08475094676979437,0.027494103849534192,0.033817229819322926,0.9034868146936337,1,0.1068079846496971,0.11856817658911731,0.36049622364755446,0,24,0 +m_87,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04793150781049812,0.0416870193878518,0.018931537126611657,0.013552513637437648,0.7945486775698906,1,0.06686304493710978,0.055239533025289445,0.10425637737887812,0,24,0 +m_87,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04793150781049812,0.06522118867150557,0.018931537126611657,0.010383450316311825,0.44710605927660796,1,0.06686304493710978,0.0756046389878174,0.10425637737887812,0,24,0 +m_87,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04793150781049812,0.0743809895095738,0.018931537126611657,0.0203975353803154,0.36442307070890645,1,0.06686304493710978,0.09477852488988919,0.10425637737887812,0,24,0 +m_87,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.046800154659205916,0.039706501634538593,0.010246899615309876,0.015218424031434077,0.7082418138953034,1,0.05704705427451579,0.05492492566597267,0.28224450772051823,0,24,0 +m_87,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.046800154659205916,0.1434693996137799,0.010246899615309876,0.07494943533085427,0.2554860979986448,1,0.05704705427451579,0.21841883494463418,0.28224450772051823,0,24,0 +m_87,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.046800154659205916,0.16239717562323763,0.010246899615309876,0.09418874048632438,0.2756455397378318,1,0.05704705427451579,0.256585916109562,0.28224450772051823,0,24,0 +m_87,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09295354006869087,0.04894702115579186,0.04472178476081878,0.0057022219892274234,0.37250547261117595,1,0.13767532482950964,0.05464924314501928,0.15144285731246063,0,24,0 +m_87,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09295354006869087,0.08317455345242471,0.04472178476081878,0.02350376451816372,0.8516155891228137,1,0.13767532482950964,0.10667831797058842,0.15144285731246063,0,24,0 +m_87,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09295354006869087,0.03182541514151035,0.04472178476081878,0.007266733413955766,0.23241612880219334,1,0.13767532482950964,0.03909214855546611,0.15144285731246063,0,24,0 +m_87,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10487663831312781,0.08513830761621873,0.042676571212793085,0.03797097554577362,0.7369434200832901,1,0.14755320952592088,0.12310928316199235,0.18535655441583856,0,24,0 +m_87,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10487663831312781,0.06038752559077768,0.042676571212793085,0.026828218427557008,0.40196911918710676,1,0.14755320952592088,0.08721574401833469,0.18535655441583856,0,24,0 +m_87,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10487663831312781,0.13127517058473762,0.042676571212793085,0.03723078797511562,0.6512948043136179,1,0.14755320952592088,0.16850595855985323,0.18535655441583856,0,24,0 +m_88,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12679451235415135,0.09025332889930475,0.05558117897278004,0.03310304360876992,0.5906594682377415,1,0.18237569132693138,0.12335637250807467,0.30713481814615984,0,24,0 +m_88,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12679451235415135,0.19998510237608236,0.05558117897278004,0.07922836866588112,0.46982930266336487,1,0.18237569132693138,0.2792134710419635,0.30713481814615984,0,24,0 +m_88,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12679451235415135,0.1258084274468838,0.05558117897278004,0.0675776812993196,0.9912557563856861,1,0.18237569132693138,0.1933861087462034,0.30713481814615984,0,24,0 +m_88,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06986181208360935,0.10280368478241038,0.03307033383279943,0.037158099276034855,0.5229826227741359,1,0.10293214591640878,0.13996178405844523,0.19240063829595017,0,24,0 +m_88,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.06986181208360935,0.12515338537025875,0.03307033383279943,0.049756285807877755,0.3796842500952312,1,0.10293214591640878,0.1749096711781365,0.19240063829595017,0,24,0 +m_88,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06986181208360935,0.12029517635203062,0.03307033383279943,0.02933411195271079,0.28087278042727576,1,0.10293214591640878,0.1496292883047414,0.19240063829595017,0,24,0 +m_88,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09355289056299228,0.1422174329125312,0.03400761909471115,0.0422579840108074,0.393239738115837,1,0.12756050965770344,0.1844754169233386,0.20292295861567247,0,24,0 +m_88,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09355289056299228,0.05739771900786832,0.03400761909471115,0.0327139120111057,0.4655983896540715,1,0.12756050965770344,0.09011163101897401,0.20292295861567247,0,24,0 +m_88,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09355289056299228,0.12301972559801506,0.03400761909471115,0.03372177227623111,0.5538276402318971,1,0.12756050965770344,0.15674149787424618,0.20292295861567247,0,24,0 +m_88,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03807724145237405,0.14688156942721706,0.015024282896187438,0.06542613922789633,0.16044298514415287,1,0.05310152434856149,0.2123077086551134,0.23353847952062476,0,24,0 +m_88,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03807724145237405,0.07606892519436292,0.015024282896187438,0.03774810603586341,0.3831320950313911,1,0.05310152434856149,0.11381703123022634,0.23353847952062476,0,24,0 +m_88,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03807724145237405,0.13522061068785166,0.015024282896187438,0.059311724593910965,0.16665008595080597,1,0.05310152434856149,0.19453233528176261,0.23353847952062476,0,24,0 +m_88,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.05352404484358061,0.0213479433380539,0.01149455564502103,0.00576299892535184,0.03923939826536772,0.9417455583688253,0.06501860048860164,0.02711094226340574,0.11099194823357933,0,24,0 +m_88,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05352404484358061,0.04521349000339766,0.01149455564502103,0.006875587766887723,0.5518558734323515,1,0.06501860048860164,0.05208907777028538,0.11099194823357933,0,24,0 +m_88,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05352404484358061,0.07643692475015795,0.01149455564502103,0.024464846371277802,0.4242569309904939,1,0.06501860048860164,0.10090177112143575,0.11099194823357933,0,24,0 +m_88,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04659926196621315,0.03804921671539526,0.015573564765353232,0.01266461022859461,0.6795377648790827,1,0.06217282673156638,0.05071382694398987,0.09243930671699845,0,24,0 +m_88,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04659926196621315,0.046640625617752285,0.015573564765353232,0.018595352622904533,0.9986738930086596,1,0.06217282673156638,0.06523597824065681,0.09243930671699845,0,24,0 +m_88,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04659926196621315,0.07584136726555646,0.015573564765353232,0.00819436611353302,0.1372868265496549,1,0.06217282673156638,0.08403573337908948,0.09243930671699845,0,24,0 +m_88,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07370913984583531,0.06960282396456845,0.02920464303085896,0.030338495459763692,0.924249518940116,1,0.10291378287669427,0.09994131942433214,0.18344431777775108,0,24,0 +m_88,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07370913984583531,0.11926030584434229,0.02920464303085896,0.04750725577179505,0.4368253222965105,1,0.10291378287669427,0.16676756161613734,0.18344431777775108,0,24,0 +m_88,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07370913984583531,0.04098420376349776,0.02920464303085896,0.018185275409301656,0.36815530848393774,1,0.10291378287669427,0.05916947917279942,0.18344431777775108,0,24,0 +m_88,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10864082218948605,0.07824191328348891,0.0500906823951497,0.03451348447452394,0.6294151919954258,1,0.15873150458463575,0.11275539775801285,0.17460465504309935,0,24,0 +m_88,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10864082218948605,0.08582933608283756,0.0500906823951497,0.022852743548248088,0.6910487153596605,1,0.15873150458463575,0.10868207963108564,0.17460465504309935,0,24,0 +m_88,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10864082218948605,0.10540288548521937,0.0500906823951497,0.03001072350381022,0.9571097547859284,1,0.15873150458463575,0.1354136089890296,0.17460465504309935,0,24,0 +m_89,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11132844069727899,0.09977236994714762,0.041498632560279254,0.033703631358806795,0.8341616334765198,1,0.15282707325755823,0.1334760013059544,0.16810978058331408,0,24,0 +m_89,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11132844069727899,0.10109694852339102,0.041498632560279254,0.04308865424022293,0.8680039632553408,1,0.15282707325755823,0.14418560276361395,0.16810978058331408,0,24,0 +m_89,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11132844069727899,0.08196756451751848,0.041498632560279254,0.017190610675207368,0.5403213411971846,1,0.15282707325755823,0.09915817519272585,0.16810978058331408,0,24,0 +m_89,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1938576258431998,0.23894294676824615,0.0525303968208222,0.09119615637977148,0.6796825728568028,1,0.246388022664022,0.33013910314801764,0.3631530134628194,0,23,0 +m_89,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1938576258431998,0.11031330129586792,0.0525303968208222,0.046595158052664246,0.26457108430464943,1,0.246388022664022,0.15690845934853215,0.3631530134628194,0,23,0 +m_89,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1938576258431998,0.13204640821420988,0.0525303968208222,0.05802739501913672,0.44820468865633345,1,0.246388022664022,0.1900738032333466,0.3631530134628194,0,23,0 +m_89,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.31719166395872156,0.1805483912384318,0.12677923990438847,0.08901326676235351,0.40523328321909113,1,0.44397090386311,0.2695616580007853,1.4126727828871268,0,24,0 +m_89,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.31719166395872156,0.8454949551320772,0.12677923990438847,0.43875302931076543,0.30316161952847914,1,0.44397090386311,1.2842479844428425,1.4126727828871268,0,24,0 +m_89,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.31719166395872156,0.09489823982737167,0.12677923990438847,0.0430290130597981,0.15865595758980897,1,0.44397090386311,0.13792725288716978,1.4126727828871268,0,24,0 +m_89,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1720529259486363,0.10939845889037818,0.0885810465305022,0.04284183485451783,0.5484375306597398,1,0.2606339724791385,0.152240293744896,0.2866973697270524,0,24,0 +m_89,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1720529259486363,0.13532890315471793,0.0885810465305022,0.0378710882013223,0.7174647199729605,1,0.2606339724791385,0.17319999135604025,0.2866973697270524,0,24,0 +m_89,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1720529259486363,0.19550552453930084,0.0885810465305022,0.064113677137998,0.8358068464286994,1,0.2606339724791385,0.25961920167729885,0.2866973697270524,0,24,0 +m_89,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18136084339519756,0.06917605949634442,0.059204588726205314,0.0406788717313317,0.1533110026456957,1,0.24056543212140288,0.10985493122767612,0.31844433731622096,0,24,0 +m_89,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18136084339519756,0.11798532759782694,0.059204588726205314,0.027687786866930825,0.3641394830093203,1,0.24056543212140288,0.14567311446475778,0.31844433731622096,0,24,0 +m_89,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18136084339519756,0.19550765269098166,0.059204588726205314,0.0939871994146737,0.901644392266234,1,0.24056543212140288,0.2894948521056554,0.31844433731622096,0,24,0 +m_89,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11411203663516038,0.13116869146364785,0.03188556717856355,0.04143886606875878,0.7514190558302464,1,0.14599760381372393,0.17260755753240664,0.18986831328564732,0,24,0 +m_89,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11411203663516038,0.0913078549077803,0.03188556717856355,0.03275480308877668,0.6286699873628836,1,0.14599760381372393,0.12406265799655698,0.18986831328564732,0,24,0 +m_89,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11411203663516038,0.0615998063990153,0.03188556717856355,0.014287415460395605,0.1769895240396199,1,0.14599760381372393,0.07588722185941091,0.18986831328564732,0,24,0 +m_89,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09861958571936658,0.12419688963683069,0.052408604600605445,0.04093397735922768,0.7090350822388469,1,0.15102819031997203,0.16513086699605836,0.19716969082637842,0,24,0 +m_89,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09861958571936658,0.12761446330038048,0.052408604600605445,0.05163071017814532,0.701769090214589,1,0.15102819031997203,0.1792451734785258,0.19716969082637842,0,24,0 +m_89,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09861958571936658,0.12117720175508288,0.052408604600605445,0.04072802074978572,0.7414141588650421,1,0.15102819031997203,0.1619052225048686,0.19716969082637842,0,24,0 +m_89,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11255261616817809,0.05459992002199732,0.04275283298994589,0.022730153736826426,0.2672697970614948,1,0.15530544915812397,0.07733007375882374,0.18997575552520649,0,24,0 +m_89,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11255261616817809,0.1356306357020721,0.04275283298994589,0.03118194776326691,0.6728595821214929,1,0.15530544915812397,0.166812583465339,0.18997575552520649,0,24,0 +m_89,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11255261616817809,0.135847417367749,0.04275283298994589,0.03685781492789325,0.6887338450514902,1,0.15530544915812397,0.17270523229564225,0.18997575552520649,0,24,0 +m_90,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.25446285013445025,0.08624954022812403,0.09962244746225435,0.04099346591844033,0.1754009193601319,1,0.3540852975967046,0.12724300614656436,0.41989841299371505,0,24,0 +m_90,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.25446285013445025,0.2584666786583481,0.09962244746225435,0.0928121169835704,0.9772036455692173,1,0.3540852975967046,0.3512787956419185,0.41989841299371505,0,24,0 +m_90,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.25446285013445025,0.2949907253696999,0.09962244746225435,0.08673510462458653,0.7663880310905333,1,0.3540852975967046,0.3817258299942864,0.41989841299371505,0,24,0 +m_90,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17997506663541804,0.13301872281277102,0.08368566313286253,0.04206622056643719,0.6307554959275932,1,0.2636607297682806,0.1750849433792082,0.37348662252849846,0,24,0 +m_90,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17997506663541804,0.22137509177840212,0.08368566313286253,0.11815820142932373,0.7813997975434881,1,0.2636607297682806,0.33953329320772585,0.37348662252849846,0,24,0 +m_90,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17997506663541804,0.12341278920018017,0.08368566313286253,0.047612459969122896,0.5732345880994414,1,0.2636607297682806,0.17102524916930306,0.37348662252849846,0,24,0 +m_90,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10070783692744581,0.24937637369915444,0.056407951496266054,0.11486997975356046,0.2825059355860194,1,0.15711578842371188,0.3642463534527149,0.6830483694416317,0,24,0 +m_90,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10070783692744581,0.3502396816795171,0.056407951496266054,0.27071338144923907,0.41406401861102987,1,0.15711578842371188,0.6209530631287561,0.6830483694416317,0,24,0 +m_90,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10070783692744581,0.20290456600898008,0.056407951496266054,0.06909067393848276,0.2816613939279059,1,0.15711578842371188,0.27199523994746283,0.6830483694416317,0,24,0 +m_90,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12775544244401088,0.30354068193583195,0.05249754070076061,0.2086343512836826,0.4470967686607396,1,0.1802529831447715,0.5121750332195145,0.563392536541466,0,24,0 +m_90,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12775544244401088,0.10623562070386094,0.05249754070076061,0.03164962581264291,0.7362842713346069,1,0.1802529831447715,0.13788524651650386,0.563392536541466,0,24,0 +m_90,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12775544244401088,0.1467527103223659,0.05249754070076061,0.052420942291839065,0.8037282369149628,1,0.1802529831447715,0.19917365261420494,0.563392536541466,0,24,0 +m_90,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.058059886589412635,0.038905534639093554,0.027061135625082573,0.01553306463603322,0.5564038684408683,1,0.0851210222144952,0.05443859927512677,0.11173038431201596,0,24,0 +m_90,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.058059886589412635,0.0658847762399053,0.027061135625082573,0.035688300407381926,0.8650438734685697,1,0.0851210222144952,0.10157307664728722,0.11173038431201596,0,24,0 +m_90,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.058059886589412635,0.07398277767477339,0.027061135625082573,0.021027645691231996,0.6527480300627317,1,0.0851210222144952,0.09501042336600539,0.11173038431201596,0,24,0 +m_90,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05128202101245435,0.051084932189474706,0.015487817861778858,0.02094646248090556,0.994124904274859,1,0.06676983887423321,0.07203139467038026,0.24234270804441296,0,24,0 +m_90,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05128202101245435,0.12253452855372182,0.015487817861778858,0.08154862887828784,0.4273812333200092,1,0.06676983887423321,0.20408315743200967,0.24234270804441296,0,24,0 +m_90,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05128202101245435,0.1474863872277837,0.015487817861778858,0.07282516553986443,0.24837573129507448,1,0.06676983887423321,0.22031155276764813,0.24234270804441296,0,24,0 +m_90,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07094219599152647,0.05255235376921311,0.023515745040701357,0.034199497711068824,0.6683207102811746,1,0.09445794103222782,0.08675185148028194,0.12203649794511313,0,24,0 +m_90,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07094219599152647,0.08886622913910809,0.023515745040701357,0.022076041720085666,0.5906724796518339,1,0.09445794103222782,0.11094227085919375,0.12203649794511313,0,24,0 +m_90,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07094219599152647,0.07135248027786949,0.023515745040701357,0.01927907094065645,0.9895103361684775,1,0.09445794103222782,0.09063155121852594,0.12203649794511313,0,24,0 +m_90,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09776753082180534,0.0740692352010821,0.02890663580902195,0.010799436431636547,0.47000837769044257,1,0.12667416663082728,0.08486867163271865,0.16192002914941372,0,24,0 +m_90,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09776753082180534,0.0765703059852864,0.02890663580902195,0.025944580502907006,0.5973520817178868,1,0.12667416663082728,0.1025148864881934,0.16192002914941372,0,24,0 +m_90,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09776753082180534,0.09355097409853001,0.02890663580902195,0.053649052400936995,0.9466058260782392,1,0.12667416663082728,0.147200026499467,0.16192002914941372,0,24,0 +m_91,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08779878725879317,0.5992224084900971,0.03342709137265021,0.5027017849474112,0.35624403574029806,1,0.12122587863144338,1.1019241934375084,2.1033041119597917,0,24,0 +m_91,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08779878725879317,0.6587465316381159,0.03342709137265021,0.5606941168120749,0.3557244070697951,1,0.12122587863144338,1.219440648450191,2.1033041119597917,0,24,0 +m_91,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08779878725879317,1.1861235537809711,0.03342709137265021,0.7259710934552028,0.1908664026327999,1,0.12122587863144338,1.912094647236174,2.1033041119597917,0,24,0 +m_91,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08966200139818303,0.10976973543402117,0.037312424733349225,0.04055795518241773,0.7228640047354895,1,0.12697442613153226,0.1503276906164389,0.16536045967808283,0,24,0 +m_91,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08966200139818303,0.06396707534275148,0.037312424733349225,0.022806303805762467,0.5724914999919148,1,0.12697442613153226,0.08677337914851395,0.16536045967808283,0,24,0 +m_91,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08966200139818303,0.10028212143163806,0.037312424733349225,0.027772160257517088,0.8243685653026536,1,0.12697442613153226,0.12805428168915514,0.16536045967808283,0,24,0 +m_91,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03253869191548899,0.08788416762316542,0.0164317801297169,0.026292367310043727,0.11152591605611986,1,0.048970472045205896,0.11417653493320915,0.15963652584733257,0,24,0 +m_91,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03253869191548899,0.1066571508068325,0.0164317801297169,0.03846696359983344,0.13213101402492414,1,0.048970472045205896,0.14512411440666595,0.15963652584733257,0,24,0 +m_91,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03253869191548899,0.09139759190140088,0.0164317801297169,0.032115006591863504,0.14484180465658436,1,0.048970472045205896,0.12351259849326439,0.15963652584733257,0,24,0 +m_91,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.6813334552218595,0.07610073873466867,0.6474799642714837,0.033942470747626664,0.4031527681658068,1,1.3288134194933432,0.11004320948229535,1.4616947614426776,0,24,0 +m_91,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.6813334552218595,0.07214112743362507,0.6474799642714837,0.02359057135490318,0.4001970915425716,1,1.3288134194933432,0.09573169878852825,1.4616947614426776,0,24,0 +m_91,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.6813334552218595,0.033374509367960124,0.6474799642714837,0.012634579135915229,0.37362514056165125,1,1.3288134194933432,0.046009088503875355,1.4616947614426776,0,24,0 +m_91,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18492206214960275,0.16348182736500405,0.0528066981833006,0.052743357565915173,0.7797724537732728,1,0.23772876033290335,0.21622518493091922,0.35986305287110154,0,24,0 +m_91,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18492206214960275,0.10972517180128467,0.0528066981833006,0.02026337886855082,0.2288367561665156,1,0.23772876033290335,0.1299885506698355,0.35986305287110154,0,24,0 +m_91,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18492206214960275,0.2559036098024787,0.0528066981833006,0.07124462008034085,0.4436058680415963,1,0.23772876033290335,0.32714822988281955,0.35986305287110154,0,24,0 +m_91,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.14475283812564532,0.04835111331731697,0.022528902845652968,0.018614529339015907,0.008412314588458807,0.20189555012301136,0.16728174097129828,0.06696564265633288,0.18400991506842812,0,24,0 +m_91,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.14475283812564532,0.09175176345885323,0.022528902845652968,0.015493035565897,0.08501205157900935,1,0.16728174097129828,0.10724479902475023,0.18400991506842812,0,24,0 +m_91,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.14475283812564532,0.08038050376539434,0.022528902845652968,0.03416473896753465,0.15150939116275017,1,0.16728174097129828,0.11454524273292899,0.18400991506842812,0,24,0 +m_91,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04631089421523157,0.07236711149483721,0.012930622095859103,0.021898083029647745,0.33514739601182403,1,0.05924151631109067,0.09426519452448495,0.13502775367670933,0,24,0 +m_91,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04631089421523157,0.09841069404545581,0.012930622095859103,0.0243418092970072,0.0972619841210778,1,0.05924151631109067,0.12275250334246302,0.13502775367670933,0,24,0 +m_91,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04631089421523157,0.04912862447032499,0.012930622095859103,0.016164499983863878,0.8945542928930208,1,0.05924151631109067,0.06529312445418886,0.13502775367670933,0,24,0 +m_91,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09925991970036045,0.07873709089616081,0.031014166564449837,0.03232128530589965,0.6566516725654442,1,0.1302740862648103,0.11105837620206047,0.15527766397035664,0,24,0 +m_91,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09925991970036045,0.033095754410551535,0.031014166564449837,0.015102031342014387,0.09519759431275884,1,0.1302740862648103,0.04819778575256592,0.15527766397035664,0,24,0 +m_91,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09925991970036045,0.10657236804312609,0.031014166564449837,0.03458914465719811,0.878097807723888,1,0.1302740862648103,0.1411615127003242,0.15527766397035664,0,24,0 +m_92,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1389296776895647,0.19959243448915656,0.05823079855472109,0.09026533050462274,0.5872896152856486,1,0.1971604762442858,0.2898577649937793,0.4815487009157724,0,24,0 +m_92,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1389296776895647,0.2696186974667127,0.05823079855472109,0.08192029691156838,0.22730891326725022,1,0.1971604762442858,0.35153899437828107,0.4815487009157724,0,24,0 +m_92,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1389296776895647,0.346729531497955,0.05823079855472109,0.09104201478911077,0.08978886740871007,1,0.1971604762442858,0.43777154628706577,0.4815487009157724,0,24,0 +m_92,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.08116670709265246,0.36092498594417355,0.01728233914900004,0.0701295652957315,0.009397654695945536,0.22554371270269286,0.0984490462416525,0.43105455123990505,0.4741600063638956,0,24,0 +m_92,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08116670709265246,0.24636117991528697,0.01728233914900004,0.06985540958113667,0.06447852388674966,1,0.0984490462416525,0.3162165894964236,0.4741600063638956,0,24,0 +m_92,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08116670709265246,0.2500728362277989,0.01728233914900004,0.10666175168686115,0.17587991585844504,1,0.0984490462416525,0.35673458791466006,0.4741600063638956,0,24,0 +m_92,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.131271561877565,0.40192715226700826,0.05667274328704294,0.1841170649724663,0.21022402666142187,1,0.18794430516460794,0.5860442172394745,0.6446486389634221,0,24,0 +m_92,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.131271561877565,0.22776770695611775,0.05667274328704294,0.16762814306801738,0.609405665562064,1,0.18794430516460794,0.39539585002413513,0.6446486389634221,0,24,0 +m_92,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.131271561877565,0.32092034913771555,0.05667274328704294,0.13134349198580975,0.22806419043979043,1,0.18794430516460794,0.4522638411235253,0.6446486389634221,0,24,0 +m_92,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.20561579333129618,0.20778490824782192,0.09726424691113494,0.11283306122748304,0.9887005922438818,1,0.3028800402424311,0.32061796947530496,0.4806788989102941,0,24,0 +m_92,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.20561579333129618,0.13683590464998363,0.09726424691113494,0.06939841913294069,0.58161466685444,1,0.3028800402424311,0.20623432378292433,0.4806788989102941,0,24,0 +m_92,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.20561579333129618,0.31919633547006465,0.09726424691113494,0.11778448172111178,0.4762208379778129,1,0.3028800402424311,0.43698081719117643,0.4806788989102941,0,24,0 +m_92,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15096642626337134,0.1623063348685577,0.059535640091139014,0.04845569851274297,0.8856129794900407,1,0.21050206635451035,0.21076203338130067,0.2592373980762655,0,24,0 +m_92,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.15096642626337134,0.15445741540716407,0.059535640091139014,0.026633992276948,0.9588250898266432,1,0.21050206635451035,0.18109140768411208,0.2592373980762655,0,24,0 +m_92,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.15096642626337134,0.16838745921896572,0.059535640091139014,0.06728290266854832,0.8501862625923364,1,0.21050206635451035,0.23567036188751406,0.2592373980762655,0,24,0 +m_92,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.2934577338852293,0.07190587182768941,0.07501357029373859,0.018426230616170342,0.030789266062544833,0.7081531194385312,0.3684713041789679,0.09033210244385975,0.40531843459686473,0,24,0 +m_92,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2934577338852293,0.10379126726222172,0.07501357029373859,0.05425217789444486,0.070389739483085,1,0.3684713041789679,0.15804344515666657,0.40531843459686473,0,24,0 +m_92,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2934577338852293,0.09413423951994027,0.07501357029373859,0.04474119491422979,0.05128988271685875,1,0.3684713041789679,0.13887543443417005,0.40531843459686473,0,24,0 +m_92,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0774453139941637,0.12061051492673099,0.04155290177271044,0.0374703316447671,0.4584594273652831,1,0.11899821576687414,0.1580808465714981,0.2576246280822914,0,24,0 +m_92,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0774453139941637,0.19069001799421756,0.04155290177271044,0.043514189353320076,0.08926921047441057,1,0.11899821576687414,0.23420420734753764,0.2576246280822914,0,24,0 +m_92,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0774453139941637,0.1434590396495811,0.04155290177271044,0.057320486684009575,0.3751450132722297,1,0.11899821576687414,0.20077952633359067,0.2576246280822914,0,24,0 +m_92,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18053257833893857,0.16397041291971273,0.055167974994723284,0.07080181341132272,0.8575095334368609,1,0.23570055333366186,0.23477222633103545,0.25927060866702806,0,24,0 +m_92,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18053257833893857,0.16020593152983556,0.055167974994723284,0.06108217039684137,0.8099861464071142,1,0.23570055333366186,0.22128810192667692,0.25927060866702806,0,24,0 +m_92,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18053257833893857,0.14335377390575502,0.055167974994723284,0.04749572570130184,0.6208708793796647,1,0.23570055333366186,0.19084949960705686,0.25927060866702806,0,24,0 +m_93,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.45370153728321,0.19265844933331588,0.39286706917123965,0.06859122052172227,0.5465358769905502,1,0.8465686064544496,0.26124966985503817,0.9312254670998947,0,24,0 +m_93,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.45370153728321,0.5563201910460859,0.39286706917123965,0.13344706630272252,0.814637250408724,1,0.8465686064544496,0.6897672573488084,0.9312254670998947,0,24,0 +m_93,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.45370153728321,0.4873694871176972,0.39286706917123965,0.1464648270790163,0.9390494542845274,1,0.8465686064544496,0.6338343141967135,0.9312254670998947,0,24,0 +m_93,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.44904505626643876,0.5535795671915644,0.15032467397856594,0.3620338241656823,0.7977748772881798,1,0.5993697302450047,0.9156133913572467,1.0071747304929715,0,24,0 +m_93,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.44904505626643876,0.6433025955681597,0.15032467397856594,0.11188526395690329,0.3262752119834346,1,0.5993697302450047,0.755187859525063,1.0071747304929715,0,24,0 +m_93,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.44904505626643876,0.42595178994841226,0.15032467397856594,0.1534775428961739,0.9165237352453572,1,0.5993697302450047,0.5794293328445862,1.0071747304929715,0,24,0 +m_93,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3730784509552642,0.7055541384042051,0.13026497841765095,0.24874782416631272,0.2729244982891242,1,0.5033434293729151,0.9543019625705178,1.0497321588275697,0,24,0 +m_93,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3730784509552642,0.15004295337779885,0.13026497841765095,0.0771041619937973,0.18737045663138502,1,0.5033434293729151,0.22714711537159615,1.0497321588275697,0,24,0 +m_93,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3730784509552642,0.5606426942714688,0.13026497841765095,0.24015683246265196,0.512894971013276,1,0.5033434293729151,0.8007995267341208,1.0497321588275697,0,24,0 +m_93,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.5829255457113124,0.8434064346751673,0.2397841526505747,0.18966590782323497,0.41883653563426826,1,0.8227096983618871,1.0330723424984023,1.1363795767482425,0,24,0 +m_93,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.5829255457113124,0.359112490560494,0.2397841526505747,0.16280379466351175,0.4642542899062442,1,0.8227096983618871,0.5219162852240058,1.1363795767482425,0,24,0 +m_93,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.5829255457113124,0.4933684070037617,0.2397841526505747,0.19536841421411089,0.7793583945545862,1,0.8227096983618871,0.6887368212178726,1.1363795767482425,0,24,0 +m_93,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.26343551713662305,0.19831042021040612,0.07451497184742716,0.08512676433218305,0.5777927773168148,1,0.3379504889840502,0.28343718454258915,0.7369939899599157,0,24,0 +m_93,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.26343551713662305,0.4230385543375124,0.07451497184742716,0.07181909141190125,0.15409701739816553,1,0.3379504889840502,0.49485764574941365,0.7369939899599157,0,24,0 +m_93,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.26343551713662305,0.5450701123769904,0.07451497184742716,0.12492442395020566,0.08816588943046488,1,0.3379504889840502,0.6699945363271961,0.7369939899599157,0,24,0 +m_93,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.31136115697886696,0.1725955956738681,0.1368678770951605,0.08404516939051909,0.4118679813660274,1,0.4482290340740275,0.25664076506438716,0.6105014297098482,0,24,0 +m_93,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.31136115697886696,0.3539945692456425,0.1368678770951605,0.14005760996523922,0.8320373640886047,1,0.4482290340740275,0.49405217921088174,0.6105014297098482,0,24,0 +m_93,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.31136115697886696,0.4472486060954911,0.1368678770951605,0.10775269364073448,0.4543756720198835,1,0.4482290340740275,0.5550012997362256,0.6105014297098482,0,24,0 +m_93,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.23681198343126766,0.26261549568388826,0.08308775688935846,0.07407053973526485,0.821416201588115,1,0.3198997403206261,0.3366860354191531,0.38957221676944137,0,24,0 +m_93,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.23681198343126766,0.18947426121336022,0.08308775688935846,0.059139538786075606,0.6535175009903057,1,0.3198997403206261,0.24861379999943584,0.38957221676944137,0,24,0 +m_93,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.23681198343126766,0.27017162329876127,0.08308775688935846,0.08398493740073089,0.7834155727984222,1,0.3198997403206261,0.35415656069949214,0.38957221676944137,0,24,0 +m_93,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2046064267359657,0.29488563710163596,0.10240321895501506,0.06234367615962423,0.4723502428129348,1,0.30700964569098077,0.3572293132612602,0.3929522445873862,0,24,0 +m_93,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2046064267359657,0.15212753517774383,0.10240321895501506,0.07813680005824246,0.6928746262243957,1,0.30700964569098077,0.23026433523598627,0.3929522445873862,0,24,0 +m_93,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2046064267359657,0.1324869708518339,0.10240321895501506,0.04914152856824202,0.5451412006027878,1,0.30700964569098077,0.18162849942007592,0.3929522445873862,0,24,0 +m_94,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.22447518604944827,0.08247900869284641,0.10822321506001938,0.019968450603588102,0.2623488755268617,1,0.33269840110946763,0.1024474592964345,0.5572545877315576,0,24,0 +m_94,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.22447518604944827,0.36266211633925544,0.10822321506001938,0.143932963416706,0.46305923710555275,1,0.33269840110946763,0.5065950797559614,0.5572545877315576,0,24,0 +m_94,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.22447518604944827,0.08537114286831075,0.10822321506001938,0.029304864210992192,0.27439233808794583,1,0.33269840110946763,0.11467600707930295,0.5572545877315576,0,24,0 +m_94,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09312269194331124,0.130478782034678,0.027938674069929833,0.061910096083541685,0.5995383994101611,1,0.12106136601324108,0.1923888781182197,0.2598785097587676,0,24,0 +m_94,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09312269194331124,0.14308825345925857,0.027938674069929833,0.09316493723053011,0.6261421271723167,1,0.12106136601324108,0.23625319068978867,0.2598785097587676,0,24,0 +m_94,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09312269194331124,0.06617976454698653,0.027938674069929833,0.03479283666159038,0.5600343616574559,1,0.12106136601324108,0.1009726012085769,0.2598785097587676,0,24,0 +m_94,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09960989615712963,0.12775883285382195,0.05632651066641092,0.06275414082258934,0.7461665722008544,1,0.15593640682354054,0.1905129736764113,0.4481451826725384,0,24,0 +m_94,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09960989615712963,0.2573198866958036,0.05632651066641092,0.1500848248246858,0.36951289300306595,1,0.15593640682354054,0.4074047115204894,0.4481451826725384,0,24,0 +m_94,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09960989615712963,0.24125000361705518,0.05632651066641092,0.14341375661313763,0.39094138176393356,1,0.15593640682354054,0.3846637602301928,0.4481451826725384,0,24,0 +m_94,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11799424824212439,0.10210542224763637,0.10016254009117123,0.03325337946983626,0.886351239829152,1,0.2181567883332956,0.13535880171747264,0.2858668277742817,0,24,0 +m_94,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11799424824212439,0.16665839069986302,0.10016254009117123,0.09322054364039305,0.7305660372861023,1,0.2181567883332956,0.25987893434025605,0.2858668277742817,0,24,0 +m_94,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11799424824212439,0.15208003106169313,0.10016254009117123,0.016482303233267576,0.7530768175511061,1,0.2181567883332956,0.1685623342949607,0.2858668277742817,0,24,0 +m_94,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.046517660409327734,0.05851369492928823,0.013346639847832527,0.022307205057377568,0.6564928380921334,1,0.05986430025716026,0.08082089998666579,0.08890298998533237,0,24,0 +m_94,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.046517660409327734,0.053726630901373085,0.013346639847832527,0.018673722883816586,0.760582291848627,1,0.05986430025716026,0.07240035378518966,0.08890298998533237,0,24,0 +m_94,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.046517660409327734,0.041284824035450716,0.013346639847832527,0.020214243386196346,0.8339659542318093,1,0.05986430025716026,0.06149906742164706,0.08890298998533237,0,24,0 +m_94,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0601819225360772,0.05599730443573033,0.01583789993048986,0.02464456205121564,0.8897307410443688,1,0.07601982246656706,0.08064186648694598,0.08870605313564058,0,24,0 +m_94,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0601819225360772,0.027358114259559956,0.01583789993048986,0.008772441177756328,0.10834051896500675,1,0.07601982246656706,0.03613055543731628,0.08870605313564058,0,24,0 +m_94,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0601819225360772,0.025646066575473563,0.01583789993048986,0.0052434907794002604,0.0832395260574195,1,0.07601982246656706,0.030889557354873823,0.08870605313564058,0,24,0 +m_94,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04600723984229327,0.02444993223112002,0.011216857776313158,0.009517232483963353,0.17431579530899322,1,0.057224097618606425,0.033967164715083376,0.09845575453327828,0,24,0 +m_94,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04600723984229327,0.057290688520030976,0.011216857776313158,0.032214542873858346,0.7517124447672208,1,0.057224097618606425,0.08950523139388933,0.09845575453327828,0,24,0 +m_94,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04600723984229327,0.025091279518234828,0.011216857776313158,0.0045504887987270854,0.13021201355732764,1,0.057224097618606425,0.029641768316961914,0.09845575453327828,0,24,0 +m_94,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.022877703010932542,0.03657243192363224,0.008760277030166134,0.010455783211930868,0.3397744473307991,1,0.031637980041098676,0.047028215135563115,0.05173103664911943,0,24,0 +m_94,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.022877703010932542,0.01738903969693843,0.008760277030166134,0.008898301973393715,0.6696090220461506,1,0.031637980041098676,0.026287341670332143,0.05173103664911943,0,24,0 +m_94,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.022877703010932542,0.017193437320416043,0.008760277030166134,0.00599751674657365,0.6055661538562143,1,0.031637980041098676,0.02319095406698969,0.05173103664911943,0,24,0 +m_97,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.22170225868044274,0.06570132561231416,0.07612733437748793,0.026070041661269163,0.11096955833010584,1,0.29782959305793066,0.09177136727358333,0.3276125523637238,0,24,0 +m_97,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.22170225868044274,0.14046331985210037,0.07612733437748793,0.0700980494039292,0.45334706905329014,1,0.29782959305793066,0.21056136925602958,0.3276125523637238,0,24,0 +m_97,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.22170225868044274,0.12306434779697943,0.07612733437748793,0.08951756101299979,0.4230354943796377,1,0.29782959305793066,0.21258190880997924,0.3276125523637238,0,24,0 +m_97,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09991881883551623,0.0934392411941487,0.02680549705206648,0.027687651311280825,0.8698309811095428,1,0.1267243158875827,0.12112689250542953,0.19329412768821636,0,24,0 +m_97,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09991881883551623,0.07402080721608999,0.02680549705206648,0.020215075921184367,0.45963635421446836,1,0.1267243158875827,0.09423588313727435,0.19329412768821636,0,24,0 +m_97,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09991881883551623,0.1200734955732694,0.02680549705206648,0.05564843868874544,0.7534779788332862,1,0.1267243158875827,0.17572193426201485,0.19329412768821636,0,24,0 +m_97,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13542402750528626,0.09580045322439797,0.04104687968547359,0.027344499906727764,0.4474505002863105,1,0.17647090719075986,0.12314495313112572,0.2509208996193292,0,24,0 +m_97,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13542402750528626,0.13254967975877036,0.04104687968547359,0.07887939412081008,0.9752582382184565,1,0.17647090719075986,0.21142907387958043,0.2509208996193292,0,24,0 +m_97,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13542402750528626,0.1605467707714446,0.04104687968547359,0.06756313797340008,0.7587724680816472,1,0.17647090719075986,0.22810990874484469,0.2509208996193292,0,24,0 +m_97,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1189601480839773,0.05681259445612644,0.052748998829793996,0.021151830311210103,0.3215161473846818,1,0.1717091469137713,0.07796442476733655,0.18888006160514842,0,24,0 +m_97,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1189601480839773,0.08170571177211301,0.052748998829793996,0.024282909713368574,0.5462042122347717,1,0.1717091469137713,0.10598862148548159,0.18888006160514842,0,24,0 +m_97,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1189601480839773,0.11321987725481608,0.052748998829793996,0.017794943189887568,0.9219509001879851,1,0.1717091469137713,0.13101482044470364,0.18888006160514842,0,24,0 +m_97,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18161879088568267,0.2006765968053584,0.06133107481157632,0.06343650970027004,0.833345993865896,1,0.242949865697259,0.26411310650562847,0.42248333305729135,0,24,0 +m_97,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18161879088568267,0.2848225936746402,0.06133107481157632,0.09925316365017013,0.40120097376104313,1,0.242949865697259,0.3840757573248103,0.42248333305729135,0,24,0 +m_97,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18161879088568267,0.22189682629866117,0.06133107481157632,0.07996346669142725,0.6983487984754598,1,0.242949865697259,0.30186029299008843,0.42248333305729135,0,24,0 +m_97,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1528030161080923,0.29181528921884886,0.052262888548319,0.11095925756832933,0.29379371322263975,1,0.2050659046564113,0.40277454678717817,0.4488211502211592,0,24,0 +m_97,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1528030161080923,0.26003426555396014,0.052262888548319,0.1479849619198209,0.5190442875434027,1,0.2050659046564113,0.40801922747378105,0.4488211502211592,0,24,0 +m_97,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1528030161080923,0.17165927020474303,0.052262888548319,0.06706165834987624,0.8292090465235229,1,0.2050659046564113,0.23872092855461927,0.4488211502211592,0,24,0 +m_97,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.30656206186101,0.2906093360504366,0.0557488002059919,0.1013447544918151,0.8938094663818069,1,0.36231086206700186,0.3919540905422517,0.4311494995964769,0,24,0 +m_97,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.30656206186101,0.24278478566085523,0.0557488002059919,0.11489189946597644,0.6323205070210313,1,0.36231086206700186,0.3576766851268317,0.4311494995964769,0,24,0 +m_97,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.30656206186101,0.1133146447491602,0.0557488002059919,0.034005673656164914,0.017515869568684138,0.4203808696484193,0.36231086206700186,0.1473203184053251,0.4311494995964769,0,24,0 +m_97,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.23961540182152105,0.2751866630564371,0.09803143762890465,0.09648266365941882,0.8011806598304593,1,0.33764683945042573,0.3716693267158559,0.4207209251288448,0,24,0 +m_97,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.23961540182152105,0.26965824055334725,0.09803143762890465,0.11281532774560254,0.8447952874320837,1,0.33764683945042573,0.3824735682989498,0.4207209251288448,0,24,0 +m_97,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.23961540182152105,0.15628877476885691,0.09803143762890465,0.03485065153319053,0.45258326816041894,1,0.33764683945042573,0.19113942630204744,0.4207209251288448,0,24,0 +m_98,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14425978433728331,0.144735507645627,0.059868063742448324,0.025230459240534724,0.9944199605839299,1,0.20412784807973164,0.16996596688616172,0.3092767810945638,0,24,0 +m_98,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14425978433728331,0.22287239849310225,0.059868063742448324,0.0582883115928648,0.3718153882637709,1,0.20412784807973164,0.28116071008596705,0.3092767810945638,0,24,0 +m_98,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14425978433728331,0.1298816076948394,0.059868063742448324,0.03903544516971711,0.8462033784320316,1,0.20412784807973164,0.1689170528645565,0.3092767810945638,0,24,0 +m_98,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09450274084849886,0.16957337095070354,0.0445250858918891,0.09351736761467798,0.4915954046291201,1,0.13902782674038797,0.2630907385653815,0.2893998124219197,0,24,0 +m_98,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09450274084849886,0.07417992637129693,0.0445250858918891,0.022662189300012542,0.6956392352438114,1,0.13902782674038797,0.09684211567130947,0.2893998124219197,0,24,0 +m_98,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09450274084849886,0.17911228727670717,0.0445250858918891,0.04652024924492434,0.2182666560505553,1,0.13902782674038797,0.2256325365216315,0.2893998124219197,0,24,0 +m_98,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.22214888704403765,0.131743623602542,0.17040344710008412,0.039936661119475976,0.6301470969701621,1,0.3925523341441218,0.17168028472201796,0.43225896401471564,0,24,0 +m_98,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.22214888704403765,0.2569470033916274,0.17040344710008412,0.13601569116720497,0.877341070403103,1,0.3925523341441218,0.39296269455883237,0.43225896401471564,0,24,0 +m_98,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.22214888704403765,0.08327158947783597,0.17040344710008412,0.019692324821191105,0.462468532804963,1,0.3925523341441218,0.10296391429902707,0.43225896401471564,0,24,0 +m_98,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.30951268483994354,0.06610637781003481,0.093056491227176,0.020563069012497773,0.05762518160720739,1,0.40256917606711956,0.08666944682253258,0.4428260936738316,0,24,0 +m_98,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.30951268483994354,0.1256684099127127,0.093056491227176,0.039610740417437514,0.12405642290242828,1,0.40256917606711956,0.1652791503301502,0.4428260936738316,0,24,0 +m_98,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.30951268483994354,0.11196185895765572,0.093056491227176,0.05085704863382634,0.109470058930265,1,0.40256917606711956,0.16281890759148204,0.4428260936738316,0,24,0 +m_98,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.046502982914736236,0.02967770932898084,0.020446170086326754,0.006839671754921095,0.46432934843090423,1,0.066949153001063,0.036517381083901936,0.1469479443061692,0,24,0 +m_98,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.046502982914736236,0.051084771677912144,0.020446170086326754,0.01484722619385006,0.8600753649904072,1,0.066949153001063,0.06593199787176221,0.1469479443061692,0,24,0 +m_98,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.046502982914736236,0.09926785323767866,0.020446170086326754,0.034321187040656974,0.22244712644001688,1,0.066949153001063,0.13358904027833562,0.1469479443061692,0,24,0 +m_98,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15675623985337758,0.0688713897380917,0.04723943274589003,0.03325593621942923,0.16260081031006354,1,0.2039956725992676,0.10212732595752094,0.22439523985919438,0,24,0 +m_98,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.15675623985337758,0.10004300349455002,0.04723943274589003,0.03432293015754909,0.356454154472745,1,0.2039956725992676,0.13436593365209912,0.22439523985919438,0,24,0 +m_98,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.15675623985337758,0.06554903543597253,0.04723943274589003,0.030730912375212915,0.14163779390208794,1,0.2039956725992676,0.09627994781118544,0.22439523985919438,0,24,0 +m_98,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11403902219404127,0.14628559766384072,0.02577172802867924,0.04778783664602867,0.5696354511201944,1,0.13981075022272052,0.1940734343098694,0.21348077774085636,0,24,0 +m_98,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11403902219404127,0.13402049008526631,0.02577172802867924,0.051780138809388566,0.7394418771385459,1,0.13981075022272052,0.18580062889465487,0.21348077774085636,0,24,0 +m_98,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11403902219404127,0.08403452213021219,0.02577172802867924,0.02428627350656609,0.41671398607438737,1,0.13981075022272052,0.10832079563677828,0.21348077774085636,0,24,0 +m_98,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05941213939322395,0.08128650326792952,0.01702564453179223,0.04139569554318626,0.6407673563795193,1,0.07643778392501618,0.12268219881111578,0.13495041869222738,0,24,0 +m_98,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05941213939322395,0.09063396725172772,0.01702564453179223,0.01948784597462696,0.25587020586425724,1,0.07643778392501618,0.11012181322635467,0.13495041869222738,0,24,0 +m_98,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05941213939322395,0.06258448537845303,0.01702564453179223,0.020088104474238186,0.9065582638891825,1,0.07643778392501618,0.08267258985269121,0.13495041869222738,0,24,0 +m_99,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.156903527667835,0.12876027254133712,0.11566522580107291,0.041018250409039704,0.8276925168117207,1,0.2725687534689079,0.16977852295037682,0.2998256288157987,0,24,0 +m_99,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.156903527667835,0.1483666662486418,0.11566522580107291,0.06116545985954057,0.9500432046668434,1,0.2725687534689079,0.2095321261081824,0.2998256288157987,0,24,0 +m_99,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.156903527667835,0.0795144797340807,0.11566522580107291,0.021562788065395255,0.5444141523564507,1,0.2725687534689079,0.10107726779947596,0.2998256288157987,0,24,0 +m_99,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.16935162483484625,0.24022183788853643,0.028936026008519678,0.0930507301276399,0.49462968428800214,1,0.19828765084336594,0.33327256801617633,0.9972198374986327,0,23,0 +m_99,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.16935162483484625,0.4929391494366838,0.028936026008519678,0.4136243391984367,0.4783513994905679,1,0.19828765084336594,0.9065634886351206,0.9972198374986327,0,23,0 +m_99,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.16935162483484625,0.2105555345367872,0.028936026008519678,0.04173627472777365,0.4383264764578081,1,0.19828765084336594,0.25229180926456085,0.9972198374986327,0,23,0 +m_99,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1469981039653585,0.17515685839810277,0.06182647753249616,0.08934225348629055,0.8016697901102131,1,0.20882458149785466,0.26449911188439335,0.3159849829333213,0,24,0 +m_99,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1469981039653585,0.1538555000585146,0.06182647753249616,0.13340357533541383,0.964408097308252,1,0.20882458149785466,0.2872590753939284,0.3159849829333213,0,24,0 +m_99,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1469981039653585,0.16432351166893758,0.06182647753249616,0.04388478801608367,0.8253391012004181,1,0.20882458149785466,0.20820829968502125,0.3159849829333213,0,24,0 +m_99,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10966322197514575,0.06978816841954065,0.046086671640456024,0.026872214281890294,0.48067015438111504,1,0.15574989361560176,0.09666038270143094,0.18784937560311807,0,24,0 +m_99,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10966322197514575,0.09365862494014136,0.046086671640456024,0.02943699414085967,0.7782653614296946,1,0.15574989361560176,0.12309561908100103,0.18784937560311807,0,24,0 +m_99,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10966322197514575,0.10744510138297632,0.046086671640456024,0.0633270582562219,0.9780481767886566,1,0.15574989361560176,0.17077215963919823,0.18784937560311807,0,24,0 +m_99,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.035894886787556736,0.045306282209510794,0.01240276972023455,0.012863205180061814,0.609902343023135,1,0.04829765650779129,0.05816948738957261,0.12750319209175198,0,24,0 +m_99,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.035894886787556736,0.06466295987092681,0.01240276972023455,0.011919281347182899,0.1254417675473672,1,0.04829765650779129,0.0765822412181097,0.12750319209175198,0,24,0 +m_99,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.035894886787556736,0.08235801181736117,0.01240276972023455,0.033553980993322456,0.23922849396393003,1,0.04829765650779129,0.11591199281068362,0.12750319209175198,0,24,0 +m_99,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.025552255384904132,0.04172252479828783,0.012784649106587996,0.017708594088032045,0.47775446221303175,1,0.03833690449149213,0.05943111888631987,0.10563195356089325,0,24,0 +m_99,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.025552255384904132,0.021921490973326296,0.012784649106587996,0.007613625001463396,0.8132587683902195,1,0.03833690449149213,0.029535115974789694,0.10563195356089325,0,24,0 +m_99,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.025552255384904132,0.06292694003127715,0.012784649106587996,0.03310210866044399,0.3300243380919754,1,0.03833690449149213,0.09602904869172113,0.10563195356089325,0,24,0 +m_99,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0726965205430045,0.028087744564372425,0.030424534698359415,0.008756228170991087,0.20993115765315268,1,0.10312105524136392,0.03684397273536351,0.11343316076550032,0,24,0 +m_99,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0726965205430045,0.06569724577456926,0.030424534698359415,0.013538582095864022,0.8395915281786241,1,0.10312105524136392,0.07923582787043328,0.11343316076550032,0,24,0 +m_99,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0726965205430045,0.032337790140640976,0.030424534698359415,0.008472931046178443,0.25028009798435963,1,0.10312105524136392,0.040810721186819415,0.11343316076550032,0,24,0 +m_99,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15109880118250793,0.06399732085162979,0.03276497847637769,0.02217936627477682,0.05591766088346512,1,0.18386377965888562,0.08617668712640661,0.2022501576247742,0,24,0 +m_99,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.15109880118250793,0.046927191139574255,0.03276497847637769,0.027912903989432615,0.03662549170405189,0.8423863091931935,0.18386377965888562,0.07484009512900687,0.2022501576247742,0,24,0 +m_99,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.15109880118250793,0.050814558843685166,0.03276497847637769,0.01729130721471528,0.02813178867011813,0.6751629280828351,0.18386377965888562,0.06810586605840044,0.2022501576247742,0,24,0 +m_100,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.37565866437965517,0.15255070822557434,0.15139736074926108,0.04266942369702226,0.21963793413847257,1,0.5270560251289163,0.1952201319225966,0.640976108657904,0,24,0 +m_100,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.37565866437965517,0.4939614554372788,0.15139736074926108,0.08874409788808837,0.5231361461764369,1,0.5270560251289163,0.5827055533253672,0.640976108657904,0,24,0 +m_100,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.37565866437965517,0.2575655226824517,0.15139736074926108,0.10835521422062748,0.5445914369107401,1,0.5270560251289163,0.3659207369030792,0.640976108657904,0,24,0 +m_100,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3567548865641564,0.33680932305555555,0.07083184807403156,0.10665345595302438,0.8797592191887402,1,0.42758673463818797,0.44346277900857994,0.487809056909438,0,24,0 +m_100,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,0.3567548865641564,0.14428670782764763,0.07083184807403156,0.05721241012700396,0.042868641776900036,0.9859787608687008,0.42758673463818797,0.20149911795465159,0.487809056909438,0,24,0 +m_100,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3567548865641564,0.26097866746765835,0.07083184807403156,0.07295079296120133,0.3684447984407274,1,0.42758673463818797,0.3339294604288597,0.487809056909438,0,24,0 +m_100,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.33771647239836894,0.22939934044353172,0.17608745196746262,0.0837031498572958,0.5993512308168523,1,0.5138039243658316,0.3131024903008275,0.5651843168024148,0,24,0 +m_100,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.33771647239836894,0.3797071052905042,0.17608745196746262,0.1330149249019773,0.8541771155506432,1,0.5138039243658316,0.5127220301924815,0.5651843168024148,0,24,0 +m_100,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.33771647239836894,0.18295539315825257,0.17608745196746262,0.10131925278822758,0.47285423637115565,1,0.5138039243658316,0.28427464594648016,0.5651843168024148,0,24,0 +m_100,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.35264067283927014,0.2584172135970379,0.19441781606091174,0.10249202333468091,0.6827340719152176,1,0.5470584889001819,0.36090923693171884,0.6017643377902002,0,24,0 +m_100,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.35264067283927014,0.3201011280505691,0.19441781606091174,0.05564535095121302,0.8789102560396389,1,0.5470584889001819,0.37574647900178215,0.6017643377902002,0,24,0 +m_100,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.35264067283927014,0.26799128111069526,0.19441781606091174,0.11861615283668743,0.7214702584761589,1,0.5470584889001819,0.3866074339473827,0.6017643377902002,0,24,0 +m_100,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04818423880724013,0.05572396581540873,0.014057446095895364,0.012550747149795451,0.6976070209369395,1,0.062241684903135495,0.06827471296520418,0.0751021842617246,0,24,0 +m_100,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04818423880724013,0.042778550346330345,0.014057446095895364,0.02076827606609612,0.8342583955951206,1,0.062241684903135495,0.06354682641242647,0.0751021842617246,0,24,0 +m_100,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04818423880724013,0.03225175507542125,0.014057446095895364,0.010725082616395843,0.39017253204635216,1,0.062241684903135495,0.042976837691817094,0.0751021842617246,0,24,0 +m_100,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10207513495333553,0.10656139077003395,0.04126526473127859,0.03701367025162397,0.9371121645978512,1,0.14334039968461412,0.1435750610216579,0.1579325671238237,0,24,0 +m_100,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10207513495333553,0.10770930569968591,0.04126526473127859,0.03409770305699921,0.9183296320851222,1,0.14334039968461412,0.14180700875668512,0.1579325671238237,0,24,0 +m_100,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10207513495333553,0.08646542914937212,0.04126526473127859,0.0325092860189036,0.7727653564843098,1,0.14334039968461412,0.11897471516827572,0.1579325671238237,0,24,0 +m_100,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.0974723210092913,0.03471497782869045,0.022008431363498733,0.013409944034625799,0.03995128932585026,0.9588309438204061,0.11948075237279004,0.04812492186331625,0.16536840506872716,0,24,0 +m_100,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0974723210092913,0.11105453668614307,0.022008431363498733,0.03928037701269979,0.7707445193544038,1,0.11948075237279004,0.15033491369884286,0.16536840506872716,0,24,0 +m_100,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0974723210092913,0.09477193349175457,0.022008431363498733,0.024309247448559692,0.9360097850404667,1,0.11948075237279004,0.11908118094031427,0.16536840506872716,0,24,0 +m_100,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04706548833270093,0.08591983689037959,0.0185364042955055,0.03129739248898286,0.31615671302215714,1,0.06560189262820643,0.11721722937936245,0.1289389523172987,0,24,0 +m_100,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04706548833270093,0.05131908294646892,0.0185364042955055,0.018831362066053875,0.8753189191573512,1,0.06560189262820643,0.0701504450125228,0.1289389523172987,0,24,0 +m_100,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04706548833270093,0.06773863779934601,0.0185364042955055,0.027067957976250608,0.5445299172102709,1,0.06560189262820643,0.09480659577559662,0.1289389523172987,0,24,0 +m_101,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17479446327782783,0.09406400343288175,0.09410983638659885,0.02308542646149171,0.44686812337116427,1,0.2689042996644267,0.11714942989437346,0.2957947296308694,0,24,0 +m_101,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17479446327782783,0.0657687049082436,0.09410983638659885,0.021606595359045935,0.31633870921346186,1,0.2689042996644267,0.08737530026728954,0.2957947296308694,0,24,0 +m_101,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17479446327782783,0.1196431128825715,0.09410983638659885,0.05433985461707801,0.6284819146175007,1,0.2689042996644267,0.1739829674996495,0.2957947296308694,0,24,0 +m_101,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07653085309585823,0.05632090266111315,0.02884585376106529,0.024244103561156298,0.6037877524924286,1,0.10537670685692352,0.08056500622226945,0.12290351464558248,0,24,0 +m_101,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07653085309585823,0.061353174794545016,0.02884585376106529,0.05037729306507541,0.800380689485622,1,0.10537670685692352,0.11173046785962043,0.12290351464558248,0,24,0 +m_101,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07653085309585823,0.028024903137373974,0.02884585376106529,0.018901592469745182,0.19456714712204295,1,0.10537670685692352,0.04692649560711916,0.12290351464558248,0,24,0 +m_101,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.021483260290738437,0.09398096799569877,0.008473876748298123,0.043487755605532134,0.15859173542417818,1,0.02995713703903656,0.1374687236012309,0.24433351100218012,0,24,0 +m_101,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.021483260290738437,0.1522627552285055,0.008473876748298123,0.06985861840984006,0.13460092518559721,1,0.02995713703903656,0.22212137363834555,0.24433351100218012,0,24,0 +m_101,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.021483260290738437,0.07363834193003005,0.008473876748298123,0.02390463276403142,0.08387145590373656,1,0.02995713703903656,0.09754297469406147,0.24433351100218012,0,24,0 +m_101,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06747141994808299,0.045005661182861645,0.029033174448093224,0.021785119818974925,0.5536129734408687,1,0.09650459439617622,0.06679078100183657,0.11087032146240514,0,24,0 +m_101,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.06747141994808299,0.05535646619488858,0.029033174448093224,0.045434735134570636,0.8277152329751247,1,0.09650459439617622,0.1007912013294592,0.11087032146240514,0,24,0 +m_101,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06747141994808299,0.0630237899871698,0.029033174448093224,0.023112410985890928,0.9075270461751938,1,0.09650459439617622,0.08613620097306073,0.11087032146240514,0,24,0 +m_101,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.3273281444623082,0.27070113407009283,0.07320555112210442,0.1254903317545995,0.7068143713577625,1,0.4005336955844126,0.39619146582469233,0.5809802489558825,0,24,0 +m_101,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.3273281444623082,0.31961113778410627,0.07320555112210442,0.2085527249030596,0.9732428660388907,1,0.4005336955844126,0.5281638626871659,0.5809802489558825,0,24,0 +m_101,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.3273281444623082,0.34316359309070116,0.07320555112210442,0.12708446125715192,0.9166795641047785,1,0.4005336955844126,0.4702480543478531,0.5809802489558825,0,24,0 +m_101,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.3077772863078061,0.3280567259004414,0.07436208598346587,0.17511334499187328,0.9182107212593031,1,0.382139372291272,0.5031700708923147,0.5534870779815462,0,24,0 +m_101,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.3077772863078061,0.19077127149273118,0.07436208598346587,0.06611295958293933,0.2672264343197586,1,0.382139372291272,0.2568842310756705,0.5534870779815462,0,24,0 +m_101,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.3077772863078061,0.2769460122319857,0.07436208598346587,0.06797345509620108,0.7659116953518672,1,0.382139372291272,0.3449194673281868,0.5534870779815462,0,24,0 +m_101,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.30264371598047884,0.07930086777637635,0.12781434968554348,0.03704626292945385,0.1456975156316832,1,0.4304580656660223,0.11634713070583019,0.4735038722326246,0,24,0 +m_101,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.30264371598047884,0.21077840255433902,0.12781434968554348,0.047385694654300696,0.524129390084714,1,0.4304580656660223,0.2581640972086397,0.4735038722326246,0,24,0 +m_101,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.30264371598047884,0.2760094067638359,0.12781434968554348,0.11385212719544961,0.8794829646237583,1,0.4304580656660223,0.3898615339592855,0.4735038722326246,0,24,0 +m_101,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.41496388373232235,0.2806950505826571,0.05814308514544285,0.059560831035351536,0.13781054108486762,1,0.4731069688777652,0.3402558816180086,0.587193297060559,0,24,0 +m_101,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.41496388373232235,0.46592487744287786,0.05814308514544285,0.0678872107939939,0.5814548661657664,1,0.4731069688777652,0.5338120882368718,0.587193297060559,0,24,0 +m_101,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.41496388373232235,0.39860188243357636,0.05814308514544285,0.09565591667196145,0.8872978557526263,1,0.4731069688777652,0.4942577991055378,0.587193297060559,0,24,0 +m_102,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07569522798396985,0.041864340689219105,0.030208600487955553,0.022792313347001797,0.39799567684567017,1,0.10590382847192541,0.0646566540362209,0.14270928693068466,0,24,0 +m_102,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07569522798396985,0.0679820236634157,0.030208600487955553,0.01510389567373495,0.8269968780294494,1,0.10590382847192541,0.08308591933715065,0.14270928693068466,0,24,0 +m_102,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07569522798396985,0.10269546932550007,0.030208600487955553,0.027040246066031448,0.5229437436022961,1,0.10590382847192541,0.1297357153915315,0.14270928693068466,0,24,0 +m_102,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03981802132007791,0.0762404955129385,0.008553912148746142,0.02802994221951278,0.26086686675978227,1,0.048371933468824055,0.10427043773245129,0.11469748150569642,0,24,0 +m_102,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03981802132007791,0.02067824050030494,0.008553912148746142,0.0046446162842099506,0.08616255032396843,1,0.048371933468824055,0.025322856784514892,0.11469748150569642,0,24,0 +m_102,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03981802132007791,0.046442973357345485,0.008553912148746142,0.009505004754116963,0.615786107022467,1,0.048371933468824055,0.055947978111462446,0.11469748150569642,0,24,0 +m_102,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.034325932163303374,0.183323420587061,0.013157221483607852,0.13299589497904993,0.31468580548324754,1,0.047483153646911226,0.3163193155661109,0.3479512471227221,0,24,0 +m_102,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.034325932163303374,0.05176437181597278,0.013157221483607852,0.025561930663063264,0.5664349823804793,1,0.047483153646911226,0.07732630247903605,0.3479512471227221,0,24,0 +m_102,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.034325932163303374,0.050356597497758525,0.013157221483607852,0.013776034760165385,0.42194542795894163,1,0.047483153646911226,0.06413263225792391,0.3479512471227221,0,24,0 +m_102,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07091788952180193,0.09133720344580036,0.030063741306683073,0.04372617624303194,0.7098583656105155,1,0.100981630828485,0.1350633796888323,0.15201755671616146,0,24,0 +m_102,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07091788952180193,0.08301650423814688,0.030063741306683073,0.05518127459472717,0.8523867007699012,1,0.100981630828485,0.13819777883287404,0.15201755671616146,0,24,0 +m_102,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07091788952180193,0.055497785971505266,0.030063741306683073,0.02366641006222192,0.6974534782978246,1,0.100981630828485,0.07916419603372718,0.15201755671616146,0,24,0 +m_102,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.009801931803075833,0.017759327115066448,0.0026872633231655296,0.004381367960650232,0.15883009302634682,1,0.012489195126241363,0.022140695075716678,0.04731668486182934,0,24,0 +m_102,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.009801931803075833,0.019385101500151086,0.0026872633231655296,0.009575405679842566,0.3737998093905249,1,0.012489195126241363,0.028960507179993652,0.04731668486182934,0,24,0 +m_102,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.009801931803075833,0.03336161901077942,0.0026872633231655296,0.009653549045429066,0.058650451202220844,1,0.012489195126241363,0.04301516805620849,0.04731668486182934,0,24,0 +m_102,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.01672647410709449,0.015800062547582188,0.008583032527888116,0.004575934600155213,0.9265741565821792,1,0.025309506634982607,0.020375997147737402,0.05215795802799711,0,24,0 +m_102,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.01672647410709449,0.03111676314604443,0.008583032527888116,0.016299562333952942,0.45841418068735507,1,0.025309506634982607,0.04741632547999737,0.05215795802799711,0,24,0 +m_102,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.01672647410709449,0.010619192190616022,0.008583032527888116,0.004406045191045036,0.5456215766377004,1,0.025309506634982607,0.015025237381661057,0.05215795802799711,0,24,0 +m_102,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.03608729440224109,0.0383920625334185,0.018178764513782766,0.0046608915156282245,0.9065043954531826,1,0.05426605891602385,0.04305295404904673,0.062431354446000495,0,24,0 +m_102,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.03608729440224109,0.03363145023840416,0.018178764513782766,0.00821386776342363,0.9054993354604102,1,0.05426605891602385,0.04184531800182779,0.062431354446000495,0,24,0 +m_102,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.03608729440224109,0.039804168973492704,0.018178764513782766,0.016951607795598646,0.8841179262790033,1,0.05426605891602385,0.056755776769091354,0.062431354446000495,0,24,0 +m_102,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.034652900132128295,0.026844682008767034,0.014025522395762447,0.012396915979324661,0.6855279912073993,1,0.048678422527890744,0.039241597988091695,0.05354626478067982,0,24,0 +m_102,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.034652900132128295,0.023383770272069764,0.014025522395762447,0.00516134972283838,0.47793094386283486,1,0.048678422527890744,0.028545119994908143,0.05354626478067982,0,24,0 +m_102,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.034652900132128295,0.03397154873492081,0.014025522395762447,0.004780691630560535,0.96478258650921,1,0.048678422527890744,0.03875224036548135,0.05354626478067982,0,24,0 +m_103,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.6410122743924906,0.5946616673328131,0.3554210316249802,0.2742088119347891,0.9203253475141582,1,0.9964333060174708,0.8688704792676022,1.5394733997254273,0,24,0 +m_103,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.6410122743924906,1.0773635170352356,0.3554210316249802,0.3221577554424256,0.3877439899619939,1,0.9964333060174708,1.3995212724776611,1.5394733997254273,0,24,0 +m_103,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.6410122743924906,0.34290491675197315,0.3554210316249802,0.23530897051663807,0.5063660741154308,1,0.9964333060174708,0.5782138872686112,1.5394733997254273,0,24,0 +m_103,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11314634160596133,0.24489022099876334,0.05483020724273686,0.10483517554655158,0.29967861693669534,1,0.1679765488486982,0.3497253965453149,0.5328930927701733,0,23,0 +m_103,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11314634160596133,0.2953197819441159,0.05483020724273686,0.18912848421058703,0.40014225095643036,1,0.1679765488486982,0.48444826615470293,0.5328930927701733,0,23,0 +m_103,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11314634160596133,0.2575492598733882,0.05483020724273686,0.09275412077790872,0.21649811898575907,1,0.1679765488486982,0.35030338065129696,0.5328930927701733,0,23,0 +m_103,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3604018895406515,0.290960842747738,0.181365054531925,0.12001156504207533,0.7585984866771274,1,0.5417669440725765,0.4109724077898133,0.7652757260845495,0,24,0 +m_103,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3604018895406515,0.4649584615619271,0.181365054531925,0.23074674396948144,0.7313678506628358,1,0.5417669440725765,0.6957052055314086,0.7652757260845495,0,24,0 +m_103,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3604018895406515,0.33442843265317507,0.181365054531925,0.12392322773784185,0.909050085765952,1,0.5417669440725765,0.45835166039101694,0.7652757260845495,0,24,0 +m_103,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14902865725308329,0.1108099625694204,0.11154438548282442,0.028854327446080585,0.7548730764783447,1,0.2605730427359077,0.13966429001550099,0.5590287636588028,0,24,0 +m_103,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14902865725308329,0.25265213203003767,0.11154438548282442,0.06625443836634627,0.45200171853391935,1,0.2605730427359077,0.3189065703963839,0.5590287636588028,0,24,0 +m_103,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14902865725308329,0.3330164885338102,0.11154438548282442,0.17519147842873775,0.40093301924610625,1,0.2605730427359077,0.508207966962548,0.5590287636588028,0,24,0 +m_103,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.044776879866909404,0.06504180513704864,0.022851095473453136,0.03448258990250055,0.6363574727714372,1,0.06762797534036254,0.09952439503954918,0.16898147476407724,0,24,0 +m_103,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.044776879866909404,0.13141670757517362,0.022851095473453136,0.022202814937623855,0.021601748584124798,0.5184419660189952,0.06762797534036254,0.15361952251279748,0.16898147476407724,0,24,0 +m_103,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.044776879866909404,0.03288727957223466,0.022851095473453136,0.011021218536406691,0.6531677861950399,1,0.06762797534036254,0.04390849810864135,0.16898147476407724,0,24,0 +m_103,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05939488064474974,0.05510431553920784,0.036325527006508956,0.02765827277561982,0.9271146554784803,1,0.0957204076512587,0.08276258831482766,0.13083693454222084,0,24,0 +m_103,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05939488064474974,0.11100392366534839,0.036325527006508956,0.007938744100306915,0.21896764309560846,1,0.0957204076512587,0.1189426677656553,0.13083693454222084,0,24,0 +m_103,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05939488064474974,0.07256088779819218,0.036325527006508956,0.037749759617914574,0.8066681732353691,1,0.0957204076512587,0.11031064741610676,0.13083693454222084,0,24,0 +m_103,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.02159635168769129,0.023586665569377423,0.007309924475195238,0.00926942152067232,0.869652467031875,1,0.028906276162886525,0.032856087090049745,0.057144583190862505,0,24,0 +m_103,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.02159635168769129,0.03459491578775934,0.007309924475195238,0.017354705294842936,0.5131552200194929,1,0.028906276162886525,0.051949621082602274,0.057144583190862505,0,24,0 +m_103,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.02159635168769129,0.022484822161901914,0.007309924475195238,0.011366490125024383,0.9490964524635436,1,0.028906276162886525,0.0338513122869263,0.057144583190862505,0,24,0 +m_103,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.025231288042276773,0.03005558858949442,0.005756505963636528,0.009374458000272458,0.6721841749403367,1,0.0309877940059133,0.03943004658976688,0.04337305124874357,0,24,0 +m_103,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.025231288042276773,0.029452229734703888,0.005756505963636528,0.009900338083656122,0.7219722482358432,1,0.0309877940059133,0.03935256781836001,0.04337305124874357,0,24,0 +m_103,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.025231288042276773,0.0227217199977446,0.005756505963636528,0.012796814041929413,0.8631643389558686,1,0.0309877940059133,0.03551853403967401,0.04337305124874357,0,24,0 +m_104,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.6410122743924904,0.44470380888213507,0.3554210316249802,0.18710927507420888,0.6419755039492647,1,0.9964333060174706,0.631813083956344,1.3957941715834783,0,24,0 +m_104,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.6410122743924904,0.8614537465875042,0.3554210316249802,0.4074500457611124,0.6930215303984663,1,0.9964333060174706,1.2689037923486166,1.3957941715834783,0,24,0 +m_104,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.6410122743924904,0.34290491675197315,0.3554210316249802,0.23530897051663807,0.5063660741154312,1,0.9964333060174706,0.5782138872686112,1.3957941715834783,0,24,0 +m_104,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.33023802838363897,0.24489022099876334,0.24472510239450834,0.10483517554655158,0.7581934203949603,1,0.5749631307781473,0.3497253965453149,0.6324594438559621,0,23,0 +m_104,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.33023802838363897,0.2953197819441159,0.24472510239450834,0.18912848421058703,0.9126383367327427,1,0.5749631307781473,0.48444826615470293,0.6324594438559621,0,23,0 +m_104,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.33023802838363897,0.25754925987338834,0.24472510239450834,0.0927541207779087,0.7899560854954564,1,0.5749631307781473,0.35030338065129707,0.6324594438559621,0,23,0 +m_104,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.3604018895406516,0.290960842747738,0.18136505453192497,0.12001156504207533,0.7585984866771269,1,0.5417669440725765,0.4109724077898133,0.7652757260845495,0,24,0 +m_104,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.3604018895406516,0.4649584615619271,0.18136505453192497,0.23074674396948144,0.731367850662836,1,0.5417669440725765,0.6957052055314086,0.7652757260845495,0,24,0 +m_104,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.3604018895406516,0.3344284326531752,0.18136505453192497,0.12392322773784181,0.9090500857659519,1,0.5417669440725765,0.458351660391017,0.7652757260845495,0,24,0 +m_104,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14902865725308329,0.1108099625694204,0.11154438548282442,0.028854327446080585,0.7548730764783447,1,0.2605730427359077,0.13966429001550099,0.4173327955033555,0,24,0 +m_104,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14902865725308329,0.25265213203003767,0.11154438548282442,0.06625443836634626,0.45200171853391924,1,0.2605730427359077,0.3189065703963839,0.4173327955033555,0,24,0 +m_104,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14902865725308329,0.2640276475901214,0.11154438548282442,0.11536580286747447,0.4918882215351714,1,0.2605730427359077,0.37939345045759587,0.4173327955033555,0,24,0 +m_104,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04478141072924524,0.06504180513704864,0.022850917054254904,0.03448258990250055,0.6364311507075098,1,0.06763232778350015,0.09952439503954918,0.16898147476407724,0,24,0 +m_104,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.04478141072924524,0.13141670757517362,0.022850917054254904,0.022202814937623855,0.02160660721283264,0.5185585731079834,0.06763232778350015,0.15361952251279748,0.16898147476407724,0,24,0 +m_104,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04478141072924524,0.03288727957223466,0.022850917054254904,0.011021218536406691,0.6530440126472302,1,0.06763232778350015,0.04390849810864135,0.16898147476407724,0,24,0 +m_104,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05939488064474974,0.05510431553920784,0.036325527006508956,0.02765827277561982,0.9271146554784803,1,0.0957204076512587,0.08276258831482766,0.13083693454222084,0,24,0 +m_104,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05939488064474974,0.11100392366534839,0.036325527006508956,0.007938744100306915,0.21896764309560846,1,0.0957204076512587,0.1189426677656553,0.13083693454222084,0,24,0 +m_104,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05939488064474974,0.07256088779819218,0.036325527006508956,0.037749759617914574,0.8066681732353691,1,0.0957204076512587,0.11031064741610676,0.13083693454222084,0,24,0 +m_104,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.02159635168769129,0.023586665569377423,0.007309924475195238,0.00926942152067232,0.869652467031875,1,0.028906276162886525,0.032856087090049745,0.057144583190862505,0,24,0 +m_104,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.02159635168769129,0.03459491578775934,0.007309924475195238,0.017354705294842936,0.5131552200194929,1,0.028906276162886525,0.051949621082602274,0.057144583190862505,0,24,0 +m_104,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.02159635168769129,0.022484822161901914,0.007309924475195238,0.011366490125024383,0.9490964524635436,1,0.028906276162886525,0.0338513122869263,0.057144583190862505,0,24,0 +m_104,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.025231288042276773,0.030050483732751026,0.005756505963636528,0.009375640585252141,0.6725359647414171,1,0.0309877940059133,0.039426124318003165,0.04336873674980349,0,24,0 +m_104,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.025231288042276773,0.029452229734703888,0.005756505963636528,0.009900338083656122,0.7219722482358432,1,0.0309877940059133,0.03935256781836001,0.04336873674980349,0,24,0 +m_104,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.025231288042276773,0.0227217199977446,0.005756505963636528,0.012796814041929413,0.8631643389558686,1,0.0309877940059133,0.03551853403967401,0.04336873674980349,0,24,0 +m_105,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.0927820121528073,0.04489645225977105,0.08098834133006362,0.01675609468992553,0.5912986277529855,1,0.17377035348287093,0.061652546949696574,0.19114738883115803,0,24,0 +m_105,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.0927820121528073,0.08719324177506782,0.08098834133006362,0.01622457221653174,0.9490702330137342,1,0.17377035348287093,0.10341781399159956,0.19114738883115803,0,24,0 +m_105,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.0927820121528073,0.038252407794893216,0.08098834133006362,0.016774504593789603,0.543019990879775,1,0.17377035348287093,0.05502691238868282,0.19114738883115803,0,24,0 +m_105,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.022233312541402667,0.042483874018666455,0.010968933995966882,0.02509629032062601,0.4842630640336053,1,0.03320224653736955,0.06758016433929247,0.11365406014257572,0,24,0 +m_105,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.022233312541402667,0.06907620187477932,0.010968933995966882,0.03424567098210768,0.2403376130272451,1,0.03320224653736955,0.103321872856887,0.11365406014257572,0,24,0 +m_105,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.022233312541402667,0.055026603015977726,0.010968933995966882,0.02274320849537353,0.23404439906187358,1,0.03320224653736955,0.07776981151135126,0.11365406014257572,0,24,0 +m_105,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.020229960038663463,0.0333792620833695,0.011160457312119402,0.012366092634418468,0.4501823717437259,1,0.031390417350782865,0.04574535471778797,0.1420776032126287,0,24,0 +m_105,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.020229960038663463,0.06993353808605848,0.011160457312119402,0.030914409418779584,0.1905876701407692,1,0.031390417350782865,0.10084794750483807,0.1420776032126287,0,24,0 +m_105,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.020229960038663463,0.08935228079593054,0.011160457312119402,0.03980917667009553,0.14752983615002194,1,0.031390417350782865,0.12916145746602606,0.1420776032126287,0,24,0 +m_105,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09838082604580638,0.08318413205256377,0.04348554355339218,0.03630936159089246,0.7950569741333925,1,0.14186636959919857,0.11949349364345623,0.15605300655911844,0,24,0 +m_105,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09838082604580638,0.0636422436952883,0.04348554355339218,0.0308379582349462,0.5340553043267144,1,0.14186636959919857,0.0944802019302345,0.15605300655911844,0,24,0 +m_105,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09838082604580638,0.0565328451404861,0.04348554355339218,0.02105390404873552,0.42056427751331493,1,0.14186636959919857,0.07758674918922162,0.15605300655911844,0,24,0 +m_105,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18165385826052902,0.1965773538303528,0.07412857409641883,0.030298586653363435,0.8577441307214724,1,0.25578243235694786,0.22687594048371623,0.28756080353064983,0,24,0 +m_105,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18165385826052902,0.08995928973914658,0.07412857409641883,0.04472934968633094,0.3197010806845845,1,0.25578243235694786,0.1346886394254775,0.28756080353064983,0,24,0 +m_105,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18165385826052902,0.18079174421908648,0.07412857409641883,0.08062716808150423,0.9938755078791246,1,0.25578243235694786,0.2614189123005907,0.28756080353064983,0,24,0 +m_105,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1223820141469435,0.14620316926989044,0.04887953006547445,0.06787172967914622,0.7821792148686126,1,0.17126154421241796,0.21407489894903664,0.2879193277683681,0,24,0 +m_105,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1223820141469435,0.10397885895981447,0.04887953006547445,0.045310163780556384,0.7881126119411183,1,0.17126154421241796,0.14928902274037087,0.2879193277683681,0,24,0 +m_105,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1223820141469435,0.1845837239251733,0.04887953006547445,0.07716111950061584,0.5140910307482927,1,0.17126154421241796,0.26174484342578913,0.2879193277683681,0,24,0 +m_105,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10347853583134399,0.11960851550203395,0.062181661646854035,0.03270777700546323,0.824500444180217,1,0.16566019747819802,0.15231629250749718,0.31442994612536507,0,24,0 +m_105,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10347853583134399,0.2164819781488502,0.062181661646854035,0.06936342741966346,0.2533006544713981,1,0.16566019747819802,0.2858454055685137,0.31442994612536507,0,24,0 +m_105,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10347853583134399,0.18928010427063915,0.062181661646854035,0.04849884270525706,0.3035739480538917,1,0.16566019747819802,0.23777894697589622,0.31442994612536507,0,24,0 +m_105,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18225020158112293,0.1670085930800853,0.043771267055776594,0.051136633538186343,0.825532867752658,1,0.22602146863689954,0.21814522661827165,0.2486236155005895,0,24,0 +m_105,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18225020158112293,0.1757813866999788,0.043771267055776594,0.028572543083923797,0.9043518591584631,1,0.22602146863689954,0.2043539297839026,0.2486236155005895,0,24,0 +m_105,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18225020158112293,0.07233285998184606,0.043771267055776594,0.027542451138439672,0.06455431975431503,1,0.22602146863689954,0.09987531112028573,0.2486236155005895,0,24,0 +m_106,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09699711901170271,0.03024924652350336,0.05509429774258491,0.008393682144080991,0.2944206015336947,1,0.1520914167542876,0.03864292866758435,0.1673005584297164,0,24,0 +m_106,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09699711901170271,0.06153205895470889,0.05509429774258491,0.019941154834682357,0.5711699796898498,1,0.1520914167542876,0.08147321378939125,0.1673005584297164,0,24,0 +m_106,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09699711901170271,0.032029453059609546,0.05509429774258491,0.0045129761877832405,0.3042664120644776,1,0.1520914167542876,0.03654242924739279,0.1673005584297164,0,24,0 +m_106,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.04787369932752594,0.009201989574365651,0.01310911254170455,0.002908078758674358,0.03103771439930212,0.7449051455832509,0.06098281186923049,0.012110068333040009,0.06708109305615355,0,24,0 +m_106,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.04787369932752594,0.03976383115790642,0.01310911254170455,0.01641982147722366,0.7079830270222934,1,0.06098281186923049,0.056183652635130074,0.06708109305615355,0,24,0 +m_106,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.04787369932752594,0.03564605733433616,0.01310911254170455,0.00518506922417713,0.4164816800253718,1,0.06098281186923049,0.04083112655851329,0.06708109305615355,0,24,0 +m_106,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07328125174519062,0.024069250488549354,0.02484567678780502,0.016589917881817243,0.14222362583625905,1,0.09812692853299565,0.040659168370366594,0.14794122577808116,1,24,4.166666666666666 +m_106,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07328125174519062,0.08856480375365346,0.02484567678780502,0.04592721968096577,0.7793718125005717,1,0.09812692853299565,0.13449202343461922,0.14794122577808116,1,24,4.166666666666666 +m_106,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07328125174519062,0.03273210716438676,0.02484567678780502,0.01642963457855927,0.21466245634617961,1,0.09812692853299565,0.049161741742946026,0.14794122577808116,1,24,4.166666666666666 +m_106,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.023129487737413346,0.049514154492828734,0.011400631836192972,0.031350355718253245,0.45783770721625194,1,0.03453011957360632,0.08086451021108199,0.08895096123219019,1,24,4.166666666666666 +m_106,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.023129487737413346,0.03464870954848472,0.011400631836192972,0.012519442212621999,0.5134373691094776,1,0.03453011957360632,0.047168151761106725,0.08895096123219019,1,24,4.166666666666666 +m_106,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.023129487737413346,0.035181909724158654,0.011400631836192972,0.009526009076873189,0.43986757624460604,1,0.03453011957360632,0.044707918801031844,0.08895096123219019,1,24,4.166666666666666 +m_106,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.034805798976429436,0.015807357711653314,0.007061670337414379,0.006004410384183215,0.06827446217079006,1,0.041867469313843816,0.02181176809583653,0.07090208019588436,0,24,0 +m_106,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.034805798976429436,0.012434010470703841,0.007061670337414379,0.00782060901359776,0.059984960436819314,1,0.041867469313843816,0.0202546194843016,0.07090208019588436,0,24,0 +m_106,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.034805798976429436,0.04498097836175171,0.007061670337414379,0.019475458179961328,0.6399677524091889,1,0.041867469313843816,0.06445643654171304,0.07090208019588436,0,24,0 +m_106,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.03600890357504379,0.016996381408120726,0.006244361657579881,0.007224343328828751,0.07508844008576913,1,0.042253265232623675,0.024220724736949476,0.04647859175588605,0,24,0 +m_106,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.03600890357504379,0.029558741115227456,0.006244361657579881,0.008444849862711086,0.5539890359215007,1,0.042253265232623675,0.03800359097793854,0.04647859175588605,0,24,0 +m_106,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.03600890357504379,0.022229523896857433,0.006244361657579881,0.007242903110338978,0.18082768271822786,1,0.042253265232623675,0.029472427007196413,0.04647859175588605,0,24,0 +m_106,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.028430348997868487,0.02566885709396464,0.0066124241753244654,0.0053013739259360005,0.7515787312574668,1,0.03504277317319295,0.03097023101990064,0.05249741189136208,0,24,0 +m_106,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.028430348997868487,0.04079779417229212,0.0066124241753244654,0.006927125728946134,0.22566457285679672,1,0.03504277317319295,0.047724919901238255,0.05249741189136208,0,24,0 +m_106,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.028430348997868487,0.01559219207762482,0.0066124241753244654,0.0031883541880195643,0.1225810912473315,1,0.03504277317319295,0.018780546265644384,0.05249741189136208,0,24,0 +m_106,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.02832649448041713,0.014358640163956013,0.006545553803077798,0.0036817593988640934,0.10052752447610694,1,0.034872048283494925,0.018040399562820105,0.076389280727022,0,24,0 +m_106,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.02832649448041713,0.03523106126967379,0.006545553803077798,0.014193332022448976,0.6719287526485014,1,0.034872048283494925,0.04942439329212277,0.076389280727022,0,24,0 +m_106,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.02832649448041713,0.04628127275416016,0.006545553803077798,0.023163527906768927,0.48486742767532987,1,0.034872048283494925,0.06944480066092909,0.076389280727022,0,24,0 +m_107,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07693904464242296,0.05214340934995095,0.03399201912538455,0.023486144322731172,0.566369151594934,1,0.11093106376780751,0.07562955367268212,0.1968149914009206,0,24,0 +m_107,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07693904464242296,0.12218810121995578,0.03399201912538455,0.05673461823542657,0.5133134444371951,1,0.11093106376780751,0.17892271945538235,0.1968149914009206,0,24,0 +m_107,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07693904464242296,0.12289288505165419,0.03399201912538455,0.03873403512830366,0.39576868158645184,1,0.11093106376780751,0.16162692017995783,0.1968149914009206,0,24,0 +m_107,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07882412851141729,0.11679696044855008,0.016597552194195904,0.07064902334155104,0.6210249868334753,1,0.09542168070561319,0.18744598379010113,0.20619058216911126,0,24,0 +m_107,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07882412851141729,0.10816308205746454,0.016597552194195904,0.03665038381183483,0.4896476480312477,1,0.09542168070561319,0.14481346586929938,0.20619058216911126,0,24,0 +m_107,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07882412851141729,0.12451045726234027,0.016597552194195904,0.024401391546867403,0.1567242709922057,1,0.09542168070561319,0.14891184880920766,0.20619058216911126,0,24,0 +m_107,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.292425575577692,0.14106316522348342,0.14875674665179478,0.04968554261643658,0.3797277934306474,1,0.4411823222294868,0.19074870783991998,0.4853005544524355,0,24,0 +m_107,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.292425575577692,0.17399808296911612,0.14875674665179478,0.10163216126504639,0.5317790810840864,1,0.4411823222294868,0.2756302442341625,0.4853005544524355,0,24,0 +m_107,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.292425575577692,0.09355963629880797,0.14875674665179478,0.01601538137182325,0.25304540965622985,1,0.4411823222294868,0.10957501767063121,0.4853005544524355,0,24,0 +m_107,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.25338365296545096,0.06467401500603505,0.1029705512867857,0.01861320014873648,0.14123601815834003,1,0.35635420425223663,0.08328721515477153,0.39198962467746035,0,24,0 +m_107,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.25338365296545096,0.10465753101964885,0.1029705512867857,0.04004189739254084,0.23389804305786072,1,0.35635420425223663,0.1446994284121897,0.39198962467746035,0,24,0 +m_107,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.25338365296545096,0.10298746313979328,0.1029705512867857,0.04356894974293907,0.23211519875026662,1,0.35635420425223663,0.14655641288273236,0.39198962467746035,0,24,0 +m_107,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.05158394687196669,0.04096099025764044,0.01701571822191706,0.024598884482395656,0.7307485002569819,1,0.06859966509388375,0.06555987474003609,0.09094849707666551,0,24,0 +m_107,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.05158394687196669,0.035395728672674785,0.01701571822191706,0.011434238551272173,0.45060088789952657,1,0.06859966509388375,0.04682996722394696,0.09094849707666551,0,24,0 +m_107,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.05158394687196669,0.06115533107360497,0.01701571822191706,0.021525120814272766,0.7348273328433202,1,0.06859966509388375,0.08268045188787773,0.09094849707666551,0,24,0 +m_107,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.15211481265719895,0.05064730888764942,0.023867365966673923,0.01757799051356359,0.007359935517509725,0.16927851690272366,0.1759821786238729,0.06822529940121301,0.1935803964862602,0,24,0 +m_107,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.15211481265719895,0.06207292751399174,0.023867365966673923,0.02830111947051816,0.035964962280135834,0.7912291701629883,0.1759821786238729,0.0903740469845099,0.1935803964862602,0,24,0 +m_107,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.15211481265719895,0.03584125401342194,0.023867365966673923,0.017071148141421938,0.003252968217965779,0.07807123723117869,0.1759821786238729,0.05291240215484388,0.1935803964862602,0,24,0 +m_107,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.051119788548870414,0.03287516747114183,0.02114165079277304,0.009784393221246503,0.45903326980466885,1,0.07226143934164345,0.04265956069238833,0.13212152211534284,0,24,0 +m_107,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.051119788548870414,0.09351800185380761,0.02114165079277304,0.026592472796504042,0.24185835913532988,1,0.07226143934164345,0.12011047465031166,0.13212152211534284,0,24,0 +m_107,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.051119788548870414,0.02982992666890098,0.02114165079277304,0.01218226642046784,0.408375609629096,1,0.07226143934164345,0.04201219308936882,0.13212152211534284,0,24,0 +m_107,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.02731670116165789,0.049357019440770866,0.00856935536903241,0.021745907434865576,0.3793341401711689,1,0.0358860565306903,0.07110292687563644,0.10127956009343901,0,24,0 +m_107,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.02731670116165789,0.05250073678546167,0.00856935536903241,0.01307264486549188,0.14306089843752803,1,0.0358860565306903,0.06557338165095354,0.10127956009343901,0,24,0 +m_107,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.02731670116165789,0.06864728087134438,0.00856935536903241,0.023425046486327435,0.14612808729429502,1,0.0358860565306903,0.09207232735767182,0.10127956009343901,0,24,0 +m_108,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.24766897967014123,0.07865672904089786,0.10685820410940479,0.021195796850578548,0.1905822132095976,1,0.354527183779546,0.09985252589147642,0.3899799021575006,0,24,0 +m_108,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.24766897967014123,0.14475776348297323,0.10685820410940479,0.048624216175343,0.4165163414060194,1,0.354527183779546,0.19338197965831622,0.3899799021575006,0,24,0 +m_108,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.24766897967014123,0.07440051614280252,0.10685820410940479,0.029632400157987484,0.18370680382147114,1,0.354527183779546,0.10403291630079001,0.3899799021575006,0,24,0 +m_108,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12677935905444734,0.07524480387820476,0.025719701848113154,0.015107270514817266,0.1219200037092085,1,0.1524990609025605,0.09035207439302202,0.2245804635112184,0,24,0 +m_108,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12677935905444734,0.1489968879848268,0.025719701848113154,0.05516716975264446,0.7257696479932061,1,0.1524990609025605,0.20416405773747126,0.2245804635112184,0,24,0 +m_108,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12677935905444734,0.1326791855466131,0.025719701848113154,0.04402007283378416,0.9107055084499569,1,0.1524990609025605,0.17669925838039724,0.2245804635112184,0,24,0 +m_108,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.19206099382448943,0.0927187569546083,0.0845453976547271,0.04427941808731261,0.3372458055095258,1,0.2766063914792165,0.1369981750419209,0.6807907639140123,1,24,4.166666666666666 +m_108,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.19206099382448943,0.39629251980894986,0.0845453976547271,0.2226081746583339,0.42930902329025467,1,0.2766063914792165,0.6189006944672838,0.6807907639140123,1,24,4.166666666666666 +m_108,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.19206099382448943,0.13568981551339152,0.0845453976547271,0.05078181953197577,0.5862401274291447,1,0.2766063914792165,0.1864716350453673,0.6807907639140123,1,24,4.166666666666666 +m_108,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09991540431005488,0.15256546963872816,0.025434954721459728,0.07249564460475451,0.517986309063943,1,0.12535035903151462,0.22506111424348269,0.3388240581582074,0,24,0 +m_108,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09991540431005488,0.22591419098052834,0.025434954721459728,0.08210768007238742,0.19355707001771458,1,0.12535035903151462,0.3080218710529158,0.3388240581582074,0,24,0 +m_108,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09991540431005488,0.11837715386641141,0.025434954721459728,0.04747254677129254,0.7411521862341734,1,0.12535035903151462,0.16584970063770396,0.3388240581582074,0,24,0 +m_108,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18146061034564967,0.39903292885490854,0.07990506971906637,0.20408659115709932,0.35637230723555713,1,0.26136568006471605,0.6031195200120079,0.6634314720132087,0,24,0 +m_108,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18146061034564967,0.29529400963475794,0.07990506971906637,0.1003538271550588,0.39673218940915755,1,0.26136568006471605,0.39564783678981674,0.6634314720132087,0,24,0 +m_108,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18146061034564967,0.20953261610380502,0.07990506971906637,0.11528260107021564,0.8458736525017894,1,0.26136568006471605,0.3248152171740207,0.6634314720132087,0,24,0 +m_108,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1435067634544319,0.16308471442299796,0.058958222924162335,0.06857132702478087,0.8330533493334887,1,0.20246498637859422,0.23165604144777885,0.31756945421071003,0,24,0 +m_108,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1435067634544319,0.12163360016244473,0.058958222924162335,0.0396917945945157,0.7654622035147658,1,0.20246498637859422,0.16132539475696045,0.31756945421071003,0,24,0 +m_108,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1435067634544319,0.23368024845979382,0.058958222924162335,0.055019255368124374,0.28974920157027306,1,0.20246498637859422,0.2886995038279182,0.31756945421071003,0,24,0 +m_108,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1919644086456953,0.1129054282878903,0.058202098356855254,0.04323072735662337,0.3031615347734345,1,0.25016650700255055,0.15613615564451366,0.4060274815026611,0,24,0 +m_108,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1919644086456953,0.2698950012843083,0.058202098356855254,0.09922089099083808,0.5170395942491541,1,0.25016650700255055,0.3691158922751464,0.4060274815026611,0,24,0 +m_108,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1919644086456953,0.25049555658925676,0.058202098356855254,0.08094731439285822,0.5714598562732076,1,0.25016650700255055,0.331442870982115,0.4060274815026611,0,24,0 +m_108,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.28166336787257557,0.22697505177704827,0.08777966892781167,0.05018782514808743,0.6034199064880873,1,0.36944303680038726,0.2771628769251357,0.406387340480426,0,24,0 +m_108,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.28166336787257557,0.13275013676724953,0.08777966892781167,0.05286197265913659,0.18329973167827643,1,0.36944303680038726,0.18561210942638612,0.406387340480426,0,24,0 +m_108,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.28166336787257557,0.18587685533773182,0.08777966892781167,0.07374089452659242,0.4235047289764946,1,0.36944303680038726,0.25961774986432423,0.406387340480426,0,24,0 +m_109,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2622381241438688,0.09565937234158677,0.1181252544672338,0.047388461987093886,0.2446565896811637,1,0.38036337861110264,0.14304783432868065,0.46513992350916394,0,24,0 +m_109,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2622381241438688,0.18993946369523218,0.1181252544672338,0.048727606333583716,0.5944265004834772,1,0.38036337861110264,0.2386670700288159,0.46513992350916394,0,24,0 +m_109,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2622381241438688,0.27648936116643125,0.1181252544672338,0.1463651147509905,0.941276267908733,1,0.38036337861110264,0.42285447591742176,0.46513992350916394,0,24,0 +m_109,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09523155790286437,0.05490322695615483,0.03706046640695303,0.024266620441835716,0.3873659857880276,1,0.1322920243098174,0.07916984739799054,0.21404218123360222,0,24,0 +m_109,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09523155790286437,0.14356738876442984,0.03706046640695303,0.051016412357026704,0.4627157647759337,1,0.1322920243098174,0.19458380112145654,0.21404218123360222,0,24,0 +m_109,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09523155790286437,0.10875576754927081,0.03706046640695303,0.04269379503631408,0.8158625997303097,1,0.1322920243098174,0.1514495625855849,0.21404218123360222,0,24,0 +m_109,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.052454347382875355,0.18010384008195335,0.024036509340271316,0.09313165983303981,0.235506851684491,1,0.07649085672314668,0.2732354999149932,0.3005590499064925,0,24,0 +m_109,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.052454347382875355,0.12375498146931711,0.024036509340271316,0.04692290677185961,0.22526822987159156,1,0.07649085672314668,0.17067788824117672,0.3005590499064925,0,24,0 +m_109,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.052454347382875355,0.07354384651498676,0.024036509340271316,0.02148057693763037,0.5301358839889574,1,0.07649085672314668,0.09502442345261713,0.3005590499064925,0,24,0 +m_109,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1072165669766699,0.05175947485257115,0.04263170620152445,0.025424502815125257,0.30247916849541506,1,0.14984827317819435,0.07718397766769641,0.1648331004960138,0,24,0 +m_109,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1072165669766699,0.08191614633603266,0.04263170620152445,0.02125024193440114,0.6145833637315267,1,0.14984827317819435,0.1031663882704338,0.1648331004960138,0,24,0 +m_109,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1072165669766699,0.13116884628291417,0.04263170620152445,0.013503846302724332,0.6160779225563506,1,0.14984827317819435,0.1446726925856385,0.1648331004960138,0,24,0 +m_109,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.08211467518548037,0.05336341296793893,0.03269611300154584,0.01901282937365044,0.4688715045832469,1,0.1148107881870262,0.07237624234158938,0.1367509285871766,0,24,0 +m_109,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.08211467518548037,0.06899042800214887,0.03269611300154584,0.02930342930747042,0.7711941541140293,1,0.1148107881870262,0.09829385730961929,0.1367509285871766,0,24,0 +m_109,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.08211467518548037,0.11071280121428669,0.03269611300154584,0.01360622477405566,0.44714997208660157,1,0.1148107881870262,0.12431902598834235,0.1367509285871766,0,24,0 +m_109,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.060217575627683186,0.06230033350567665,0.019885574419222115,0.0210072159341257,0.9440243450181882,1,0.0801031500469053,0.08330754943980236,0.09792562302386351,0,24,0 +m_109,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.060217575627683186,0.055417279865961566,0.019885574419222115,0.018884487456605214,0.864549332354345,1,0.0801031500469053,0.07430176732256678,0.09792562302386351,0,24,0 +m_109,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.060217575627683186,0.06318206550883398,0.019885574419222115,0.025841228149223756,0.9294703178286035,1,0.0801031500469053,0.08902329365805774,0.09792562302386351,0,24,0 +m_109,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.030595375642805456,0.0833497405119507,0.009449562451439825,0.030070243329220994,0.14540168128970335,1,0.04004493809424528,0.11341998384117169,0.16022614647294298,0,24,0 +m_109,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.030595375642805456,0.0952986255135233,0.009449562451439825,0.03402946252896375,0.11864100239160466,1,0.04004493809424528,0.12932808804248705,0.16022614647294298,0,24,0 +m_109,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.030595375642805456,0.10432128057082246,0.009449562451439825,0.041338852586398404,0.1370470834546382,1,0.04004493809424528,0.14566013315722087,0.16022614647294298,0,24,0 +m_109,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11211516158874717,0.06804605120159168,0.0325850196950346,0.03474910106391883,0.3767846138977925,1,0.14470018128378176,0.10279515226551052,0.15917019941215996,0,24,0 +m_109,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11211516158874717,0.10079671782166244,0.0325850196950346,0.022514507481664243,0.7816015721505992,1,0.14470018128378176,0.12331122530332668,0.15917019941215996,0,24,0 +m_109,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11211516158874717,0.08789794657863255,0.0325850196950346,0.026366207306197244,0.5767523425983185,1,0.14470018128378176,0.1142641538848298,0.15917019941215996,0,24,0 +m_110,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,*,0.1503236334751487,0.028216220624721622,0.04309723981485633,0.00816977672375408,0.045903207913099216,1,0.19342087329000504,0.0363859973484757,0.22833370642251924,0,24,0 +m_110,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1503236334751487,0.1597762452683952,0.04309723981485633,0.047799851479349544,0.8864713227856605,1,0.19342087329000504,0.20757609674774474,0.22833370642251924,0,24,0 +m_110,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1503236334751487,0.05240472577570632,0.04309723981485633,0.018984948055210206,0.08672784082764716,1,0.19342087329000504,0.07138967383091652,0.22833370642251924,0,24,0 +m_110,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.092496794051914355,0.10888680230915597,0.028098789606524337,0.04388157388277147,0.7606809353582034,1,0.1205955836584387,0.15276837619192743,0.1680452138111202,0,24,0 +m_110,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.092496794051914355,0.10450495303308993,0.028098789606524337,0.04234198937386749,0.8186752087669038,1,0.1205955836584387,0.14684694240695742,0.1680452138111202,0,24,0 +m_110,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.092496794051914355,0.03443336666628446,0.028098789606524337,0.01354425187746226,0.10379231419199167,1,0.1205955836584387,0.047977618543746714,0.1680452138111202,0,24,0 +m_110,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.19753901161469703,0.07848664590636252,0.12850372876001462,0.035036984666605465,0.4157592022039079,1,0.32604274037471165,0.11352363057296799,0.35864701441218283,0,24,0 +m_110,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.19753901161469703,0.09159796418547232,0.12850372876001462,0.04907828731889654,0.4750782864444582,1,0.32604274037471165,0.14067625150436885,0.35864701441218283,0,24,0 +m_110,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.19753901161469703,0.07838951704192147,0.12850372876001462,0.01483263056814101,0.40786280717166357,1,0.32604274037471165,0.09322214761006248,0.35864701441218283,0,24,0 +m_110,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1419260822068476,0.09418600874209575,0.053899333620181816,0.021765710011652947,0.44684964098480323,1,0.19582541582702942,0.1159517187537487,0.21540795740973237,0,24,0 +m_110,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1419260822068476,0.05165751134916766,0.053899333620181816,0.016650621823995307,0.17332230980643532,1,0.19582541582702942,0.06830813317316298,0.21540795740973237,0,24,0 +m_110,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1419260822068476,0.09968319083714598,0.053899333620181816,0.015173655380818853,0.48712798619052555,1,0.19582541582702942,0.11485684621796484,0.21540795740973237,0,24,0 +m_110,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.1155800231850151,0.07196179914858192,0.03955377979761177,0.018535463177903635,0.3508416773630198,1,0.15513380298262688,0.09049726232648556,0.1706471832808896,0,24,0 +m_110,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.1155800231850151,0.05150476022224493,0.03955377979761177,0.01230317988361552,0.1732022095919594,1,0.15513380298262688,0.06380794010586045,0.1706471832808896,0,24,0 +m_110,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.1155800231850151,0.07681887836997259,0.03955377979761177,0.020187505386076582,0.4100320357575462,1,0.15513380298262688,0.09700638375604917,0.1706471832808896,0,24,0 +m_110,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04529628429102931,0.054604226158506096,0.012012889557369087,0.019743770262466848,0.6973628183574536,1,0.0573091738483984,0.07434799642097295,0.12435502707461372,0,24,0 +m_110,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04529628429102931,0.06438217956058989,0.012012889557369087,0.01790713371644961,0.3997859209181731,1,0.0573091738483984,0.0822893132770395,0.12435502707461372,0,24,0 +m_110,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04529628429102931,0.08450687233764424,0.012012889557369087,0.028543152275640957,0.24759329387356865,1,0.0573091738483984,0.1130500246132852,0.12435502707461372,0,24,0 +m_110,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11740413001918881,0.11753404172838515,0.031789134906404615,0.04271460115261767,0.9981051492470407,1,0.14919326492559343,0.16024864288100282,0.20352734582328308,0,24,0 +m_110,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11740413001918881,0.11878548633942887,0.031789134906404615,0.046590541208144626,0.9810056382026653,1,0.14919326492559343,0.1653760275475735,0.20352734582328308,0,24,0 +m_110,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11740413001918881,0.12557008593376687,0.031789134906404615,0.05945477390558136,0.9067185939112581,1,0.14919326492559343,0.18502485983934824,0.20352734582328308,0,24,0 +m_110,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.15515886272204785,0.1833612941588557,0.03491730749019848,0.04398671165864887,0.6269679313777703,1,0.19007617021224632,0.22734800581750456,0.29586969358609216,0,24,0 +m_110,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.15515886272204785,0.23570845369641077,0.03491730749019848,0.033263995018218424,0.12589358709327003,1,0.19007617021224632,0.2689724487146292,0.29586969358609216,0,24,0 +m_110,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.15515886272204785,0.11395335933780874,0.03491730749019848,0.05261333600585844,0.5309314920379935,1,0.19007617021224632,0.1665666953436672,0.29586969358609216,0,24,0 +m_111,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2551198285217036,0.11346673836649634,0.18403945881816675,0.03299026218384002,0.4884577813223989,1,0.43915928733987036,0.14645700055033636,0.48307521607385745,0,24,0 +m_111,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2551198285217036,0.28089048330448413,0.18403945881816675,0.07661969359825524,0.9018396850769506,1,0.43915928733987036,0.35751017690273934,0.48307521607385745,0,24,0 +m_111,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2551198285217036,0.1896980344611797,0.18403945881816675,0.1253179297395659,0.7770569526389888,1,0.43915928733987036,0.3150159642007456,0.48307521607385745,0,24,0 +m_111,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11520738576908025,0.19534959630818516,0.05324507977454878,0.07640088668488997,0.41197114165714876,1,0.16845246554362903,0.27175048299307514,0.44557100126820526,0,24,0 +m_111,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,*,0.11520738576908025,0.33378191568448695,0.05324507977454878,0.07128263092297231,0.035669696152289924,0.8204030115026683,0.16845246554362903,0.4050645466074593,0.44557100126820526,0,24,0 +m_111,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11520738576908025,0.24492049984982103,0.05324507977454878,0.10812937706142438,0.31615570923373665,1,0.16845246554362903,0.3530498769112454,0.44557100126820526,0,24,0 +m_111,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.12442058101485345,0.1318379761659072,0.05340290973137087,0.06587534063216177,0.9322330610905099,1,0.17782349074622433,0.19771331679806897,0.21748464847787588,0,24,0 +m_111,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.12442058101485345,0.11677600826531317,0.05340290973137087,0.04962299948914127,0.9190782021365077,1,0.17782349074622433,0.16639900775445443,0.21748464847787588,0,24,0 +m_111,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.12442058101485345,0.11868488703943185,0.05340290973137087,0.04367523759825689,0.9357330911391399,1,0.17782349074622433,0.16236012463768873,0.21748464847787588,0,24,0 +m_111,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.06325153025398782,0.09803400772488365,0.03307332133563065,0.0523123106559245,0.5892057720173525,1,0.09632485158961847,0.15034631838080814,0.18686148394501667,0,24,0 +m_111,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.06325153025398782,0.05758245615577051,0.03307332133563065,0.025169271207556777,0.8949297131701772,1,0.09632485158961847,0.08275172736332728,0.18686148394501667,0,24,0 +m_111,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.06325153025398782,0.10711052095977484,0.03307332133563065,0.06276355535387666,0.5548682898765276,1,0.09632485158961847,0.1698740763136515,0.18686148394501667,0,24,0 +m_111,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.04575301774260717,0.07999939554321826,0.017167342187788703,0.040450963812874524,0.46224682217972046,1,0.06292035993039588,0.12045035935609279,0.14438049807408423,0,24,0 +m_111,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04575301774260717,0.04692648202675439,0.017167342187788703,0.017331974299207933,0.9625816314040669,1,0.06292035993039588,0.06425845632596232,0.14438049807408423,0,24,0 +m_111,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.04575301774260717,0.10006412715527284,0.017167342187788703,0.031190871093894637,0.16673928296127274,1,0.06292035993039588,0.13125499824916748,0.14438049807408423,0,24,0 +m_111,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09179724586156442,0.05133186533798432,0.03723499913271374,0.02099588362268731,0.37191891797038457,1,0.12903224499427815,0.07232774896067162,0.14193546949370597,0,24,0 +m_111,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09179724586156442,0.05839145927098214,0.03723499913271374,0.026936950086332415,0.4855534159701759,1,0.12903224499427815,0.08532840935731456,0.14193546949370597,0,24,0 +m_111,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09179724586156442,0.08981456635382612,0.03723499913271374,0.037280031514314464,0.9707240229389367,1,0.12903224499427815,0.1270945978681406,0.14193546949370597,0,24,0 +m_111,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0503412407335276,0.04734982307482779,0.013396684856634321,0.035251441897098966,0.9391918718775623,1,0.06373792559016192,0.08260126497192675,0.14740236835504827,0,24,0 +m_111,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.0503412407335276,0.10691208120130218,0.013396684856634321,0.015599853713030482,0.020843608486697664,0.5002466036807439,0.06373792559016192,0.12251193491433265,0.14740236835504827,0,24,0 +m_111,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0503412407335276,0.0956939495188703,0.013396684856634321,0.03830820353117358,0.3051621019446136,1,0.06373792559016192,0.13400215305004387,0.14740236835504827,0,24,0 +m_111,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11785827882770923,0.05277830039680905,0.032777659885487295,0.03358129247219674,0.1956374742216002,1,0.15063593871319653,0.0863595928690058,0.1656995325845162,0,24,0 +m_111,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11785827882770923,0.08642908011469445,0.032777659885487295,0.04289302956158461,0.5741919990900385,1,0.15063593871319653,0.12932210967627905,0.1656995325845162,0,24,0 +m_111,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11785827882770923,0.10105058640502455,0.032777659885487295,0.036900649000408924,0.7405928812505216,1,0.15063593871319653,0.13795123540543347,0.1656995325845162,0,24,0 +m_112,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.11853597668340185,0.2196020893372516,0.041172778717853985,0.09055463417975278,0.3438713473111383,1,0.15970875540125584,0.31015672351700435,0.3411723958687048,0,24,0 +m_112,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.11853597668340185,0.23522936899023397,0.041172778717853985,0.06769888549453262,0.17898376436502555,1,0.15970875540125584,0.30292825448476657,0.3411723958687048,0,24,0 +m_112,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.11853597668340185,0.06524522275919664,0.041172778717853985,0.017375836813421888,0.28270142764832645,1,0.15970875540125584,0.08262105957261853,0.3411723958687048,0,24,0 +m_112,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.09991544939923387,0.1865267793356454,0.04121655814721463,0.06306011394330521,0.28119768646925325,1,0.1411320075464485,0.24958689327895062,0.2745455826068457,0,24,0 +m_112,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.09991544939923387,0.09685179315170012,0.04121655814721463,0.03903051641588598,0.958023968287955,1,0.1411320075464485,0.1358823095675861,0.2745455826068457,0,24,0 +m_112,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.09991544939923387,0.11539838447507826,0.04121655814721463,0.058272558065956846,0.8331062825527316,1,0.1411320075464485,0.1736709425410351,0.2745455826068457,0,24,0 +m_112,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.2646315883326971,0.1813988269621473,0.10869827745244307,0.040008581843735,0.5040627486325713,1,0.37332986578514016,0.22140740880588228,0.4106628523636542,0,24,0 +m_112,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.2646315883326971,0.05715946319585532,0.10869827745244307,0.029574484494560488,0.1300735328003487,1,0.37332986578514016,0.08673394769041581,0.4106628523636542,0,24,0 +m_112,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.2646315883326971,0.170422161408834,0.10869827745244307,0.08053541982538238,0.5065720029514984,1,0.37332986578514016,0.2509575812342164,0.4106628523636542,0,24,0 +m_112,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.20924120710877378,0.18826829969941752,0.07475462166680434,0.03998784135875894,0.8125860889600427,1,0.2839958287755781,0.22825614105817646,0.34131678778756896,0,24,0 +m_112,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.20924120710877378,0.1628229193863376,0.07475462166680434,0.05392461544026904,0.6288167574289987,1,0.2839958287755781,0.21674753482660664,0.34131678778756896,0,24,0 +m_112,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.20924120710877378,0.261536989366113,0.07475462166680434,0.04875099953167697,0.5760439992882596,1,0.2839958287755781,0.31028798889778997,0.34131678778756896,0,24,0 +m_112,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.3180419223616764,0.06816118098505353,0.16353848755475545,0.032095826286180414,0.18996161518324936,1,0.4815804099164318,0.10025700727123393,0.529738450908075,0,24,0 +m_112,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.3180419223616764,0.06033086154883138,0.16353848755475545,0.028273955629086463,0.17790934537409384,1,0.4815804099164318,0.08860481717791785,0.529738450908075,0,24,0 +m_112,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.3180419223616764,0.14677143819870184,0.16353848755475545,0.02240633197146999,0.3453856212492262,1,0.4815804099164318,0.16917777017017183,0.529738450908075,0,24,0 +m_112,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.42080686254123806,0.8217117607645367,0.284046967662694,0.3685756379251954,0.4103939151863213,1,0.704853830203932,1.190287398689732,1.3093161385587053,0,24,0 +m_112,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.42080686254123806,0.177762244137595,0.284046967662694,0.06901669779542312,0.4397873293282072,1,0.704853830203932,0.24677894193301814,1.3093161385587053,0,24,0 +m_112,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.42080686254123806,0.2690511958120337,0.284046967662694,0.09220998155362974,0.6293569210624033,1,0.704853830203932,0.36126117736566343,1.3093161385587053,0,24,0 +m_112,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.3399080922556166,0.3427437407096448,0.2541068261292859,0.22828160530947997,0.9935416591109505,1,0.5940149183849025,0.5710253460191248,1.3734599000319725,0,24,0 +m_112,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.3399080922556166,0.9871072120329722,0.2541068261292859,0.2614926970870026,0.10631308071636271,1,0.5940149183849025,1.2485999091199749,1.3734599000319725,0,24,0 +m_112,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.3399080922556166,0.0741361285051408,0.2541068261292859,0.03168184045658733,0.3455364838667783,1,0.5940149183849025,0.10581796896172813,1.3734599000319725,0,24,0 +m_112,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.09282064895905018,0.41359492046547497,0.038213260213220454,0.28657525427271785,0.316061478297185,1,0.13103390917227065,0.7001701747381928,0.7701871922120122,0,24,0 +m_112,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.09282064895905018,0.1567064950895678,0.038213260213220454,0.04815626357398229,0.3244125804811188,1,0.13103390917227065,0.20486275866355008,0.7701871922120122,0,24,0 +m_112,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.09282064895905018,0.08731589828351434,0.038213260213220454,0.04441030475220664,0.9270396134315608,1,0.13103390917227065,0.13172620303572097,0.7701871922120122,0,24,0 +m_120,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.25846092115160085,0.17158507609272625,0.10414831897054723,0.08858454970150594,0.5421368765027096,1,0.36260924012214807,0.2601696257942322,0.3988701641343629,0,24,0 +m_120,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.25846092115160085,0.2319511237417288,0.10414831897054723,0.11019579913440038,0.8650880796775333,1,0.36260924012214807,0.3421469228761292,0.3988701641343629,0,24,0 +m_120,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.25846092115160085,0.13791887860418964,0.10414831897054723,0.045788716505086965,0.33342334668957746,1,0.36260924012214807,0.1837075951092766,0.3988701641343629,0,24,0 +m_120,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14458848610305977,0.14836021236210414,0.08633735035444684,0.11701220737374939,0.9798612278486875,1,0.2309258364575066,0.2653724197358535,0.2919096617094389,0,24,0 +m_120,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14458848610305977,0.17604594483706873,0.08633735035444684,0.05031331176412415,0.7609221371323431,1,0.2309258364575066,0.22635925660119288,0.2919096617094389,0,24,0 +m_120,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14458848610305977,0.12291978251203217,0.08633735035444684,0.05627221744314596,0.8383622991920969,1,0.2309258364575066,0.17919199995517812,0.2919096617094389,0,24,0 +m_120,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.019462886155536686,0.17765788850420128,0.012613856413318511,0.0952029477658904,0.15843975466594895,1,0.0320767425688552,0.27286083627009167,0.4519437840647055,0,24,0 +m_120,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.019462886155536686,0.2303498491125477,0.012613856413318511,0.12377591510332295,0.16386408350659834,1,0.0320767425688552,0.3541257642158706,0.4519437840647055,0,24,0 +m_120,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,*,0.019462886155536686,0.30601580800089606,0.012613856413318511,0.10484217751247257,0.04086685446995466,0.8990707983390025,0.0320767425688552,0.4108579855133686,0.4519437840647055,0,24,0 +m_120,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.13714922760228446,0.11313307438611353,0.07946174884008193,0.04078430771813369,0.7969526280844503,1,0.21661097644236638,0.1539173821042472,0.23827207408660303,0,24,0 +m_120,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.13714922760228446,0.0900476035191254,0.07946174884008193,0.03189443999030961,0.60470323474114,1,0.21661097644236638,0.12194204350943501,0.23827207408660303,0,24,0 +m_120,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.13714922760228446,0.1609442091989223,0.07946174884008193,0.05480297836769713,0.8120085748402527,1,0.21661097644236638,0.21574718756661942,0.23827207408660303,0,24,0 +m_120,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11753552370366009,0.10895238988916589,0.04810296184985696,0.04822386848524039,0.9022196585364881,1,0.16563848555351707,0.1571762583744063,0.1822023341088688,0,24,0 +m_120,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11753552370366009,0.07385652592485203,0.04810296184985696,0.01841650383529257,0.426846903637015,1,0.16563848555351707,0.0922730297601446,0.1822023341088688,0,24,0 +m_120,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11753552370366009,0.1184694962310553,0.04810296184985696,0.030410804204150127,0.9872872024576551,1,0.16563848555351707,0.14888030043520542,0.1822023341088688,0,24,0 +m_120,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18878413453901258,0.10067170740210007,0.053207490993832075,0.06477451260240757,0.31884038938297216,1,0.24199162553284465,0.16544622000450765,0.2661907880861291,0,24,0 +m_120,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18878413453901258,0.16616283996443437,0.053207490993832075,0.04995805312641125,0.7629914102786649,1,0.24199162553284465,0.21612089309084562,0.2661907880861291,0,24,0 +m_120,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18878413453901258,0.09693362001859429,0.053207490993832075,0.03839001303693694,0.19470857389523114,1,0.24199162553284465,0.13532363305553124,0.2661907880861291,0,24,0 +m_120,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.10159240078165614,0.16810453406645368,0.03762113609212294,0.08504967473843154,0.49801976170788087,1,0.13921353687377908,0.2531542088048852,0.27846962968537375,0,24,0 +m_120,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.10159240078165614,0.16445519760823082,0.03762113609212294,0.030540439058808568,0.2248545834017082,1,0.13921353687377908,0.1949956366670394,0.27846962968537375,0,24,0 +m_120,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.10159240078165614,0.10680536530118571,0.03762113609212294,0.046148353987139366,0.9320287448538315,1,0.13921353687377908,0.15295371928832507,0.27846962968537375,0,24,0 +m_120,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.04233948125386918,0.15452979106760414,0.019306072152701383,0.039553944109711955,0.0370479102162121,0.8521019349728783,0.06164555340657056,0.19408373517731609,0.24576059901027467,0,24,0 +m_120,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.04233948125386918,0.1557791859237548,0.019306072152701383,0.06763954044922213,0.15955127672621675,1,0.06164555340657056,0.22341872637297694,0.24576059901027467,0,24,0 +m_120,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.04233948125386918,0.15688359573401267,0.019306072152701383,0.030942342880674826,0.013010761344433488,0.3122582722664037,0.06164555340657056,0.1878259386146875,0.24576059901027467,0,24,0 +m_121,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.23354236217279184,0.1707689178956152,0.08068538077039485,0.08590855982886288,0.6072235986232536,1,0.31422774294318667,0.2566774777244781,0.3456505172375054,0,24,0 +m_121,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.23354236217279184,0.14360890486341446,0.08068538077039485,0.08548721429775287,0.4638790405554316,1,0.31422774294318667,0.22909611916116734,0.3456505172375054,0,24,0 +m_121,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.23354236217279184,0.14240481136309688,0.08068538077039485,0.11098739917993175,0.5238603995554092,1,0.31422774294318667,0.25339221054302863,0.3456505172375054,0,24,0 +m_121,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.23551029414235103,0.36332330516789163,0.09692915318571448,0.06927894296954261,0.31113839496697737,1,0.3324394473280655,0.43260224813743425,0.47586247295117773,0,24,0 +m_121,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.23551029414235103,0.11367038036306935,0.09692915318571448,0.053159501321634765,0.3034173867165632,1,0.3324394473280655,0.1668298816847041,0.47586247295117773,0,24,0 +m_121,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.23551029414235103,0.1287604539197913,0.09692915318571448,0.06485182315117483,0.3846024647339884,1,0.3324394473280655,0.19361227707096612,0.47586247295117773,0,24,0 +m_121,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.037422844129498145,0.1714031752817086,0.019864893985421482,0.10967029793837653,0.2800274306146322,1,0.05728773811491963,0.28107347322008513,0.3121904371030778,0,24,0 +m_121,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.037422844129498145,0.21182171850910114,0.019864893985421482,0.07198776976642411,0.07120535855339236,1,0.05728773811491963,0.28380948827552527,0.3121904371030778,0,24,0 +m_121,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.037422844129498145,0.19374716303451053,0.019864893985421482,0.08504824476828969,0.12776089912439204,1,0.05728773811491963,0.2787954078028002,0.3121904371030778,0,24,0 +m_121,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.1062300435770911,0.1652883103277701,0.05666400135726169,0.03254929163596198,0.3983381367747867,1,0.16289404493435278,0.1978376019637321,0.30120394089439717,0,24,0 +m_121,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.1062300435770911,0.06951733625048913,0.05666400135726169,0.0374420642141412,0.6052090492941411,1,0.16289404493435278,0.10695940046463033,0.30120394089439717,0,24,0 +m_121,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.1062300435770911,0.1903035972163932,0.05666400135726169,0.08351816723305876,0.427802764855018,1,0.16289404493435278,0.27382176444945194,0.30120394089439717,0,24,0 +m_121,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.21483340036375234,0.104346117904118,0.10597478052435268,0.040192449506900256,0.36499132206270035,1,0.32080818088810503,0.14453856741101825,0.35288899897691556,0,24,0 +m_121,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.21483340036375234,0.1581858670339468,0.10597478052435268,0.03968789564523008,0.6334740919952984,1,0.32080818088810503,0.1978737626791769,0.35288899897691556,0,24,0 +m_121,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.21483340036375234,0.11613203081427985,0.10597478052435268,0.03214414246195111,0.4075899161681997,1,0.32080818088810503,0.14827617327623097,0.35288899897691556,0,24,0 +m_121,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.2383556375431933,0.18724922118856147,0.11761717389758834,0.05415893140343792,0.704779215382657,1,0.35597281144078163,0.24140815259199938,0.3915700925848598,0,24,0 +m_121,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.2383556375431933,0.14056011461683804,0.11761717389758834,0.07078107740238902,0.49597037724976023,1,0.35597281144078163,0.21134119201922708,0.3915700925848598,0,24,0 +m_121,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.2383556375431933,0.16606878150535112,0.11761717389758834,0.0673507858829758,0.6083611017449759,1,0.35597281144078163,0.23341956738832692,0.3915700925848598,0,24,0 +m_121,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.18646177297489733,0.17902435547877762,0.07675434215991157,0.0833512514186117,0.9489675201839979,1,0.2632161151348089,0.2623756068973893,0.33760378665993673,0,24,0 +m_121,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.18646177297489733,0.2049434610370411,0.07675434215991157,0.10196907229017407,0.8879551411650657,1,0.2632161151348089,0.3069125333272152,0.33760378665993673,0,24,0 +m_121,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.18646177297489733,0.12576978800969277,0.07675434215991157,0.04722733736921891,0.5189427231890098,1,0.2632161151348089,0.17299712537891168,0.33760378665993673,0,24,0 +m_121,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.13183928877299725,0.22051867786854337,0.040300404550483525,0.05949814630844668,0.2491683831139477,1,0.17213969332348078,0.28001682417699003,0.30801850659468905,0,24,0 +m_121,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.13183928877299725,0.14763111300529352,0.040300404550483525,0.06845813691161468,0.8473293996428997,1,0.17213969332348078,0.2160892499169082,0.30801850659468905,0,24,0 +m_121,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.13183928877299725,0.08560403585455763,0.040300404550483525,0.03640433383874822,0.41469801555068053,1,0.17213969332348078,0.12200836969330585,0.30801850659468905,0,24,0 +m_122,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.17375024254925037,0.13305597826255924,0.050177582092892505,0.04005662838794095,0.5436952012442354,1,0.22392782464214286,0.17311260665050018,0.24632060710635717,0,24,0 +m_122,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.17375024254925037,0.07585766570979839,0.050177582092892505,0.025378752769468254,0.1323886864366605,1,0.22392782464214286,0.10123641847926665,0.24632060710635717,0,24,0 +m_122,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.17375024254925037,0.135494844559141,0.050177582092892505,0.040564103868489694,0.5693316700015291,1,0.22392782464214286,0.17605894842763067,0.24632060710635717,0,24,0 +m_122,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.07612603904755932,0.15406362146728628,0.0228526032830902,0.06492336137880163,0.29924000488536323,1,0.09897864233064953,0.21898698284608792,0.24088568113069672,0,24,0 +m_122,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.07612603904755932,0.06427537786688993,0.0228526032830902,0.0283806281228416,0.7520080416431362,1,0.09897864233064953,0.09265600598973153,0.24088568113069672,0,24,0 +m_122,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.07612603904755932,0.09939102942661789,0.0228526032830902,0.03688883937367365,0.6058573129537113,1,0.09897864233064953,0.13627986880029153,0.24088568113069672,0,24,0 +m_122,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.14880548607298305,0.15274364934420634,0.08194665159251938,0.06495365990827445,0.9708735627227374,1,0.23075213766550243,0.2176973092524808,0.2538273514320527,0,24,0 +m_122,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.14880548607298305,0.1084936270111772,0.08194665159251938,0.04480644587297329,0.6806335871987981,1,0.23075213766550243,0.15330007288415048,0.2538273514320527,0,24,0 +m_122,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.14880548607298305,0.0767305001837757,0.08194665159251938,0.03876516612056247,0.4580765855124508,1,0.23075213766550243,0.11549566630433816,0.2538273514320527,0,24,0 +m_122,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.25736601391187175,0.10873343856137636,0.10002749933635659,0.04805086020271388,0.23044302181901055,1,0.3573935132482283,0.15678429876409025,0.3931328645730512,0,24,0 +m_122,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.25736601391187175,0.1609084239078374,0.10002749933635659,0.05819719573737522,0.4338362519149619,1,0.3573935132482283,0.21910561964521263,0.3931328645730512,0,24,0 +m_122,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.25736601391187175,0.13259855778880433,0.10002749933635659,0.049228735843754846,0.3065936016447236,1,0.3573935132482283,0.18182729363255917,0.3931328645730512,0,24,0 +m_122,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0812296132296606,0.02735607416580373,0.042113602812187116,0.012144708316293152,0.26633496243497745,1,0.12334321604184773,0.03950078248209688,0.13567753764603252,0,24,0 +m_122,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.0812296132296606,0.044460581245372145,0.042113602812187116,0.014663205611647318,0.44021930596843983,1,0.12334321604184773,0.05912378685701947,0.13567753764603252,0,24,0 +m_122,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.0812296132296606,0.05574347280420455,0.042113602812187116,0.020119576579033967,0.6015960932908071,1,0.12334321604184773,0.07586304938323851,0.13567753764603252,0,24,0 +m_122,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.020729940957797677,0.05163493824368929,0.007445732213341497,0.01635041446786284,0.1291514704577264,1,0.028175673171139174,0.06798535271155212,0.13395419572654643,0,24,0 +m_122,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.020729940957797677,0.08017771626152677,0.007445732213341497,0.04159882530806089,0.2151551189021564,1,0.028175673171139174,0.12177654156958766,0.13395419572654643,0,24,0 +m_122,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.020729940957797677,0.07641157169046682,0.007445732213341497,0.02717435695023319,0.097636384418307,1,0.028175673171139174,0.10358592864070001,0.13395419572654643,0,24,0 +m_122,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.11478744809935885,0.08940116103451852,0.014231244834024402,0.03746288265520552,0.5483379768847074,1,0.12901869293338325,0.12686404368972404,0.15653422549017,0,24,0 +m_122,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.11478744809935885,0.10782801534406117,0.014231244834024402,0.034475826010638824,0.8575396937269122,1,0.12901869293338325,0.14230384135469998,0.15653422549017,0,24,0 +m_122,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.11478744809935885,0.07104563144875553,0.014231244834024402,0.015882960549079693,0.06771707031945118,1,0.12901869293338325,0.08692859199783523,0.15653422549017,0,24,0 +m_122,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.0764580275394701,0.10999278216097134,0.012787713894116703,0.018770351783850198,0.17460364807010867,1,0.08924574143358681,0.12876313394482153,0.20188853600588652,0,24,0 +m_122,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,*,0.0764580275394701,0.16011066783895758,0.012787713894116703,0.023424364893666495,0.014518966102431828,0.3484551864583639,0.08924574143358681,0.1835350327326241,0.20188853600588652,0,24,0 +m_122,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,*,0.0764580275394701,0.02737703639649025,0.012787713894116703,0.017427827599764478,0.048784793786771606,1,0.08924574143358681,0.04480486399625473,0.20188853600588652,0,24,0 +m_123,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.44797774316996225,0.1238466842680687,0.2135960608410952,0.06184108152180914,0.20868815905047938,1,0.6615738040110575,0.18568776578987783,0.7277311844121633,0,24,0 +m_123,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.44797774316996225,0.14511532715233813,0.2135960608410952,0.07848695342285922,0.23983398386216115,1,0.6615738040110575,0.22360228057519735,0.7277311844121633,0,24,0 +m_123,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.44797774316996225,0.18642043625638247,0.2135960608410952,0.06270670962909139,0.2961803228320695,1,0.6615738040110575,0.24912714588547386,0.7277311844121633,0,24,0 +m_123,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.08316848535615813,0.16938038184406815,0.048537004158967674,0.09639420846356091,0.44932930033132035,1,0.1317054895151258,0.26577459030762907,0.29368209478185986,0,24,0 +m_123,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.08316848535615813,0.1556216247921599,0.048537004158967674,0.11136209773680354,0.5701149173860243,1,0.1317054895151258,0.26698372252896346,0.29368209478185986,0,24,0 +m_123,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.08316848535615813,0.03972724026926892,0.048537004158967674,0.017516265163287484,0.4307450341274913,1,0.1317054895151258,0.0572435054325564,0.29368209478185986,0,24,0 +m_123,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.03681074442612555,0.060946702171928026,0.019165936364660255,0.018189612519954497,0.38545706800179214,1,0.055976680790785806,0.07913631469188252,0.16815460865003581,0,24,0 +m_123,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.03681074442612555,0.09493306719029118,0.019165936364660255,0.05793475885519593,0.3857436576710299,1,0.055976680790785806,0.1528678260454871,0.16815460865003581,0,24,0 +m_123,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.03681074442612555,0.07275146038467313,0.019165936364660255,0.021427669088480514,0.24276304770371518,1,0.055976680790785806,0.09417912947315364,0.16815460865003581,0,24,0 +m_123,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,fruit,fruit,ns,0.10966189641367308,0.086796691207138,0.055440328002131695,0.012483158077283856,0.7061845299444196,1,0.16510222441580477,0.09927984928442185,0.18763140584910218,0,24,0 +m_123,1,1,967514 MM WT,1017361 Sl10g086080 #2,fruit,fruit,ns,0.10966189641367308,0.05252865321413632,0.055440328002131695,0.021500080780858667,0.37916710254658986,1,0.16510222441580477,0.07402873399499499,0.18763140584910218,0,24,0 +m_123,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,fruit,fruit,ns,0.10966189641367308,0.12325942565078656,0.055440328002131695,0.04731457966657904,0.856438738724894,1,0.16510222441580477,0.1705740053173656,0.18763140584910218,0,24,0 +m_123,0.4,0.4,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.07923322404764217,0.11053283791378161,0.02713665441676786,0.03359752063631386,0.4859469060176752,1,0.10636987846441004,0.14413035855009548,0.17594851399475217,0,24,0 +m_123,0.4,0.4,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07923322404764217,0.08984307755386116,0.02713665441676786,0.05937881476282275,0.8754922586414504,1,0.10636987846441004,0.14922189231668392,0.17594851399475217,0,24,0 +m_123,0.4,0.4,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07923322404764217,0.11093333526745146,0.02713665441676786,0.049019859273232304,0.5874477260338049,1,0.10636987846441004,0.15995319454068377,0.17594851399475217,0,24,0 +m_123,0.6,0.6,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,*,0.07326808422917568,0.1850148287749175,0.03576989987070827,0.024593613658634477,0.030332749068972858,0.7279859776553486,0.10903798409988394,0.20960844243355198,0.2764370745261719,0,24,0 +m_123,0.6,0.6,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.07326808422917568,0.06581197072530191,0.03576989987070827,0.01924165440482699,0.8591088227531497,1,0.10903798409988394,0.0850536251301289,0.2764370745261719,0,24,0 +m_123,0.6,0.6,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.07326808422917568,0.17005548612903817,0.03576989987070827,0.0812509452583908,0.31237384515944067,1,0.10903798409988394,0.251306431387429,0.2764370745261719,0,24,0 +m_123,0.8,0.8,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.16000669438904103,0.13845345481270832,0.049838504733865786,0.05439603713362546,0.7761903784654722,1,0.2098451991229068,0.19284949194633377,0.2308297190351975,0,24,0 +m_123,0.8,0.8,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.16000669438904103,0.14404678235243717,0.049838504733865786,0.039121046681990256,0.8065045158080906,1,0.2098451991229068,0.18316782903442744,0.2308297190351975,0,24,0 +m_123,0.8,0.8,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.16000669438904103,0.08523125362639898,0.049838504733865786,0.023469508817899273,0.21614878114973918,1,0.2098451991229068,0.10870076244429826,0.2308297190351975,0,24,0 +m_123,1,1,967514 MM WT,1015695 Sl10g074590 #30.1,leaf,leaf,ns,0.12609733565527118,0.1844959192053345,0.048252186734712474,0.0662428683335864,0.4938929162504686,1,0.17434952238998364,0.2507387875389209,0.27581266629281304,0,24,0 +m_123,1,1,967514 MM WT,1017361 Sl10g086080 #2,leaf,leaf,ns,0.12609733565527118,0.06529558963775257,0.048252186734712474,0.04573119105119279,0.3819937668991039,1,0.17434952238998364,0.11102678068894536,0.27581266629281304,0,24,0 +m_123,1,1,967514 MM WT,1017363 Sl10g007190 #19.2,leaf,leaf,ns,0.12609733565527118,0.09343856474630068,0.048252186734712474,0.06160667266041197,0.6857421240302184,1,0.17434952238998364,0.15504523740671264,0.27581266629281304,0,24,0 diff --git a/runs/GC-MS normalization/cmQTL_val1/fruit/treatment_loess_PCA.jpg b/runs/GC-MS normalization/cmQTL_val1/fruit/treatment_loess_PCA.jpg index 6286c04e16eae7884d92156296c14f9025cb8776..578a0fa1711dadc037cb78cbb30bece7e696c45c 100644 Binary files a/runs/GC-MS normalization/cmQTL_val1/fruit/treatment_loess_PCA.jpg and b/runs/GC-MS normalization/cmQTL_val1/fruit/treatment_loess_PCA.jpg differ diff --git a/runs/GC-MS normalization/cmQTL_val1/leaf/treatment_loess_PCA.jpg b/runs/GC-MS normalization/cmQTL_val1/leaf/treatment_loess_PCA.jpg index 74c88ce98a3ae9d447d3df2c9659a3ec4e13ad25..bbd5f3045f9b5435e8dc22518844b91d68637d0f 100644 Binary files a/runs/GC-MS normalization/cmQTL_val1/leaf/treatment_loess_PCA.jpg and b/runs/GC-MS normalization/cmQTL_val1/leaf/treatment_loess_PCA.jpg differ diff --git a/runs/GC-MS normalization/cmQTL_val1_batch_imp_PCA.jpg b/runs/GC-MS normalization/cmQTL_val1_batch_imp_PCA.jpg index e7f73b839d77b26971fa45e0a170e9fc8ee55296..d168d50264ae12257b90caf064df180a6d109740 100644 Binary files a/runs/GC-MS normalization/cmQTL_val1_batch_imp_PCA.jpg and b/runs/GC-MS normalization/cmQTL_val1_batch_imp_PCA.jpg differ diff --git a/runs/GC-MS normalization/cmQTL_val1_tissue_imp_PCA.jpg b/runs/GC-MS normalization/cmQTL_val1_tissue_imp_PCA.jpg index 14f114311185bd145bbf581da0df2dd30dab474a..869e22d52c25ea149a5d8f0df2fdb23ddc2fab0b 100644 Binary files a/runs/GC-MS normalization/cmQTL_val1_tissue_imp_PCA.jpg and b/runs/GC-MS normalization/cmQTL_val1_tissue_imp_PCA.jpg differ diff --git a/runs/GC-MS normalization/cmQTL_val1_tissue_lin_PCA.jpg b/runs/GC-MS normalization/cmQTL_val1_tissue_lin_PCA.jpg index 118159746a2104f2f62922a084423dfe0c607b02..925ac483f18909a8035fc211739ac7aa966f84cc 100644 Binary files a/runs/GC-MS normalization/cmQTL_val1_tissue_lin_PCA.jpg and b/runs/GC-MS normalization/cmQTL_val1_tissue_lin_PCA.jpg differ diff --git a/runs/GC-MS normalization/cmQTL_val1_tissue_loess_PCA.jpg b/runs/GC-MS normalization/cmQTL_val1_tissue_loess_PCA.jpg index 45eeb89cfc6d3f9dcb2b77deafc79f637a4ca2fd..1013c0de96052bd74b02acffb5e61ad3dc1c12d9 100644 Binary files a/runs/GC-MS normalization/cmQTL_val1_tissue_loess_PCA.jpg and b/runs/GC-MS normalization/cmQTL_val1_tissue_loess_PCA.jpg differ diff --git a/runs/GC-MS normalization/cmQTL_val1_treatment_PCA.jpg b/runs/GC-MS normalization/cmQTL_val1_treatment_PCA.jpg index 406d231a09de9d09430fa584bb5d21c13dfb79df..d6df9792cea39edfed4371687037566513ef41ca 100644 Binary files a/runs/GC-MS normalization/cmQTL_val1_treatment_PCA.jpg and b/runs/GC-MS normalization/cmQTL_val1_treatment_PCA.jpg differ diff --git a/runs/GC-MS normalization/cmQTL_val1_treatment_loess_outlier_exp2_imp_PCA.jpg b/runs/GC-MS normalization/cmQTL_val1_treatment_loess_outlier_exp2_imp_PCA.jpg index de3ef4890c34549d3e5920e0ea7c46d76ca07577..2058f878a7ad4255b5a7d90d9fab770a9e61ea50 100644 Binary files a/runs/GC-MS normalization/cmQTL_val1_treatment_loess_outlier_exp2_imp_PCA.jpg and b/runs/GC-MS normalization/cmQTL_val1_treatment_loess_outlier_exp2_imp_PCA.jpg differ diff --git a/runs/GC-MS normalization/cmQTL_val2_class_isnorm_PCA.jpg b/runs/GC-MS normalization/cmQTL_val2_class_isnorm_PCA.jpg index 6d5caa04b710ef2b0c385d32df0e281f6945d777..5b6df63beb228887aa895cf144752200834974e1 100644 Binary files a/runs/GC-MS normalization/cmQTL_val2_class_isnorm_PCA.jpg and b/runs/GC-MS normalization/cmQTL_val2_class_isnorm_PCA.jpg differ diff --git a/runs/GC-MS normalization/cmQTL_val_1_2_feat_dat_GC.csv b/runs/GC-MS normalization/cmQTL_val_1_2_feat_dat_GC.csv index 82f3610d35b7b62206d5eb796827b65ab6e71093..b07279bcfd4417751b0e745de3c171775e9f086d 100644 --- a/runs/GC-MS normalization/cmQTL_val_1_2_feat_dat_GC.csv +++ b/runs/GC-MS normalization/cmQTL_val_1_2_feat_dat_GC.csv @@ -1,36147 +1,37434 @@ -exp,tissue,treatment,batch_GC,daily_num,class,machine_num_GC,met,Compound_Name,loess_norm_fw,loess_norm_med,area,rescaled -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_1,adenine,0.02156758702333582,1.0781749540370946,997.85,79.9358910923102 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_1,adenine,0.019804535101135813,0.9900390664606922,884.93,73.40149638739572 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_1,adenine,0.015745574816416183,0.7871295191997529,998.52,58.35778255346968 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_1,adenine,0.019945295833533765,0.9970757690839008,977.32,73.9231975198804 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_1,adenine,0.023659764182538984,1.1827639843268838,973.65,87.69012179799516 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_1,adenine,0.02006228724484998,1.002924230916099,1109.57,74.35680248011958 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_1,adenine,0.018735399696874443,0.936592428498749,945.51,69.43896264889726 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_1,adenine,0.0196829880342805,0.9839628650257205,981.14,72.95100681300691 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_1,adenine,0.02088177512774397,1.0438908587320526,1023.56,77.39406826639438 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_1,adenine,0.022361119374315473,1.11784405123924,48.85,82.87695795887726 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_1,adenine,0.01616579688233626,0.80813664002966,141.03,59.91525049179899 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_1,adenine,0.02456538146106161,1.2280362656715638,187.83,91.04660873688974 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_1,adenine,0.017608987591637263,0.8802824983022516,43.85,65.26414442412893 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_1,adenine,0.023753041545686457,1.187426968489897,223.67,88.03583544384097 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_1,adenine,0.013321538654085651,0.6659506837984088,130.2,49.37358369681403 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_1,adenine,0.017167510814323363,0.8582128433346445,180.97,63.627900204830546 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_1,adenine,0.027678358288055385,1.3836556051800146,290.87,102.58422656804629 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_1,adenine,0.021731722183829693,1.0863801565444442,257.06,80.5442248062051 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_1,adenine,0.016634135314827256,0.8315491231868363,202.26,61.651051993072045 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_1,adenine,0.018570415108221137,0.9107725993895951,258.61,111.74269021910942 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_1,adenine,0.01955293812401923,0.9589597312250263,226.12,117.65476942399847 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_1,adenine,0.018978950933416883,0.9308089439348811,236.54,114.20094933137057 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_1,adenine,0.024862803993914016,1.219378268589505,360.67,149.60551977324636 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_1,adenine,0.018825584994253974,0.9232872221933249,265.29,113.27810929089904 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_1,adenine,0.017293620711380277,0.8481531401626434,536.07,104.05990876655471 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_1,adenine,0.01806071346422141,0.885774650312341,583.63,108.67569184682112 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_1,adenine,0.023093094596451914,1.1325841490882556,853.14,138.95674925163806 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_2,adenosine-5-monophosphate,0.0019568365204108346,0.11349046983820167,19.03,4.398890610928697 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_2,adenosine-5-monophosphate,0.0013844442047834912,0.08029348472741431,8.75,3.1121754680345783 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_2,adenosine-5-monophosphate,0.014169062573286888,0.8217618343874733,1388.62,31.851488700858464 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_2,adenosine-5-monophosphate,0.001680288872973611,0.09745156106226033,3.5,3.77722250677321 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_2,adenosine-5-monophosphate,0.030135382807207227,1.747759057985065,1742.58,67.74314108750112 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_2,adenosine-5-monophosphate,4.0147974205241555e-4,0.023284584113588875,2.89,0.9025104802427047 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_2,adenosine-5-monophosphate,0.07009650370618997,4.065380555121971,1505.47,157.57415031652758 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_2,adenosine-5-monophosphate,6.207090874473691e-4,0.03599920853503572,20.15,1.3953293228179846 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_2,adenosine-5-monophosphate,0.03066285856742225,1.7783510217135923,1315.91,68.92888560161883 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_2,adenosine-5-monophosphate,0.01568891962894802,0.909908845921004,32.05,35.26806686789811 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_2,adenosine-5-monophosphate,5.502226800814499e-4,0.031911214772794634,4.47,1.23687868459352 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_2,adenosine-5-monophosphate,0.07139966753851364,4.140960029474542,570.84,160.50361074243324 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_2,adenosine-5-monophosphate,0.014113735133795149,0.8185530139073935,33.57,31.727114819050573 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_2,adenosine-5-monophosphate,0.0038161601000724164,0.2213254905136833,20.62,8.578576012310364 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_2,adenosine-5-monophosphate,0.00820661923073963,0.4759585497128404,38.86,18.448153386869695 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_2,adenosine-5-monophosphate,0.00419714144094763,0.24342123071707972,9.11,9.43500690259401 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_2,adenosine-5-monophosphate,0.0013689472905337023,0.07939471160001907,2.63,3.077339021616739 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_2,adenosine-5-monophosphate,0.031128593953045302,1.805362234547835,221.79,69.97584021107409 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_2,adenosine-5-monophosphate,0.017258742720483455,1.0009537330962546,136,38.79696669481083 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_2,adenosine-5-monophosphate,0.0349793849760938,1.928218714949463,239.37,60.41109233936667 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_2,adenosine-5-monophosphate,0.0012133090941470288,0.0668829741846976,10.02,2.0954435812065757 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_2,adenosine-5-monophosphate,0.04432025078444815,2.443128633400286,385.42,76.54322008443096 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_2,adenosine-5-monophosphate,6.646221968994427e-4,0.036636920840894774,2.34,1.1478347299452332 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_2,adenosine-5-monophosphate,0.02086396769484904,1.1501143603526416,88.9,36.03308290984826 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_2,adenosine-5-monophosphate,0.053026118167491025,2.923034624581209,640.56,91.57867478812926 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_2,adenosine-5-monophosphate,0.002407053330501079,0.13268744670398488,29.44,4.157097705235846 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_2,adenosine-5-monophosphate,4.744078630850891e-4,0.026151463804896323,6.8,0.8193253610074017 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_3,2-aminoadipic_acid,0.021648725729182316,1.0764230647923998,227.9,52.970779018433994 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_3,2-aminoadipic_acid,0.01811404226950933,0.9006706971782941,182.53,44.322005008143854 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_3,2-aminoadipic_acid,0.0249253766698499,1.2393454784222169,462.54,60.988190993157296 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_3,2-aminoadipic_acid,0.020513012154847056,1.01995284563468,230.54,50.1918795336826 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_3,2-aminoadipic_acid,0.014766113390078037,0.7342041850063311,173.17,36.130187944161555 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_3,2-aminoadipic_acid,0.018121081106485706,0.9010206838964718,256.5,44.33922785454538 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_3,2-aminoadipic_acid,0.021627536302569132,1.0753694791069657,282.16,52.918932066853785 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_3,2-aminoadipic_acid,0.01994656606227864,0.9917878789465828,302.35,48.80588152296134 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_3,2-aminoadipic_acid,0.020029821722965257,0.995927536613214,303.05,49.00959407673626 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_3,2-aminoadipic_acid,0.002362072279238105,0.11744751695252252,3.81,5.779592309233633 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_3,2-aminoadipic_acid,0.015932098756881136,0.792179585394236,61.29,38.98315739725036 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_3,2-aminoadipic_acid,0.03100225759769799,1.54150159026741,99.61,75.85729325705925 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_3,2-aminoadipic_acid,0.03847764647798308,1.913194645539695,68.75,94.1483085070084 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_3,2-aminoadipic_acid,0.014392339043536819,0.7156192884781108,22.46,35.215625186007834 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_3,2-aminoadipic_acid,0.005484925702989295,0.27272277404353934,8.09,13.420687710682571 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_3,2-aminoadipic_acid,0.016229707178284664,0.8069773417648746,16.51,39.711354988249475 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_3,2-aminoadipic_acid,0.05220824312999215,2.5959106221969557,54.23,127.74476171831219 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_3,2-aminoadipic_acid,0.02068575392221777,1.0285419526785273,51.52,50.61454949131033 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_3,2-aminoadipic_acid,0.01583844805289682,0.7875230629243303,43.33,38.75400992650629 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_3,2-aminoadipic_acid,0.028843613168873766,1.789261890764282,173.31,116.92826456144583 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_3,2-aminoadipic_acid,0.00940483578883038,0.5834121462982889,48.2,38.12598376059317 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_3,2-aminoadipic_acid,0.032937835494949774,2.0432396409675566,167.89,133.52571053722983 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_3,2-aminoadipic_acid,0.0062689842124661445,0.38888520933546356,19.35,25.41364843007254 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_3,2-aminoadipic_acid,0.029590946447729406,1.8356213724189352,87.16,119.9578566875774 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_3,2-aminoadipic_acid,0.017084896679897897,1.0598309704824036,141.01,69.25995392102507 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_3,2-aminoadipic_acid,0.02662113043658487,1.65139415441364,236.94,107.91860799093136 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_3,2-aminoadipic_acid,0.009118804513726639,0.5656687083623605,140.14,36.966450091480255 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_4,adipic_acid,0.016949236788363967,0.8523264429632295,455.32,38.942795178989954 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_4,adipic_acid,0.01759677601653404,0.8848892547238306,426.64,40.43059004833182 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_4,adipic_acid,0.021118652242976408,1.0619938803846851,1978.56,48.52250039477626 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_4,adipic_acid,0.02035042308941086,1.0233619331167882,271.64,46.757406724106055 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_4,adipic_acid,0.01991942945537268,1.0016885518532879,1133.03,45.76714993417672 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_4,adipic_acid,0.022141186360121336,1.1134140639455763,264.99,50.87188858167338 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_4,adipic_acid,0.030776123802476726,1.5476392510351469,333,70.71163737979586 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_4,adipic_acid,0.02257049572254642,1.1350027482253187,285,51.858275566414804 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_4,adipic_acid,0.012746013123740005,0.6409588917406699,163.56,29.285411763631206 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_4,adipic_acid,0.01999220405141604,1.0053481687055528,22.52,45.934357828156706 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_4,adipic_acid,0.01210562673073788,0.6087557746749934,25.23,27.81405134490045 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_4,adipic_acid,0.006776280783591889,0.340758900764431,11.56,15.569274175926852 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_4,adipic_acid,0.023196049234481993,1.1664599640497644,28.5,53.29555575743373 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_4,adipic_acid,0.01436624157288539,0.7224353362609316,15.26,33.008070513761965 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_4,adipic_acid,0.04887896326741119,2.4579769235417155,55.21,112.30496563662098 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_4,adipic_acid,0.0015643478978103508,0.0786663786662693,1.91,3.594266841261844 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_4,adipic_acid,0.03781275111657538,1.901490200430168,47.1,86.87908725765436 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_4,adipic_acid,0.009106340039838543,0.45793061430929527,20.84,20.9228497677917 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_4,adipic_acid,0.028055947550746554,1.4108497201660097,69.07,64.46172371438499 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_4,adipic_acid,0.0031689831768372577,0.14675641427007616,7.46,4.581735253511778 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_4,adipic_acid,0.03022516114198539,1.399734874692524,58.77,43.6997227879006 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_4,adipic_acid,0.01067257922736879,0.49424984956377344,20.03,15.430480303381007 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_4,adipic_acid,0.0076341652676938255,0.35354012884033614,6.72,11.037522822395294 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_4,adipic_acid,0.016322515961397197,0.7558998519996732,14,23.5991933794298 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_4,adipic_acid,0.037782717514669134,1.749727226184262,154.4,54.62648400147266 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_4,adipic_acid,0.010400839871149193,0.4816655310901588,45.73,15.037597880634758 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_4,adipic_acid,0.036719711293552684,1.7004991386077513,226.94,53.08958310733399 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_5,L-alanine,0.019933423858078933,1.0355775901828286,202355.81,776.8229956117962 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_5,L-alanine,0.02014297906125494,1.0464643637677553,194505.07,784.9895455149251 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_5,L-alanine,0.022411317355733845,1.1643086599328538,424618.14,873.3886766187313 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_5,L-alanine,0.020027334361655814,1.0404564114871568,190677.09,780.4827702309184 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_5,L-alanine,0.017407570643900395,0.904354926012447,207715.11,678.3882824243469 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_5,L-alanine,0.01956582142093111,1.0164799756075689,203272.33,762.4972065023836 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_5,L-alanine,0.02038015832230739,1.0587862573546662,192924.98,794.2326291607426 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_5,L-alanine,0.02004061170106729,1.0411461933956576,188149.41,781.0001997828516 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_5,L-alanine,0.019956195705953455,1.0367606290583276,184707.27,777.7104344786685 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_5,L-alanine,0.018408934703656763,0.9563776084819169,8401.45,717.4123173385827 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_5,L-alanine,0.01886670047063569,0.980159371876473,33506.52,735.251850422558 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_5,L-alanine,0.021584609036633222,1.1213596605550404,33509.91,841.1711289704552 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_5,L-alanine,0.02178845718850439,1.1319499424544748,11330.71,849.1152700830875 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_5,L-alanine,0.019246429819177763,0.999887001534311,34469.09,750.0502358959403 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_5,L-alanine,0.018513030353111744,0.9617855666219037,34131.73,721.4690160179217 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_5,L-alanine,0.02170733832379896,1.1277356700330328,40373.28,845.953996840229 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_5,L-alanine,0.02201852496029184,1.1439023812518778,40689.34,858.0812127603774 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_5,L-alanine,0.019250779944814406,1.0001129984656891,38755.95,750.2197641040597 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_5,L-alanine,0.019439776826289758,1.0099317298820178,40171.15,757.5851381950474 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_5,L-alanine,0.03442635581324794,1.9165258259210005,126592.6,28807.203863127263 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_5,L-alanine,0.019569780748985646,1.08945571865058,86056.56,16375.554434250937 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_5,L-alanine,0.019277675673265916,1.073194139163737,88882.69,16131.127446063172 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_5,L-alanine,0.02150086012644835,1.1969595020567376,91424.83,17991.43842743972 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_5,L-alanine,0.022392834445047784,1.2466159869582343,91309.23,18737.82256916987 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_5,L-alanine,0.01682200479331587,0.936486185324042,125605.47,14076.27702729641 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_5,L-alanine,0.0177000282708741,0.985366022610153,137231.01,14810.98741755208 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_5,L-alanine,0.00582826255273892,0.3244611704813076,55645.01,4876.959630446011 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_6,L-alanine_peak_2,0.018340411889438545,0.9404980307099989,751.6,97.30392625725649 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_6,L-alanine_peak_2,0.017996681419244775,0.9228715001685325,740.44,95.48028540743638 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_6,L-alanine_peak_2,0.02387024657702652,1.2240684687776004,611.1,126.64212377973055 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_6,L-alanine_peak_2,0.021892641648502072,1.1226567037631687,1643.53,116.15006257133744 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_6,L-alanine_peak_2,0.019313412765209294,0.9903936062869283,349.45,102.46612250644561 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_6,L-alanine_peak_2,0.018640170150576105,0.9558696622735886,2263.79,98.89427525882549 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_6,L-alanine_peak_2,0.02044484590779158,1.0484136032691902,2321.01,108.46887139423043 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_6,L-alanine_peak_2,0.020184319933933267,1.0350538070530733,3042.99,107.08666687771097 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_6,L-alanine_peak_2,0.01995852955007868,1.0234752551291233,3024.82,105.8887498956591 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_6,L-alanine_peak_2,0.005905027299932505,0.30281035019030417,1.37,31.328758830688873 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_6,L-alanine_peak_2,0.02687107108624579,1.3779510292370112,233.6,142.56281348486118 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_6,L-alanine_peak_2,0.018327555314137482,0.9398387443305427,148.78,97.23571648843796 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_6,L-alanine_peak_2,0.021993662525325464,1.127837063740128,9.11,116.68602261455365 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_6,L-alanine_peak_2,0.018894864802805424,0.9689304277731892,322.74,100.24554205741416 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_6,L-alanine_peak_2,0.016994994171335532,0.8715048847552512,308.62,90.1658953767783 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_6,L-alanine_peak_2,0.022992954541810703,1.1790808514627908,578.8,121.98770489234035 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_6,L-alanine_peak_2,0.020801618068403274,1.0667089129105551,529.47,110.36170412972605 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_6,L-alanine_peak_2,0.021451770939641502,1.1000488127310233,703.1,113.81105016515168 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_6,L-alanine_peak_2,0.01767269811101043,0.9062576059324506,599.71,93.76141190977135 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_6,L-alanine_peak_2,0.03335629476912931,1.9199159965476083,11934.68,728.8577097693685 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_6,L-alanine_peak_2,0.0180284812177544,1.0376802856250893,1506.23,393.93456683185264 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_6,L-alanine_peak_2,0.01695888247055679,0.9761165010727209,1392.65,370.56310730223703 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_6,L-alanine_peak_2,0.03220456360391233,1.853624848111393,1785.54,703.6916010885282 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_6,L-alanine_peak_2,0.030539615990759807,1.7577940737993838,1662.98,667.31136423646 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_6,L-alanine_peak_2,0.014053968167244248,0.8089159328402056,3020.78,307.0887555841272 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_6,L-alanine_peak_2,0.012490640599157445,0.718934187967525,3170.23,272.9289857781115 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_6,L-alanine_peak_2,0.005844527719435725,0.33639834215625797,5142.77,127.70690263278021 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_7,beta-cyano-L-alanine,0.026901854380920097,1.732905237737626,2618.62,128.9888013710002 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_7,beta-cyano-L-alanine,0.014194419659160327,0.9143453022127157,1324.71,68.0592925702035 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_7,beta-cyano-L-alanine,0.02525223261026356,1.6266434846934124,3901.82,121.07920778315415 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_7,beta-cyano-L-alanine,0.020698172955324754,1.33328995904909,1984.42,99.24343810181902 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_7,beta-cyano-L-alanine,0.01370807006015204,0.8830166898591079,1355.43,65.72734730966269 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_7,beta-cyano-L-alanine,0.021333512310987613,1.3742158700134242,2163.11,102.28975828444923 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_7,beta-cyano-L-alanine,0.016672703750854743,1.0739860252011288,1534.55,79.94214978584603 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_7,beta-cyano-L-alanine,0.022358861055448886,1.4402645588742502,1890.17,107.20609243980482 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_7,beta-cyano-L-alanine,0.0186664003082002,1.202411640690809,1542.57,89.50151047482036 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_7,beta-cyano-L-alanine,0.00913125651912574,0.5881974537911999,38.41,43.78247747294797 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_7,beta-cyano-L-alanine,0.011550610384929407,0.7440421374560349,143.85,55.38277650153996 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_7,beta-cyano-L-alanine,0.012670231313768758,0.8161634471766929,135.61,60.751126190597134 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_7,beta-cyano-L-alanine,0.03554898800079177,2.2899175138846743,166.76,170.45001014600575 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_7,beta-cyano-L-alanine,0.01849878725332332,1.1916147068959642,210.93,88.69784070780109 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_7,beta-cyano-L-alanine,0.03515770340337038,2.2647125923682414,417.44,168.57388181293007 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_7,beta-cyano-L-alanine,0.0134696154311823,0.8676564373778693,174.39,64.58400691622171 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_7,beta-cyano-L-alanine,0.019479871201149135,1.2548120422087843,253.51,93.40193436181086 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_7,beta-cyano-L-alanine,0.022864343212443936,1.4728256108016182,398.2,109.62977434001846 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_7,beta-cyano-L-alanine,0.018357706032669726,1.1825268431838467,334.73,88.02138557238963 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_7,beta-cyano-L-alanine,0.031244255617761417,1.9837961035026002,336.03,175.60563108205017 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_7,beta-cyano-L-alanine,0.023843797372245467,1.5139177229390215,725.25,134.01199683456218 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_7,beta-cyano-L-alanine,0.015111303967534809,0.9594642386870466,468.95,84.93177440857735 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_7,beta-cyano-L-alanine,0.021247358554104322,1.3490616523247732,451.74,119.41893746378891 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_7,beta-cyano-L-alanine,0.02185877886507999,1.3878826517863945,437.46,122.85537233613164 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_7,beta-cyano-L-alanine,0.020854578559965004,1.3241228145608035,611.97,117.21135154492232 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_7,beta-cyano-L-alanine,0.013383634866989434,0.8497690911458962,398.13,75.22155994823473 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_7,beta-cyano-L-alanine,0.01025479164333479,0.6511089895421917,293.04,57.6361677542748 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_8,beta-alanine,0.02043788070574883,1.2723431748078433,1765.71,102.10553977832943 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_8,beta-alanine,0.019437398582773345,1.2100589967654958,1583.15,97.10723449043104 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_8,beta-alanine,0.021451972243706218,1.33547459560078,3434.74,107.1718362969626 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_8,beta-alanine,0.020064674317323835,1.249109523141912,1691.25,100.24103923213845 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_8,beta-alanine,0.018489851054969208,1.1510702176858467,1814.4,92.3733849692892 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_8,beta-alanine,0.01946521365305805,1.211790600709323,1888.3,97.24619570692317 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_8,beta-alanine,0.020667638907102978,1.2866465795276316,1860.29,103.25338800709244 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_8,beta-alanine,0.020375378722319013,1.2684521660886021,1938.61,101.79328632861032 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_8,beta-alanine,0.019560853694818362,1.2177445915425233,1828.02,97.7240034712875 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_8,beta-alanine,0.015937492018503613,0.9921752399500846,51.59,79.62206300599429 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_8,beta-alanine,0.014766687500382425,0.9192877836079669,176.54,73.77284463453934 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_8,beta-alanine,0.02464638900777349,1.5343403403308344,282.56,123.13081231154946 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_8,beta-alanine,0.024849756848258808,1.5470008352002522,97.42,124.14681702482024 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_8,beta-alanine,0.017002755596893272,1.0584923333341465,213.5,84.94400975006526 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_8,beta-alanine,0.02180075043519005,1.3571874902910526,296.38,108.91429609585697 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_8,beta-alanine,0.020967844409319293,1.3053356220601702,299.72,104.75318367032865 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_8,beta-alanine,0.021316512332333514,1.3270416520790647,305.38,106.49509257934494 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_8,beta-alanine,0.016545982075371172,1.030056279669438,272.83,82.6620164434724 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_8,beta-alanine,0.02247508633138892,1.3991677076829285,403.98,112.28320854155501 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_8,beta-alanine,0.020249414736027486,1.0966840513257805,231.43,128.22429928101025 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_8,beta-alanine,0.020541036729481665,1.1124779492436307,378.2,130.0709218255653 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_8,beta-alanine,0.019658852713987464,1.0646999194714564,368.4,124.48471458460268 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_8,beta-alanine,0.01171090504873834,0.6342485924144523,148.26,74.15634542509777 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_8,beta-alanine,0.028399914969757353,1.5381053829139617,410.6,179.8352813703004 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_8,beta-alanine,0.021585243307893763,1.1690309269845898,619.45,136.68309598303824 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_8,beta-alanine,0.017555455101825334,0.9507824238338775,499.99,111.16548099465696 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_8,beta-alanine,0.020033271200189735,1.0849779762791432,611.23,126.85562498655742 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_10,ascorbic_acid,0.020135686342330806,1.0374085485855646,166.52,57.648793044899826 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_10,ascorbic_acid,0.01994791439126229,1.0277343699203183,107.31,57.111198936472086 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_10,ascorbic_acid,0.019937014503908286,1.0271727979864185,177.21,57.079992384105275 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_10,ascorbic_acid,0.01993709995836258,1.0271772006762445,113.47,57.08023704157891 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_10,ascorbic_acid,0.020033867172375187,1.0321627339892285,142.59,57.35728312778143 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_10,ascorbic_acid,0.020187052727902537,1.0400549906584147,238.8,57.7958558308881 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_10,ascorbic_acid,0.019836434368458087,1.0219908195546938,106.82,56.79202984265434 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_10,ascorbic_acid,0.020093761030782194,1.0352485190805754,229.76,57.52876020530757 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_10,ascorbic_acid,0.019915245849735287,1.0260512574763838,170.35,57.01766837796265 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_10,ascorbic_acid,0.023594410673027196,1.2156051159567058,64.41,67.55117629371415 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_10,ascorbic_acid,0.01804613380049652,0.92975293492712,66.67,51.666370593900055 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_10,ascorbic_acid,0.016585709110529374,0.8545105502286522,7.45,47.4851512762062 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_10,ascorbic_acid,0.01811501428861896,0.9333017192096177,17.07,51.863576536478455 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_10,ascorbic_acid,0.026201806155355358,1.3499404605247276,533.99,75.01619139135911 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_10,ascorbic_acid,0.016117193451253235,0.830372204913972,55.77,46.14378342706942 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_10,ascorbic_acid,0.025216716465705745,1.2991877596834551,578.23,72.1958638056096 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_10,ascorbic_acid,0.014836673924072574,0.7643986949206598,20.42,42.477635476741064 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_10,ascorbic_acid,0.024824978762472444,1.2790050832537398,540.22,71.07431247641033 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_10,ascorbic_acid,0.015333760642868795,0.7900090467457893,4.38,43.90080272766351 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_10,ascorbic_acid,0.02262143808726249,1.1714706197076639,51.7,64.86432821321334 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_10,ascorbic_acid,0.01963857407333287,1.0170004422847092,43.74,56.311314489304344 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_10,ascorbic_acid,0.017881619422769307,0.9260150351963382,37.42,51.27345249882124 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_10,ascorbic_acid,0.024846208001315043,1.2866822424112452,994.1,71.24359576231065 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_10,ascorbic_acid,0.02035101466052312,1.053894790599841,658.38,58.3541545555132 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_10,ascorbic_acid,0.015858740771429795,0.821258525104593,227.62,45.47308453504131 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_10,ascorbic_acid,0.01583167464141703,0.8198568822922824,185.2,45.39547557252367 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_10,ascorbic_acid,0.021449363248813483,1.1107737165291367,114.29,61.503540684218294 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_11,L-asparagine_peak_2,0.02256107387551761,1.2342286001433098,91921.65,1397.5849265152776 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_11,L-asparagine_peak_2,0.018168375042010878,0.9939211324206202,70457.07,1125.4715639021515 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_11,L-asparagine_peak_2,0.020372422584058417,1.1144960007748521,149218.63,1262.0051189574076 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_11,L-asparagine_peak_2,0.01973253812797246,1.07949041102119,72735.94,1222.3663643718996 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_11,L-asparagine_peak_2,0.01926399112793622,1.0538580270687745,89351.73,1193.3414062414622 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_11,L-asparagine_peak_2,0.02118100826704885,1.158730578486872,79382.92,1312.094364202502 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_11,L-asparagine_peak_2,0.018619343989381282,1.018591889481749,63140.4,1153.4076190141059 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_11,L-asparagine_peak_2,0.02022934861899435,1.1066689806342196,60840.21,1253.1421535660618 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_11,L-asparagine_peak_2,0.01997920845942722,1.0929847854276613,58607.05,1237.6467867029394 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_11,L-asparagine_peak_2,0.02111070080653734,1.1548843307840568,2888.73,1307.7390463849806 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_11,L-asparagine_peak_2,0.017213049236454295,0.9416589733505955,8774.03,1066.2922467684136 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_11,L-asparagine_peak_2,0.01848522945537343,1.0112550049663798,8204.1,1145.099661148705 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_11,L-asparagine_peak_2,0.020123931930445215,1.1009020436232588,3126.57,1246.6119336070153 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_11,L-asparagine_peak_2,0.020208650388422466,1.1055366609456652,10015.25,1251.8599657051286 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_11,L-asparagine_peak_2,0.022636045448778622,1.2383300033135238,11520.73,1402.2291709020853 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_11,L-asparagine_peak_2,0.019234581489027496,1.052249140113246,9008.68,1191.519575052935 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_11,L-asparagine_peak_2,0.020031775013273134,1.0958604971302857,9245.24,1240.9031132279647 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_11,L-asparagine_peak_2,0.01980283567488971,1.0833361163898223,8756.85,1226.7210680745973 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_11,L-asparagine_peak_2,0.020068354339144657,1.0978616097729594,9006.61,1243.1690831344595 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_11,L-asparagine_peak_2,0.02059300405923139,1.1277294003174558,2261.99,846.4173014082664 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_11,L-asparagine_peak_2,0.022309884442788322,1.221750480476352,11097.91,916.9848231215259 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_11,L-asparagine_peak_2,0.01751922558717359,0.9594008581080671,9001.11,720.0783140530096 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_11,L-asparagine_peak_2,0.018987941154815634,1.0398317520937062,7676.02,780.4457215339311 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_11,L-asparagine_peak_2,0.02112134041894549,1.1566625488951252,8113.92,868.1330760732362 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_11,L-asparagine_peak_2,0.0199121848112947,1.0904458704355666,12739.63,818.4341480554144 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_11,L-asparagine_peak_2,0.020110144240772794,1.1012866719063183,12882.47,826.5707115992872 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_11,L-asparagine_peak_2,0.019339736615455776,1.0590970366884647,6424.24,794.9052808865271 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_12,L-asparagine,0.021604262984901684,1.147865098750133,10325.48,219.9309529205255 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_12,L-asparagine,0.021609791689240064,1.148158846644045,9916.94,219.98723501699902 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_12,L-asparagine,0.018825871954960903,1.0002452472338712,13721.26,191.64698937000972 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_12,L-asparagine,0.018983209511699087,1.008604814520596,8812.47,193.24868246214618 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_12,L-asparagine,0.0198427919858397,1.0542756491263796,9294.02,201.99921437261432 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_12,L-asparagine,0.018333123316977083,0.9740648140298517,9273.43,186.63081836811958 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_12,L-asparagine,0.020285208448807525,1.077781862567132,9362.28,206.5030048678625 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_12,L-asparagine,0.020441189362761812,1.0860693495008173,9616.32,208.0908873643566 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_12,L-asparagine,0.020293995186767846,1.0782487144029742,9434.1,206.59245367960986 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_12,L-asparagine,0.028311389679020735,1.5042242418717957,267.55,288.20936474263607 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_12,L-asparagine,0.018756574634387978,0.9965633824195913,973.4,190.94154407159368 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_12,L-asparagine,0.020450970360634237,1.0865890277743393,944.49,208.1904577215634 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_12,L-asparagine,0.011750352204638,0.6243128591404259,130.35,119.61834381130559 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_12,L-asparagine,0.019548378050089067,1.0386330196291367,1235.99,199.0020865609426 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_12,L-asparagine,0.02086165935168295,1.108409515684303,1362.26,212.37126320511246 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_12,L-asparagine,0.020852538324057354,1.107924902564963,1376.24,212.27841133144688 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_12,L-asparagine,0.018859083894220977,1.002009844617503,1232.79,191.98508622871356 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_12,L-asparagine,0.018993156565429985,1.0091333155771267,1221.7,193.34994326457746 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_12,L-asparagine,0.02103717878416575,1.1177351117872683,1371.07,214.1580474184406 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_12,L-asparagine,0.022608229640019243,1.3614203122406903,412.08,210.21691041308497 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_12,L-asparagine,0.019329114755896465,1.1639588709647546,1440.28,179.72688926566775 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_12,L-asparagine,0.021085552285370776,1.2697278660556124,1619.72,196.0586797976471 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_12,L-asparagine,0.016579735993120667,0.9983970311707846,993.34,154.16248558308084 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_12,L-asparagine,0.022366720819717446,1.3468771561077506,1273.89,207.97130167459775 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_12,L-asparagine,0.020047952440330058,1.2072457731403963,1979.17,186.41081983060857 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_12,L-asparagine,0.02163470612272448,1.3027967617905911,2145.93,201.16484798808517 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_12,L-asparagine,0.016211542181088646,0.976225169750268,883.95,150.73892846113887 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_13,L-aspartic_acid,0.020367501745073787,1.124757590448374,320726.93,4766.317755587647 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_13,L-aspartic_acid,0.019964981211799154,1.102529138928959,301008.21,4672.121580290914 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_13,L-aspartic_acid,0.019490464557645925,1.0763248348747274,514507.34,4561.077173258539 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_13,L-aspartic_acid,0.019872746096713956,1.0974356253946815,315658.59,4650.537103597518 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_13,L-aspartic_acid,0.020401643671028324,1.1266430151239448,342494.87,4774.307506609833 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_13,L-aspartic_acid,0.0201075349180726,1.1104014035387504,367230.27,4705.48140369195 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_13,L-aspartic_acid,0.019799335324015302,1.0933816513311487,330596.66,4633.357820946929 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_13,L-aspartic_acid,0.020024520657075592,1.105817094606781,345016.79,4686.054752789479 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_13,L-aspartic_acid,0.020040529050472565,1.1067011285059547,341215.49,4689.8009702019735 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_13,L-aspartic_acid,0.019723013768665122,1.0891669346825688,13860.72,4615.49736908824 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_13,L-aspartic_acid,0.01832702473252391,1.0120760236697686,49897.16,4288.813840943957 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_13,L-aspartic_acid,0.019587492320820018,1.0816830135301279,46593.31,4583.78320545581 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_13,L-aspartic_acid,0.020994846805592,1.1594015604099241,16791.16,4913.12642845551 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_13,L-aspartic_acid,0.02061779857685132,1.1385797697676934,57075.64,4824.891175558368 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_13,L-aspartic_acid,0.020349527873027254,1.1237650166282207,57962.67,4762.111585064413 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_13,L-aspartic_acid,0.01995133428899048,1.101775512872733,57046.88,4668.927984370007 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_13,L-aspartic_acid,0.020391472186610943,1.1260813137210055,57976.61,4771.927218276681 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_13,L-aspartic_acid,0.019806055154934523,1.0937527415575066,62581.13,4634.930367733751 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_13,L-aspartic_acid,0.01992718682017579,1.100442013596318,64780.32,4663.2770944963 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_13,L-aspartic_acid,0.02413031139403629,1.2325961754038792,33464.19,9846.274072208284 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_13,L-aspartic_acid,0.020176503888457348,1.0306324323721914,42305.3,8232.939221572833 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_13,L-aspartic_acid,0.019274987724059563,0.9845822443677333,42025.97,7865.079267748102 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_13,L-aspartic_acid,0.02069661292164472,1.0572000300559163,39069.91,8445.167568093873 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_13,L-aspartic_acid,0.02125403970203171,1.0856738489948012,38428.38,8672.623267494231 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_13,L-aspartic_acid,0.018487743672555026,0.9443691699838792,64372.93,7543.847578432023 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_13,L-aspartic_acid,0.01873129465864769,0.9568099548984018,67267.3,7643.2275541176095 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_13,L-aspartic_acid,0.016584503484802667,0.8471500940262309,61482.05,6767.238267104099 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_14,4-hydroxy-benzoic_acid,0.022304064920696646,1.583019599500927,108.51,67.39705944875197 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_14,4-hydroxy-benzoic_acid,0.020751572393936515,1.4728322364943078,96.38,62.70583246874516 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_14,4-hydroxy-benzoic_acid,0.011234363572212682,0.7973532083037199,100.08,33.94731284353088 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_14,4-hydroxy-benzoic_acid,0.00487994931009097,0.3463519062517035,26.38,14.745932408666276 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_14,4-hydroxy-benzoic_acid,0.029767142668525346,2.1127077253837254,167.32,89.94853140821212 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_14,4-hydroxy-benzoic_acid,0.041230554705019094,2.926317531284418,269.47,124.5879688944341 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_14,4-hydroxy-benzoic_acid,0.02107854133665298,1.4960386899631535,123.32,63.693847225181266 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_14,4-hydroxy-benzoic_acid,0.015980373583757118,1.1341988413493307,49.02,48.28851567044776 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_14,4-hydroxy-benzoic_acid,0.008125221442092524,0.5766834359050955,21.95,24.552297283659442 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_14,4-hydroxy-benzoic_acid,0.026816248044359538,1.9032694887786243,59.53,81.03169848474994 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_14,4-hydroxy-benzoic_acid,0.012536898615140166,0.8897999667453907,72.81,37.883233584185014 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_14,4-hydroxy-benzoic_acid,0.01682761294041154,1.1943312213357236,82.76,50.84865174836843 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_14,4-hydroxy-benzoic_acid,0.01452231022642956,1.0307135403438692,35.79,43.88262898014023 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_14,4-hydroxy-benzoic_acid,0.03469042705798637,2.4621353167283764,142.05,104.82541110971063 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_14,4-hydroxy-benzoic_acid,0.020829064384611237,1.4783321908962785,85.91,62.939993027409066 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_14,4-hydroxy-benzoic_acid,0.0016603246009259545,0.11784068931580423,5.5,5.017067347620365 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_14,4-hydroxy-benzoic_acid,0.021588692030472766,1.5322463745214217,71.14,65.23538939524953 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_14,4-hydroxy-benzoic_acid,0.017028560149291116,1.20859334670401,77.32,51.45586173592323 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_14,4-hydroxy-benzoic_acid,0.02600853208043738,1.8459422613756913,125.17,78.59099177807006 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_14,4-hydroxy-benzoic_acid,0.039603310371133425,1.9644992173985867,84.01,65.28030899415504 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_14,4-hydroxy-benzoic_acid,0.009590486859294645,0.4757305324478246,11.97,15.80852559324121 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_14,4-hydroxy-benzoic_acid,0.02314912195357034,1.1482987541970942,33.23,38.15796760196943 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_14,4-hydroxy-benzoic_acid,0.04666335640699384,2.314708701966198,99.94,76.91777016633675 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_14,4-hydroxy-benzoic_acid,0.005100864476934634,0.2530254208319494,10.55,8.408034734245678 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_14,4-hydroxy-benzoic_acid,0.003618487481710447,0.17949297064742606,10.97,5.964551414613967 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_14,4-hydroxy-benzoic_acid,0.016943922360842346,0.840493431119823,53.88,27.929596716111714 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_14,4-hydroxy-benzoic_acid,0.0021502229602210886,0.10666056152885962,11.53,3.544330459604005 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_15,benzoic_acid,0.02277666942662588,1.075809390083058,596.85,76.22109528738466 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_15,benzoic_acid,0.018876199510411994,0.8915786721057374,471.36,63.168348918691485 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_15,benzoic_acid,0.02274395905433679,1.0742643825579203,1084.06,76.11163150422865 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_15,benzoic_acid,0.017563798438237008,0.8295900920128805,444.3,58.776458019112575 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_15,benzoic_acid,0.016605409449678463,0.7843225485485055,500.08,55.56925256466161 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_15,benzoic_acid,0.021832334848733814,1.0312056779578431,621.9,73.06092228331318 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_15,benzoic_acid,0.02122578303599008,1.002556443800772,551.02,71.03112404328468 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_15,benzoic_acid,0.017953256542291973,0.8479853489109977,457.07,60.07976197034419 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_15,benzoic_acid,0.020942188217214927,0.9891614226366786,524.3,70.08208679380867 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_15,benzoic_acid,0.027159210368239234,1.282809746856008,78.31,90.88707056474816 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_15,benzoic_acid,0.014430679390756424,0.6816036226835487,120.47,48.29161666712942 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_15,benzoic_acid,0.019989453191994723,0.9441609325652577,142.5,66.8938020722485 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_15,benzoic_acid,0.013713943676456015,0.6477500773205517,44.18,45.893092978161086 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_15,benzoic_acid,0.008901004759100358,0.4204207525539305,57.91,29.786810318445976 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_15,benzoic_acid,0.03475559147438501,1.6416092698050395,230.83,116.30801676568704 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_15,benzoic_acid,0.025901882446558205,1.2234224343731377,131.82,86.6794794753368 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_15,benzoic_acid,0.014089927875497376,0.6655089218765827,69.58,47.151307114955884 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_15,benzoic_acid,0.019588669309103194,0.9252307256709774,75.61,65.55259691378875 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_15,benzoic_acid,0.019269342275403625,0.910147966426126,74.37,64.48398342129103 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_15,benzoic_acid,0.03440075360167345,1.6613568135291694,526.97,87.50366336858136 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_15,benzoic_acid,0.015743936728090636,0.7603408011885275,44.76,40.04714999859975 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_15,benzoic_acid,0.02261055979677863,1.091958856804217,59.77,57.5134729878781 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_15,benzoic_acid,0.006542984265935824,0.315988179122269,7.76,16.64309739436991 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_15,benzoic_acid,0.04754460186127935,2.2961284268181155,58.14,120.93708424051015 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_15,benzoic_acid,0.02582627421754902,1.2472592064759462,244.75,65.6931424050881 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_15,benzoic_acid,0.010830227322188433,0.5230371451197583,121.73,27.54836643345767 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_15,benzoic_acid,0.003824513291956737,0.1847018030359692,144.62,9.728243965904499 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_16,benzyl_alchohol,0.04532958121205979,3.5852100036244305,261.65,125.75124087712692 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_16,benzyl_alchohol,0.010036049795236384,0.7937718628907535,53.48,27.84154809089318 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_16,benzyl_alchohol,0.025126155132528222,1.9872793951556151,379.63,69.70382478508321 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_16,benzyl_alchohol,0.007809751427054401,0.617689336486665,17.05,21.66545347726978 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_16,benzyl_alchohol,0.0099368014993343,0.7859221106142829,92.82,27.566218029795973 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_16,benzyl_alchohol,0.010917985820054004,0.8635260007889364,19.33,30.288174477671944 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_16,benzyl_alchohol,0.011976611451625232,0.9472548838475923,21.21,33.2249650509543 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_16,benzyl_alchohol,0.011625440222365007,0.9194800275514593,71.02,32.250761966367435 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_16,benzyl_alchohol,0.0298896459579009,2.3640337022250955,195.08,82.91848210554522 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_16,benzyl_alchohol,0.007483918316903439,0.5919185242534716,13.72,20.76154223819052 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_16,benzyl_alchohol,0.013321683511532918,1.0536394052976554,86.56,36.956402140815264 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_16,benzyl_alchohol,0.019709403204728006,1.5588573211053351,110.82,54.67692053776963 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_16,benzyl_alchohol,0.035110012640698345,2.7769232624925024,72.92,97.40058343192453 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_16,benzyl_alchohol,0.021188254639614223,1.6758227290455663,113.78,58.77948222127324 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_16,benzyl_alchohol,0.030920040522008564,2.445529731973021,165.88,85.77695534895372 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_16,benzyl_alchohol,3.828642519728754e-4,0.03028152278270219,1.64,1.0621244116032793 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_16,benzyl_alchohol,0.02258946637605598,1.7866474532181873,95.54,62.66665942162793 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_16,benzyl_alchohol,0.018034779503760496,1.4264078811484981,87.46,50.03125643128357 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_16,benzyl_alchohol,0.026441637932511024,2.0913236410539087,133.55,73.35317670996585 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_16,benzyl_alchohol,0.02917131478129219,1.3060895213813393,89.16,36.07419258055259 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_16,benzyl_alchohol,0.0017203608876098628,0.0770258503995345,2.07,2.1274539880351426 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_16,benzyl_alchohol,0.03760478634170252,1.683681992495579,47.45,46.503296632727896 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_16,benzyl_alchohol,0.004159951029748651,0.18625380755544915,5.43,5.144330164681506 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_16,benzyl_alchohol,0.04330805105647152,1.9390347024255685,54.94,53.55613848099421 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_16,benzyl_alchohol,0.017730793924134736,0.7938622007169769,57.83,21.926473983802904 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_16,benzyl_alchohol,0.0124933160118529,0.5593641991361752,44.72,15.44963918014116 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_16,benzyl_alchohol,0.011260030570588764,0.5041462151754298,86.52,13.924518463145372 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_17,4-aminobutyric_acid,0.019520420356437057,1.8686455370495,239952.89,6648.01482456721 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_17,4-aminobutyric_acid,0.020221791843057023,1.9357862376263697,237330.81,6886.878945085018 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_17,4-aminobutyric_acid,0.020329566325419605,1.9461032442172779,444475.59,6923.583398338262 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_17,4-aminobutyric_acid,0.019997831900258747,1.9143470606032247,245118.09,6810.605535360971 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_17,4-aminobutyric_acid,0.0197669955703048,1.8922496226443597,273362.82,6731.990253745046 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_17,4-aminobutyric_acid,0.019930556729854186,1.9079069612285577,283705.06,6787.6938192191965 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_17,4-aminobutyric_acid,0.02031265941832599,1.9444847843732318,264587.77,6917.825460397194 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_17,4-aminobutyric_acid,0.01983791118703739,1.8990382136836286,271234.27,6756.141786484766 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_17,4-aminobutyric_acid,0.02004443835561481,1.9188085907961483,271296.98,6826.478165174779 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_17,4-aminobutyric_acid,0.019784823186479353,1.893956219879077,10595.55,6738.061754996096 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_17,4-aminobutyric_acid,0.01844257159886443,1.76546552177958,38026.25,6280.93489554195 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_17,4-aminobutyric_acid,0.019976338268001024,1.9122895239692796,35976.64,6803.285509292167 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_17,4-aminobutyric_acid,0.020807778939263884,1.9918814523861512,12675.04,7086.4469273033765 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_17,4-aminobutyric_acid,0.020404062554729013,1.953234599171944,42737,6948.954370263054 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_17,4-aminobutyric_acid,0.01987927734833138,1.9029981024193952,42870.31,6770.229744043897 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_17,4-aminobutyric_acid,0.020378665658136185,1.9508034119020732,44482.18,6940.305020404589 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_17,4-aminobutyric_acid,0.020719806058876338,1.9834600082104694,44997.22,7056.4862501101 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_17,4-aminobutyric_acid,0.01975643630494939,1.8912388081372635,48060.36,6728.394114351658 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_17,4-aminobutyric_acid,0.01975518137467533,1.8911186765103254,49472.63,6727.966726267106 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_17,4-aminobutyric_acid,0.02372029239541666,1.3725177215424564,65708.33,5973.32065074771 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_17,4-aminobutyric_acid,0.01984011499017595,1.1480005797364583,71399.05,4996.201843065243 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_17,4-aminobutyric_acid,0.0195377748908112,1.1305063963851938,73074.49,4920.065582644038 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_17,4-aminobutyric_acid,0.020882152004579112,1.2082955476453652,67948.25,5258.6109699519175 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_17,4-aminobutyric_acid,0.02140789612811031,1.238716468033463,66800.25,5391.005553363754 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_17,4-aminobutyric_acid,0.018368263635324344,1.0628354378261318,114297.24,4625.55548060873 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_17,4-aminobutyric_acid,0.018428846889814245,1.0663409422705952,118996.49,4640.811751446435 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_17,4-aminobutyric_acid,0.017034407274843833,0.985655044674428,124821.85,4289.659463377131 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_18,calystegine_a_3,0.019937083932025382,0.9866639015363181,664.71,58.03063736885855 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_18,calystegine_a_3,0.0202776047029209,1.0035158922041325,647.83,59.02178719998605 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_18,calystegine_a_3,0.01977449582634647,0.9786175987149276,1105.25,57.55739406841847 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_18,calystegine_a_3,0.019364920504028132,0.958348175820917,671.79,56.36524796090723 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_18,calystegine_a_3,0.02022248153348468,1.0007879084324627,718.32,58.86134083445529 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_18,calystegine_a_3,0.02059132389528696,1.0190415028391717,849.58,59.93492598948588 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_18,calystegine_a_3,0.020294259755654343,1.0043401320662058,766.91,59.07026486747389 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_18,calystegine_a_3,0.01950147250624858,0.9651059811114391,774.72,56.76270827906929 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_18,calystegine_a_3,0.020190639694487023,0.9992120915675372,793.44,58.7686591655447 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_18,calystegine_a_3,0.015258918335839002,0.7551467380983992,40.36,44.41395540125735 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_18,calystegine_a_3,0.01316975083432851,0.6517561838412591,79.75,38.33303995262365 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_18,calystegine_a_3,0.018294086217432816,0.9053537891436443,92.67,53.24838310848344 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_18,calystegine_a_3,0.026981081471327207,1.3352634318505647,78.67,78.53351874429096 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_18,calystegine_a_3,0.015119838900509906,0.7482638529807392,54.43,44.00913851306217 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_18,calystegine_a_3,0.03230656263467653,1.5988155160020519,118.85,94.03433457366067 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_18,calystegine_a_3,0.022488916196235723,1.112951215491376,78.76,65.45822573912528 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_18,calystegine_a_3,0.01828637516390636,0.9049721777613926,64.59,53.22593863503631 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_18,calystegine_a_3,0.021484993047445892,1.0632681859066693,122.13,62.53611835410075 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_18,calystegine_a_3,0.017845583351349805,0.8831578858105168,108.3,51.94293105394554 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_18,calystegine_a_3,0.02623823150210282,1.538813475165521,57.24,95.94502017657022 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_18,calystegine_a_3,0.015272338965923253,0.8956884535520121,99.07,55.84617507896795 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_18,calystegine_a_3,0.02555703945970628,1.4988630884966898,171.18,93.45411356776862 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_18,calystegine_a_3,0.005990830417789604,0.35134877796879366,31.65,21.906596306354285 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_18,calystegine_a_3,0.034249134443074786,2.008634979439649,171.81,125.23839096806213 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_18,calystegine_a_3,0.01627869225974224,0.9547088188987296,139.21,59.52609485833579 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_18,calystegine_a_3,0.022339970312821887,1.310189192797271,193.18,81.69029617090986 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_18,calystegine_a_3,0.014016751557115374,0.8220510659191269,86.15,51.25488396005756 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_19,calystegine_b_2,0.019789893665816766,1.0553595355460834,2541.45,3.894276686165048 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_19,calystegine_b_2,0.020212051954794363,1.0778724799461785,2532.04,3.9773494510013987 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_19,calystegine_b_2,0.020547600861040228,1.0957667013012087,4520.14,4.04337912780146 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_19,calystegine_b_2,0.01999455581059952,1.0662738006608514,2688.06,3.9345503244385416 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_19,calystegine_b_2,0.01943032003678485,1.0361841188137935,2595.3,3.823519398422898 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_19,calystegine_b_2,0.019881793634479002,1.0602603960500288,3118.7,3.912360861424606 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_19,calystegine_b_2,0.020120610263143726,1.0729960585333311,2916.77,3.9593554559879918 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_19,calystegine_b_2,0.0202227441439377,1.0784426752164933,3055.72,3.9794534715488603 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_19,calystegine_b_2,0.01978186391993898,1.0549313235999642,2900.48,3.892696584083868 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_19,calystegine_b_2,0.018778721744628583,1.0014355505503634,NA,3.6952971815308406 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_19,calystegine_b_2,0.028185276212753782,1.5030702294530116,352.9,5.546329146681613 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_19,calystegine_b_2,0.01800190219273618,0.9600091570925566,122.42,3.542433789671534 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_19,calystegine_b_2,0.017756634081775788,0.9469294486293154,NA,3.4941696654421737 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_19,calystegine_b_2,0.024876526041001604,1.3266205171167587,335.23,4.89522970816084 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_19,calystegine_b_2,0.011571777035274915,0.6171021150298102,NA,2.2771068044599994 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_19,calystegine_b_2,0.013172058777458272,0.7024422701965207,NA,2.5920119770251615 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_19,calystegine_b_2,0.029433909578004274,1.5696576073677435,357.42,5.792036571186974 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_19,calystegine_b_2,0.01908597146951754,1.0178206273188941,NA,3.7557581148067194 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_19,calystegine_b_2,0.01992379887954456,1.0625004604319541,NA,3.9206266989939107 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_19,calystegine_b_2,0.013716530018627951,0.6812639748789283,NA,2.5138640673032455 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_19,calystegine_b_2,0.02075102787009125,1.0306489841383286,NA,3.8030947514704327 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_19,calystegine_b_2,0.020659376313022424,1.0260968923200804,NA,3.7862975326610964 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_19,calystegine_b_2,0.01798119079084886,0.8930784604119156,NA,3.2954595189199685 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_19,calystegine_b_2,0.017677582682336795,0.8779990440777916,NA,3.239816472647051 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_19,calystegine_b_2,0.02261187570152606,1.1230724023473402,453.02,4.144137164661685 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_19,calystegine_b_2,0.02121116964767831,1.053503016169833,409.34,3.887426129666684 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_19,calystegine_b_2,0.02536409179551586,1.2597677380751733,654.56,4.648542953497389 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_20,4-hydroxy-cinnamic_acid,0.020072743990404235,1.4909260792938683,63.98,54.59025839334498 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_20,4-hydroxy-cinnamic_acid,0.008457884489869897,0.6282190699801874,25.55,23.00224124732456 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_20,4-hydroxy-cinnamic_acid,0.008777382597243465,0.6519501583055306,58.08,23.871155046357 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_20,4-hydroxy-cinnamic_acid,0.04373739813566534,3.248645404539394,124.35,118.9491514872099 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_20,4-hydroxy-cinnamic_acid,0.034081741708752236,2.531460450331433,140.55,92.68942438888541 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_20,4-hydroxy-cinnamic_acid,0.003141897790992851,0.23336806155184273,12.17,8.54477157372072 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_20,4-hydroxy-cinnamic_acid,0.011837193251524348,0.8792211036406298,43.51,32.19268070980166 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_20,4-hydroxy-cinnamic_acid,0.0326024770909887,2.421586374427578,213.03,88.66638509966575 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_20,4-hydroxy-cinnamic_acid,0.012826355063326219,0.9526922315821805,86.49,34.882826059381536 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_20,4-hydroxy-cinnamic_acid,0.03030903413867127,2.251238269025676,53.71,82.4290892203751 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_20,4-hydroxy-cinnamic_acid,0.00922889724203008,0.6854869263436864,35.05,25.099103808074073 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_20,4-hydroxy-cinnamic_acid,0.008144936313499062,0.6049744852915278,25.91,22.151140778949287 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_20,4-hydroxy-cinnamic_acid,0.012798217782813972,0.9506023028043229,24.84,34.80630331718028 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_20,4-hydroxy-cinnamic_acid,0.013266337348556896,0.9853724203890184,43.37,36.07941117254391 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_20,4-hydroxy-cinnamic_acid,0.037186382528890866,2.7620612076468145,132.39,101.1328711179881 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_20,4-hydroxy-cinnamic_acid,0.02304278137027256,1.7115290117200561,95.75,62.66763476412984 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_20,4-hydroxy-cinnamic_acid,0.021967698584996503,1.6316760049396073,91.23,59.743816920863715 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_20,4-hydroxy-cinnamic_acid,0.024320743847467484,1.8064511402800456,119.38,66.14320850135385 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_20,4-hydroxy-cinnamic_acid,0.01286895820215956,0.9558566285762722,65.34,34.9986904553202 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_20,4-hydroxy-cinnamic_acid,0.024740324083412767,1.4222268997378544,59.98,57.64285624637524 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_20,4-hydroxy-cinnamic_acid,0.008409893849511192,0.48345273151590995,19.85,19.594339208339832 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_20,4-hydroxy-cinnamic_acid,0.031655720786027186,1.8197666886127615,75.15,73.75514388947522 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_20,4-hydroxy-cinnamic_acid,0.021595143141833546,1.2414224395951579,30.97,50.31485147679175 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_20,4-hydroxy-cinnamic_acid,0.024522575240408337,1.409709349003128,32.9,57.13551991509678 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_20,4-hydroxy-cinnamic_acid,0.026513168833248592,1.5241409847665954,62.23,61.77343411259012 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_20,4-hydroxy-cinnamic_acid,0.0015348751699649271,0.08823412123074777,3.94,3.5761289334822073 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_20,4-hydroxy-cinnamic_acid,0.016806412668547238,0.9661365835271525,101.3,39.15751573035549 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_22,decanoic_acid,0.01753511073745158,1.1510555505801339,49.98,38.894167054102724 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_22,decanoic_acid,0.019538363182573217,1.2825548539318732,53.36,43.33752851435799 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_22,decanoic_acid,0.003010023812778488,0.19758669728142192,12.21,6.676454501139246 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_22,decanoic_acid,0.02913343281679217,1.9124030668138032,68.36,64.62009962763841 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_22,decanoic_acid,0.03808664126204488,2.5001176487581436,100.4,84.47897535153767 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_22,decanoic_acid,0.0019180864595376636,0.1259087609311724,3.18,4.254457031864315 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_22,decanoic_acid,0.01674265917662336,1.0990367306642135,24.31,37.13645112914377 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_22,decanoic_acid,0.0361170457946209,2.3708276870852045,22.63,80.11026754660907 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_22,decanoic_acid,0.02204140086997376,1.4468615108177125,12.2,48.889450450530504 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_22,decanoic_acid,0.008956676149061116,0.5879422120845882,14.15,19.866567346338236 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_22,decanoic_acid,0.02285096767007693,1.50000382470307,92.44,50.68512923671673 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_22,decanoic_acid,0.025892771517285317,1.6996766556608556,88.56,57.432074194780306 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_22,decanoic_acid,0.030561954385448207,2.0061753677330696,53.56,67.78866567570041 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_22,decanoic_acid,0.0069219755414324,0.45437856009249467,17.34,15.353451545525393 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_22,decanoic_acid,0.020467996780548448,1.3435787008283588,51.15,45.399524300990244 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_22,decanoic_acid,0.017724052470840926,1.163458234213579,54.49,39.31325373407684 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_22,decanoic_acid,0.03020199651399186,1.9825466885579843,95.88,66.99025260637428 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_22,decanoic_acid,0.0251664792003272,1.6520007204873863,158.2,55.821104345268786 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_22,decanoic_acid,0.014144879834250928,0.9285109566333866,95.62,31.374385224642133 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_22,decanoic_acid,0.01394992770419358,0.34299133928183523,2.71,8.214642575799953 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_22,decanoic_acid,0.016958504259920647,0.4169641744149196,59.89,9.986291977237325 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_22,decanoic_acid,0.024268634730971125,0.5967006930376518,82.9,14.290981598251761 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_22,decanoic_acid,0.017892293511060947,0.4399235497355037,16.04,10.536169016165314 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_22,decanoic_acid,0.011805544379867245,0.2902666998470933,8.98,6.9518874613378845 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_22,decanoic_acid,0.004293277098235161,0.10556017873763132,1.42,2.52816628076627 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_22,decanoic_acid,0.12120433189863275,2.9800897184703596,36.06,71.37314875736512 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_22,decanoic_acid,0.0051818731664142435,0.12740837479772232,2.31,3.0514305764054495 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_23,dehydroascorbic_acid,0.01964310778209485,1.035747384144371,76387.61,1973.9687945977078 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_23,dehydroascorbic_acid,0.020833568545372355,1.098518338474475,77754.18,2093.6001901981936 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_23,dehydroascorbic_acid,0.017596442317276167,0.9278302243486666,114709.97,1768.2959547726625 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_23,dehydroascorbic_acid,0.018947914663173006,0.9990910432849677,79900.49,1904.1076739342227 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_23,dehydroascorbic_acid,0.02248030106407528,1.1853477199324702,93010.44,2259.083098556099 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_23,dehydroascorbic_acid,0.020691390014848304,1.0910215084053547,112195.33,2079.312431579261 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_23,dehydroascorbic_acid,0.020519403399071535,1.0819529491236608,102604.66,2062.0292085578376 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_23,dehydroascorbic_acid,0.02001661815548816,1.0554419455388537,116192.2,2011.5034774857688 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_23,dehydroascorbic_acid,0.019652739249160726,1.0362552348841632,113789.35,1974.9366768516334 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_23,dehydroascorbic_acid,0.018447680586304128,0.9727145583455993,2695.03,1853.8383138773768 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_23,dehydroascorbic_acid,0.02578955092580621,1.359838789563123,31248.07,2591.635158700982 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_23,dehydroascorbic_acid,0.02201410008532656,1.1607657418880042,23919.65,2212.233781519834 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_23,dehydroascorbic_acid,0.016227512729311184,0.8556489149784161,2960.97,1630.7299281224646 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_23,dehydroascorbic_acid,0.01856356215860181,0.9788247949084341,25280.46,1865.48344712829 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_23,dehydroascorbic_acid,0.01893738386135399,0.9985357721660599,25839.95,1903.0494160249636 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_23,dehydroascorbic_acid,0.01897027732271417,1.0002701879691598,20416.08,1906.3549350391434 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_23,dehydroascorbic_acid,0.017268451689859153,0.9105358410901935,17999.29,1735.3356273833342 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_23,dehydroascorbic_acid,0.021521914390229838,1.1348136343159843,13750.2,2162.7732168247753 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_23,dehydroascorbic_acid,0.0222594209249769,1.1737010890215953,13518.81,2236.886483500917 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_23,dehydroascorbic_acid,0.009800902772247065,0.48146456366486495,10015.98,3468.6247853020595 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_23,dehydroascorbic_acid,0.02272100671919787,1.1161583621726907,13831.23,8041.162011767959 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_23,dehydroascorbic_acid,0.019826244465738302,0.9739545797597068,13077.41,7016.68045805445 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_23,dehydroascorbic_acid,0.017527738879330915,0.8610416150097091,16195.32,6203.219327846748 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_23,dehydroascorbic_acid,0.016765749130081047,0.82360924059839,15399.18,5933.544524227793 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_23,dehydroascorbic_acid,0.023142280004753508,1.1368532066504924,68150.99,8190.254293736275 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_23,dehydroascorbic_acid,0.021609440421263386,1.061553210478395,66430.99,7647.76902531371 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_23,dehydroascorbic_acid,0.02863906979384939,1.406880321383084,81085.69,10135.61603694658 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_24,erythritol,0.02021281608247262,1.0626557102982588,2733.44,135.69582092653616 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_24,erythritol,0.019303368055098868,1.0148429693340624,2499.73,129.5903729691131 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_24,erythritol,0.02210339582679688,1.1620498448356285,5026.33,148.38795493628558 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_24,erythritol,0.020937445250613442,1.1007519023494619,2893.38,140.56051417051455 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_24,erythritol,0.01786916659547437,0.9394421758686903,2582.66,119.96206864755241 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_24,erythritol,0.019629134792840217,1.0319696221801378,3118.07,131.7773609042927 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_24,erythritol,0.019179488458920743,1.0083302023979264,2785.61,128.75872519520323 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_24,erythritol,0.02112815095220574,1.1107779423607407,3166.62,141.8407893497548 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_24,erythritol,0.019308368086104522,1.0151058377774376,2859.89,129.6239399549899 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_24,erythritol,0.015976229705671596,0.8399241182672345,88.34,107.2541102821345 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_24,erythritol,0.01449664249423237,0.7621372432120772,297.54,97.3211152719662 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_24,erythritol,0.02723195589678878,1.4316754933225984,488.15,182.8178021198292 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_24,erythritol,0.024344319018110298,1.279862712467366,152.49,163.43206906852032 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_24,erythritol,0.016155594715052318,0.8493539399540505,348.8,108.45825136243249 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_24,erythritol,0.019591078705593554,1.0299688857038711,439.68,131.52187685995582 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_24,erythritol,0.02063176890164967,1.0846814687985846,535.22,138.50840015823528 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_24,erythritol,0.024511110643199014,1.288631509061926,638.86,164.55180054966266 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_24,erythritol,0.022168102238612257,1.1654516784904723,737.38,148.82235208484087 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_24,erythritol,0.01647684167292077,0.8662429727737215,569.73,110.61489640834037 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_24,erythritol,0.024748807090361775,1.4184970481722403,367.86,220.57629099078338 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_24,erythritol,0.021418206931017834,1.227601120242394,597.02,190.89197419769226 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_24,erythritol,0.018156973662306345,1.0406810093789522,515.65,161.82589695842708 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_24,erythritol,0.01605249641049233,0.9200612656173885,319.86,143.06952680350392 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_24,erythritol,0.02598415540086566,1.4893019934577347,490.26,231.58645998267775 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_24,erythritol,0.016895516824621693,0.9683796336350997,571.72,150.583033030258 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_24,erythritol,0.02002579167596928,1.1477937613703144,699.25,178.4819298930839 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_24,erythritol,0.015743359482127888,0.9023428431186827,616.78,140.31431210495518 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_25,erythronic_acid,0.018553787614566854,0.9334024926978222,223.18,62.20194211338287 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_25,erythronic_acid,0.021646821143701266,1.0890065809878777,575.31,72.57139855703217 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_25,erythronic_acid,0.019907094350997384,1.0014845418950045,880.04,66.7389298718831 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_25,erythronic_acid,0.019139834326397043,0.9628852847305491,303.94,64.1666753744438 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_25,erythronic_acid,0.020156981813582293,1.0140558607715644,579.6,67.57668256181705 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_25,erythronic_acid,0.0207914062500258,1.0459724355813276,720.48,69.70360310713967 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_25,erythronic_acid,0.020325728395870376,1.0225451506035914,602.23,68.14240883622334 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_25,erythronic_acid,0.019843370669521552,0.9982787359232509,704.3,66.52529496192544 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_25,erythronic_acid,0.019807381052150755,0.9964681730741447,704.1,66.404639053661 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_25,erythronic_acid,0.013681313955473466,0.6882784698577871,35.83,45.86687723132293 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_25,erythronic_acid,0.013482912151941917,0.6782972874804111,18.32,45.201731237694595 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_25,erythronic_acid,0.020353432948195936,1.0239389090499507,124.7,68.23528889908872 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_25,erythronic_acid,0.0285505670906152,1.4363196908319666,146.76,95.71634419704226 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_25,erythronic_acid,0.018885033854471513,0.9500668025652609,48.87,63.312451722948985 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_25,erythronic_acid,0.0246589110216693,1.2405385624210326,151.95,82.6694897997376 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_25,erythronic_acid,0.018734939162922782,0.9425158505902419,63.34,62.809256283333724 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_25,erythronic_acid,0.02190150391035088,1.1018191416453733,124.79,73.42522759924768 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_25,erythronic_acid,0.018241399223016888,0.9176868819869571,145.2,61.15465381561082 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_25,erythronic_acid,0.021059855332150875,1.0594775509584842,231.92,70.60358399587338 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_25,erythronic_acid,0.02242596362894884,1.1126496279733087,207.14,73.43487544623838 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_25,erythronic_acid,0.021782317241405166,1.0807155302687008,86.56,71.32722499773425 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_25,erythronic_acid,0.017484644665891235,0.8674892952040897,13.4,57.25429348346992 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_25,erythronic_acid,0.02007238410553172,0.9958783077097164,81.58,65.72796830884128 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_25,erythronic_acid,0.021980779501624786,1.090562106480706,113.33,71.9770990277266 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_25,erythronic_acid,0.0197012959938326,0.9774670119340308,192.45,64.51282278764603 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_25,erythronic_acid,0.01788562591068788,0.8873837193737313,129.61,58.56732547866626 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_25,erythronic_acid,0.018083990071795897,0.8972254284619937,292.19,59.216878278491585 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_26,ethanolamine,0.019434202680734473,1.0998794892752761,4507.77,255.2545324735597 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_26,ethanolamine,0.020122303259263154,1.1388225694373662,4462.69,264.29224780217675 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_26,ethanolamine,0.02262570583088958,1.2805027395562272,9062.22,297.1726732825114 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_26,ethanolamine,0.0202214380055674,1.1444331044269305,4749.39,265.5943127098799 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_26,ethanolamine,0.017396209226208464,0.9845391670230793,4418.98,228.48692718688113 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_26,ethanolamine,0.019807731962982852,1.1210193941603876,5285.28,260.16057589977197 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_26,ethanolamine,0.020247762543616588,1.1459229427259647,4928.87,265.94006693312826 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_26,ethanolamine,0.020112762604927795,1.1382826157181365,4852.95,264.1669380427865 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_26,ethanolamine,0.01981715477022473,1.1215526783185803,4706.25,260.2843378207845 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_26,ethanolamine,0.02070834340303733,1.1719895351533371,261.78,271.9894713707107 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_26,ethanolamine,0.018160297548171837,1.0277827766081222,829.1,238.52268788132994 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_26,ethanolamine,0.016597858843120254,0.9393564946984642,659.33,218.00115850714607 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_26,ethanolamine,0.02074144034028673,1.173862657659903,296.75,272.424176276422 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_26,ethanolamine,0.022373417580737364,1.2662244758020549,1013.32,293.85904522176185 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_26,ethanolamine,0.02086901473640951,1.18108273578491,975.67,274.099775907283 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_26,ethanolamine,0.019481764816795293,1.102571270295512,900.77,255.87922755383093 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_26,ethanolamine,0.020166131663440705,1.1413030397501691,925.35,264.8679029500205 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_26,ethanolamine,0.02010851070536033,1.1380419792895913,995.37,264.11109234363187 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_26,ethanolamine,0.019652321355252928,1.1122239245099967,998.49,258.11936728065746 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_26,ethanolamine,0.032779411768841804,1.7732563102137575,3608.24,1064.2375071378885 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_26,ethanolamine,0.018602120543631254,1.0063123728384282,1564.38,603.9484336827111 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_26,ethanolamine,0.0201137860479758,1.0880884099868258,1735.06,653.0271401376933 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_26,ethanolamine,0.021760617443617552,1.1771764688200135,1498.2,706.4942295270192 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_26,ethanolamine,0.02357409467250943,1.275279508686586,1555.33,765.3717499333414 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_26,ethanolamine,0.016305164594743057,0.8820547546916417,2296.85,529.3739815757357 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_26,ethanolamine,0.017407534928457525,0.9416892949401562,2633.42,565.1642472512841 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_26,ethanolamine,0.006789833071783908,0.3673072117567255,1892.49,220.44309620791634 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_27,fructose-6-phosphate,0.021965648836924284,1.056425014972634,1480.81,100.022320417609 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_27,fructose-6-phosphate,0.020441533371198646,0.9831235743617549,1324.48,93.08214002057096 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_27,fructose-6-phosphate,0.01583026009830328,0.7613470872419,1620.68,72.0843422200631 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_27,fructose-6-phosphate,0.019486450362039272,0.9371894164526466,1309.91,88.73309394973658 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_27,fructose-6-phosphate,0.023262234363565976,1.1187835364333434,1529.87,105.92642522950896 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_27,fructose-6-phosphate,0.018355017891415467,0.8827738344867717,1403.75,83.58102664920756 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_27,fructose-6-phosphate,0.0203239289121664,0.977467456788522,1423.16,92.54661880873726 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_27,fructose-6-phosphate,0.020370441252704673,0.9797044405632493,1525.48,92.75841643252845 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_27,fructose-6-phosphate,0.020242069225076563,0.9735304630852372,1503.75,92.17386424491026 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_27,fructose-6-phosphate,0.020803632788461823,1.0005385337441883,39.65,94.73098837489975 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_27,fructose-6-phosphate,0.02623460295236545,1.2617378627197666,305.67,119.46134084230751 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_27,fructose-6-phosphate,0.007280322507522022,0.35014284672919754,75.65,33.151524728320425 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_27,fructose-6-phosphate,0.020624477364099447,0.9919221585453689,46.75,93.91518997107553 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_27,fructose-6-phosphate,0.024385369512027796,1.1728000635497902,333.38,111.04071001689414 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_27,fructose-6-phosphate,0.026854023389224872,1.2915285258202154,371.62,122.281920824658 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_27,fructose-6-phosphate,0.012321245716364441,0.5925830958615299,158,56.10576751616966 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_27,fructose-6-phosphate,0.011792710445309485,0.5671635015766938,150.11,53.699040329281374 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_27,fructose-6-phosphate,0.016184265677752618,0.7783727782354436,224.62,73.69633464333181 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_27,fructose-6-phosphate,0.028723685336602765,1.381448822070796,409.99,130.79557447366295 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_27,fructose-6-phosphate,0.024605836641003652,1.0999633933183977,324.51,177.45709424405712 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_27,fructose-6-phosphate,0.027691353931088486,1.2378963609334288,346.39,199.7098199093901 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_27,fructose-6-phosphate,0.009834437540661755,0.43963232977730216,135.68,70.92588376297216 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_27,fructose-6-phosphate,0.023270610321394006,1.0402743002469437,414.76,167.82745285883942 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_27,fructose-6-phosphate,0.022489113924478703,1.0053387911984697,389.14,162.19130718404912 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_27,fructose-6-phosphate,0.015422465864731328,0.6894359307270064,518.18,111.22669870418795 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_27,fructose-6-phosphate,0.01668375619961066,0.7458198373974108,577.92,120.32311436732428 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_27,fructose-6-phosphate,0.017952616888884578,0.8025421642902195,634.15,129.47412736494113 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_28,fructose-6-phosphate_peak_2,0.022671520098183774,1.212188662203436,609.45,88.04126253583554 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_28,fructose-6-phosphate_peak_2,0.021440922241881134,1.1463917168428372,555.33,83.26243039429527 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_28,fructose-6-phosphate_peak_2,0.014743055384530836,0.7882737684094363,562.45,57.252323799577354 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_28,fructose-6-phosphate_peak_2,0.01809058284150898,0.9672575688864358,485.39,70.25191722822183 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_28,fructose-6-phosphate_peak_2,0.023607236486432707,1.2622190435788856,582.89,91.67496913513446 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_28,fructose-6-phosphate_peak_2,0.020135261898096318,1.076581370709435,606.42,78.19210495462626 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_28,fructose-6-phosphate_peak_2,0.019258734503394628,1.029715674657002,530.58,74.78824945033804 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_28,fructose-6-phosphate_peak_2,0.019080877466820693,1.0202061101331263,554.1,74.09756977896896 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_28,fructose-6-phosphate_peak_2,0.02140735013802777,1.144596701621929,615.81,83.1320584388007 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_28,fructose-6-phosphate_peak_2,0.018611301082289457,0.9950990521633855,52.56,72.27404415862668 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_28,fructose-6-phosphate_peak_2,0.02987605615442371,1.5973969272861788,306.14,116.01893882879516 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_28,fructose-6-phosphate_peak_2,0.002896589700973701,0.15487330268855004,25.86,11.24844797426939 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_28,fructose-6-phosphate_peak_2,0.022828304107807864,1.220571505438387,72.92,88.65010843999003 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_28,fructose-6-phosphate_peak_2,0.034278533179861355,1.8327862047909607,353.97,133.11526205396746 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_28,fructose-6-phosphate_peak_2,0.012597968426003086,0.6735814108036444,133.62,48.92221786666869 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_28,fructose-6-phosphate_peak_2,0.022367442914840767,1.1959304266512165,249.2,86.86042688767785 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_28,fructose-6-phosphate_peak_2,0.013417723638030147,0.7174116422789915,150.3,52.105607578723145 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_28,fructose-6-phosphate_peak_2,0.007874217985883024,0.42101445888361205,118.83,30.57828014871674 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_28,fructose-6-phosphate_peak_2,0.032302139666494215,1.7271134577241247,510.41,125.44025043450317 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_28,fructose-6-phosphate_peak_2,0.029183252054606798,1.4599958810210347,133.57,144.72939168561516 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_28,fructose-6-phosphate_peak_2,0.03247153841462908,1.6245040904648254,230.97,161.03709048777813 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_28,fructose-6-phosphate_peak_2,0.0034074557860665094,0.17047008342694536,27.84,16.898699370113093 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_28,fructose-6-phosphate_peak_2,0.03436591006572933,1.7192767635909783,416.83,170.43190557477368 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_28,fructose-6-phosphate_peak_2,0.013824117963982278,0.6916006224528001,162.25,68.55836970374607 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_28,fructose-6-phosphate_peak_2,0.01388444578307022,0.6946187359658029,248.44,68.85755529629004 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_28,fructose-6-phosphate_peak_2,0.012366816172173363,0.618693922080121,222.49,61.33112849580239 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_28,fructose-6-phosphate_peak_2,0.018193128576551764,0.9101759027729283,232.73,90.22573724188038 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_30,fucose,0.01996730332116293,1.006737659264932,10517.3,168.0345827079098 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_30,fucose,0.020273557895104762,1.0221788036172894,10262.27,170.61186411176178 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_30,fucose,0.0202095479839034,1.018951468050933,17661.78,170.07318953238124 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_30,fucose,0.01986086722564878,1.0013712247526843,10771.77,167.13887112347052 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_30,fucose,0.019694986567169802,0.9930076363828187,10904.51,165.74290458865627 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_30,fucose,0.020016291670737315,1.009207618056488,12716,168.4468435298084 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_30,fucose,0.019994971618991376,1.008132675754822,11624.23,168.2674249102373 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_30,fucose,0.019975232406674388,1.0071374382866418,12137.5,168.1013098244234 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_30,fucose,0.020035549737480708,1.0101785964967596,12047.21,168.60890954127413 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_30,fucose,0.021372767634081326,1.0776002003807474,2064.71,179.86224944555056 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_30,fucose,0.00813993129318639,0.41040972057525493,1043.34,68.5014864612158 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_30,fucose,0.009386395057946148,0.4732555637374005,968.8,78.99108614340952 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_30,fucose,0.021545253286213754,1.0862968079742494,2254.99,181.31380021898198 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_30,fucose,0.034883309793056975,1.7587924159620725,1393.56,293.5600421482295 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_30,fucose,0.030573204005874467,1.5414798554435278,1348.17,257.2884026720792 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_30,fucose,0.03298585053933744,1.6631238293274635,1469.16,277.5919983530469 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_30,fucose,0.03213716553988824,1.6203337171096968,1460.61,270.4499007227795 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_30,fucose,0.017059991624140052,0.8601530090727247,1651.19,143.56813874432848 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_30,fucose,0.01630853365348897,0.8222650165761404,1726.03,137.24425391672358 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_30,fucose,0.01936062839660607,0.9730118835512107,1073.97,723.0354005480692 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_30,fucose,0.020760634568082,1.0433723395232861,1445.38,775.3195517763587 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_30,fucose,0.019193145668967092,0.9645946627387466,1363.78,716.7806479345353 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_30,fucose,0.018786894363632723,0.9441775905393842,1162.82,701.6089257539111 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_30,fucose,0.021357900994857612,1.0733893058631139,1306.24,797.6248592938214 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_30,fucose,0.01977217677933202,0.9936951722774605,2674.21,738.4049455676582 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_30,fucose,0.019991062617161985,1.0046957718957534,2815.62,746.5793811380155 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_30,fucose,0.020746192778046325,1.0426465349142309,3127.42,774.7802136294158 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_31,fucose_peak_2,0.02085972517626307,1.051899001006173,4554.38,97.40584749317162 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_31,fucose_peak_2,0.02124310533738459,1.0712318160400076,4495.6,99.1960661653047 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_31,fucose_peak_2,0.018808192378437883,0.9484458019669367,5731.64,87.82608126213833 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_31,fucose_peak_2,0.01950016083479795,0.9833398823933277,4190.97,91.05727310962214 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_31,fucose_peak_2,0.020324560225194604,1.0249120933338216,4143.92,94.90685984271188 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_31,fucose_peak_2,0.018665586585076013,0.9412545810708081,4441.32,87.16017420715683 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_31,fucose_peak_2,0.02026255581776121,1.0217853803169414,4576.46,94.61732621734878 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_31,fucose_peak_2,0.020115302971708098,1.0143598212383949,4785.71,93.92971944667536 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_31,fucose_peak_2,0.020379463541023754,1.027680717684555,4830,95.1632344575898 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_31,fucose_peak_2,0.019703040180627292,0.9935705340150239,NA,92.0046314497912 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_31,fucose_peak_2,0.011401647655069784,0.5749539688010811,254.59,53.240737510980104 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_31,fucose_peak_2,0.03132249621905994,1.5795079850496525,968.8,146.2624394155978 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_31,fucose_peak_2,0.015700188924746374,0.7917176715416098,NA,73.31305638475305 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_31,fucose_peak_2,0.030159447179492843,1.5208585966946238,1393.56,140.83150605392214 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_31,fucose_peak_2,0.012289405142214289,0.6197211556154927,434.66,57.38617900999462 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_31,fucose_peak_2,0.014503363827632383,0.731365048801119,466.33,67.7244035189836 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_31,fucose_peak_2,0.01562637347307392,0.7879953598037049,508.72,72.96837031782307 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_31,fucose_peak_2,0.022472257106567698,1.1332145846126234,649.52,104.93567053512892 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_31,fucose_peak_2,0.022640329067801616,1.1416899948409558,646.6,105.7204935222725 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_31,fucose_peak_2,0.025784928523362224,1.193906961490676,1089.81,260.8447929464829 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_31,fucose_peak_2,0.020326164049704415,0.941152454130567,733.52,205.62298817844626 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_31,fucose_peak_2,0.019990466676060744,0.9256088224705382,719.29,202.2270155333632 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_31,fucose_peak_2,0.019267422111404073,0.8921300428637048,456.72,194.9125717648622 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_31,fucose_peak_2,0.01901949728716312,0.8806505007226654,430.19,192.40452139788792 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_31,fucose_peak_2,0.021757127938432142,1.0074096767110325,1414.96,220.09886616782637 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_31,fucose_peak_2,0.020475678122797727,0.948075331289028,1388.22,207.13549838002683 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_31,fucose_peak_2,0.013056471251619678,0.604547416359446,1136.68,132.08151952621176 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_32,fumaric_acid,0.021305622918329385,1.0590455333954796,1336.68,122.48391116485419 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_32,fumaric_acid,0.020446348301741968,1.0163332903343236,1232.38,117.5440266936162 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_32,fumaric_acid,0.02090863086418718,1.0393121201390618,1989.47,120.20164325468319 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_32,fumaric_acid,0.019753462511219615,0.9818917908100547,1235.82,113.56069506613689 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_32,fumaric_acid,0.01824201959140136,0.9067620056189979,1115.72,104.8715597598652 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_32,fumaric_acid,0.019316820867585356,0.9601875025027884,1297.75,111.05048560195999 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_32,fumaric_acid,0.019395396383793274,0.9640932812633168,1184.55,111.50220844450891 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_32,fumaric_acid,0.020397851022264747,1.0139226202774536,1172.8,117.2652206481889 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_32,fumaric_acid,0.02025852311700572,1.0069970027394195,1141.18,116.46423835182756 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_32,fumaric_acid,0.034735630931311275,1.7266153131730906,171.99,199.69169404503378 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_32,fumaric_acid,0.01300303263043998,0.6463459754568363,171.5,74.7531437914604 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_32,fumaric_acid,0.027488432946643365,1.3663764839815575,308.4,158.02827225488704 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_32,fumaric_acid,0.004148740486089978,0.20622279375979402,22.81,23.850697212288978 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_32,fumaric_acid,0.02185607023795544,1.0864067974830913,233.39,125.64837816290692 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_32,fumaric_acid,0.01324367955911105,0.6583078906710206,146,76.13659909555689 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_32,fumaric_acid,0.02504912566873928,1.245125043122678,281.48,144.0049368623533 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_32,fumaric_acid,0.02286554069913259,1.136584874280114,257.41,131.45172363486657 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_32,fumaric_acid,0.01406894432851697,0.6993295951880985,210.84,80.88096433147953 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_32,fumaric_acid,0.023297135095133596,1.1580382774063918,365.89,133.93291697343625 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_32,fumaric_acid,0.02845774873600133,1.5093475623777066,590.23,157.4853246584899 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_32,fumaric_acid,0.019697633289813242,1.0447268709270043,437.98,109.00680171252364 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_32,fumaric_acid,0.020304311980411816,1.0769040122496079,445.54,112.36416463812408 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_32,fumaric_acid,0.015278953459531324,0.8103680784366369,168.18,84.55380530407871 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_32,fumaric_acid,0.025381034224525603,1.3461641851152182,261.77,140.45877107492186 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_32,fumaric_acid,0.022368067446922022,1.1863618724485145,533.75,123.78499777127801 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_32,fumaric_acid,0.017191562368593306,0.9118093983897703,445.41,95.13819262798863 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_32,fumaric_acid,0.01051252999674907,0.5575655921419611,549.14,58.17639388409222 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_33,galactinol,0.019809211257933772,1.3272883737468266,1950.83,133.08056879372558 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_33,galactinol,0.021781083668521842,1.4594109146701784,2073.45,146.32783535940544 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_33,galactinol,0.016447996978548304,1.102074932554747,2211.22,110.4995431126017 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_33,galactinol,0.019085287588217745,1.2787828851747165,2048.54,128.21716598204296 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_33,galactinol,0.023011388081006237,1.5418457335833209,2007.08,154.59316247773168 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_33,galactinol,0.020257503010240346,1.3573255328813076,2532.43,136.09224455434432 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_33,galactinol,0.019787291823290004,1.3258196928194057,2259.92,132.9333115005377 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_33,galactinol,0.020482221993575536,1.3723825126902107,2330.39,137.60193263488398 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_33,galactinol,0.0196590950056067,1.3172300451324368,2199.59,132.0720704752038 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_33,galactinol,0.0250741875590864,1.6800607149360114,159.84,168.45128758305918 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_33,galactinol,0.02284924580376429,1.5309816180628264,473.71,153.5038719350693 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_33,galactinol,0.015095039618329063,1.011421925172892,270.02,101.41021932746001 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_33,galactinol,0.014783786341997816,0.9905668366190954,105.98,99.3191838736136 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_33,galactinol,0.019968896198658506,1.3379878388858792,361.08,134.15335066589267 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_33,galactinol,0.023740073891507008,1.5906703027091913,435.44,159.48855790113706 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_33,galactinol,0.019444758810256705,1.302868749447469,341.23,130.63213516335048 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_33,galactinol,0.01604204119511948,1.074874435544319,281.53,107.77228527985113 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_33,galactinol,0.01844197026342261,1.2356783115138892,422.88,123.8952859039401 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_33,galactinol,0.022599757172609373,1.5142649827964272,542.78,151.82777850008378 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_33,galactinol,0.016864415942033542,0.9227205114846099,218.92,67.62618628670707 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_33,galactinol,0.021466627043554776,1.1745261237365907,334.15,86.08101960865474 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_33,galactinol,0.017429425865025702,0.9536344931445251,279.19,69.89187200256225 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_33,galactinol,0.023163798159465312,1.2673852304813835,295.31,92.88666354198061 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_33,galactinol,0.02067509893397374,1.1312184144961728,251.9,82.90699759842451 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_33,galactinol,0.016454090717710913,0.9002699562941193,407.95,65.98078509679601 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_33,galactinol,0.018198138515365673,0.9956938761877577,472.3,72.97440418580076 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_33,galactinol,0.02496480341947527,1.36592552386687,844.43,100.1086816442029 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_34,galactinol_peak_2,0.020021123718487507,1.0151361644303825,8276.19,407.57717001879854 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_34,galactinol_peak_2,0.020283406946025838,1.0284347781016931,8301.77,412.9165634078298 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_34,galactinol_peak_2,0.018691643169809334,0.947727171616271,7311.06,380.5124594039328 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_34,galactinol_peak_2,0.019981308736804364,1.0131174152152538,10383.26,406.7666422089244 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_34,galactinol_peak_2,0.02120174506466279,1.074997510968805,6710.05,431.6115006539752 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_34,galactinol_peak_2,0.019712188815446684,0.9994721589059601,12707.2,401.28807180074296 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_34,galactinol_peak_2,0.02006891967677214,1.0175595751465119,12035.61,408.5501694213245 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_34,galactinol_peak_2,0.019854351854078585,1.0066802878696353,12317.4,404.18213557965856 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_34,galactinol_peak_2,0.020229746014063434,1.0257139941228313,12551.08,411.82416864031677 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_34,galactinol_peak_2,0.019733009612139328,1.0005278410940401,433.85,401.7119281992571 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_34,galactinol_peak_2,0.018290127576611828,0.9273690236437306,1485.02,372.33866299295784 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_34,galactinol_peak_2,0.019498799837605982,0.9886526429016258,1441.57,396.94403612500275 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_34,galactinol_peak_2,0.02110986643611615,1.0703389653303386,544.2,429.74109458013095 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_34,galactinol_peak_2,0.02013684228937529,1.0210034727721173,1887.73,409.9328943180051 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_34,galactinol_peak_2,0.02043120996845781,1.0359288726086995,2007.29,415.92544235239285 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_34,galactinol_peak_2,0.02030806331006703,1.0296849360435505,2182.18,413.4185018214855 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_34,galactinol_peak_2,0.02070943605503206,1.0500358411455681,2247.09,421.5893902199456 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_34,galactinol_peak_2,0.02006620833827837,1.0174221014563365,2542.6,408.4949737347191 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_34,galactinol_peak_2,0.019477628932837127,0.9875792090940754,2513.78,396.5130524512713 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_34,galactinol_peak_2,0.01940150324525135,0.9717855560313361,1933.38,1374.065904806068 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_34,galactinol_peak_2,0.020263946957001247,1.014983772755792,2494.8,1435.1464553257797 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_34,galactinol_peak_2,0.019186811267858286,0.9610320303900973,2391.78,1358.860849690382 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_34,galactinol_peak_2,0.02060648417447052,1.0321408309554587,2335.1,1459.4058493377804 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_34,galactinol_peak_2,0.02135999394952159,1.0698827474691843,2362.01,1512.7714096115278 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_34,galactinol_peak_2,0.018573253636352132,0.9303000589261639,3899.53,1315.4070713192386 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_34,galactinol_peak_2,0.018716815868708978,0.9374908266740261,4108.77,1325.5745292840058 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_34,galactinol_peak_2,0.02153521802695072,1.0786593987091455,5963.21,1525.1812433987834 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_35,galactonolactone,0.020209232683609885,1.5847780238877411,7653.31,213.50129537815647 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_35,galactonolactone,0.008727265159497824,0.6843791770793132,3289.34,92.19956273612507 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_35,galactonolactone,0.027244858011914404,2.1365013168580766,6099.51,287.82945740712006 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_35,galactonolactone,0.022484620997867764,1.763210597390217,13856.67,237.53973168041003 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_35,galactonolactone,0.023968521899374186,1.8795759030478547,3916.24,253.21646565860698 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_35,galactonolactone,0.02234881425970655,1.7525608346058874,16422.66,236.10499563810515 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_35,galactonolactone,0.020271992392493474,1.5896995470836697,13413.56,214.164322983112 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_35,galactonolactone,0.016457706021724826,1.290588872678345,6709.76,173.86813292722664 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_35,galactonolactone,0.021096668319233337,1.6543694089229337,7840.75,222.87664677009764 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_35,galactonolactone,0.020462101890179354,1.6046076516506118,1094.11,216.17274283037042 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_35,galactonolactone,0.01323034123541087,1.0375037175666615,1312.74,139.77250083058064 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_35,galactonolactone,0.013260895821271452,1.0398997628277027,1081.67,140.0952960481481 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_35,galactonolactone,0.022490802112493827,1.7636953112225469,1311.09,237.6050323279015 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_35,galactonolactone,0.013501819157733665,1.0587926131919168,909.41,142.64054084921503 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_35,galactonolactone,0.011810384934767095,0.9261528525748283,914.27,124.77131229888086 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_35,galactonolactone,0.0063242411748140855,0.4959376037933309,601.61,66.81271398303754 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_35,galactonolactone,0.07641099145617881,5.992036508216183,7146.38,807.2471583868842 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_35,galactonolactone,0.007424303790679417,0.5822028809474574,564.4,78.43437212124147 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_35,galactonolactone,0.008407828007638746,0.6593293898753623,630.25,88.8248554040088 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_35,galactonolactone,0.010156141238372914,0.5102960717602412,501.5,233.00118636572614 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_35,galactonolactone,0.020064091880027557,1.008121788532247,1057.58,460.30840864382407 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_35,galactonolactone,0.022307060784676657,1.1208199279395892,1255.86,511.76637909721643 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_35,galactonolactone,0.019023432005004493,0.955833755725424,1287.33,436.4336928642286 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_35,galactonolactone,0.014613873846784803,0.7342751781589775,972.97,335.27004634738915 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_35,galactonolactone,0.02467956249554751,1.240026452827954,4637.6,566.1960783612438 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_35,galactonolactone,0.02155558437108013,1.0830619396566086,4179.15,494.5260816472075 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_35,galactonolactone,0.026679600725853212,1.3405185224379286,3799.58,612.0807573451582 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_36,galactonic_glucoronic_acid,0.020199653309046182,1.1039000860887744,132816.58,NA -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_36,galactonic_glucoronic_acid,0.020672529429788932,1.1297425093428148,130935.94,NA -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_36,galactonic_glucoronic_acid,0.01719589081344118,0.9397460965743294,171736.17,NA -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_36,galactonic_glucoronic_acid,0.01870336531595909,1.022128759664933,134629.14,NA -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_36,galactonic_glucoronic_acid,0.022702639674072156,1.2406869319597282,145353.26,NA -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_36,galactonic_glucoronic_acid,0.020584475354176117,1.1249304019188757,180827.43,NA -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_36,galactonic_glucoronic_acid,0.020840686361273918,1.1389321943489217,167830.1,NA -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_36,galactonic_glucoronic_acid,0.019681179387212037,1.0755657677620742,166531.75,NA -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_36,galactonic_glucoronic_acid,0.01987546690674101,1.0861834752173778,166192.13,NA -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_36,galactonic_glucoronic_acid,0.019630113419271202,1.0727750403399927,6673.57,NA -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_36,galactonic_glucoronic_acid,0.02314130844236852,1.2646599419751996,54136.1,NA -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_36,galactonic_glucoronic_acid,0.021560162289530126,1.1782511631940524,45005.4,NA -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_36,galactonic_glucoronic_acid,0.0174446292016984,0.95333951444194,7198.71,NA -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_36,galactonic_glucoronic_acid,0.020034797616283743,1.0948908119864718,51400.37,NA -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_36,galactonic_glucoronic_acid,0.019684587395247574,1.0757520135508638,50718.54,NA -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_36,galactonic_glucoronic_acid,0.01726809516685842,0.9436920252857681,35557.07,NA -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_36,galactonic_glucoronic_acid,0.017285085453447466,0.9446205352231105,34563.84,NA -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_36,galactonic_glucoronic_acid,0.021756532622771593,1.1889826952878957,29364.03,NA -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_36,galactonic_glucoronic_acid,0.022208786207132795,1.2136981081255362,29013.16,NA -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_36,galactonic_glucoronic_acid,0.014855552455597689,0.8886259982765156,21339.37,NA -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_36,galactonic_glucoronic_acid,0.02096786210068732,1.2542507218522647,28061.7,NA -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_36,galactonic_glucoronic_acid,0.01970879017989223,1.1789358491228512,27958.23,NA -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_36,galactonic_glucoronic_acid,0.0190700455895253,1.140727573062094,29828.01,NA -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_36,galactonic_glucoronic_acid,0.018925163504493702,1.1320610500345323,28926.64,NA -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_36,galactonic_glucoronic_acid,0.021423830472565446,1.2815257323814113,85248.35,NA -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_36,galactonic_glucoronic_acid,0.020617291494654535,1.2332803704847597,85253.07,NA -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_36,galactonic_glucoronic_acid,0.024590273603152565,1.4709352946520853,96694.72,NA -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_37,galacturonic_acid,0.020177989791386547,1.0590337907161627,32565.95,577.104578743912 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_37,galacturonic_acid,0.020777268505533898,1.0904866963276965,32321.72,594.2443678633332 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_37,galacturonic_acid,0.017100977520314697,0.8975380221483539,40841.11,489.09988209941315 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_37,galacturonic_acid,0.01912782853271542,1.0039164935952922,33436.94,547.0692344373505 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_37,galacturonic_acid,0.022688859710032296,1.1908158024740279,34843.91,648.9172093211843 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_37,galacturonic_acid,0.020410430073435903,1.0712333267234087,42526.26,583.7525328980206 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_37,galacturonic_acid,0.020199430828277926,1.0601591150329415,38528.05,577.7178073504759 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_37,galacturonic_acid,0.01991182040650819,1.045063996125393,39189.01,569.491948728591 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_37,galacturonic_acid,0.019949070997100884,1.0470190785974158,38744.84,570.5573415954827 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_37,galacturonic_acid,0.02049823755113055,1.0758418673618761,1395.3,586.263887990844 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_37,galacturonic_acid,0.019814675579184714,1.039965388395263,6910.94,566.7135389251727 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_37,galacturonic_acid,0.020503000965182334,1.076091873259003,6330.88,586.4001249543948 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_37,galacturonic_acid,0.019333528518902222,1.0147125757805784,1537.12,552.9523974829895 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_37,galacturonic_acid,0.020077388753589706,1.053753785150224,7789.92,574.2273189108373 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_37,galacturonic_acid,0.019929986719409282,1.0460174478524422,7918.87,570.0115179454706 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_37,galacturonic_acid,0.019835090450872145,1.041036854838335,7392.51,567.297418491328 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_37,galacturonic_acid,0.019754042092192333,1.0367830638803952,7252.18,564.9793789156631 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_37,galacturonic_acid,0.019238554754863066,1.0097279154457859,6427.64,550.2360816034493 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_37,galacturonic_acid,0.02094080989033182,1.0990701010410564,7038.62,598.921765510808 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_37,galacturonic_acid,0.01680443698181133,1.2000624685343106,5214.28,1231.1440864693493 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_37,galacturonic_acid,0.020843564475591735,1.4885104133334968,6172,1527.0628330388345 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_37,galacturonic_acid,0.02004346027165063,1.4313722285132908,6307.49,1468.4447692317851 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_37,galacturonic_acid,0.01853538456576952,1.3236753710526588,6561.75,1357.9585631629227 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_37,galacturonic_acid,0.018935355709308994,1.3522386819435859,6555.58,1387.2616638059249 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_37,galacturonic_acid,0.021634057496087256,1.5449622305863915,19477.24,1584.9767523585792 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_37,galacturonic_acid,0.02105357136539595,1.5035077254636466,19663,1542.4485755531553 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_37,galacturonic_acid,0.02222200334167641,1.5869494595299083,18994.28,1628.051450531733 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_38,6-phosphogluconic_acid,0.01490504543861293,0.44180117999103474,9.94,15.774511131579894 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_38,6-phosphogluconic_acid,0.04004329028569408,1.1869251235633624,26.18,42.379161536829855 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_38,6-phosphogluconic_acid,0.004129736027664121,0.12240970734291758,3.39,4.3706386006788716 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_38,6-phosphogluconic_acid,0.02021350120486506,0.599149376688559,16.57,21.392628494665 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_38,6-phosphogluconic_acid,0.027892792633394912,0.82677162907233,14.84,29.519881016027544 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_38,6-phosphogluconic_acid,0.011118530827933553,0.32956491543610283,17.28,11.767115305646051 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_38,6-phosphogluconic_acid,0.02148270168736034,0.6367698101935095,32.41,22.735866072959258 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_38,6-phosphogluconic_acid,0.008637028883865576,0.25601059508501345,27.56,9.140858297510405 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_38,6-phosphogluconic_acid,0.0315381918863767,0.9348250864159441,104.42,33.37792971048128 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_38,6-phosphogluconic_acid,0.028243519201794978,0.8371675324200608,28.4,29.89106674505827 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_38,6-phosphogluconic_acid,0.0013997150010342696,0.041489020724893605,2.5,1.4813654849823261 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_38,6-phosphogluconic_acid,0.03434621234307804,1.0180577579511652,49.97,36.34975224764635 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_38,6-phosphogluconic_acid,0.012087153090510814,0.35827589524053904,13.24,12.792240839563446 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_38,6-phosphogluconic_acid,0.02142870677559145,0.6351693443759947,18.33,22.67872144094489 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_38,6-phosphogluconic_acid,0.012699395056355131,0.3764233892595322,11.54,13.440197113511598 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_38,6-phosphogluconic_acid,0.008476953816029061,0.25126580217924294,10.17,8.971445466809868 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_38,6-phosphogluconic_acid,0.04758773768658368,1.4105504575364136,59.09,50.36370408633765 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_38,6-phosphogluconic_acid,0.015031807981109504,0.445558554705812,38.67,15.908668195771018 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_38,6-phosphogluconic_acid,0.02094750569213257,0.620906039553431,58.17,22.169450142255254 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_38,6-phosphogluconic_acid,0.030498506711160583,1.4701573296532764,89.43,39.23849912844595 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_38,6-phosphogluconic_acid,0.0068098616408403985,0.32826420322876265,10.8,8.761371584175675 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_38,6-phosphogluconic_acid,0.03515981711046535,1.6948522537106308,52.51,45.235606651536735 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_38,6-phosphogluconic_acid,0.03518308886671207,1.6959740510282517,10.2,45.26554742194404 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_38,6-phosphogluconic_acid,0.00612939112473017,0.29546263932444483,1.55,7.885897843569433 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_38,6-phosphogluconic_acid,0.03245320495786417,1.5643820725847093,43.67,41.75335751728589 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_38,6-phosphogluconic_acid,0.007499408401823044,0.36150328061697934,12.52,9.648522559667178 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_38,6-phosphogluconic_acid,0.008038618949512626,0.3874955151358618,57.57,10.342255298976152 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_39,methyl_alpha-D-glucopyranoside,0.016036870095282273,0.8402182838248603,261.29,100.59933512235052 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_39,methyl_alpha-D-glucopyranoside,0.015844448775384067,0.8301367710224496,253.82,99.3922755945179 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_39,methyl_alpha-D-glucopyranoside,0.022645255588739355,1.1864508270315952,1306.07,142.0537575204929 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_39,methyl_alpha-D-glucopyranoside,0.019167755739967204,1.0042544921123455,1879.82,120.23939034061114 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_39,methyl_alpha-D-glucopyranoside,0.021473212920620786,1.1250441015717565,692.89,134.70153028118642 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_39,methyl_alpha-D-glucopyranoside,0.025150803891356523,1.3177237925390353,4368.63,157.7710696806987 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_39,methyl_alpha-D-glucopyranoside,0.021028984984232887,1.1017697074960258,2905.94,131.91488707849916 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_39,methyl_alpha-D-glucopyranoside,0.018605010554039653,0.9747706345053773,1276.64,116.70928806932882 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_39,methyl_alpha-D-glucopyranoside,0.018097717650740797,0.94819208332464,1029.59,113.52703813645915 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_39,methyl_alpha-D-glucopyranoside,0.022576412427678372,1.1828439335233192,1536.15,141.62190416074702 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_39,methyl_alpha-D-glucopyranoside,0.006882453783153529,0.36059177831005496,401.25,43.17365361706288 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_39,methyl_alpha-D-glucopyranoside,0.005536443847802131,0.29007040155930963,184.67,34.730129178696146 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_39,methyl_alpha-D-glucopyranoside,0.020299994183943824,1.0635757584583532,1482.09,127.34192556021863 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_39,methyl_alpha-D-glucopyranoside,0.09670625738399355,5.066722192768007,360.08,606.6386481401136 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_39,methyl_alpha-D-glucopyranoside,0.07419831037080854,3.887465361511227,385.77,465.4462277337392 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_39,methyl_alpha-D-glucopyranoside,2.442615472288401,127.97573142242796,104.32,15322.5343232073 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_39,methyl_alpha-D-glucopyranoside,0.8480504854696469,44.431832350363905,173.22,5319.82328730907 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_39,methyl_alpha-D-glucopyranoside,0.013502296950888646,0.7074246224085047,112.06,84.69995004097026 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_39,methyl_alpha-D-glucopyranoside,0.011362949966717628,0.5953380094431195,97.39,71.2798198706247 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_39,methyl_alpha-D-glucopyranoside,0.03425657091767378,1.7925293442199692,3521.07,232.4372800650034 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_39,methyl_alpha-D-glucopyranoside,0.017037716692819303,0.8915255179445992,129.67,115.60411391187617 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_39,methyl_alpha-D-glucopyranoside,0.018862314612476016,0.987000494708837,146.71,127.98435414889488 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_39,methyl_alpha-D-glucopyranoside,0.032319195135171314,1.6911530871140634,133.06,219.29182080608058 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_39,methyl_alpha-D-glucopyranoside,0.032646440787775136,1.7082767343252945,140.01,221.51224413996093 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_39,methyl_alpha-D-glucopyranoside,0.014703157332390906,0.769366000885865,247.63,99.76368933487011 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_39,methyl_alpha-D-glucopyranoside,0.013425005013352814,0.7024846558801238,305.47,91.09118532797564 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_39,methyl_alpha-D-glucopyranoside,0.004512044679536417,0.2360998860609203,482.32,30.615072225519533 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_40,glucose 1-phosphate,0.020191565725677818,1.8258532640973844,52469.52,313.1429640590219 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_40,glucose 1-phosphate,0.020071165368388103,1.8149658773368642,49906.33,311.2757227926589 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_40,glucose 1-phosphate,0.019828171444782387,1.7929927795296392,82459.05,307.50722665323076 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_40,glucose 1-phosphate,0.01986886686757013,1.7966727254803552,53113.75,308.1383557835083 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_40,glucose 1-phosphate,0.020077955910548693,1.8155799225148037,53594.07,311.3810346109014 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_40,glucose 1-phosphate,0.02001777009371987,1.8101375278237608,62460.64,310.4476367094141 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_40,glucose 1-phosphate,0.019974587873383284,1.8062327093949324,56943.18,309.7779408247779 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_40,glucose 1-phosphate,0.01997226967633335,1.8060230828752288,58622.9,309.7419888285161 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_40,glucose 1-phosphate,0.020048310863214312,1.8128992236935644,58217.56,310.9212813595648 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_40,glucose 1-phosphate,0.01985916049080281,1.7957950114910615,1484.73,307.9878234457745 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_40,glucose 1-phosphate,0.02089877756821671,1.8898039784031029,7495.25,324.11083131602413 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_40,glucose 1-phosphate,0.019680834743290257,1.7796696325783041,6088.94,305.22224033534206 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_40,glucose 1-phosphate,0.019987045732839964,1.8073592304216657,1732.23,309.9711448134678 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_40,glucose 1-phosphate,0.019317930491778382,1.7468534596682892,7639.96,299.59410260040994 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_40,glucose 1-phosphate,0.019862897703641982,1.7961329546874305,8200.85,308.04578239366776 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_40,glucose 1-phosphate,0.019996280190772812,1.8081942704273757,8730.97,310.11435834964703 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_40,glucose 1-phosphate,0.021118843205923995,1.9097037508319707,9371.87,327.52374178643714 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_40,glucose 1-phosphate,0.02012968079652776,1.8202572245716642,9719.88,312.1832153001632 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_40,glucose 1-phosphate,0.019498716300938922,1.763201293424365,9545.25,302.3978378287457 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_40,glucose 1-phosphate,0.021189035218176347,1.1367623568490262,6989.11,249.37155822197087 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_40,glucose 1-phosphate,0.02022014135396834,1.0847825445889168,9819.43,237.96874680647068 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_40,glucose 1-phosphate,0.019456408908749744,1.0438093579624668,9695.6,228.98045885622633 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_40,glucose 1-phosphate,0.02072267614604829,1.111742839324441,9284.03,243.88302666260265 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_40,glucose 1-phosphate,0.02034261200255745,1.0913529250569978,8684.65,239.4100911697536 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_40,glucose 1-phosphate,0.01917343837718836,1.0286283813363766,15834.68,225.65020801376093 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_40,glucose 1-phosphate,0.019420349698787406,1.041874831350904,16631.25,228.55608175344784 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_40,glucose 1-phosphate,0.01924545685062414,1.0324920725689672,16308.23,226.49778595945435 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_41,glucose-6-phosphate,0.022421198222937047,1.1286794810380676,2583.13,186.75695032996387 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_41,glucose-6-phosphate,0.019966143329423636,1.0050924159945962,2220.92,166.30761661254587 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_41,glucose-6-phosphate,0.01589501682279498,0.8001525681303889,2543.31,132.3972446856948 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_41,glucose-6-phosphate,0.018185227841202124,0.9154414192444679,2234.72,151.4735144352859 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_41,glucose-6-phosphate,0.02324547379989655,1.170173379855806,2410.1,193.62273829784095 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_41,glucose-6-phosphate,0.019581805319704677,0.9857449029384464,2765.14,163.10628036471005 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_41,glucose-6-phosphate,0.02170824152823309,1.0927893566932472,2795.56,180.81839090524815 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_41,glucose-6-phosphate,0.019223562835283717,0.9677110343921885,2392.64,160.1223063057035 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_41,glucose-6-phosphate,0.020404374033036923,1.0271528785181019,2489.66,169.95785104399772 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_41,glucose-6-phosphate,0.012057066639071403,0.6069507785318472,113.15,100.42911056977209 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_41,glucose-6-phosphate,0.012975858007650333,0.6532025869659318,304.27,108.0821660523179 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_41,glucose-6-phosphate,0.014746342720465575,0.742328500174346,292.69,122.82938528134817 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_41,glucose-6-phosphate,0.03141057445637543,1.5812032222373051,325.88,261.6337911674957 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_41,glucose-6-phosphate,0.024724300728379993,1.2446172875180774,447.81,205.94059947917867 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_41,glucose-6-phosphate,0.02218285147337683,1.116681144333407,421.63,184.7716455471272 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_41,glucose-6-phosphate,0.019971799323735884,1.0053771378306742,420.65,166.3547281111525 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_41,glucose-6-phosphate,0.023476281498817676,1.1817922019743932,497.63,195.54524669969297 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_41,glucose-6-phosphate,0.019398977648597326,0.9765413876359618,572.32,161.5834207051844 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_41,glucose-6-phosphate,0.018936949361409765,0.9532829586161298,587.1,157.7349647474179 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_41,glucose-6-phosphate,0.01991725086900227,0.9652145273364966,410.3,294.2842572396244 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_41,glucose-6-phosphate,0.019202886214624376,0.9305955356515363,519.01,283.7292728647969 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_41,glucose-6-phosphate,0.02034539774768615,0.9859630528161156,573.12,300.6102751731055 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_41,glucose-6-phosphate,0.024264536296035935,1.1758893376428516,614,358.51690015392904 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_41,glucose-6-phosphate,0.017032530634784875,0.8254174290481197,414.36,251.6615199424812 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_41,glucose-6-phosphate,0.01955327709998171,0.94757590985165,986.78,288.90641915466955 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_41,glucose-6-phosphate,0.01878565568119157,0.9103760297183927,982.03,277.56454770084076 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_41,glucose-6-phosphate,0.020746928024370753,1.0054217049549306,1143.13,306.54302362370873 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_42,glucose-6-phosphate_peak_2,0.021278468113819848,1.114734410059765,359.02,51.155162077642615 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_42,glucose-6-phosphate_peak_2,0.019625168685769773,1.0281215132703305,179.02,47.18049624397547 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_42,glucose-6-phosphate_peak_2,0.01982793838943991,1.0387441936620605,94.75,47.66797104715196 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_42,glucose-6-phosphate_peak_2,0.019610405807413935,1.0273481169709942,196.35,47.14500508779892 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_42,glucose-6-phosphate_peak_2,0.019783431232296554,1.0364125568498497,70.62,47.5609722338396 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_42,glucose-6-phosphate_peak_2,0.019586283713814233,1.0260844109732485,161.18,47.08701361956238 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_42,glucose-6-phosphate_peak_2,0.020399677203745456,1.068696393532089,236.03,49.04247749918756 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_42,glucose-6-phosphate_peak_2,0.019810894932488613,1.0378513226232076,60.99,47.626997195178994 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_42,glucose-6-phosphate_peak_2,0.020234061242153878,1.0600201199275356,97.4,48.644323303474614 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_42,glucose-6-phosphate_peak_2,0.018392195312293007,0.9635286187654223,7.68,44.216328315145226 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_42,glucose-6-phosphate_peak_2,0.015994344511178215,0.8379102338377965,6.41,38.45170063081648 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_42,glucose-6-phosphate_peak_2,0.017180416483807824,0.9000460621138453,21.21,41.30311379040436 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_42,glucose-6-phosphate_peak_2,0.02400008991346963,1.257314479969401,29.32,57.69816148579581 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_42,glucose-6-phosphate_peak_2,0.023662444474330954,1.239625942082448,140.07,56.886434482163544 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_42,glucose-6-phosphate_peak_2,0.021938750109661894,1.1493252018954812,115.88,52.74253351498363 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_42,glucose-6-phosphate_peak_2,0.018165556614422963,0.9516554917237819,38.58,43.671470515204355 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_42,glucose-6-phosphate_peak_2,0.017397552601865353,0.9114213688873777,24,41.82512661824176 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_42,glucose-6-phosphate_peak_2,0.022539800716835267,1.1808129852462157,74.49,54.18750789294884 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_42,glucose-6-phosphate_peak_2,0.018889563033428147,0.9895846727180214,12.76,45.41204063103 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_42,glucose-6-phosphate_peak_2,0.0211849890101546,1.1104844695759941,79.33,52.6147541685106 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_42,glucose-6-phosphate_peak_2,0.021828304904426835,1.1442060971528731,105.05,54.21248488310313 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_42,glucose-6-phosphate_peak_2,0.019329970980228584,1.0132472837540476,69.4,48.00765630426678 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_42,glucose-6-phosphate_peak_2,0.022204067706986824,1.1639030040659335,181.19,55.14572433264393 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_42,glucose-6-phosphate_peak_2,0.013251702151076232,0.6946338007144219,6.28,32.91174947784931 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_42,glucose-6-phosphate_peak_2,0.03175831522152551,1.6647219319537239,986.92,78.87452513596745 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_42,glucose-6-phosphate_peak_2,0.012878890497613238,0.6750915884881536,55.07,31.985839462568723 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_42,glucose-6-phosphate_peak_2,0.017234407515881657,0.9034010770341534,82.32,42.80314302987819 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_43,levoglucosan,0.011445070748461295,0.294553665959799,468.96,38.57032978910588 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_43,levoglucosan,0.010956216937268575,0.28197238224649435,450.57,36.9228735932672 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_43,levoglucosan,0.023181834087277465,0.5966144171714641,761.33,78.12367485651737 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_43,levoglucosan,0.03140978217892842,0.8083712797534234,2511.83,105.85217722731201 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_43,levoglucosan,0.027480148651075346,0.7072370895900925,605.67,92.60916069637466 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_43,levoglucosan,0.01565108989765627,0.40280099677328957,2133.66,52.744776522478396 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_43,levoglucosan,0.01643613486893587,0.4230051422360688,2106.81,55.39040835010202 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_43,levoglucosan,0.02890949684890752,0.744023210083153,5322.36,97.42611924433847 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_43,levoglucosan,0.013346905817694259,0.34349984584853327,2486.52,44.979587314636184 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_43,levoglucosan,0.01580992263235047,0.4068887621796229,141.33,53.28004896361072 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_43,levoglucosan,0.0075722448437784825,0.19488149329090013,173.26,25.518757138976916 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_43,levoglucosan,0.01235168176355838,0.3178864704452831,240.21,41.625643872457594 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_43,levoglucosan,0.028942238638979982,0.7448658623050474,286.06,97.53646033953443 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_43,levoglucosan,0.02488861285595301,0.6405405714386471,499.55,83.87558512703363 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_43,levoglucosan,0.027915611818254308,0.718444296177284,594.63,94.07668836293445 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_43,levoglucosan,0.021061989022850666,0.5420574687071964,488.05,70.97971523986382 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_43,levoglucosan,0.018184523911063292,0.468002190589991,421.41,61.28254684680637 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_43,levoglucosan,0.018346617332670696,0.4721738739820615,522.52,61.82880792858104 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_43,levoglucosan,0.020653978713544578,0.5315567968461984,611.42,69.60470476302544 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_43,levoglucosan,1.6784219989113836e-4,0.005936543519253267,NA,0.4449439367680324 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_43,levoglucosan,0.033045632737862436,1.1688171210626421,807.65,87.60284322364502 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_43,levoglucosan,0.00908100820565146,0.3211933616606047,215.1,24.073442456462324 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_43,levoglucosan,0.011939521331867568,0.4222983733033566,133.87,31.65126307908658 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_43,levoglucosan,1.6816151893029436e-4,0.00594783776690794,NA,0.4457904406297501 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_43,levoglucosan,0.035496919224828075,1.2555186116142878,1627.2,94.10111994049088 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_43,levoglucosan,0.023863998176540675,0.8440646262400076,1135.2,63.26264373668857 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_43,levoglucosan,0.028683229851218347,1.0145198430129279,929.56,76.03826223381894 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_47,L-glutamine,0.020826401315140925,1.170043171449937,4919.11,226.36240216456207 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_47,L-glutamine,0.017786057233583376,0.9992343131332371,4096.6,193.3168663903217 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_47,L-glutamine,0.02091645206870714,1.1751022917319165,6415.78,227.34116486991522 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_47,L-glutamine,0.021212867190219847,1.191755120206335,6692.64,230.5629043307186 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_47,L-glutamine,0.01954625514414621,1.098123579429917,3881.71,212.4484782944089 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_47,L-glutamine,0.019121456593369727,1.0742580716037275,8590.08,207.83133782281516 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_47,L-glutamine,0.020096289859347857,1.1290249508595656,8382.19,218.42681211804586 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_47,L-glutamine,0.020305515989508673,1.1407794350442906,10551.26,220.70089340084368 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_47,L-glutamine,0.019865262055485108,1.1160456319539913,10341.15,215.91576818597892 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_47,L-glutamine,0.009944362382520135,0.5586818924704169,62.14,108.0853923267892 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_47,L-glutamine,0.02024356014022431,1.1372987079955013,823.82,220.02749454234964 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_47,L-glutamine,0.01922367847850931,1.080000975376227,707.08,208.94238870116175 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_47,L-glutamine,0.03133055175714151,1.760174385699155,231.81,340.532137529287 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_47,L-glutamine,0.017724193134519485,0.9957587406820818,1118.68,192.64446476605897 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_47,L-glutamine,0.019590295202215526,1.1005977836111644,1311.63,212.92715020633392 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_47,L-glutamine,0.021702494834727387,1.219262776154205,1928.91,235.88467298867326 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_47,L-glutamine,0.022497919682985947,1.2639503531399572,2019.11,244.5301550702218 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_47,L-glutamine,0.01897210282669504,1.065867262640443,2194.67,206.20800996673333 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_47,L-glutamine,0.0197113427120991,1.1073983253954682,2363.89,214.24281702263426 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_47,L-glutamine,0.027296422797832107,1.6427748778918259,5350.83,502.1141414276365 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_47,L-glutamine,0.019129747752768992,1.1512815895844186,2455.59,351.8892178564775 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_47,L-glutamine,0.019257310817557403,1.1589586907098426,2565.45,354.23572381546336 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_47,L-glutamine,0.021785689923574072,1.3111235992003667,2625.25,400.74492809559206 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_47,L-glutamine,0.02400150301019595,1.4444774126200306,2791.95,441.5045211673123 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_47,L-glutamine,0.01660933564669561,0.9995961573775062,4451.04,305.5265655024347 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_47,L-glutamine,0.016616688182892678,1.0000386535185863,4774.73,305.6618144479559 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_47,L-glutamine,0.013239576888270837,0.7967946740514266,6610.48,243.54029212381852 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_48,oxoglutaric_acid,0.016953049265684545,1.0223011972637792,549.61,70.74835435663985 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_48,oxoglutaric_acid,0.02199117898359988,1.3261100260990974,684.56,91.77344435618805 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_48,oxoglutaric_acid,0.02118758489987332,1.277651770534972,1106.75,88.41989077987274 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_48,oxoglutaric_acid,0.020857334717384986,1.2577370548007478,720.47,87.04169287748577 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_48,oxoglutaric_acid,0.019191973259725676,1.1573125833466256,639.28,80.09181733050323 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_48,oxoglutaric_acid,0.02041390630029526,1.2309974757086732,824.44,85.19118030641874 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_48,oxoglutaric_acid,0.018697871592137292,1.127517310624327,690.75,78.02983548175656 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_48,oxoglutaric_acid,0.020015958819670585,1.2070004838097481,759.7,83.53046848205364 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_48,oxoglutaric_acid,0.02025825668669877,1.2216115072118188,759,84.54162435659393 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_48,oxoglutaric_acid,0.008571417147441897,0.516872798205917,11.1,35.770181999840496 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_48,oxoglutaric_acid,0.015802876742156493,0.9529436009142737,105.73,65.94846190127232 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_48,oxoglutaric_acid,0.016382671615696117,0.9879063373576061,97.03,68.36805807683315 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_48,oxoglutaric_acid,0.03481559112276308,2.0994465320342317,52.7,145.29219724942902 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_48,oxoglutaric_acid,0.034381635593587576,2.0732781861465495,257.23,143.48121687227197 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_48,oxoglutaric_acid,0.010843365121618535,0.6538755932619728,83.6,45.25146043169483 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_48,oxoglutaric_acid,0.015152490456946555,0.913724067741566,103.42,63.23427410805509 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_48,oxoglutaric_acid,0.022627924420138654,1.3645069900861866,150.52,94.43070624891456 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_48,oxoglutaric_acid,0.02406960004214547,1.4514427791201283,110.67,100.4470975290085 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_48,oxoglutaric_acid,0.016516949127387655,0.9960035273566772,73.51,68.92842411071885 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_48,oxoglutaric_acid,0.027178626853217175,1.7220508507285641,211.48,84.01886100704664 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_48,oxoglutaric_acid,0.024223829773085567,1.5348334886060697,215.74,74.88452590909014 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_48,oxoglutaric_acid,0.014064180143094124,0.8911132085890553,127.34,43.47741344706001 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_48,oxoglutaric_acid,0.022283982880819373,1.4119238578454287,140.52,68.88776502427847 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_48,oxoglutaric_acid,0.023630994954044506,1.4972711897458413,141.3,73.0518613476996 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_48,oxoglutaric_acid,0.016071998396393495,1.018329537429938,179.85,49.684298131206674 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_48,oxoglutaric_acid,0.0157138288319434,0.9956357418052574,186.32,48.57706784267851 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_48,oxoglutaric_acid,0.013728011035379793,0.869813372469498,271.52,42.4381944427868 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_49,glutaric_acid,0.020100391193385567,1.0345417127830208,73.44,32.52599144989817 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_49,glutaric_acid,0.019809653617666293,1.0195778174706758,1.7,32.055526581278045 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_49,glutaric_acid,0.019803285134329628,1.0192500396878676,139.78,32.04522124778656 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_49,glutaric_acid,0.020056118340132382,1.032263045020106,22.52,32.45435013543213 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_49,glutaric_acid,0.020235681379006953,1.041504927528888,188.99,32.74491492150823 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_49,glutaric_acid,0.019979721157646978,1.0283309786608077,3.65,32.330725969095795 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_49,glutaric_acid,0.020015917764435315,1.0301939722325977,13.52,32.38929848699287 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_49,glutaric_acid,0.020082695777030934,1.0336309520834999,61.29,32.49735713350523 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_49,glutaric_acid,0.019917111872540062,1.025108557941357,20.54,32.22941306167626 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_49,glutaric_acid,0.015333719819930407,0.7892071658319721,36.03,24.812673293757204 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_49,glutaric_acid,0.016095445963381447,0.8284122470433648,10.09,26.04528104704339 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_49,glutaric_acid,0.01939131365051028,0.9980463884560211,97.58,31.3785784530573 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_49,glutaric_acid,0.026376624602826824,1.3575715085098838,163.28,42.682048227550744 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_49,glutaric_acid,0.02090469209512117,1.0759380629569562,63.1,33.8274926993667 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_49,glutaric_acid,0.021510053425857496,1.1070952450200922,84.81,34.80707450343169 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_49,glutaric_acid,0.01980538208827217,1.019357967255171,4.28,32.04861449050257 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_49,glutaric_acid,0.02077687762358942,1.069359613760384,34.28,33.62066625662647 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_49,glutaric_acid,0.019930973099345103,1.025821977754046,30.13,32.251842980587206 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_49,glutaric_acid,0.019556919593289555,1.006569916880995,21.38,31.646558186738478 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_49,glutaric_acid,0.020877229867189668,1.0370980676303554,49.67,21.779059420237463 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_49,glutaric_acid,0.020601454150541074,1.0233986226055576,86.91,21.49137107471671 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_49,glutaric_acid,0.019118639475846636,0.9497382642360617,33.24,19.944503548957297 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_49,glutaric_acid,0.02164764768560636,1.0753693725798517,96.85,22.582756824176883 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_49,glutaric_acid,0.019011774601177762,0.9444296406436746,8.18,19.833022453517167 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_49,glutaric_acid,0.01970200922680171,0.9787177622479284,11.72,20.553073007206496 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_49,glutaric_acid,0.019604756439505447,0.973886629074694,3.89,20.451619210568573 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_49,glutaric_acid,0.019303917457763668,0.9589421403366255,0.52,20.137784947069136 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_50,glyceric_acid,0.01879488499259726,0.9825518481883883,870.38,111.57367512103244 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_50,glyceric_acid,0.01965036002019619,1.0272740462639502,872.29,116.65210432350288 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_50,glyceric_acid,0.020668611997789625,1.0805058358120092,1588.8,122.69684018563271 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_50,glyceric_acid,0.020575872436738578,1.0756576323169214,1002.62,122.146302437748 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_50,glyceric_acid,0.019909279712744907,1.040809751459609,973.53,118.18915132699591 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_50,glyceric_acid,0.021624337583350157,1.1304688944220138,1210.64,128.37039530609178 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_50,glyceric_acid,0.018585112414730022,0.9715854371587981,948.73,110.32838431656732 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_50,glyceric_acid,0.019912155250921423,1.0409600777505648,982.8,118.2062216289654 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_50,glyceric_acid,0.019947090597838828,1.0427864145275292,965.75,118.41361130167358 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_50,glyceric_acid,0.021479543729936178,1.122899416431898,131.43,127.51084323292417 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_50,glyceric_acid,0.013272257978210866,0.693842053902458,188.98,78.78923443089363 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_50,glyceric_acid,0.0182454786226734,0.9538301909721947,217.99,108.31218733584757 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_50,glyceric_acid,0.020155463409015126,1.0536796490865128,135.99,119.65059255201896 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_50,glyceric_acid,0.01685600250307892,0.8811916869399055,159.62,100.06372201046096 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_50,glyceric_acid,0.028908881539455845,1.5112875123651561,283.05,171.6142534666253 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_50,glyceric_acid,0.01629865841689112,0.8520550648123222,158.99,96.75511288476325 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_50,glyceric_acid,0.026496444003143774,1.3851710205177161,259.82,157.29309523488925 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_50,glyceric_acid,0.018421116660182157,0.9630121294854859,265.74,109.35484236372436 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_50,glyceric_acid,0.0199307820517213,1.0419338425572642,304.48,118.31679749159014 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_50,glyceric_acid,0.03596742913657727,1.7952430491787161,455,128.7548314870975 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_50,glyceric_acid,0.013139885434020105,0.6558513788365262,107.26,47.03766089015566 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_50,glyceric_acid,0.02547689832840562,1.2716289636667504,210.35,91.20122927417934 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_50,glyceric_acid,0.020968126069876403,1.0465825188202709,117.91,75.06089824978983 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_50,glyceric_acid,0.02876713041934745,1.4358543874249683,153.35,102.97947666611873 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_50,glyceric_acid,0.009246150005808203,0.4615032802750528,98.27,33.099015261326784 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_50,glyceric_acid,0.018009963312528358,0.8989316787142774,212.93,64.47137999738797 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_50,glyceric_acid,0.003169543332207623,0.15820148319774965,99.26,11.346210374942604 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_51,glycerophosphoric_acid,0.02031801153117011,1.036370716870088,113.44,40.216365668143766 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_51,glycerophosphoric_acid,0.01983160280152206,1.0115602297284763,82.45,39.25359471461352 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_51,glycerophosphoric_acid,0.019627468317996385,1.0011478426351401,109.67,38.849542033456615 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_51,glycerophosphoric_acid,0.020344278836953715,1.0377105461384906,122.53,40.26835774290413 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_51,glycerophosphoric_acid,0.020274026636170478,1.0341271578932516,109.27,40.12930436204763 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_51,glycerophosphoric_acid,0.019521932827019,0.9957647424104121,105.89,38.640650829236044 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_51,glycerophosphoric_acid,0.01980947673716295,1.010431634779793,119.26,39.20979958762987 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_51,glycerophosphoric_acid,0.018545291358020386,0.9459487150005261,105.48,36.707539885595416 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_51,glycerophosphoric_acid,0.02159351843663043,1.10143111926019,326.81,42.74103458289167 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_51,glycerophosphoric_acid,0.015447624185762922,0.7879444957878144,46.09,30.576186159046138 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_51,glycerophosphoric_acid,0.015586082703411648,0.795006916880166,43.31,30.85024340953484 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_51,glycerophosphoric_acid,0.01355383172319896,0.6913469006432489,12.36,26.827716479461273 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_51,glycerophosphoric_acid,0.027147892616655272,1.38474579018092,110.61,53.7350603879706 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_51,glycerophosphoric_acid,0.022695537920087657,1.157642364160965,18.07,44.922311941266244 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_51,glycerophosphoric_acid,0.024023886387834533,1.2253980818728167,29.9,47.55157256707465 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_51,glycerophosphoric_acid,0.023606119086125647,1.2040888215009193,28.69,46.72466671834317 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_51,glycerophosphoric_acid,0.021564062355708468,1.0999286385841434,15.58,42.68273082025768 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_51,glycerophosphoric_acid,0.021065741438686777,1.0745105406953395,73.94,41.69638153168265 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_51,glycerophosphoric_acid,0.01704695294461489,0.8695222372798681,36.88,33.74181041764528 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_51,glycerophosphoric_acid,0.021756093432620482,1.0896136780022208,55.91,53.69616205194944 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_51,glycerophosphoric_acid,0.017152988221803726,0.8590756719708175,44.6,42.33524911472188 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_51,glycerophosphoric_acid,0.022921773862574758,1.1479946251419897,115.48,56.573175126997256 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_51,glycerophosphoric_acid,0.023461531446720064,1.1750273848748716,106.91,57.90534952663367 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_51,glycerophosphoric_acid,0.0164979749429416,0.8262705440588763,31.31,40.71861241122143 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_51,glycerophosphoric_acid,0.020369900096151968,1.0201887500182771,129.04,50.2749016009007 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_51,glycerophosphoric_acid,0.01975541052198027,0.9894131768630648,118.23,48.75828135581184 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_51,glycerophosphoric_acid,0.01814816655552734,0.9089173371500472,67.08,44.79144637475433 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_52,glycerol,0.019818630496954058,1.0073788012447584,2017.4,173.84335973080795 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_52,glycerol,0.020186534928074432,1.026079342881661,2006.01,177.07051220108823 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_52,glycerol,0.020831030173565083,1.0588389650921919,3819.24,182.72384020595953 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_52,glycerol,0.020082630436186112,1.020797889024469,2164.75,176.15909170895262 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_52,glycerol,0.019113264040240906,0.9715251020847098,2035.16,167.65608686675836 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_52,glycerol,0.01978605526725833,1.0057230059138855,2554.2,173.55761913055923 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_52,glycerol,0.020099681503762942,1.0216645929078747,2423.91,176.30865879811194 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_52,glycerol,0.018951695855113818,0.9633126090631747,2440.67,166.23885694603206 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_52,glycerol,0.021017534590692256,1.0683189640346666,2963.44,184.35980362346243 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_52,glycerol,0.015925314499586583,0.8094819787121486,159.45,139.69230506635546 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_52,glycerol,0.014811195619724072,0.7528514389877946,311.2,129.9195728261237 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_52,glycerol,0.020279637469830084,1.0308117348055665,436.49,177.8871810753966 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_52,glycerol,0.025934599175251174,1.3182528142872008,326.09,227.49088816154222 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_52,glycerol,0.01941863973501485,0.9870473149529471,322.19,170.33475514143007 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_52,glycerol,0.0196644952467087,0.9995441234830638,345.84,172.4913293894723 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_52,glycerol,0.019682432587121726,1.0004558765169362,337.9,172.6486706105277 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_52,glycerol,0.02897869697414128,1.4729839694994151,630.62,254.19284361651407 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_52,glycerol,0.017533761765553352,0.8912391757548019,316.9,153.80114456000615 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_52,glycerol,0.01892382993451882,0.9618961873942362,381.91,165.99442505862334 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_52,glycerol,0.030349203575239403,1.552676248153581,1037.53,356.6963144883221 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_52,glycerol,0.016423095965570452,0.8402115384567218,309.79,193.0217967296627 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_52,glycerol,0.022601717992707684,1.1563120794172546,570.68,265.63957400452585 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_52,glycerol,0.02023526021923225,1.035243242535767,458.93,237.82643010774171 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_52,glycerol,0.023832644651302925,1.2192867331435608,568.56,280.1067412050702 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_52,glycerol,0.01822927149388147,0.9326161327272863,683.24,214.24990417143945 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_52,glycerol,0.016151945427387567,0.8263393787057454,569.08,189.83494547007086 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_52,glycerol,0.009988279456841881,0.5110039950178957,384.02,117.39294777546118 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_53,L-glycine,0.026825073394678735,1.4390358648518395,1342.95,136.104012097687 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_53,L-glycine,0.014152621514701638,0.7592199149535014,679.33,71.80701955630217 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_53,L-glycine,0.023686013688590624,1.270640444921017,1850.91,120.1771732806298 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_53,L-glycine,0.02191936667504586,1.1758683495899145,1049.49,111.21362850421413 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_53,L-glycine,0.015252730433832094,0.8182354548769134,764.39,77.38870932225848 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_53,L-glycine,0.020731625197287207,1.1121517453697047,1007.73,105.1873120770667 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_53,L-glycine,0.014808593268990543,0.7944096371534327,653.33,75.13526348197168 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_53,L-glycine,0.018471422143210455,0.9909027478810601,767.86,93.71958189459068 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_53,L-glycine,0.023330492292357504,1.2515684359697514,952.2,118.3733426740191 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_53,L-glycine,0.03576360466071066,1.9185449749171657,115.95,181.45598372766557 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_53,L-glycine,0.02764727072431296,1.4831427878011636,268.15,140.27564487023406 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_53,L-glycine,0.009961427734179235,0.5343825742321103,82.8,50.541903870873 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_53,L-glycine,0.0028284206838254484,0.1517311339666637,10.26,14.350730650567055 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_53,L-glycine,0.016503888961782533,0.8853540781084558,128.7,83.73678870749777 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_53,L-glycine,0.03218142625998166,1.7263783732791176,251.03,163.28086654473896 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_53,L-glycine,0.011356159490770677,0.6092032090185572,79.21,57.61843950897514 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_53,L-glycine,0.015079701225531374,0.8089532720195479,105.55,76.51080046760885 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_53,L-glycine,0.01933644168241794,1.0373068759295638,197.14,98.10848432541816 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_53,L-glycine,0.023636588345726076,1.2679890135542422,255.26,119.92640090196025 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_53,L-glycine,0.030475794746537922,1.4927689307551162,447.56,275.96819222869834 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_53,L-glycine,0.02739433675296751,1.3418325961169042,532.65,248.0645920441321 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_53,L-glycine,0.01100024126305779,0.5388150998151904,220.42,99.61074750283424 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_53,L-glycine,0.015448261226012838,0.7566885321341987,246.98,139.88900893564931 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_53,L-glycine,0.02939242916708802,1.4397033916575332,448.55,266.15796601572816 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_53,L-glycine,0.015304351305397703,0.7496395196274416,434.16,138.58585799352514 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_53,L-glycine,0.018059387658917146,0.8845870314425975,533.15,163.533604502793 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_53,L-glycine,0.010217260439012,0.5004630418218423,389.86,92.52060254160399 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_54,L-glycine_peak_2,0.019469912459599628,1.0186015752493678,18832.71,568.2880048473747 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_54,L-glycine_peak_2,0.01951672045420835,1.021050415075517,17982.52,569.6542370747817 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_54,L-glycine_peak_2,0.02221398467783399,1.1621623791251663,39883.32,648.3820129377215 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_54,L-glycine_peak_2,0.0204683259252303,1.0708352733182134,19515.02,597.4297073369644 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_54,L-glycine_peak_2,0.017994359382728725,0.9414055071322921,20362.57,525.219546484177 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_54,L-glycine_peak_2,0.01983533966531691,1.0377195208567231,21715.92,578.9540978811743 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_54,L-glycine_peak_2,0.020387817400452465,1.0666233329548518,20399.84,595.0798236888413 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_54,L-glycine_peak_2,0.01966761579888806,1.0289447616015983,20283.59,574.0585719451477 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_54,L-glycine_peak_2,0.020140288775984398,1.0536734520899191,20531.27,587.8549556554867 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_54,L-glycine_peak_2,0.020185976743766303,1.0560636958082286,943.45,589.1884965283688 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_54,L-glycine_peak_2,0.018002599999254305,0.9418366289974468,2923.81,525.4600736839656 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_54,L-glycine_peak_2,0.019015628052032454,0.9948349140422703,2681.28,555.028346893323 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_54,L-glycine_peak_2,0.020815652799346957,1.0890062693016715,1097.99,607.5674877060956 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_54,L-glycine_peak_2,0.020046832416809202,1.0487841237547015,3179.02,585.1271504839855 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_54,L-glycine_peak_2,0.019980453304702668,1.0453113876396487,3280.4,583.1896762780364 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_54,L-glycine_peak_2,0.020361302524705045,1.0652361621465645,3424.17,594.3059072231897 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_54,L-glycine_peak_2,0.022980497507443767,1.2022638011171491,3844.93,670.7549972812686 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_54,L-glycine_peak_2,0.019265364538996497,1.007900302987735,3611.7,562.3176580398872 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_54,L-glycine_peak_2,0.01931606362221125,1.0105527117303734,3728.08,563.7974634014926 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_54,L-glycine_peak_2,0.033767015167221366,1.707850847564341,20140.93,2712.7161292542482 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_54,L-glycine_peak_2,0.019193237579569623,0.9707457678874579,7755.56,1541.9131627970805 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_54,L-glycine_peak_2,0.01907535335267346,0.9647834796655923,7901.73,1532.4427834312337 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_54,L-glycine_peak_2,0.023262196454460985,1.1765434917541924,7706.23,1868.7981514325243 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_54,L-glycine_peak_2,0.0234087376181133,1.1839551758875775,7436.63,1880.5707222763106 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_54,L-glycine_peak_2,0.016668219852765887,0.8430367108837202,11432.34,1339.0626508334835 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_54,L-glycine_peak_2,0.015624090660860292,0.7902272778754494,11607.49,1255.1812036318065 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_54,L-glycine_peak_2,0.005755266795165895,0.2910869446235335,8638.8,462.3566811011282 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_55,glycolic_acid,0.02352099790366405,1.2694008478544196,267.64,78.448972397403125 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_55,glycolic_acid,0.017065828146573977,0.9210228582701481,182.33,56.91921264109515 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_55,glycolic_acid,0.0196122225831073,1.0584487986977709,491.4,65.41213575952224 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_55,glycolic_acid,0.018517182115664943,0.9993507407199804,160.31,61.75987577649479 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_55,glycolic_acid,0.020221752330969615,1.0913444089052096,316.09,67.44508447034195 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_55,glycolic_acid,0.03130440520703273,1.6894622700168425,256.1,104.40876828704086 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_55,glycolic_acid,0.009941147099913663,0.5365121245689198,73.13,33.15644929835924 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_55,glycolic_acid,0.03872790285452432,2.090099787454109,237.44,129.16816686466393 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_55,glycolic_acid,0.0019314292951015748,0.10423698836310315,11.52,6.441845880839774 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_55,glycolic_acid,0.0017495633519464182,0.09442189533930603,1.52,5.835273131969113 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_55,glycolic_acid,0.026785064091680987,1.4455586964071034,112.55,89.33552743795899 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_55,glycolic_acid,0.0031357030821708935,0.16923024131163164,11.63,10.458428913058835 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_55,glycolic_acid,0.04197150175462355,2.2651530403283937,42.32,139.98645789229474 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_55,glycolic_acid,0.020039611123528697,1.0815144601886753,89.61,66.83759363966013 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_55,glycolic_acid,0.03159263368980231,1.705017625359419,143.81,105.37008924721208 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_55,glycolic_acid,0.024567414830609768,1.3258747500125925,100.95,81.93905955077821 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_55,glycolic_acid,0.002231677635517322,0.12044104141610985,9.05,7.443256359515589 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_55,glycolic_acid,0.02420476044982257,1.306302715682464,96.09,80.72950782917627 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_55,glycolic_acid,0.020759942708977998,1.120389916453361,83.87,69.24009683681771 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_55,glycolic_acid,0.03821700427470608,2.4118761346248028,120,125.53815280722098 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_55,glycolic_acid,0.017939385894750973,1.1321551108078696,78.04,58.928673517549605 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_55,glycolic_acid,0.01909960278097584,1.2053764286997721,88.41,62.739843113823135 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_55,glycolic_acid,0.02449600338670634,1.5459434114041308,107.87,80.466354563585 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_55,glycolic_acid,0.02551075308676871,1.609984291390581,106.63,83.79968236687974 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_55,glycolic_acid,0.013757614928759205,0.8682434362861223,70.01,45.19207085869267 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_55,glycolic_acid,0.0022909100422922723,0.14457939240501927,11.99,7.525357374681253 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_55,glycolic_acid,0.005501694693478422,0.3472120953230989,43.62,18.072389561567295 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_56,guanidine,0.020836777455545213,1.1659597900656387,3259.37,150.25140834680855 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_56,guanidine,0.01759805066813129,0.9847309405859345,2649.48,126.89735265860645 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_56,guanidine,0.016037489195013986,0.8974068842887288,3910.42,115.64433814386705 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_56,guanidine,0.020611145863086256,1.1533341638267978,3560.02,148.6244070215403 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_56,guanidine,0.024752387625751684,1.3850648806571704,3857.69,178.48638584588628 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_56,guanidine,0.018375254864349783,1.0282208153227732,3856.78,132.50167536656917 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_56,guanidine,0.02221599050771223,1.2431361655484265,4271.96,160.196741973398 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_56,guanidine,0.017744071217138987,0.9929017860551783,3544.03,127.95028866000057 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_56,guanidine,0.021780156793354214,1.2187482971661607,4294.27,157.0539993143173 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_56,guanidine,0.008205749659201522,0.45916765058253334,17.53,59.170639292318164 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_56,guanidine,0.01841806314750617,1.0306162306862372,355.18,132.81036056738196 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_56,guanidine,0.02161399634653298,1.2094504870750258,378.53,155.8558370169232 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_56,guanidine,0.03200816975266808,1.7910753697316235,85.14,230.80692752046568 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_56,guanidine,0.015390838435616274,0.861222364619998,443.32,110.98142001675605 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_56,guanidine,0.023469749158305343,1.3132925117568222,707.15,169.2374395275429 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_56,guanidine,0.020838726484960716,1.1660688515523767,732.32,150.26546255529703 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_56,guanidine,0.02076793884136063,1.162107800173521,729.99,149.7550216693608 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_56,guanidine,0.017080128014295308,0.9557496362539571,672.53,123.1626768758662 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_56,guanidine,0.022196888978506406,1.2420673047310438,894.96,160.05900322416596 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_56,guanidine,0.029794204503117275,2.4795192528264858,1014.13,1002.0233204522394 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_56,guanidine,0.017314092288844715,1.4409052327916112,703.25,582.298622675746 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_56,guanidine,0.019774632855390842,1.6456751808019159,911.74,665.0502540656703 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_56,guanidine,0.01975214207170437,1.6438034633960716,1303.13,664.2938556276205 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_56,guanidine,0.026925898569608045,2.240814447521532,1718.31,905.5579345324015 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_56,guanidine,0.01477128775613776,1.2292891517392814,1544.14,496.78033200087845 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_56,guanidine,0.012980075051681922,1.0802216917860894,1379.6,436.53919008459445 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_56,guanidine,0.015041395676176432,1.2517679458284718,1391.34,505.86446226820203 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_57,L-gulonolactone,0.019986764128239624,1.0684870778961397,6339.31,188.58796924866866 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_57,L-gulonolactone,0.020567496326176094,1.0995328662604813,6300.17,194.06755089497494 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_57,L-gulonolactone,0.01679992961771256,0.8981197551997895,7446.68,158.51813679276285 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_57,L-gulonolactone,0.019979634233756566,1.0681059156393067,6891.1,188.52069411033762 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_57,L-gulonolactone,0.02304567470573812,1.2320156212624456,6609.99,217.45075715282164 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_57,L-gulonolactone,0.01963284743370839,1.0495667858302502,7830.85,185.24853769903916 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_57,L-gulonolactone,0.019862397322168934,1.0618384616242345,7234.97,187.41448847667738 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_57,L-gulonolactone,0.019464998660165114,1.0405936351780989,7027.69,183.66477660893446 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_57,L-gulonolactone,0.02074146175375345,1.1088330116053924,7361.86,195.70902654835174 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_57,L-gulonolactone,0.021878185233830852,1.1696019455764368,296.71,206.4347433942411 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_57,L-gulonolactone,0.017669209984906318,0.9445912517089721,996.37,166.72035592663357 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_57,L-gulonolactone,0.017538766118239072,0.9376177573989136,869.14,165.48953418090827 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_57,L-gulonolactone,0.01976003643003962,1.0563662756405334,306.29,186.44864765055414 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_57,L-gulonolactone,0.02122834531035944,1.1348616766426993,1346.86,200.30308592743643 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_57,L-gulonolactone,0.019970921735558634,1.0676401478101096,1320.12,188.43848608848435 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_57,L-gulonolactone,0.020495740935610796,1.0956968422249505,1405.53,193.39049265270376 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_57,L-gulonolactone,0.021903338100982467,1.1709466111436642,1489.71,206.6720768668567 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_57,L-gulonolactone,0.018454916619309404,0.9865949187603481,1273.45,174.13400316120143 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_57,L-gulonolactone,0.020237632215516808,1.08189841891124,1420.13,190.95507093783385 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_57,L-gulonolactone,0.017624112587642488,1.0558237211568413,1468.66,626.3568643390845 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_57,L-gulonolactone,0.02144923042318384,1.284978529769245,1892.16,762.3006630003069 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_57,L-gulonolactone,0.019386688908303997,1.161415981785534,1796.64,688.9984170344502 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_57,L-gulonolactone,0.018578858384376663,1.1130205448183934,1770.78,660.2883080080637 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_57,L-gulonolactone,0.01863328529906776,1.1162811474339562,1731.31,662.2226279037202 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_57,L-gulonolactone,0.02149997418305475,1.2880184822835046,5134.72,764.1040844298662 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_57,L-gulonolactone,0.021632883154678543,1.2959807807707122,5359.27,768.8276383844174 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_57,L-gulonolactone,0.021184234888675154,1.2691032015821633,4852.09,752.8827833066025 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_58,hexose,0.013152869255078798,0.4992196343850909,280723.82,NA -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_58,hexose,0.016275819739969673,0.6177518093071495,306593.65,NA -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_58,hexose,0.016072202296483543,0.6100234708191559,1579210.45,NA -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_58,hexose,0.021536281602174995,0.8174136318811717,274505.65,NA -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_58,hexose,0.02610160958909902,0.9906915170544157,1532932.3,NA -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_58,hexose,0.034286730258485616,1.3013593165074673,1035455.13,NA -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_58,hexose,0.011201200976705674,0.42514369662009005,327160.38,NA -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_58,hexose,0.026592108162125726,1.009308482945584,1600647.46,NA -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_58,hexose,0.01321758069016027,0.5016757691139778,825249.01,NA -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_58,hexose,0.019210971488809167,0.7291560477667245,425244.81,NA -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_58,hexose,0.03379378040950594,1.2826493119749736,1974706.71,NA -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_58,hexose,0.009533398357988363,0.3618419335298003,472378.76,NA -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_58,hexose,0.019943060658890076,0.7569426303546989,490487.71,NA -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_58,hexose,0.01477941745080292,0.560955578066397,585146.42,NA -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_58,hexose,0.019434081083230456,0.7376242145214267,775193.04,NA -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_58,hexose,0.023412157525139157,0.8886128564954023,966525.08,NA -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_58,hexose,0.023888583217559982,0.9066956835477695,1000642.11,NA -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_58,hexose,0.01651807199404529,0.6269465393210508,1144632.96,NA -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_58,hexose,0.02173864284475296,0.825094291026664,1605474.07,NA -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_58,hexose,0.035039209650459785,2.095045760964949,326611.42,NA -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_58,hexose,0.01488612255821539,0.8900631114088106,1107147.52,NA -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_58,hexose,0.02256447124288259,1.3491628463485148,1804379.47,NA -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_58,hexose,0.02402662586520048,1.4365872167587133,1868904.54,NA -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_58,hexose,0.02502487241084685,1.4962738425335866,1837578.82,NA -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_58,hexose,0.004347402020324634,0.25993754610192993,288898.51,NA -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_58,hexose,0.004487130278136534,0.2682921036714669,285610.92,NA -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_58,hexose,0.03429783512078335,2.0507178899547185,916877.71,NA -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_59,L-histidine,0.02313308882383117,1.2554651974038133,50943.63,1179.8045872822725 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_59,L-histidine,0.019760333029872398,1.0724210068547697,42029.39,1007.7915548766671 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_59,L-histidine,0.015806078471706755,0.857818062247644,45941.4,806.1216567262898 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_59,L-histidine,0.01924894861315739,1.0446674568394798,43079.86,981.7105725530486 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_59,L-histidine,0.022805668743281497,1.2376956501033336,43263.99,1163.1059217498562 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_59,L-histidine,0.0201432027426367,1.0931998835182437,47821.58,1027.3181925380168 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_59,L-histidine,0.018361356807976265,0.9964966038508482,39572.14,936.4427360197768 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_59,L-histidine,0.020512216847255425,1.1132267968815241,40255.92,1046.138183967459 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_59,L-histidine,0.02041381455148232,1.1078863661838085,39092.39,1041.1195943257412 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_59,L-histidine,0.021029378537480013,1.1412938876384935,1449.87,1072.5138114999597 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_59,L-histidine,0.017354039122397538,0.9418280592996063,5436.47,885.0687913059156 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_59,L-histidine,0.018820000698035966,1.0213878514640362,5194.05,959.8339125955561 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_59,L-histidine,0.020256733858420032,1.0993613765109804,1611.11,1033.1083631555462 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_59,L-histidine,0.020372747613308942,1.1056576058123229,6981.66,1039.0251501980433 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_59,L-histidine,0.022488998499782874,1.2205095115468454,7931.21,1146.9555058334747 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_59,L-histidine,0.018079210068298702,0.9811841042999356,6051.87,922.0530442543001 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_59,L-histidine,0.0201669318013051,1.0944876928355467,6656.36,1028.5283920268125 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_59,L-histidine,0.019440080019331115,1.0550404265025177,5970.96,991.4584151993436 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_59,L-histidine,0.02091433416932829,1.1350502683158976,6482.2,1066.64646389584 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_59,L-histidine,0.015801823703732936,0.8196831157478228,3396.39,1847.6641048694823 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_59,L-histidine,0.02189349337779922,1.1356744134716166,9023.33,2559.94640889464 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_59,L-histidine,0.018902290131440375,0.9805126522230583,8220.45,2210.19317962904 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_59,L-histidine,0.018157435356601862,0.9418750307645273,8005.25,2123.099344346936 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_59,L-histidine,0.0191167638507203,0.9916379811573296,8167.86,2235.2710060863596 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_59,L-histidine,0.02220258609856263,1.1517078846177649,21286.65,2596.087776874596 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_59,L-histidine,0.021275541367556033,1.1036195798881292,20802.62,2487.69096741743 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_59,L-histidine,0.022047298728826582,1.1436527108955408,13907.47,2577.9304486838564 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_60,L-homoserine,0.01905095351206918,1.0099662932686806,282.32,61.48169810273093 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_60,L-homoserine,0.020582677684056715,1.0911690416409463,296.11,66.4249154098926 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_60,L-homoserine,0.01974462207631146,1.046740403716273,449.66,63.72032207622812 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_60,L-homoserine,0.020383364236385437,1.0806026485301956,311.24,65.78168622927566 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_60,L-homoserine,0.02040622681408458,1.081814684076802,299.79,65.85546889317531 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_60,L-homoserine,0.022044580811301027,1.168670300651707,360.91,71.14280455217266 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_60,L-homoserine,0.017224341232538472,0.9131303615643721,245.62,55.58681076023115 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_60,L-homoserine,0.02081023135992697,1.1032325607919824,260.93,67.15928213821194 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_60,L-homoserine,0.01959377402697786,1.038743352800383,235.19,63.23350160172332 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_60,L-homoserine,0.00956205202497828,0.5069221461063069,11.12,30.858885644221434 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_60,L-homoserine,0.015322777281455204,0.8123209457064084,73.76,49.450037569877615 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_60,L-homoserine,0.036503910191397565,1.9352164626543302,158.7,117.80630216408235 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_60,L-homoserine,0.027838584537416472,1.4758333233708865,39.39,89.84135356020272 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_60,L-homoserine,0.00819377250453749,0.4343842442874001,29.8,26.443140870995478 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_60,L-homoserine,0.021327959507975267,1.1306793748464044,84.84,68.83010694377487 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_60,L-homoserine,0.02262550636929967,1.1994674590251833,77.06,73.01758156815804 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_60,L-homoserine,0.021341610798012813,1.1314030836512585,71.72,68.87416271727037 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_60,L-homoserine,0.026958262870181895,1.4291639946898969,108.46,87.00035817674747 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_60,L-homoserine,0.013283333888991593,0.7042019960636587,52.47,42.868296510375224 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_60,L-homoserine,0.030307395715128718,1.5472646460314137,45.49,82.71676797683938 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_60,L-homoserine,0.024095394773868715,1.230127220966297,115.22,65.76260123285824 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_60,L-homoserine,0.016242091004099204,0.82919738219945,78.54,44.3288920523826 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_60,L-homoserine,0.019766915511208825,1.0091480580865702,82.47,53.94905518530804 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_60,L-homoserine,0.017830300752379666,0.9102792678584724,70.91,48.66352965971393 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_60,L-homoserine,0.0140375083786797,0.716648194944011,110.2,38.31201250170683 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_60,L-homoserine,0.031176634768115337,1.5916413674190801,262.06,85.08914750222402 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_60,L-homoserine,0.0060870119992397324,0.31075644225317867,16.94,16.61303940285493 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_61,myo-inositol_1-phosphate,0.01923734148162514,0.88682521783133,1219.69,103.86496951240537 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_61,myo-inositol_1-phosphate,0.022195944681520016,1.0232143301070242,1361.27,119.83886234213469 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_61,myo-inositol_1-phosphate,0.014643348443854178,0.6750460132916455,1255.04,79.06138907671752 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_61,myo-inositol_1-phosphate,0.01915056358804261,0.8828248301242875,1337.45,103.39644410415656 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_61,myo-inositol_1-phosphate,0.02495306821494294,1.1503153996831472,1388.5,134.7249396108902 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_61,myo-inositol_1-phosphate,0.019709085171478055,0.9085722040723324,1627.22,106.41197654095157 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_61,myo-inositol_1-phosphate,0.02039319343251881,0.940109017940151,1540.9,110.10556818115049 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_61,myo-inositol_1-phosphate,0.018645982528984903,0.8595640688574655,1445.69,100.67214374458636 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_61,myo-inositol_1-phosphate,0.021352838950914475,0.984347866988237,1632.72,115.28682218166232 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_61,myo-inositol_1-phosphate,0.009968565894075796,0.45954248038502427,14.86,53.82161530269404 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_61,myo-inositol_1-phosphate,0.016100243662161964,0.742207654133095,163.58,86.92736045206809 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_61,myo-inositol_1-phosphate,0.031185834104946148,1.4376406505954595,283.39,168.37647299774022 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_61,myo-inositol_1-phosphate,0.026098088719007907,1.203099879228237,47,140.90705785521112 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_61,myo-inositol_1-phosphate,0.018682906234259566,0.8612662205297544,219.13,100.87149974844485 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_61,myo-inositol_1-phosphate,0.020165850068974533,0.9296286806185812,238.37,108.87811107404823 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_61,myo-inositol_1-phosphate,0.01453536295869615,0.6700679734991222,171.94,78.4783610562172 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_61,myo-inositol_1-phosphate,0.01981199332257664,0.9133161830468591,234,106.96759135844815 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_61,myo-inositol_1-phosphate,0.02424163309393545,1.1175188406179064,340.3,130.8838066131692 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_61,myo-inositol_1-phosphate,0.0181629484627032,0.8372966057852221,263.84,98.06417846956522 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_61,myo-inositol_1-phosphate,0.01869333547667076,0.979779347617321,264.62,155.19704866258365 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_61,myo-inositol_1-phosphate,0.01881039796687031,0.9859149787047378,307.51,156.16893262683047 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_61,myo-inositol_1-phosphate,0.019918237855962525,1.0439805200391798,352.85,165.3665143742061 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_61,myo-inositol_1-phosphate,0.021130064177472208,1.1074963331585683,436.59,175.42741917231723 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_61,myo-inositol_1-phosphate,0.022479876031096562,1.1782444229791729,449.41,186.633916599901 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_61,myo-inositol_1-phosphate,0.01870342268363702,0.980308051393756,734.38,155.28079534077096 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_61,myo-inositol_1-phosphate,0.015587904912459993,0.8170134925846266,629.76,129.41493722540486 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_61,myo-inositol_1-phosphate,0.023736073061171523,1.244085851232664,909.98,197.06319883525398 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_62,myo-inositol,0.020667082491898064,1.179224288680991,158793.17,2943.2730710904325 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_62,myo-inositol,0.021119653878015853,1.2050471483459357,156928.04,3007.725379442555 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_62,myo-inositol,0.015837625781768772,0.9036647046927614,162469.61,2255.492883030851 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_62,myo-inositol,0.01941691209979697,1.1078919517663162,160891.13,2765.231838091619 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_62,myo-inositol,0.02343722799220768,1.3372835047520566,156430.31,3337.7793908508484 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_62,myo-inositol,0.01948054884817243,1.1115229431927276,184954,2774.2945748324564 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_62,myo-inositol,0.01990037900865293,1.1354776510018014,172504.82,2834.0840882414363 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_62,myo-inositol,0.02001967369583099,1.1422843782060945,171953.2,2851.07327093972 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_62,myo-inositol,0.020342096329966614,1.1606811984414753,171788.22,2896.990630438016 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_62,myo-inositol,0.02081950530128156,1.1879212433210313,8751.88,2964.980148054695 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_62,myo-inositol,0.019707054986325957,1.1244469512016317,37621.31,2806.552123382201 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_62,myo-inositol,0.01940748024413888,1.1073537880809623,32582.76,2763.888613822797 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_62,myo-inositol,0.01941130301007948,1.1075719078106758,9428.23,2764.4330275809784 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_62,myo-inositol,0.020426384359819517,1.1654905125808357,40306.07,2908.994389971011 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_62,myo-inositol,0.020472938518459927,1.1681468040351035,41239.63,2915.6243340633764 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_62,myo-inositol,0.019276180258031073,1.0998620614290509,34236.19,2745.1897136032253 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_62,myo-inositol,0.019865850653707728,1.1335075289579406,34565.63,2829.166781827282 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_62,myo-inositol,0.020143558429947972,1.1493530047296883,29164.39,2868.716138625018 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_62,myo-inositol,0.020160243594721773,1.150305028391936,29100.86,2871.092332564569 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_62,myo-inositol,0.020978774563241213,1.0586129078901874,71808.75,25089.962221194673 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_62,myo-inositol,0.020053571354421075,1.0119260980231053,48751.69,23983.447944765034 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_62,myo-inositol,0.01925054984594231,0.9714047162032832,49246.48,23023.05918374361 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_62,myo-inositol,0.020889766491585283,1.0541214590080166,55232.38,24983.51133444261 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_62,myo-inositol,0.021204631018723843,1.0700098824076205,54558.2,25360.07952086771 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_62,myo-inositol,0.019332525475744065,0.9755413000432478,124352.52,23121.09948865201 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_62,myo-inositol,0.018261961771574388,0.9215194336784445,123949.8,21840.738578531742 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_62,myo-inositol,0.019632204969365456,0.9906634693206408,175915.94,23479.50684703995 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_63,isocitric_acid,0.022085384909594455,1.2379739512556318,74426.03,1866.1281239924956 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_63,isocitric_acid,0.020577557400402215,1.1534542026975827,66580.41,1738.7226324173496 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_63,isocitric_acid,0.01610655380808383,0.9028366107507937,82932.83,1360.9404212288002 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_63,isocitric_acid,0.017914942158216197,1.0042039937682141,59311.91,1513.7421212261747 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_63,isocitric_acid,0.023039180383720267,1.291437993500162,76222.89,1946.7200885921118 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_63,isocitric_acid,0.02089498097638293,1.1712470607431684,74823.96,1765.5436755995559 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_63,isocitric_acid,0.020302639661442433,1.1380439664276025,66042.74,1715.4931652128002 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_63,isocitric_acid,0.019610610856091937,1.0992529904926398,58875.16,1657.0194541335577 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_63,isocitric_acid,0.02016712702773709,1.1304479425738194,59161.46,1704.0428808754882 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_63,isocitric_acid,0.01042040689711018,0.5841053870201173,4465.97,880.4833809210598 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_63,isocitric_acid,0.031241919915899016,1.7512342755817392,51233.97,2639.8193031832916 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_63,isocitric_acid,0.0095169434443748,0.5334626554138421,13610.45,804.1442740841026 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_63,isocitric_acid,0.029823945493427453,1.6717511510741854,14547.17,2520.0060438849823 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_63,isocitric_acid,0.027224334082664458,1.5260325582995853,42736.8,2300.349108543586 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_63,isocitric_acid,0.009769420345112186,0.5476149931560225,15754.16,825.4775787583541 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_63,isocitric_acid,0.023178313384360348,1.2992369533669483,37273.6,1958.4762796901048 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_63,isocitric_acid,0.023168348325734986,1.298678372067531,36980.77,1957.6342714464565 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_63,isocitric_acid,0.01886757090122118,1.0576026360778275,32554.16,1594.2355016368974 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_63,isocitric_acid,0.019020858325012466,1.0661950078424804,33666.95,1607.1876857967943 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_63,isocitric_acid,0.03383555765314478,2.2489155932479883,18143.34,16458.21649691082 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_63,isocitric_acid,0.019447699928658354,1.29261163864112,35727.73,9459.7068289509225 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_63,isocitric_acid,0.01905676739369753,1.266627900385822,37156.16,9269.550297114558 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_63,isocitric_acid,0.02234463461665015,1.485159421043052,41096.43,10868.827339425157 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_63,isocitric_acid,0.02276018015921373,1.5127790884933703,39827.17,11070.956075530146 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_63,isocitric_acid,0.014484277622938016,0.9627126036189533,34440.09,7045.410019938549 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_63,isocitric_acid,0.014569735280899696,0.9683926358951351,34499.45,7086.978143345009 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_63,isocitric_acid,0.012553412110371259,0.8343756155252294,18980.43,6106.202723342131 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_64,L-isoleucine,0.01916388561066481,1.0013051762245126,34942.14,1046.8445356392035 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_64,L-isoleucine,0.019389773925367698,1.0131077481744706,33618.99,1059.1838885614454 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_64,L-isoleucine,0.02255070867306478,1.1782652944507663,78880.24,1231.8528000423871 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_64,L-isoleucine,0.020649141492460978,1.0789091878886594,36826.33,1127.9779777538356 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_64,L-isoleucine,0.017768712417550195,0.9284079481583052,39065.53,970.6319416405449 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_64,L-isoleucine,0.01963734975134611,1.0260434837083063,40424.14,1072.70794134736 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_64,L-isoleucine,0.02071742554139895,1.0824770014857679,38994.94,1131.7080555133407 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_64,L-isoleucine,0.019679488826516593,1.0282452331315048,38526.92,1075.0098263343257 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_64,L-isoleucine,0.020041966220449806,1.0471845285428545,38820.88,1094.8104809009835 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_64,L-isoleucine,0.021457340906576944,1.1211372763471703,1755.6,1172.1265996754396 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_64,L-isoleucine,0.01824121875437441,0.9530962107827531,5578.94,996.4430264491527 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_64,L-isoleucine,0.020845613965704203,1.0891747941670957,5558.94,1138.7104638058152 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_64,L-isoleucine,0.018864066581964774,0.985639754740214,1751.7,1030.466650785799 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_64,L-isoleucine,0.020228030671143222,1.0569063199047801,6199.13,1104.9744193340496 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_64,L-isoleucine,0.019050608259841402,0.9953864810270546,6014.53,1040.656658184165 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_64,L-isoleucine,0.021220206806492094,1.1087471167157559,6795.47,1159.1729355839884 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_64,L-isoleucine,0.021018495402241762,1.0982077784373552,6697.73,1148.1542682006861 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_64,L-isoleucine,0.01947831399042296,1.0177339303195858,6985.14,1064.0204694705205 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_64,L-isoleucine,0.019682224187593952,1.0283881546277633,7269.66,1075.159247900234 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_64,L-isoleucine,0.03393738775646105,1.7647750972934844,25393.79,4513.25348156933 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_64,L-isoleucine,0.019278571617684318,1.0025032965538434,11279.28,2563.8119556397646 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_64,L-isoleucine,0.01918229266865848,0.9974967034461567,11518.1,2551.0080443602355 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_64,L-isoleucine,0.022644600616928225,1.177539872652793,10786.83,3011.452245720979 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_64,L-isoleucine,0.023394301178549997,1.2165249852098183,10661.26,3111.153162425441 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_64,L-isoleucine,0.016510667312645118,0.8585697497447009,15372.74,2195.7148636945954 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_64,L-isoleucine,0.01604559660255988,0.8343856489079247,16049.78,2133.8662023736156 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_64,L-isoleucine,0.0056584431810135834,0.2942442030884293,10692.21,752.5030674203799 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_65,itaconic_acid,0.028524837295231892,1.5905671885345527,3771.61,129.86185810790357 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_65,itaconic_acid,0.020692392102580413,1.1538239321055643,2454.63,94.2039549367588 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_65,itaconic_acid,0.022849222943756256,1.2740905030131262,2826.32,104.0231191185067 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_65,itaconic_acid,0.01735966686860502,0.9679885721805321,1701.72,79.03142697567955 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_65,itaconic_acid,0.011710066316188473,0.6529624363959636,601.78,53.31111811954846 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_65,itaconic_acid,0.017966955429027487,1.001851456241288,1351.36,81.79616214481996 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_65,itaconic_acid,0.015739686643918633,0.8776572106098314,948.59,71.65632296023969 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_65,itaconic_acid,0.02264356192304113,1.262622683998969,1264.71,103.08682903509583 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_65,itaconic_acid,0.02147378482197334,1.1973949999424325,1106.45,97.76131477029992 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_65,itaconic_acid,0.017900548315360525,0.9981485437587122,16.51,81.49383785518006 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_65,itaconic_acid,0.023014289432269967,1.2832947392315186,252.16,104.77459898455734 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_65,itaconic_acid,0.023656723609753953,1.319117370327473,235.68,107.69933770038655 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_65,itaconic_acid,0.017650097359120456,0.9841832029853523,20.91,80.3536376077391 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_65,itaconic_acid,0.02428978142314451,1.3544171680442074,319.14,110.58138968496932 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_65,itaconic_acid,0.015545885221068468,0.8668506920279249,168.17,70.77402475061993 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_65,itaconic_acid,0.010721096320306376,0.5978166976275201,71.98,48.80874427779889 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_65,itaconic_acid,0.023028818565619166,1.284104895045692,269.23,104.84074415600553 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_65,itaconic_acid,0.027414085872014944,1.5286308223389689,347.86,124.80506348986513 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_65,itaconic_acid,0.015560809619424536,0.8676828881273484,151.83,70.84196940115737 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_65,itaconic_acid,0.022452082593582872,1.1892241614875647,146.48,90.80915697119045 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_65,itaconic_acid,0.02301727390252002,1.2191607679315006,569.86,93.09511623924939 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_65,itaconic_acid,0.016816861642767075,0.8907422330473731,375.37,68.01707691549741 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_65,itaconic_acid,0.012385066698829116,0.6560024219798776,54.83,50.09234494238345 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_65,itaconic_acid,0.02719636333850276,1.4405154734281114,216.12,109.99776155097058 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_65,itaconic_acid,0.02100319469051602,1.1124806124456317,158.9,84.94901956634844 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_65,itaconic_acid,0.020580490568520512,1.0900911546774192,156.94,83.23936057116774 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_65,itaconic_acid,0.016721151400508474,0.88567272859845,204.92,67.62996955577765 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_66,L-leucine,0.019069054499083152,1.0030704708346607,35697.15,1003.2159160529317 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_66,L-leucine,0.019517862307369693,1.0266786607212592,34737.61,1026.8275291270638 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_66,L-leucine,0.022524896964058964,1.1848547081517427,81135.09,1185.0265120844247 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_66,L-leucine,0.020541456070832548,1.0805217434136642,37555.22,1080.6784190664591 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_66,L-leucine,0.017795700346334632,0.9360894912796367,40280.66,936.2252242558723 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_66,L-leucine,0.019570889898065116,1.0294680182307596,41277.11,1029.617291093403 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_66,L-leucine,0.02095313747990825,1.1021770103203319,40401.18,1102.3368259868282 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_66,L-leucine,0.019524008964218752,1.0270019871861316,39049.62,1027.1509024742736 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_66,L-leucine,0.020126890092990894,1.0587147424107748,39818.31,1058.8682560484244 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_66,L-leucine,0.021332274316832225,1.1221203675299085,1787.26,1122.2830749832003 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_66,L-leucine,0.018458224630146104,0.9709395959523209,5796.16,971.080382193734 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_66,L-leucine,0.0205139699431859,1.0790759180319565,5618.18,1079.232384040071 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_66,L-leucine,0.019023959142202094,1.0006983647157488,1809.17,1000.8434659786326 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_66,L-leucine,0.02046171166325198,1.0763270278097985,6468.36,1076.483095228831 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_66,L-leucine,0.01889750877668429,0.9940468221506333,6157.49,994.1909589398451 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_66,L-leucine,0.020948166997014236,1.1019155529619185,6955.04,1102.0753307170978 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_66,L-leucine,0.021309556923682145,1.1209253871367126,7042.1,1121.0879213178475 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_66,L-leucine,0.019346131489851346,1.0176452756631154,7214.39,1017.7928342280865 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_66,L-leucine,0.019788877005790143,1.0409345768266323,7601.6,1041.085512340272 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_66,L-leucine,0.03383551047864902,1.9077624184330344,23641.84,5077.318900417678 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_66,L-leucine,0.019361593675620747,1.091673222977625,12162.94,2905.379115632651 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_66,L-leucine,0.019202910247810928,1.0827261057117354,12432.11,2881.567257741213 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_66,L-leucine,0.022343618730456517,1.2598100487551251,11728.35,3352.85846375689 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_66,L-leucine,0.02319309928275195,1.3077066830879098,11635.37,3480.3305663701635 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_66,L-leucine,0.016422810082356708,0.9259744994819485,15953.97,2464.388532921258 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_66,L-leucine,0.016254938697718994,0.9165093336188758,16794.86,2439.197940493276 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_66,L-leucine,0.005986221932459884,0.337523775157848,10623.67,898.2857752050967 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_67,L-lysine,0.02061109661148031,1.1364277636318652,25831.58,627.1490256378811 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_67,L-lysine,0.01928727028723642,1.0634363543218186,23444.62,586.8679864960388 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_67,L-lysine,0.01694147295192081,0.934096840274737,28502.11,515.4906822740164 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_67,L-lysine,0.01934840862850219,1.066807320444898,29034.67,588.7282878607215 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_67,L-lysine,0.02330340962535476,1.2848730072318642,25410.78,709.0700177709766 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_67,L-lysine,0.020752108802927337,1.144202709933447,39432.28,631.4397075038721 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_67,L-lysine,0.020398535777696396,1.124707861604031,35582.13,620.6812805048005 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_67,L-lysine,0.019803274115483344,1.0918871004229993,36398.36,602.5688152394364 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_67,L-lysine,0.019803655293657234,1.0919081173280123,35938.09,602.5804136286368 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_67,L-lysine,0.020556785702805364,1.1334332395825284,1809.64,625.4964675960141 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_67,L-lysine,0.02299815525579548,1.268042289920885,11519.78,699.7818181157396 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_67,L-lysine,0.02069265985716513,1.1409248914963053,9190.28,629.630810621151 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_67,L-lysine,0.017486578190155148,0.9641521419652653,1823.74,532.0770010649513 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_67,L-lysine,0.0191982447305271,1.0585277792845784,10115,584.1591402759875 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_67,L-lysine,0.020557489494015847,1.133472044304396,10903.54,625.517882369824 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_67,L-lysine,0.017649451014395943,0.9731324113268323,7649.64,537.0328525148257 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_67,L-lysine,0.018224773005931953,1.0048537649517204,7696.23,554.5385987262564 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_67,L-lysine,0.02125352260623232,1.17184901026793,6717.22,646.6965948064599 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_67,L-lysine,0.021406595017207198,1.1802889172247013,6658.13,651.3542418596237 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_67,L-lysine,0.015710918877917136,0.8309559459437993,7073.22,2162.2221573809006 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_67,L-lysine,0.021272862174712522,1.125129055065416,10106.3,2927.6870628951688 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_67,L-lysine,0.01922170262170422,1.0166425152330851,9739.29,2645.3953224628585 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_67,L-lysine,0.01857021032276744,0.9821848616900429,10609.58,2555.733406755044 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_67,L-lysine,0.020035697006762523,1.0596949604455537,11166.18,2757.421659625771 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_67,L-lysine,0.020914588297962413,1.1061798255216053,28641.26,2878.379462191514 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_67,L-lysine,0.02056988400656339,1.0879482960511702,29124.56,2830.9393816717893 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_67,L-lysine,0.02379715172249713,1.2586396043410348,29644.82,3275.0935280597637 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_68,pectin,0.020265572145850688,1.041895370031503,8130.99,213.27598224544866 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_68,pectin,0.020117171963934467,1.0342658068818633,7745.22,211.7142106687174 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_68,pectin,0.020019458116082616,1.029242133978276,12940.37,210.6858648253531 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_68,pectin,0.01981491644031001,1.0187262194295916,8234.97,208.53325711723738 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_68,pectin,0.019826880609039182,1.0193413223201238,8177.94,208.65916867892932 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_68,pectin,0.020093214510061894,1.0330341041651607,9663.29,211.4620811226084 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_68,pectin,0.019885319923648836,1.02234580948098,8742.2,209.27418720075661 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_68,pectin,0.019735709892982737,1.0146540454814525,8864.58,207.69968311005331 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_68,pectin,0.020288380982082476,1.0430680199174611,8992.48,213.51602367710427 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_68,pectin,0.03080672613586447,1.5838381021656733,573.9,324.2116595133133 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_68,pectin,0.019282955584116194,0.9913770013015551,1150.92,202.93487216642833 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_68,pectin,0.017688533695762412,0.9094044435372376,913.07,186.15508959207253 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_68,pectin,0.009149802125770122,0.47041042823437745,191.13,96.29301465957705 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_68,pectin,0.020212236694762003,1.0391532831489858,1191.91,212.71467706059738 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_68,pectin,0.020212602737127983,1.0391721021511637,1238.76,212.7185293103432 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_68,pectin,0.02220962552783162,1.1418432127670821,1482.91,233.7353056534217 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_68,pectin,0.02009041297939724,1.03289007162527,1343.89,211.43259766169277 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_68,pectin,0.02046823967969182,1.052314931031068,1712.53,215.4088663820596 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_68,pectin,0.01869513255413369,0.9611557922022573,1626,196.74859066380208 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_68,pectin,0.025311351755820232,1.3323560981295242,819.55,803.9836402942987 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_68,pectin,0.019580512524885685,1.030692296433125,1014.18,621.9506524366407 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_68,pectin,0.019553227519396043,1.0292560498113594,1057.15,621.0839781376686 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_68,pectin,0.022270189697861372,1.1722733474170932,1057.07,707.3849060318965 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_68,pectin,0.020785262711503747,1.094108753734508,943.12,660.2180452660141 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_68,pectin,0.018231648816231297,0.9596898938309792,1479.74,579.1056726344277 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_68,pectin,0.01692767586238389,0.8910504812221658,1412.7,537.6865918838914 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_68,pectin,0.016106506142745947,0.8478251926594028,1389.47,511.6031560064634 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_69,citramalic_acid,0.018851422473557974,0.9244168447872895,389.85,65.36551509490924 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_69,citramalic_acid,0.017584633752778748,0.8622973504139909,346.45,60.973045647773304 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_69,citramalic_acid,0.02039531603343019,1.0001247238773878,798.43,70.7188192253701 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_69,citramalic_acid,0.021118012203249822,1.035563562192194,453,73.22469948261003 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_69,citramalic_acid,0.020833974929557953,1.0216352318120057,512.74,72.23982724142692 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_69,citramalic_acid,0.01683393408910545,0.8254853053044436,429.89,58.37006593807722 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_69,citramalic_acid,0.02488109694134845,1.22009387682175,579.94,86.27283803006596 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_69,citramalic_acid,0.020573837153584646,1.0088788606462473,469.06,71.33782423629616 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_69,citramalic_acid,0.018409119082540875,0.9027276218261971,412.05,63.831870139330405 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_69,citramalic_acid,0.03314081294165572,1.6251254130123474,32.66,114.9126179541031 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_69,citramalic_acid,0.017613594898149024,0.8637175175479125,55.54,61.0734656658129 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_69,citramalic_acid,0.014241530602884835,0.6983616649261626,39.33,49.38115332692896 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_69,citramalic_acid,0.0077998226716133115,0.38247975579066695,8.55,27.045143531958065 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_69,citramalic_acid,0.021883198667481327,1.0730859962647952,94.55,75.87791079588368 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_69,citramalic_acid,0.022174962227909486,1.0873932004205142,102.81,76.88957320173456 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_69,citramalic_acid,0.015109136389275517,0.740906433348781,107.68,52.38949390209231 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_69,citramalic_acid,0.024466036709073963,1.1997405761170397,178.28,84.83365613723588 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_69,citramalic_acid,0.032478407943785405,1.5926430717481004,365.53,112.6157916033082 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_69,citramalic_acid,0.008238955287908628,0.4040134935321186,97.61,28.567794127656107 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_69,citramalic_acid,0.010313264319511168,0.5415193643008659,33.73,37.29443861940064 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_69,citramalic_acid,0.03222209978509682,1.691888276251582,225.23,116.52034558544645 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_69,citramalic_acid,0.0067677805188750655,0.3553563731878365,45.8,24.473393421446303 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_69,citramalic_acid,0.01368327255183659,0.7184686462275455,32.42,49.48093566569106 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_69,citramalic_acid,0.01903994016981452,0.9997316055963529,41.38,68.85151567742082 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_69,citramalic_acid,0.03449318882065386,1.8111365232376349,195.06,124.73297235537592 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_69,citramalic_acid,0.014543364174778792,0.7636295433467067,87.1,52.5911666502877 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_69,citramalic_acid,0.028541328684189075,1.498621744438788,242.01,103.21007953949933 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_71,cellobiose,0.01944400719236024,1.1174605006949918,3618.09,175.54187005417623 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_71,cellobiose,0.022785990226341857,1.3095265700767498,4103.58,205.7135288933566 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_71,cellobiose,0.016770505242023736,0.963812500132335,4105.58,151.40530564578847 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_71,cellobiose,0.01884353759498794,1.082951098888382,3827.9,170.12078812437588 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_71,cellobiose,0.022356134847037277,1.2848224850271996,3566.13,201.83276417292277 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_71,cellobiose,0.020231732483875425,1.1627316163636037,4754.2,182.65350961455846 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_71,cellobiose,0.019601407162119083,1.1265063854900355,4206.86,176.96288809662965 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_71,cellobiose,0.02068732096258892,1.1889146003800921,4405.8,186.76659457370863 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_71,cellobiose,0.019589384966186275,1.1258154616000355,4101.29,176.85435086274956 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_71,cellobiose,0.023170268819398595,1.331611325793785,154.45,209.18282316894565 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_71,cellobiose,0.01691769913439501,0.9722718346224537,507.4,152.73418250084123 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_71,cellobiose,0.02123400539246002,1.220332931523579,561.2,191.702100213039 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_71,cellobiose,0.01729358648551859,0.9938743398795237,132.79,156.12772005167434 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_71,cellobiose,0.019137458859579577,1.0998429566338637,634.13,172.7743300576136 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_71,cellobiose,0.022886741877244224,1.315316836926036,779.6,206.62312191271096 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_71,cellobiose,0.01850292481952135,1.0633758478174218,633.93,167.04571193363876 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_71,cellobiose,0.019203395688144238,1.1036323916373159,653.72,173.36961240230593 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_71,cellobiose,0.02202646300101396,1.265876016715513,808.34,198.8564634658399 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_71,cellobiose,0.018735285031228767,1.0767297494050627,704.73,169.14347633404128 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_71,cellobiose,0.018635233043258394,0.9527240559074039,769.02,333.43436508647324 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_71,cellobiose,0.016769898940829052,0.8573590734806458,815.46,300.0585285367564 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_71,cellobiose,0.023135772742531358,1.1828136086438963,1173.23,413.96110675319085 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_71,cellobiose,0.0188845498158329,0.9654703460247073,870.91,337.89531170172705 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_71,cellobiose,0.022435428856488072,1.1470086114060165,995.54,401.4300738198777 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_71,cellobiose,0.020462909100320163,1.0461637752780546,1936.13,366.1363980718136 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_71,cellobiose,0.01713227241497115,0.8758853739157678,1685.84,306.5423631630404 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_71,cellobiose,0.022356989905117208,1.1429984294180746,2452.32,400.0265903277378 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_72,D-maltose,0.019518296321697815,1.089019878247446,1231.69,113.42142031947151 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_72,D-maltose,0.02110666148659514,1.1776424306454263,1284.96,122.65145915172116 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_72,D-maltose,0.01814661299506075,1.0124870505483525,1630.87,105.45052631461093 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_72,D-maltose,0.020006145702172046,1.1162393478246415,1355.16,116.25632807593642 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_72,D-maltose,0.021637544647384887,1.2072629623556743,1256.18,125.73643752934349 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_72,D-maltose,0.018617315669482527,1.038749822705352,1438.13,108.18579403476241 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_72,D-maltose,0.02083135579127997,1.1622817982494695,1468.09,121.05164928768225 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_72,D-maltose,0.01864404654693585,1.0402412672674117,1286.07,108.34112798590094 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_72,D-maltose,0.021509557804133023,1.2001219591575378,1457.18,124.99270204625758 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_72,D-maltose,0.030736778937301996,1.7149531242031892,250.2,178.61236788576218 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_72,D-maltose,0.010381809180920654,0.579251200199576,175.78,60.329012500785844 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_72,D-maltose,0.016746984221265367,0.934395011586128,235.3,97.31724045669525 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_72,D-maltose,0.010357954866280857,0.5779202529490298,92.45,60.19039434464146 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_72,D-maltose,0.02804822561539315,1.5649457688976902,294.16,162.98910183069444 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_72,D-maltose,0.023753832962006713,1.3253408931719988,259.29,138.03425402386367 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_72,D-maltose,0.016265656212912354,0.9075394008087173,172.88,94.52022859422792 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_72,D-maltose,0.02315833610467759,1.2921152517340024,248.23,134.57380346809637 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_72,D-maltose,0.012449482345998207,0.69461665737757206,212.15,72.34432486587413 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_72,D-maltose,0.025933988362693453,1.4469822767171925,471.35,150.7032041200956 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_72,D-maltose,0.021401979450893383,1.2820121600492091,448.89,158.6746450492906 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_72,D-maltose,0.019216343737583734,1.1510891504121807,413.43,142.47030414651562 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_72,D-maltose,0.01941832666970474,1.16318824506348,439.4,143.96780909150692 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_72,D-maltose,0.02024203092260684,1.212529422636691,436.71,150.07476663974325 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_72,D-maltose,0.024726775751248233,1.4811726767912066,512.76,183.32474220644764 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_72,D-maltose,0.016604243656643595,0.9946202558076214,677.71,123.10414906130929 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_72,D-maltose,0.015878879232184794,0.9511697883049782,676.9,117.72628469850716 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_72,D-maltose,0.020665595483207032,1.2379016046117877,1130.39,153.21508160280095 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_73,Methyl alpha-D-mannopyranoside,0.020178336036768378,1.4860953795500014,16327.28,142.29363259191263 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_73,Methyl alpha-D-mannopyranoside,0.02005091448758627,1.4767110291680083,15475.29,141.3950810428368 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_73,Methyl alpha-D-mannopyranoside,0.01991268292217937,1.4665305420215538,26646.09,140.42029939856377 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_73,Methyl alpha-D-mannopyranoside,0.01990308533649507,1.465823698418876,16133.88,140.35261912360738 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_73,Methyl alpha-D-mannopyranoside,0.0200016205761674,1.4730806280355242,17077.92,141.04747013440144 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_73,Methyl alpha-D-mannopyranoside,0.020035919024173444,1.475606642322066,18694.84,141.28933600233782 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_73,Methyl alpha-D-mannopyranoside,0.019919136426717773,1.4670058301354474,16918.19,140.4658082354691 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_73,Methyl alpha-D-mannopyranoside,0.020067832322614398,1.4779569949612965,17520.79,141.51438226754414 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_73,Methyl alpha-D-mannopyranoside,0.01996988685744833,1.4707435010951055,17157.35,140.82369022985637 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_73,Methyl alpha-D-mannopyranoside,0.013704033208097542,1.0092755118481582,NA,96.63813025946115 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_73,Methyl alpha-D-mannopyranoside,0.021423181021441216,1.577775802386025,1558.32,151.0720330784619 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_73,Methyl alpha-D-mannopyranoside,0.02040727877836983,1.5029565691870197,1295.82,143.90809149965713 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_73,Methyl alpha-D-mannopyranoside,0.025291720880386,1.862686272679867,283.93,178.35221060909726 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_73,Methyl alpha-D-mannopyranoside,0.019794424823732344,1.4578210620438063,1862.02,139.58636669069446 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_73,Methyl alpha-D-mannopyranoside,0.020015738452932235,1.4741203823240367,1949.78,141.14702660752653 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_73,Methyl alpha-D-mannopyranoside,0.018830346533936813,1.3868185626613518,1837.99,132.78787737482443 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_73,Methyl alpha-D-mannopyranoside,0.020052901653122457,1.4768573800621725,2035.03,141.40909414095302 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_73,Methyl alpha-D-mannopyranoside,0.019847726502823137,1.4617466275054356,2054.96,139.96223958364547 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_73,Methyl alpha-D-mannopyranoside,0.020640302065439084,1.5201182830969358,2234.61,145.5513256065316 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_73,Methyl alpha-D-mannopyranoside,0.01809472259471055,1.149828832970104,1448.52,122.15781521474385 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_73,Methyl alpha-D-mannopyranoside,0.020239122315063904,1.2860946759510894,2129.01,136.63469837304373 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_73,Methyl alpha-D-mannopyranoside,0.020055920409481946,1.2744531140431563,2182.19,135.39789883594491 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_73,Methyl alpha-D-mannopyranoside,0.01904537390568408,1.2102379540128179,1859.98,128.57568023432177 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_73,Methyl alpha-D-mannopyranoside,0.01997764270506846,1.2694789586759085,1954.73,134.86944456972853 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_73,Methyl alpha-D-mannopyranoside,0.020300804046178546,1.2900142404833392,4840.73,137.05111290894996 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_73,Methyl alpha-D-mannopyranoside,0.02082920090810639,1.3235912098961315,5234.47,140.618330139365 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_73,Methyl alpha-D-mannopyranoside,0.02158314889814577,1.3715008218268803,5382.18,145.70824731088774 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_74,L-methionine,0.02111681212590912,1.0663061597499843,8907.68,218.20889253123678 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_74,L-methionine,0.01897645303120339,0.9582274368275318,7668.13,196.0916626723861 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_74,L-methionine,0.020604131269030046,1.0404180307835236,14527.38,212.91114581954025 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_74,L-methionine,0.019984658570285578,1.0091373833766304,8641.69,206.50987413419364 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_74,L-methionine,0.01929118954975803,0.9741202470884759,8649.61,199.3439673641857 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_74,L-methionine,0.020128976322013846,1.016424795260184,10114.92,208.00117010204403 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_74,L-methionine,0.019912525105788715,1.0054949605971644,9150.81,205.7644887366037 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_74,L-methionine,0.020306930600799543,1.0254107038571658,9619.01,209.8400464373304 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_74,L-methionine,0.019699252498895665,0.9947256317287709,9216.97,203.56065327697567 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_74,L-methionine,0.020371906781266408,1.0286917152643675,327.16,210.51147261170016 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_74,L-methionine,0.020367668521932055,1.0284777018040074,1325.89,210.46767689717205 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_74,L-methionine,0.01693655574585858,0.8552215935377837,966.97,175.01254690157205 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_74,L-methionine,0.020417630321734794,1.0310005530073145,374.14,210.98395316741684 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_74,L-methionine,0.019848947052096288,1.002284548444377,1390.93,205.1075099936573 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_74,L-methionine,0.021962644560159485,1.109016978474885,1589.23,226.94923447510044 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_74,L-methionine,0.019288742337768516,0.9739966736436265,1470.8,199.31867929443172 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_74,L-methionine,0.020225019458918036,1.0212745513631423,1539.36,208.99362419095343 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_74,L-methionine,0.01975846200734374,0.9977154515556229,1751.76,204.17249000634266 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_74,L-methionine,0.020203555551900218,1.0201907184375596,1849.18,208.77182862106218 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_74,L-methionine,0.024685430036563472,1.318762547482378,1863.71,630.3157471946774 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_74,L-methionine,0.02017785133775403,1.077955481977969,2483.99,515.21960216619 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_74,L-methionine,0.019334740598862872,1.032914222247716,2462.58,493.6916816655183 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_74,L-methionine,0.02032527151016172,1.0858310669617712,2131.92,518.9838167650481 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_74,L-methionine,0.021519851223564847,1.149648751469794,2155.91,549.4861172525027 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_74,L-methionine,0.018867272568702742,1.0079408136659156,3551.91,481.755391299761 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_74,L-methionine,0.018401771009223838,0.9830724592752428,3570.05,469.869312635195 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_74,L-methionine,0.015966738272287558,0.8529864137573532,3216.29,407.6933863194645 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_75,nicotinic_acid,0.01969859088235145,0.981379403105646,2449.57,130.9209192713087 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_75,nicotinic_acid,0.02080496571263162,1.0364987503237375,2582.18,138.2741157869382 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_75,nicotinic_acid,0.020375890397949573,1.0151223138707475,3427.49,135.42239228192707 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_75,nicotinic_acid,0.02001730509305142,0.9972576739792367,2824.18,133.03915999720007 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_75,nicotinic_acid,0.01937630728681647,0.9653233062758859,2046.21,128.77895567373457 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_75,nicotinic_acid,0.019528372399727913,0.9728991562761988,3170.62,129.7896119430263 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_75,nicotinic_acid,0.01997015483222073,0.9949086585036295,2997.25,132.7257895876767 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_75,nicotinic_acid,0.0200473697822998,0.9987554900903154,2977.77,133.23897615549853 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_75,nicotinic_acid,0.020160191419351547,1.0043762388783133,2950.73,133.9888121475614 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_75,nicotinic_acid,0.012464524053369013,0.6209798075684003,39.14,82.84181122866245 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_75,nicotinic_acid,0.015876610868671873,0.7909692114879787,281.01,105.51924765855381 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_75,nicotinic_acid,0.01967097119982551,0.9800033966840109,343.43,130.73735313463047 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_75,nicotinic_acid,0.0297298136116239,1.4811326815644166,166.68,197.590505384101 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_75,nicotinic_acid,0.020099419759610524,1.0013486083478567,475.46,133.5849110966458 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_75,nicotinic_acid,0.021671012740486474,1.0796450200408818,548.86,144.03004389855383 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_75,nicotinic_acid,0.021557743280924652,1.0740019608353388,582.86,143.27723158523838 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_75,nicotinic_acid,0.018831856938801,0.9381989114017942,482.7,125.16042577555636 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_75,nicotinic_acid,0.016178081007845447,0.8059883865651871,420.18,107.5228807097288 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_75,nicotinic_acid,0.02331407468012299,1.1615019993150058,715.47,154.95017421861834 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_75,nicotinic_acid,0.02480928465000341,1.2197212765636651,750.45,414.04658454230173 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_75,nicotinic_acid,0.019520665557756306,0.9597121178371268,609.4,325.78387552099105 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_75,nicotinic_acid,0.020172348951516067,0.9917514173238167,650.22,336.6599361247428 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_75,nicotinic_acid,0.019217418457088072,0.9448033066416682,459.01,320.7229304725807 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_75,nicotinic_acid,0.022359997843857494,1.0993047763699595,540.46,373.1699993865464 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_75,nicotinic_acid,0.016635736955101413,0.8178777663970592,752.6,277.6367865811457 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_75,nicotinic_acid,0.021618507728817474,1.0628502279041363,1163.73,360.7951383643381 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_75,nicotinic_acid,0.015109608666138282,0.7428473424620516,996.2,252.16695887216804 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_76,6-hydroxy-nicotinic_acid,0.01870750673409428,0.9850698713666904,115.83,47.963052036844154 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_76,6-hydroxy-nicotinic_acid,0.01837692761613441,0.9676627666234505,106.15,47.1155001068958 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_76,6-hydroxy-nicotinic_acid,0.019577271208973627,1.0308685334528167,315.98,50.19298889381764 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_76,6-hydroxy-nicotinic_acid,0.024865032962526755,1.3093030070803076,127.09,63.74996341474017 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_76,6-hydroxy-nicotinic_acid,0.0209919582928167,1.105360855893928,208.25,53.820020073475355 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_76,6-hydroxy-nicotinic_acid,0.02093815597761496,1.1025278199117243,150.61,53.68207955150186 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_76,6-hydroxy-nicotinic_acid,0.014308832080999286,0.7534515196377908,96.84,36.685554491164034 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_76,6-hydroxy-nicotinic_acid,0.02579682974556464,1.3583680669118345,279.39,66.13894117793723 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_76,6-hydroxy-nicotinic_acid,0.015692298565108703,0.8262998778349886,174.11,40.232541051785596 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_76,6-hydroxy-nicotinic_acid,0.03563614644630804,1.876471017481569,56.22,91.3653738411776 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_76,6-hydroxy-nicotinic_acid,0.0062864534679914095,0.3310219794164781,16.92,16.117460177788317 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_76,6-hydroxy-nicotinic_acid,0.002036463540066381,0.10723282936470196,4.48,5.221166461767338 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_76,6-hydroxy-nicotinic_acid,0.00742271721984427,0.3908535328022864,12.7,19.030658512143326 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_76,6-hydroxy-nicotinic_acid,0.005360923199030534,0.2822868916279125,11.58,13.744548753363059 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_76,6-hydroxy-nicotinic_acid,0.04058929551630886,2.13728599334115,100.34,104.0644550157806 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_76,6-hydroxy-nicotinic_acid,0.046289560165227714,2.4374413825268726,141.6,118.67902091523342 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_76,6-hydroxy-nicotinic_acid,0.010916918146063121,0.5748455583481973,33.2,27.989230235973725 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_76,6-hydroxy-nicotinic_acid,0.018283166860675604,0.9627256632118707,57.53,46.87511254178598 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_76,6-hydroxy-nicotinic_acid,0.013555875292261375,0.7138035292578134,43.46,34.75509383956293 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_76,6-hydroxy-nicotinic_acid,0.023915643769233944,1.4388304590146828,5.87,59.82657048583051 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_76,6-hydroxy-nicotinic_acid,0.006659491870466683,0.40065322252017505,50,16.659160992388877 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_76,6-hydroxy-nicotinic_acid,0.03395859037739369,2.0430415610661203,258.8,84.94966810912928 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_76,6-hydroxy-nicotinic_acid,0.028089223634003714,1.6899244245589553,124.64,70.26705757316135 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_76,6-hydroxy-nicotinic_acid,0.014441953481476906,0.868867372224106,58.69,36.127505337078325 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_76,6-hydroxy-nicotinic_acid,0.01656755714118283,0.9967494948585128,41.58,41.44484399621696 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_76,6-hydroxy-nicotinic_acid,0.0028457125166003916,0.17120583857129104,6.54,7.118738767794281 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_76,6-hydroxy-nicotinic_acid,0.04780057240282726,2.8758130115653393,31.37,119.5763050208868 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_77,nonanoic_acid,0.017723594813250077,0.8688556742491275,17650.64,568.8571870443888 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_77,nonanoic_acid,0.02155508908195,1.0566852636349207,20448.09,691.8329758070553 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_77,nonanoic_acid,0.0226289170582859,1.1093270408949942,41917.3,726.2986002147707 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_77,nonanoic_acid,0.01871504670260006,0.917459166310611,18620.07,600.6788653668832 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_77,nonanoic_acid,0.017653209589682285,0.8654052116581834,20607.07,566.5981001768458 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_77,nonanoic_acid,0.02517782322171056,1.2342809007950437,28570.46,808.1083913685311 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_77,nonanoic_acid,0.017347154812723448,0.8504016284464447,17937.89,556.7749541764563 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_77,nonanoic_acid,0.01830853828809425,0.8975310904154579,18300.24,587.6315555168086 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_77,nonanoic_acid,0.020748468795367955,1.0171426866156512,20353.35,665.9436597809992 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_77,nonanoic_acid,0.0225892662301445,1.1073832565001052,903.45,725.0259656957489 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_77,nonanoic_acid,0.015801705241951014,0.7746397616818278,2169.83,507.1721447683263 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_77,nonanoic_acid,0.019189917179584993,0.9407385242969093,2287.38,615.9203266276725 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_77,nonanoic_acid,0.018706126374238546,0.9170218691372818,843.2,600.3925581615612 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_77,nonanoic_acid,0.02152286021707621,1.0551053227473495,2936.21,690.7985569091446 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_77,nonanoic_acid,0.020831947944288637,1.0212350467144613,2944.9,668.6230097848921 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_77,nonanoic_acid,0.021184167101772733,1.0385017252175446,3110.17,679.9278495344308 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_77,nonanoic_acid,0.019474278492911473,0.9546786387727796,2850.95,625.0471983773143 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_77,nonanoic_acid,0.020400201370818202,1.0000697321070116,3473.79,654.7656550051026 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_77,nonanoic_acid,0.019131854400743453,0.9378921392722737,3366.16,614.056741424343 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_77,nonanoic_acid,0.026564780341294038,1.2559754483228993,4390.05,3621.040016287335 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_77,nonanoic_acid,0.022199117191135934,1.0495681051489303,4036.74,3025.957325549624 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_77,nonanoic_acid,0.01731934655391234,0.8188539025446384,3274.64,2360.79674373132 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_77,nonanoic_acid,0.01969684716836584,0.9312614723329886,3360.27,2684.873387809623 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_77,nonanoic_acid,0.021421958656649052,1.0128242651385981,3524.49,2920.0229976078354 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_77,nonanoic_acid,0.0198004133529358,0.9361580528213336,7169.43,2698.9904741865457 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_77,nonanoic_acid,0.019101107115626913,0.9030950478337212,7209.34,2603.66817765701 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_77,nonanoic_acid,0.013245294155120324,0.6262338348337932,5794.37,1805.4634575175678 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_78,ornithine_peak_2,0.020035660595222174,1.0151578506675805,791.26,65.06146664928524 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_78,ornithine_peak_2,0.020000605279292726,1.0133816836675318,712.12,64.94763210625212 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_78,ornithine_peak_2,0.019975299709720472,1.0120995124361516,866.69,64.86545775203295 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_78,ornithine_peak_2,0.01998443911091754,1.0125625835104248,790.9,64.89513597718313 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_78,ornithine_peak_2,0.02001124492012525,1.0139207682097202,628.84,64.98218203456098 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_78,ornithine_peak_2,0.02003081857083886,1.0149125171512494,995.3,65.04574322422359 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_78,ornithine_peak_2,0.019961447927257583,1.0113976765447863,783.65,64.82047708975536 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_78,ornithine_peak_2,0.019996187203790296,1.0131578306026519,807.52,64.93328536332396 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_78,ornithine_peak_2,0.02001008143604019,1.0138618173207559,815.89,64.97840387208724 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_78,ornithine_peak_2,0.020254904342184032,1.0262663943504966,37.65,65.77341321392333 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_78,ornithine_peak_2,0.01990238721628492,1.0084052149723337,97.44,64.62869022757687 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_78,ornithine_peak_2,0.020094185276824435,1.0181231529446875,118.06,65.25151287222502 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_78,ornithine_peak_2,0.019733777738829356,0.999862185710958,17.9,64.0811674822153 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_78,ornithine_peak_2,0.019700628363636487,0.9981825880599681,65.82,63.97352206876336 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_78,ornithine_peak_2,0.0203501465429908,1.0310920833965023,208.03,66.08269162488183 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_78,ornithine_peak_2,0.019820448430319288,1.0042535773733707,99.72,64.36261177385933 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_78,ornithine_peak_2,0.020090255646816088,1.0179240482166836,159.34,65.23875225020726 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_78,ornithine_peak_2,0.01988207104692309,1.0073758444294891,141.25,64.56271786948597 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_78,ornithine_peak_2,0.020132575533033797,1.0200682932007252,209.11,65.37617691123448 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_78,ornithine_peak_2,0.020221000891422692,1.0004070141769,167,53.94194620441844 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_78,ornithine_peak_2,0.020082634932813034,0.9935615431609163,255.74,53.57283840723661 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_78,ornithine_peak_2,0.019907255252503694,0.9848848676952627,212.46,53.10499206612857 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_78,ornithine_peak_2,0.019826363276880477,0.9808828452316556,89.36,52.88920301489087 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_78,ornithine_peak_2,0.02020666321284484,0.999697676677074,162.04,53.903698726427834 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_78,ornithine_peak_2,0.020047374461948375,0.9918170784548617,224.89,53.47877687028614 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_78,ornithine_peak_2,0.01990603709297338,0.9848246008793392,164.39,53.10174247941397 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_78,ornithine_peak_2,0.019779316017552534,0.9785552449075076,189.34,52.76369880541281 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_79,ornithine,0.019615604984930365,0.9989426489488921,2126.77,120.57737244137601 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_79,ornithine,0.0202904310819237,1.0333087859825574,2411.58,124.72553701202459 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_79,ornithine,0.019681156683616263,1.0022809292404609,3939.1,120.98031956396983 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_79,ornithine,0.020025725416576327,1.0198284075421764,2310.3,123.0983879323784 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_79,ornithine,0.020384407140694723,1.0380946028441134,2936.36,125.3032090362987 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_79,ornithine,0.020077444763355278,1.022462262644426,2682.2,123.41630741249543 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_79,ornithine,0.019915600298921057,1.0142201850667096,2347.76,122.42144743847719 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_79,ornithine,0.02008331412215595,1.0227611651168442,2565.67,123.45238643542868 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_79,ornithine,0.019922528942492544,1.014573032586235,2432.44,122.4640378983215 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_79,ornithine,0.018993921058785935,0.9672828256363424,49.08,116.7558734684347 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_79,ornithine,0.021232156095365856,1.0812669947776492,432.2,130.51433260463614 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_79,ornithine,0.019503207939745037,0.9932187264831961,271.31,119.88646638015419 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_79,ornithine,0.020834053188186197,1.0609932396241468,90.91,128.06718898883264 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_79,ornithine,0.019290532977965187,0.9823880592746812,334.66,118.5791506947504 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_79,ornithine,0.019693886059334267,1.0029291843571895,379.2,121.05856719783455 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_79,ornithine,0.020542419698970547,1.0461415370912348,448.57,126.27451423459749 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_79,ornithine,0.020806501389974613,1.0595901390667115,465.56,127.89782773604742 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_79,ornithine,0.01863624901449339,0.9490680492042592,248.77,114.5572588792001 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_79,ornithine,0.020846100488830364,1.061606759443057,450.46,128.14124389857417 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_79,ornithine,0.021364681259931233,1.0744480748301475,564.82,162.97228399023678 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_79,ornithine,0.019663407433063548,0.9888895604859562,643.15,149.99476853450986 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_79,ornithine,0.02033452623872614,1.0226406986355736,723.45,155.11414116904382 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_79,ornithine,0.018480855333539468,0.9294180050126271,341.71,140.97412300031527 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_79,ornithine,0.021830331518945714,1.0978660242137688,605.13,166.52431855274446 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_79,ornithine,0.019841741083836673,0.997858112153983,849.45,151.35511845151615 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_79,ornithine,0.01966064626738244,0.9887506991046765,851.29,149.97370604019733 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_79,ornithine,0.018680952493536847,0.9394810621545736,885.04,142.50048750760573 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_80,palatinose,0.02005925699025154,1.013278826927456,419.25,50.71967168185382 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_80,palatinose,0.02014687229562187,1.0177046505703597,416.86,50.94120628429936 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_80,palatinose,0.01978062133855724,0.9992037489509298,522.55,50.0151436537388 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_80,palatinose,0.019977959055696756,1.0091721206921587,421,50.51411050124601 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_80,palatinose,0.020141446686981687,1.0174305798826486,395.11,50.92748767602598 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_80,palatinose,0.020025050823257885,1.011550927196082,465.7,50.6331816607999 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_80,palatinose,0.019812147121979536,1.0007962510490702,388.73,50.09485634626122 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_80,palatinose,0.019635650322203258,0.9918806431419244,336.87,49.64858559246903 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_80,palatinose,0.020421589772780344,1.031581804800294,461.09,51.635827239278726 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_80,palatinose,0.017808406471668273,0.8995787445082761,1.24,45.02841405636177 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_80,palatinose,0.017969692397542834,0.9077259861458655,8.03,45.4362242365313 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_80,palatinose,0.019873527604838143,1.0038968416490828,36.36,50.25005640874485 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_80,palatinose,0.023082179368021837,1.1659795596778484,24.79,58.36310685967471 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_80,palatinose,0.023213778910817166,1.1726272151923396,112.53,58.69585525645257 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_80,palatinose,0.017985874771526203,0.9085434270378556,12.64,45.47714124037987 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_80,palatinose,0.020395449651192374,1.0302613555059223,58.76,51.56973214984895 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_80,palatinose,0.019270555073435683,0.973438121289406,35.38,48.725445161141224 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_80,palatinose,0.018596191129780594,0.9393731154877911,13.67,47.02032129574139 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_80,palatinose,0.021387482194777614,1.0803731603711986,74.33,54.078078542380354 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_80,palatinose,0.017976326338661884,0.8798827943803587,5.77,35.23930591493336 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_80,palatinose,0.020283595454976176,0.9928161245393636,51.97,39.76228578780151 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_80,palatinose,0.01953895761755973,0.9563685206828295,40.05,38.30255925334732 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_80,palatinose,0.02137928321259532,1.046446481920495,90.48,41.91018160091583 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_80,palatinose,0.019047577197774286,0.932317044940829,41.57,37.3392976498802 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_80,palatinose,0.019512511701546963,0.9550740789797315,111.88,38.250716863138244 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_80,palatinose,0.01998934215297375,0.9784133810230365,137.59,39.18545590997261 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_80,palatinose,0.022339912628100124,1.0934661720704488,237.32,43.79332019142147 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_81,L-phenylalanine,0.020442496726119436,1.2095218097028262,29812.31,682.3033480714613 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_81,L-phenylalanine,0.020381884494718245,1.2059355640109866,28539.32,680.2803110142377 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_81,L-phenylalanine,0.01935996254381284,1.145471477652354,44891.76,646.1719152584694 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_81,L-phenylalanine,0.019728179541264847,1.1672577836544211,29767.97,658.4617883372955 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_81,L-phenylalanine,0.020331444442156718,1.202951175926053,30121.17,678.5967878516458 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_81,L-phenylalanine,0.01972872706152245,1.167290178801731,34665.83,658.4800627638444 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_81,L-phenylalanine,0.019998975527447463,1.183279977795187,32161.52,667.500068274043 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_81,L-phenylalanine,0.020011789347090057,1.1840381334417776,33618.42,667.9277514558412 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_81,L-phenylalanine,0.020135923908893173,1.191382806739288,33454.45,672.0709551096998 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_81,L-phenylalanine,0.018142780236169012,1.07345441597913,1076.05,605.546370597987 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_81,L-phenylalanine,0.01892095493372662,1.119496701374349,4523.43,631.5192842122841 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_81,L-phenylalanine,0.019539846949481555,1.1561147036142663,4090.85,652.1758654558438 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_81,L-phenylalanine,0.02251645730223996,1.3322318965816218,1524.57,751.5253351806587 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_81,L-phenylalanine,0.020820371805607616,1.2318795557309898,5153.12,694.9155761834087 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_81,L-phenylalanine,0.019799370573094218,1.1714699455447468,5041.4,660.8379109812471 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_81,L-phenylalanine,0.019643374847820753,1.1622401418438326,5056.14,655.6312864155244 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_81,L-phenylalanine,0.020829668681617584,1.2324296242694277,5332.72,695.2258753466269 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_81,L-phenylalanine,0.019911082998884416,1.178079637952593,5660.15,664.5665045654373 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_81,L-phenylalanine,0.019818255830501296,1.172587330129504,5793.68,661.4682387993545 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_81,L-phenylalanine,0.023491838377323892,1.2522510176360646,5386.01,1518.617331597432 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_81,L-phenylalanine,0.0204231074848438,1.088669891236489,7133.33,1320.2408638014026 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_81,L-phenylalanine,0.019064000049800193,1.01622159488464,6924.52,1232.3820903325518 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_81,L-phenylalanine,0.020599438077127573,1.098069332867284,6495.67,1331.639660661484 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_81,L-phenylalanine,0.02115831541885006,1.127860731423017,6393.06,1367.767987604007 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_81,L-phenylalanine,0.01872233097970274,0.9980086549753777,10995,1210.2950759751905 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_81,L-phenylalanine,0.01879704500239162,1.0019913450246225,11380.8,1215.12492402481 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_81,L-phenylalanine,0.017185918297348987,0.9161089622359789,10560.79,1110.974499593194 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_82,phosphate,0.019781208345867045,1.0007766992031513,412296.04,6065.412344744035 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_82,phosphate,0.019819682221899594,1.0027231808329982,393554.16,6077.209395690456 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_82,phosphate,0.020244734906123468,1.0242275710030702,781865.13,6207.541160716162 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_82,phosphate,0.02011281305964905,1.0175533422219432,407271.09,6167.090628971242 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_82,phosphate,0.019887983213844114,1.0061786846665048,483465.18,6098.152185051709 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_82,phosphate,0.01999156527882844,1.0114191389036353,463640.39,6129.913032248957 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_82,phosphate,0.020214803276215002,1.0227132611966208,429356.18,6198.3633757006655 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_82,phosphate,0.019927264538449976,1.008166016971591,442178.69,6110.196819889806 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_82,phosphate,0.019963893146000902,1.0100191422367564,438735.19,6121.428065450021 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_82,phosphate,0.020656466059550654,1.0450579943766785,15650.14,6333.788211808707 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_82,phosphate,0.01833202037338809,0.9274589559053604,58968.77,5621.0551313503975 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_82,phosphate,0.019617430219632463,0.9924907881653168,55886.5,6015.193882287476 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_82,phosphate,0.02005246816147063,1.01450035541968,17374.72,6148.587376593832 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_82,phosphate,0.02088788537972327,1.0567660285535985,75318.29,6404.747153084937 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_82,phosphate,0.02004205061277277,1.0139733077379942,74414.45,6145.3930960742 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_82,phosphate,0.019944631863800848,1.009044669793741,77282.53,6115.522075442274 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_82,phosphate,0.020243597785319624,1.024170041453572,78227.53,6207.192491087871 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_82,phosphate,0.019750504096314,0.9992233007968488,84781.03,6055.997655255966 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_82,phosphate,0.020053384716785413,1.014546726055211,88567.4,6148.8684153364475 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_82,phosphate,0.033071432862580206,1.7043499253771368,303249.94,98890.37084920685 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_82,phosphate,0.01950626123763072,1.0052632138101159,109858.58,58327.72398118323 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_82,phosphate,0.019237804257819825,0.9914281726914295,110906.72,57524.98252148083 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_82,phosphate,0.021954010172804447,1.1314089642026142,105291.44,65646.9956000119 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_82,phosphate,0.02257608908839643,1.163468057552861,104607.76,67507.13921447167 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_82,phosphate,0.018105006503520787,0.9330489734583811,197725.57,54137.684774653164 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_82,phosphate,0.01746590853648051,0.9001127962761025,205898.72,52226.650703882755 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_82,phosphate,0.006110357361252254,0.3148997854417552,127729.86,18271.22241682857 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_83,L-pipecolic acid,0.019845478944036755,1.0463877072756385,7285.48,262.71132972715816 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_83,L-pipecolic acid,0.02052686434581037,1.082314948454528,7199.25,271.73140253373606 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_83,L-pipecolic acid,0.02157622714634623,1.1376444438045512,13845.99,285.62270228378964 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_83,L-pipecolic acid,0.019887635725165987,1.0486104975482409,7244.78,263.2693945669491 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_83,L-pipecolic acid,0.018201691008871316,0.9597161034521409,7401.15,240.95112351321174 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_83,L-pipecolic acid,0.01936634732797821,1.021124651915545,8089.67,256.3686607331763 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_83,L-pipecolic acid,0.02052559344740439,1.0822479381055734,7841.27,271.7145785804758 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_83,L-pipecolic acid,0.019884426357445546,1.0484412780025565,7930.91,263.22690946171184 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_83,L-pipecolic acid,0.020144228458878147,1.062139799768147,7951.43,266.6661288287898 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_83,L-pipecolic acid,0.024223784017100486,1.2772415264288968,507.23,320.67064383287095 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_83,L-pipecolic acid,0.017481523947823676,0.9217440312239968,1112.6,231.41766519925275 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_83,L-pipecolic acid,0.019368849299015774,1.0212565727296028,1059.87,256.4017814323577 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_83,L-pipecolic acid,0.01637453675546332,0.8633761886809217,383.62,216.7635428111756 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_83,L-pipecolic acid,0.020209687656799768,1.0655912508632028,1144.38,267.53266739797004 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_83,L-pipecolic acid,0.01954508313777307,1.0305488111785541,1145.03,258.73473727854366 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_83,L-pipecolic acid,0.022142141312947748,1.1674832614503659,1318.42,293.1141850360361 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_83,L-pipecolic acid,0.022063499358395033,1.1633367263754428,1309.34,292.07313520745055 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_83,L-pipecolic acid,0.020152350487741867,1.062568047994612,1418.16,266.77364696976724 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_83,L-pipecolic acid,0.01828390091703156,0.9640507651429834,1333.55,242.03940535062313 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_83,L-pipecolic acid,0.030352103934822194,1.631383035404937,2502.52,635.3910646295149 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_83,L-pipecolic acid,0.01991974462533712,1.0706583478086662,1905.13,417.0000133045193 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_83,L-pipecolic acid,0.019359285709566722,1.0405344668021739,1907.12,405.2673641301107 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_83,L-pipecolic acid,0.020031152230280756,1.0766463503903136,1590.98,419.3322205500194 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_83,L-pipecolic acid,0.022826029368268386,1.226867078374943,1733.39,477.8401896854728 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_83,L-pipecolic acid,0.018157637246589472,0.9759475465270214,2726.53,380.11205042134435 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_83,L-pipecolic acid,0.01812676831112177,0.9742883845212784,2850.97,379.4658400033475 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_83,L-pipecolic acid,0.009576616888079138,0.5147297321244576,2047.31,200.47693606783375 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_84,L-proline,0.01940136659430523,2.8751427888413477,80194.21,2791.864277962558 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_84,L-proline,0.020107104452900555,2.9797280563321578,79305.71,2893.420233180497 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_84,L-proline,0.02101081910444602,3.1136520585889826,156427.71,3023.4651267119525 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_84,L-proline,0.020063214454625746,2.973223874710276,82723.96,2887.1044451792927 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_84,L-proline,0.019129506947695517,2.834855147312204,89983.38,2752.743567970306 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_84,L-proline,0.019987055175687784,2.961937618117088,95710.6,2876.1450950083263 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_84,L-proline,0.020375795529048366,3.0195461385408184,89261.55,2932.0849846379833 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_84,L-proline,0.019850198212894857,2.941656401958206,90785.52,2856.4513242754865 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_84,L-proline,0.019970902000994894,2.959543833972584,90368.55,2873.820646821568 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_84,L-proline,0.020246192491109663,3.0003399017981565,3709.76,2913.435056542573 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_84,L-proline,0.018168211342311988,2.6923980624296067,12431.59,2614.412752551333 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_84,L-proline,0.019982163304493976,2.961212678040395,11916.63,2875.441152820955 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_84,L-proline,0.02038526447734916,3.0209493684778748,4239.75,2933.447570019913 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_84,L-proline,0.0205519950263038,3.0456576349381974,13930.41,2957.4401615422125 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_84,L-proline,0.019870113741864835,2.9446077399078123,13854.39,2859.3171767213826 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_84,L-proline,0.020309953778900863,3.0097888654012626,14073.33,2922.610330914915 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_84,L-proline,0.02088003739493159,3.0942711512083076,14375.26,3004.6455873135587 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_84,L-proline,0.019757573361802533,2.9279300661668,15005.82,2843.1225718002784 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_84,L-proline,0.019687026897554492,2.9174755882837555,15378.1,2832.9709078691167 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_84,L-proline,0.03362892986703359,1.8832759937518337,22290.69,2414.096165350725 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_84,L-proline,0.01918264352461581,1.0742599359970268,8375.1,1377.0508415571487 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_84,L-proline,0.01937646863799089,1.085114464655798,8638.98,1390.964827663681 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_84,L-proline,0.022328178594400214,1.250415130582528,7807.98,1602.8571392885192 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_84,L-proline,0.023362939541782084,1.3083634643291373,7846.4,1677.138790384948 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_84,L-proline,0.017358753813927128,0.9721190792712175,13329.56,1246.1205629546027 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_84,L-proline,0.016618565414269183,0.930667298038776,13841.09,1192.9851826639854 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_84,L-proline,0.00562638048309587,0.3150866631029961,9398.73,403.89698996520656 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_85,4-hydroxyproline,0.020355601252944878,1.027708216517454,214.73,47.13583735057303 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_85,4-hydroxyproline,0.019745473056481857,0.9969042253779976,155.77,45.723012296961855 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_85,4-hydroxyproline,0.019857455906159716,1.00255798589791,350.95,45.98232202320763 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_85,4-hydroxyproline,0.01997461669492639,1.0084731688381219,160.98,46.253621888760456 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_85,4-hydroxyproline,0.02010272576490092,1.014941105706564,241.66,46.550273813231556 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_85,4-hydroxyproline,0.019552849761451618,0.9871791113646445,139.88,45.27696994273941 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_85,4-hydroxyproline,0.02047136467668849,1.0335528496616746,209.8,47.4039014497327 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_85,4-hydroxyproline,0.019968815863060724,1.0081802979719212,184.09,46.24018936648216 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_85,4-hydroxyproline,0.020011389790419658,1.010329759165059,187.56,46.33877440410543 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_85,4-hydroxyproline,0.015892449920372607,0.802373811552051,17.41,36.80087486683482 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_85,4-hydroxyproline,0.01734925314483303,0.8759245077473058,37.12,40.17427754783017 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_85,4-hydroxyproline,0.01753277483440176,0.885190102309474,31.95,40.59924404242402 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_85,4-hydroxyproline,0.026213973902189082,1.3234841865924412,59.02,60.701602218062305 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_85,4-hydroxyproline,0.019141811423779326,0.9664267164007091,42.78,44.32516134771852 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_85,4-hydroxyproline,0.020165424768833606,1.018106636447139,60.99,46.69546088064802 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_85,4-hydroxyproline,0.024690786056732056,1.2465818811963165,127.34,57.17447798106905 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_85,4-hydroxyproline,0.021752700906833514,1.0982446146200313,87.36,50.37098924954773 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_85,4-hydroxyproline,0.020686354083585073,1.0444071780200606,61.72,47.90173521989007 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_85,4-hydroxyproline,0.016650311268925654,0.8406365150315802,6.11,38.555793761923425 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_85,4-hydroxyproline,0.013551956930904647,0.689257126403872,7.59,26.246911373459447 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_85,4-hydroxyproline,0.017989703837734395,0.9149624393933046,17.9,34.84176969209704 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_85,4-hydroxyproline,0.022207502179562116,1.1294810937589754,84.83,43.010640050341785 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_85,4-hydroxyproline,0.023763182243985895,1.2086035095307726,193.89,46.023621642931815 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_85,4-hydroxyproline,0.015249596410843199,0.7755996462021622,55.48,29.534834527378333 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_85,4-hydroxyproline,0.028944909513178057,1.4721479161121738,700.16,56.059392645551576 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_85,4-hydroxyproline,0.011307541484704604,0.575105395492118,8.41,21.900013460339853 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_85,4-hydroxyproline,0.027141526220415785,1.3804272301247884,558.5,52.56666892315194 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_86,1_4-diaminobutane,0.021920281133007723,1.1845877342640279,71395.33,1272.8691351600546 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_86,1_4-diaminobutane,0.019229629842816696,1.0391830062771001,60219.16,1116.628119819901 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_86,1_4-diaminobutane,0.01962507893367363,1.0605533591349199,97985.99,1139.59109822445 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_86,1_4-diaminobutane,0.019642592471166218,1.0614998032781957,66358.47,1140.6080761175033 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_86,1_4-diaminobutane,0.019853917171925313,1.0729199418679918,63576.22,1152.879300535704 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_86,1_4-diaminobutane,0.020249176490360336,1.0942800392878482,78279.09,1175.8312592157752 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_86,1_4-diaminobutane,0.019408975089899638,1.048874952224504,68539.73,1127.0423580390352 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_86,1_4-diaminobutane,0.02014889748993401,1.0888608900904226,71866.31,1170.0082479244115 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_86,1_4-diaminobutane,0.020075816883556162,1.0849115616396385,70582.98,1165.7645957708328 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_86,1_4-diaminobutane,0.021293442813813672,1.1507129413369508,3203.28,1236.469823290087 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_86,1_4-diaminobutane,0.017508314553627904,0.9461618919035365,9147.15,1016.6746068976477 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_86,1_4-diaminobutane,0.018644812909911393,1.007579079242316,8453.09,1082.6689101228496 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_86,1_4-diaminobutane,0.019794637359207102,1.0697164182174799,3361.34,1149.4370342851375 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_86,1_4-diaminobutane,0.020199343796338677,1.0915870447160543,10185.77,1172.9375692235183 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_86,1_4-diaminobutane,0.021233714941058947,1.1474852042002956,11054.63,1233.0015390433227 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_86,1_4-diaminobutane,0.02086246621112201,1.1274226562258458,10784.12,1211.443829681077 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_86,1_4-diaminobutane,0.020684160973103077,1.1177869131151337,10616.63,1201.089982815039 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_86,1_4-diaminobutane,0.01985750957572571,1.073114077949215,11152.82,1153.0879046083803 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_86,1_4-diaminobutane,0.019315964394082966,1.043848587427846,11152.09,1121.6414034059064 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_86,1_4-diaminobutane,0.022638234966451832,1.2704874296280932,10175.52,1473.4223867625885 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_86,1_4-diaminobutane,0.020853579463794115,1.1703302227741434,12558.34,1357.2670692578574 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_86,1_4-diaminobutane,0.018644307562521854,1.0463429868718521,11633.43,1213.4753521648931 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_86,1_4-diaminobutane,0.019603650365615354,1.1001825628741637,10419.87,1275.914723642054 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_86,1_4-diaminobutane,0.022160722940104495,1.243688828594507,11296.11,1442.3432451859076 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_86,1_4-diaminobutane,0.01881267273991104,1.0557918613877788,19542.66,1224.4334954072488 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_86,1_4-diaminobutane,0.018762837493407857,1.052995042009919,20216.66,1221.1899400701634 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_86,1_4-diaminobutane,0.017962433032028817,1.0080752941449778,21434.52,1169.095160878755 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_87,2-hydroxypyridine,0.01992468861745815,0.9654315265801073,28428.68,274.86800993262233 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_87,2-hydroxypyridine,0.020209481415174698,0.9792308862959522,27497.1,278.7968256373205 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_87,2-hydroxypyridine,0.022161068864497886,1.0737931696334082,56586.2,305.7196533263276 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_87,2-hydroxypyridine,0.019988822041617737,0.9685390496526108,27548.99,275.7527528265948 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_87,2-hydroxypyridine,0.01765869946665478,0.8556352127166517,28526.88,243.60790141255788 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_87,2-hydroxypyridine,0.019984606689668383,0.9683347988487127,30449.65,275.69460058021696 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_87,2-hydroxypyridine,0.019929148676308524,0.9656476344203463,27678,274.92953799581676 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_87,2-hydroxypyridine,0.019589275411993654,0.9491794039395064,27029.52,270.24086809561686 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_87,2-hydroxypyridine,0.020419946343549,0.9894287609525197,27766,281.70026253079186 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_87,2-hydroxypyridine,0.01843621427838056,0.8933089413271631,1475.55,254.3339886852566 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_87,2-hydroxypyridine,0.01813920410402789,0.8789176004364514,5328.1,250.23663002026206 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_87,2-hydroxypyridine,0.02050807225818597,0.993698816958549,5246.43,282.91599017626845 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_87,2-hydroxypyridine,0.022326237988393643,1.0817962798695633,2025.27,307.99821884166334 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_87,2-hydroxypyridine,0.01892347588510171,0.9169187314650371,5517.96,261.0559320354107 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_87,2-hydroxypyridine,0.019692918536238623,0.9542013313372414,5934.77,271.67066104502595 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_87,2-hydroxypyridine,0.020970820970687972,1.016120858502643,6416.32,289.2997696242875 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_87,2-hydroxypyridine,0.023179204493705807,1.1231259473567472,7045.85,319.7651884719395 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_87,2-hydroxypyridine,0.019030643503293466,0.92211143480998,6295.43,262.5343466047494 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_87,2-hydroxypyridine,0.019331765717519905,0.9367020206178349,6562.97,266.6884322901038 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_87,2-hydroxypyridine,0.034763902643212,1.6877165488270236,10876.91,7697.489530379684 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_87,2-hydroxypyridine,0.019557350627682747,0.9494694725247642,7036.52,4330.425822543472 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_87,2-hydroxypyridine,0.018632772758362202,0.9045831032713915,7114.01,4125.704029879457 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_87,2-hydroxypyridine,0.023929935917595766,1.1617495675038234,9089.45,5298.611984932513 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_87,2-hydroxypyridine,0.0215271395155355,1.0450987043128068,7847.08,4766.580229513238 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_87,2-hydroxypyridine,0.015517506208593008,0.7533432679740345,9792.27,3435.9157774700943 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_87,2-hydroxypyridine,0.016155707192913114,0.7843266237200573,10562.96,3577.2274548585724 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_87,2-hydroxypyridine,0.006289919039556462,0.30536273682478576,5125.97,1392.7258527567972 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_88,4-hydroxypyridine,0.01985390014973335,0.8782302187719898,1050.74,81.71932185673366 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_88,4-hydroxypyridine,0.019169254315942384,0.8479451535779026,965.95,78.90129654042384 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_88,4-hydroxypyridine,0.02226176359781553,0.9847412028523994,2226.45,91.63016892541577 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_88,4-hydroxypyridine,0.020036504289483927,0.8863076480122075,1054.98,82.47092664753592 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_88,4-hydroxypyridine,0.017938467202706268,0.7935017229387283,1128.66,73.83533531944867 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_88,4-hydroxypyridine,0.022717179170555664,1.0048863488974253,1411.05,93.50467476490545 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_88,4-hydroxypyridine,0.018010053260621973,0.7966683067751631,1025.16,74.12998594542894 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_88,4-hydroxypyridine,0.018999302700269588,0.8404274042446576,1162.49,78.2017699649654 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_88,4-hydroxypyridine,0.020707902679796275,0.9160067172510087,1257.04,85.234425040206375 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_88,4-hydroxypyridine,0.013819510741031322,0.6113011473758623,39.22,56.88157176332399 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_88,4-hydroxypyridine,0.009975605866170531,0.4412673810262793,81.69,41.0599298044953 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_88,4-hydroxypyridine,0.016964450608275634,0.7504164449649771,119.37,69.82625020399112 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_88,4-hydroxypyridine,0.030209862647116267,1.3363225402342427,95.41,124.3448123687963 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_88,4-hydroxypyridine,0.02303127504900977,1.018780268478452,184.06,94.79750398191996 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_88,4-hydroxypyridine,0.02151847877905834,0.9518622629935327,182.79,88.57078357154823 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_88,4-hydroxypyridine,0.014050871385907614,0.6215353032964895,136.55,57.833859971738356 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_88,4-hydroxypyridine,0.031490156303239335,1.3929558752076965,306.09,129.61454418807617 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_88,4-hydroxypyridine,0.01530403212903555,0.6769684235042839,176.81,62.99191180707362 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_88,4-hydroxypyridine,0.021701193713521548,0.959944593198497,259.14,89.32284439712016 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_88,4-hydroxypyridine,0.035646659143756636,2.164315290251113,694.78,311.7479744077703 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_88,4-hydroxypyridine,0.013241021512529308,0.8039391630654507,262.63,115.79939704794751 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_88,4-hydroxypyridine,0.02571161370287586,1.5611010964518617,529.67,224.86100193292614 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_88,4-hydroxypyridine,0.01462926428082022,0.8882274280014594,251.54,127.9402787293302 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_88,4-hydroxypyridine,0.03216620207386396,1.9529965682622494,525.87,281.30962569249436 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_88,4-hydroxypyridine,0.014776531711639864,0.8971688873116729,397.19,129.22820652837336 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_88,4-hydroxypyridine,0.01295190289686851,0.7863850961317898,367.99,113.270909246823 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_88,4-hydroxypyridine,0.004906686113372026,0.29791335386597834,241.77,42.911439490855514 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_90,pyruvic_acid,0.02448950279943648,1.1976721872479312,653.27,83.06455454658027 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_90,pyruvic_acid,0.0176717668604119,0.8642471773143573,448.94,59.93986298263725 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_90,pyruvic_acid,0.022311069234776548,1.0911347326687961,1083.53,75.67564938424437 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_90,pyruvic_acid,0.01939439400947428,0.9484931761950567,478.33,65.78274423500817 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_90,pyruvic_acid,0.016639556574745397,0.8137663831284312,510.7,56.43876750187235 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_90,pyruvic_acid,0.02038643212264758,0.9970093288735388,565.11,69.14758200402429 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_90,pyruvic_acid,0.018728301221246243,0.9159175533610355,475.63,63.52346191335462 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_90,pyruvic_acid,0.021638143493000785,1.058224940599577,606.63,73.39319075528367 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_90,pyruvic_acid,0.018911268393072018,0.9248656604202032,528.13,64.1440578784432 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_90,pyruvic_acid,0.021282261713263195,1.0408203524774444,74.34,72.18609554607316 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_90,pyruvic_acid,0.023750358952980024,1.1615239634752248,168.56,80.55749448682423 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_90,pyruvic_acid,0.006444518783061404,0.3151726259974185,37.79,21.858797476050963 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_90,pyruvic_acid,0.020092036183204744,0.9826117385428145,76.93,68.1490371266369 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_90,pyruvic_acid,0.020244814217797037,0.990083429754847,74.12,68.66723627064742 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_90,pyruvic_acid,0.027653391152188726,1.352403833483568,104.69,93.79596787125286 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_90,pyruvic_acid,0.013969705766849362,0.683195906344718,53.45,47.38305208453792 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_90,pyruvic_acid,0.032756721660410014,1.6019849320500579,127.07,111.10566496233177 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_90,pyruvic_acid,0.025132968940404826,1.229141241837773,169.57,85.24709082765875 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_90,pyruvic_acid,0.012954126019408123,0.6335284374947322,93.78,43.93836478244715 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_90,pyruvic_acid,0.04190418317933085,2.169004901270132,123.58,179.1164247468875 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_90,pyruvic_acid,0.028622364682889163,1.4815239093778485,308.84,122.34424443642273 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_90,pyruvic_acid,0.009785802862727738,0.5065235201288726,109.14,41.828712292242294 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_90,pyruvic_acid,0.019773864752511246,1.023516181706766,170.93,84.52196628534473 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_90,pyruvic_acid,0.024134181298583215,1.2492107840581672,197.56,103.15982654752345 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_90,pyruvic_acid,0.020377327335524897,1.0547520441190743,238.26,87.10142380335316 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_90,pyruvic_acid,0.012522024583939455,0.6481532542981662,146.39,53.52449573994256 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_90,pyruvic_acid,0.001278537421796884,0.06617845102640187,10.47,5.465016485760266 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_91,quinic_acid,0.022606667478099654,0.9985891239810663,15349.84,354.67888505559506 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_91,quinic_acid,0.022811833491064037,1.007651784338028,14807.29,357.89776076118073 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_91,quinic_acid,0.015911035234212487,0.7028274623650872,17693.89,249.63025808283163 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_91,quinic_acid,0.016494373693123825,0.7285948799304163,10013.32,258.78232945368524 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_91,quinic_acid,0.0222624664871858,0.983384965016767,15816.28,349.27867187465523 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_91,quinic_acid,0.022493809835374187,0.9936039392034792,14625.06,352.9082471262917 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_91,quinic_acid,0.01770714636394507,0.7821658717679698,10527.36,277.8096743345475 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_91,quinic_acid,0.01786258817496221,0.7890320983820434,11569.84,280.24842070333415 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_91,quinic_acid,0.02248721117127715,0.9933124608506221,14502,352.8047198449239 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_91,quinic_acid,6.784931890478167e-5,0.002997062348684282,4.59,1.0644966050056832 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_91,quinic_acid,0.028947392166466242,1.278673692752428,12785.28,454.15932219180735 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_91,quinic_acid,1.8213426258863716e-5,8.045294331927489e-4,7.22,0.28575276408140055 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_91,quinic_acid,0.04521162213739899,1.997102588768799,3650.26,709.3308974789019 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_91,quinic_acid,0.023694531107529854,1.0466425927099692,14086.43,371.7465160787268 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_91,quinic_acid,0.022670548015643874,1.0014108760189337,14110.73,355.68111494440484 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_91,quinic_acid,0.019438232869014166,0.8586319921418387,12725.35,304.96891096893825 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_91,quinic_acid,0.01895578308487705,0.8373210621795586,12268.11,297.39969486493555 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_91,quinic_acid,0.023212421148530265,1.0253466736150234,13549.55,364.18263153458395 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_91,quinic_acid,0.01694062802941089,0.7483069727091222,9893.39,265.78367056682595 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_91,quinic_acid,0.03640537850604014,1.9228322999039047,4419.85,542.680960001879 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_91,quinic_acid,0.019914639997730955,1.0518366955652463,11236.76,296.85987058937945 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_91,quinic_acid,0.018938717749967488,1.0002911575925242,11362.98,282.3121734073381 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_91,quinic_acid,0.021524228814711877,1.136850764745753,12431.29,320.85339133419393 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_91,quinic_acid,0.022275468310235084,1.1765291756353933,12263.64,332.05182923957705 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_91,quinic_acid,0.01602165994757392,0.8462201605776614,12490.77,238.82871591983337 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_91,quinic_acid,0.016210533932594143,0.8561959667335622,12526,241.6441876912133 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_91,quinic_acid,0.010794241448758495,0.5701222446345595,3978.74,160.90560110321175 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_92,chlorogenic_acid,0.020215735860543167,1.0153024384664449,583.85,71.50775074119171 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_92,chlorogenic_acid,0.02437971091532501,1.2244313099553634,680,86.23669716015625 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_92,chlorogenic_acid,0.015204084546166154,0.7636004061816885,595.03,53.780376607376326 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_92,chlorogenic_acid,0.01792092819392448,0.9000494575310855,531.44,63.39048329391436 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_92,chlorogenic_acid,0.022898813322386816,1.1500556380727551,582.64,80.99841858946415 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_92,chlorogenic_acid,0.019606360678647374,0.984697561533555,668.66,69.35224925880829 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_92,chlorogenic_acid,0.019502099012828438,0.9794611890228145,609.83,68.98345154287684 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_92,chlorogenic_acid,0.01944685332198908,0.9766865640964254,662.41,68.78803470931125 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_92,chlorogenic_acid,0.021142366347131368,1.0618409468383618,715.3,74.78545788582583 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_92,chlorogenic_acid,0.03019251958657281,1.5163701668423772,113.15,106.79795085070865 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_92,chlorogenic_acid,0.0209951084108047,1.0544451566050805,154.4,74.26457237969584 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_92,chlorogenic_acid,0.015641029422994442,0.7855452516218713,95.01,55.3259520717284 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_92,chlorogenic_acid,0.009561572112536412,0.4802144007222965,39.18,33.821500242871345 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_92,chlorogenic_acid,0.007440218978306038,0.37367289143020466,33.65,26.317781743429318 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_92,chlorogenic_acid,0.023610291719405156,1.1857884828423992,114.42,83.51508284659019 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_92,chlorogenic_acid,0.016286219045134873,0.8179488505386422,99.75,57.60813754343658 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_92,chlorogenic_acid,0.04263140616759074,2.141093004766107,264.94,150.79718032567695 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_92,chlorogenic_acid,0.02465723274144942,1.238369392087794,240.25,87.21835628474335 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_92,chlorogenic_acid,0.010600272727450323,0.532381448928394,109.43,37.49562544802679 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_92,chlorogenic_acid,0.025083828808863274,1.5905608834576095,181.12,85.17453530915499 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_92,chlorogenic_acid,0.018159668282158054,1.151501162213337,188.29,61.6628872365242 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_92,chlorogenic_acid,0.021581551579229266,1.3684821407374475,236.97,73.28221863649031 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_92,chlorogenic_acid,0.016661176482436528,1.0564820780463746,183.8,56.57461527938336 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_92,chlorogenic_acid,0.024898047806780396,1.5787805449353594,264.6,84.54369818128849 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_92,chlorogenic_acid,0.02040320527955522,1.2937634227255344,425.2,69.28103128695236 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_92,chlorogenic_acid,0.01677907950060104,1.063958286330327,359.13,56.974966232989004 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_92,chlorogenic_acid,0.015852700224898115,1.0052167500837463,311.46,53.82935696698461 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_93,raffinose,0.016071640698194903,0.5674405225285477,14.16,16.552240042157738 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_93,raffinose,0.01628533928140162,0.5749855664973349,11.91,16.77232897472726 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_93,raffinose,6.597130133853676e-4,0.023292450600660885,3.86,0.679440784021278 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_93,raffinose,0.1016848748911304,3.5901822113254225,2.93,104.72561510436257 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_93,raffinose,0.04267542658795667,1.506738908425113,147.53,43.95157395876055 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_93,raffinose,0.03885771738402132,1.3719472623060935,58.68,40.01970164146875 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_93,raffinose,0.002296873132652152,0.08109557169980192,3.61,2.365557826483222 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_93,raffinose,0.01854834408763991,0.6548853510837771,98.71,19.10300569111378 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_93,raffinose,0.021558221014714832,0.7611549080206641,121.29,22.202888666962775 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_93,raffinose,0.0076795389902362485,0.27114105518097154,25.34,7.90918457962894 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_93,raffinose,0.008263824853044619,0.29177040357943734,38.42,8.510942672412188 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_93,raffinose,0.0061557056885074655,0.2173391577134342,22.36,6.339783230500876 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_93,raffinose,0.03709605974343161,1.309748514159309,132.45,38.205364158027045 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_93,raffinose,0.041842369049712794,1.4773261923450092,6.62,43.09360503070392 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_93,raffinose,0.10355155169204826,3.656088865113652,29.61,106.64811219536523 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_93,raffinose,0.11998911897588284,4.236449137209883,5.88,123.5772213324123 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_93,raffinose,1.1144100976599012,39.3464152168514,75.05,1147.7349318755553 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_93,raffinose,0.004787382481360675,0.1690278464894022,7.16,4.930542282095862 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_93,raffinose,0.009585131439196393,0.3384217015860301,16.69,9.871761035264498 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_93,raffinose,0.05508167985889596,4.063202511527262,50.09,179.3091268336981 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_93,raffinose,0.02073777275876381,1.5297603590294653,58.71,67.50832464397031 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_93,raffinose,0.014316931848834586,1.0561150929777638,48.47,46.60635905310872 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_93,raffinose,0.034257554103706345,2.5270721631863946,195.88,111.5196945614156 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_93,raffinose,0.013641472724972195,1.0062885950288563,75.36,44.40751569862343 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_93,raffinose,0.013820875807610202,1.0195225969296309,100.21,44.991532202504615 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_93,raffinose,0.009815437189850246,0.7240539711879621,70.03,31.95250174852477 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_93,raffinose,0.00461166718204404,0.34018820276380685,13.29,15.012505387966797 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_94,rhamnose,0.020780533190586797,1.0401287091835694,10779.66,390.6307380209813 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_94,rhamnose,0.019712617628150124,0.9866762965199011,9791.34,370.556149921014 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_94,rhamnose,0.019532842263790227,0.9776779943127485,16927.66,367.1767475440958 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_94,rhamnose,0.019972184572709814,0.9996684093071655,10410.67,375.4354677993991 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_94,rhamnose,0.020265936122201664,1.0143715652460148,11173.28,380.9573850437933 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_94,rhamnose,0.019755026533715324,0.9887989908607471,11822.86,371.3533490076622 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_94,rhamnose,0.019874366369553805,0.9947723115771321,10878.32,373.59668933590774 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_94,rhamnose,0.019985434147185163,1.0003315906928345,11387.21,375.6845322006009 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_94,rhamnose,0.020175143051448293,1.0098270966984852,11370.75,379.2506644360831 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_94,rhamnose,0.021332069882205373,1.0677347932940806,2007.61,400.9984789695249 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_94,rhamnose,0.006580569423425944,0.3293774571280678,881.77,123.70099779901714 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_94,rhamnose,0.007564809509604226,0.3786416584348502,796.28,142.20266124179236 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_94,rhamnose,0.021726712742746793,1.087487865333127,2211.41,408.4169427045092 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_94,rhamnose,0.04605511847923447,2.305198355391661,1123.11,865.7402943508921 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_94,rhamnose,0.03850111589676806,1.9270976164351994,1124.31,723.7407808284034 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_94,rhamnose,0.04524605842684728,2.2647024460603893,1320.91,850.5316506424398 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_94,rhamnose,0.04251786881750405,2.1281482820864057,1290.24,799.2473688203705 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_94,rhamnose,0.016365689566288436,0.8191523964935341,1415.26,307.6408740271117 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_94,rhamnose,0.0147194012724344,0.7367506745393504,1410.87,276.6940833299984 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_94,rhamnose,0.017206382617420496,0.8716908589255349,788.48,485.92406930803946 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_94,rhamnose,0.019775792436040177,1.0018594772530556,1043.26,558.4865655947159 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_94,rhamnose,0.020408252384416858,1.0339004685465014,1131.24,576.3478161912473 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_94,rhamnose,0.019403029173252234,0.982974954228063,1067.42,547.9593882344337 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_94,rhamnose,0.02016511969042069,1.0215831470283907,1075.07,569.4815253109764 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_94,rhamnose,0.019569697311226573,0.9914185123876543,2430.42,552.666249730498 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_94,rhamnose,0.02088786553128991,1.0581981030490883,2687.96,589.8925325447143 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_94,rhamnose,0.022732029739541068,1.151625124778957,2832.16,641.9734258080297 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_97,O-acetylserine,0.020296562216060954,1.0624592485986566,1738.74,124.45647638084662 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_97,O-acetylserine,0.019955987486998367,1.0446312653727488,1641.63,122.36810642576377 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_97,O-acetylserine,0.021702804695520793,1.136071484610336,2963.2,133.07941370725473 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_97,O-acetylserine,0.020328474339530726,1.064129744831563,1821.26,124.65215830956927 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_97,O-acetylserine,0.018049491472101224,0.9448323781581895,1573.83,110.67766477745032 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_97,O-acetylserine,0.02035069661304705,1.065293008825286,2117.71,124.788423053794 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_97,O-acetylserine,0.018790073708767268,0.9835994579383842,1789,115.21884050290231 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_97,O-acetylserine,0.020527020964130907,1.074523017117723,2027.98,125.86962622517005 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_97,O-acetylserine,0.01983521557661338,1.0383092472992683,1936.81,121.62754522863628 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_97,O-acetylserine,0.01080026510740388,0.5653588735139793,41.18,66.22613844342753 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_97,O-acetylserine,0.01775550970398905,0.9294433854250753,255.99,108.87499816869331 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_97,O-acetylserine,0.027608825363847192,1.4452325245283562,347.62,169.29453792325162 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_97,O-acetylserine,0.028659657690850642,1.500240190982717,124.07,175.73813597171545 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_97,O-acetylserine,0.014154637631413306,0.7409494032520096,204.76,86.7948130969404 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_97,O-acetylserine,0.020101229709925374,1.0522342249968035,299.13,123.25871711612555 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_97,O-acetylserine,0.019532490336525175,1.0224625621467724,338.29,119.77126452987291 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_97,O-acetylserine,0.024747792349692085,1.295466719163061,432.48,151.75097148276097 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_97,O-acetylserine,0.0229952194105713,1.203725206083612,554.21,141.0043706406343 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_97,O-acetylserine,0.0162241170088513,0.8492799412484047,409.3,99.48465231783811 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_97,O-acetylserine,0.02665684833629376,1.5024551780949924,254.14,159.4104943958787 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_97,O-acetylserine,0.020562181520077535,1.1589425617021376,369.53,122.96380579659679 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_97,O-acetylserine,0.018929090051514004,1.0668969191606166,348.43,113.19776312294141 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_97,O-acetylserine,0.017422433264909516,0.9819774919992357,235.8,104.1878119011189 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_97,O-acetylserine,0.025048658722644824,1.411813074351029,321.36,149.79336718864417 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_97,O-acetylserine,0.017942198825133038,1.011272945366468,398.11,107.29605950338224 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_97,O-acetylserine,0.01797429895757386,1.0130821993936059,410.52,107.48802135566157 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_97,O-acetylserine,0.014122187951224798,0.795966355274633,355.18,84.45203029463856 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_98,L-serine,0.020062800739678043,1.0877369749886951,72779.96,1966.215110729065 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_98,L-serine,0.01955977030998138,1.0604643720742182,67730.64,1916.9166082487982 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_98,L-serine,0.02133259393695327,1.1565808532281767,138214.43,2090.6586819123168 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_98,L-serine,0.02008437781997636,1.0889068110627964,72677.88,1968.3297298133318 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_98,L-serine,0.01872288369339284,1.0150912196141917,76703.55,1834.899190399005 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_98,L-serine,0.020059244338238406,1.087544158970932,83831.51,1965.8665726390361 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_98,L-serine,0.02021281255234043,1.0958701064211,77240.69,1980.9167217689087 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_98,L-serine,0.01986781715599518,1.077165626738787,78637.69,1947.1061302055662 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_98,L-serine,0.01999323209843079,1.083965199334526,78237.66,1959.3971736210758 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_98,L-serine,0.019936317661705272,1.0808794917087425,3038.21,1953.8193868025571 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_98,L-serine,0.018192943346778366,0.9863596523205549,11099.71,1782.9634347276813 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_98,L-serine,0.019865784933288798,1.0770554465197921,10617.27,1946.9069662381066 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_98,L-serine,0.020787595089531697,1.127032865120302,3612.77,2037.2471476487603 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_98,L-serine,0.020686052024909217,1.1215275447327502,13341.07,2027.2956204098139 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_98,L-serine,0.01974514926205495,1.0705149897906316,13148.18,1935.0843058453415 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_98,L-serine,0.020205331465137,1.0954645072592546,13904.3,1980.1835526119737 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_98,L-serine,0.020908389910506756,1.1335819504083724,14326.71,2049.085405197182 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_98,L-serine,0.01936288635297505,1.0497899920314393,14872.69,1897.6213853958702 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_98,L-serine,0.02010239247351734,1.0898835044468551,15884.67,1970.095220308224 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_98,L-serine,0.03299857335098711,1.7823701004711088,57925.28,10625.118114031387 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_98,L-serine,0.01961502699551364,1.0594772466334923,25219.81,6315.787546948973 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_98,L-serine,0.01894512553477521,1.0232934904091833,24956.23,6100.087853831935 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_98,L-serine,0.02233224032179807,1.2062435852220708,23388.42,7190.695447533364 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_98,L-serine,0.023184894716519716,1.2522984762327358,23286.92,7465.2392454728715 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_98,L-serine,0.0170826568202631,0.922694942875008,37347.35,5500.396774314783 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_98,L-serine,0.016650904081856342,0.8993744446356589,39197.66,5361.377920595428 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_98,L-serine,0.006510431923165876,0.35165154194935394,28899.05,2096.275721414747 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_100,spermidine,0.03354613651275918,1.3034398728146717,97.72,55.19416141433727 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_100,spermidine,0.019482268185779396,0.7569862823563929,54.72,32.05458412638146 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_100,spermidine,0.019371512371372822,0.7526828495426415,70.63,31.872355263883154 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_100,spermidine,0.011114562348155322,0.43185789004227537,27.8,18.28702235384015 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_100,spermidine,0.014197167868172354,0.551632962960749,34.16,23.358897816572917 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_100,spermidine,0.02716588175425808,1.0555341729203545,63.56,44.696594552312405 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_100,spermidine,0.014752021628377692,0.5731918841902539,31.17,24.2718103360363 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_100,spermidine,0.0236146048382199,0.9175488067065759,44.67,38.853604219989954 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_100,spermidine,0.017538757696424698,0.681470907758935,32.44,28.856885589052105 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_100,spermidine,0.02400469927806066,0.9327059812699822,26.91,39.495434776877396 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_100,spermidine,0.015696722061637452,0.6098983529696831,33.75,25.82614575650123 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_100,spermidine,0.014848538841416254,0.5769420741365554,26.27,24.430612129312436 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_100,spermidine,0.01760052718190188,0.6838709698424952,21.56,28.958516217980456 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_100,spermidine,0.015468543534087503,0.6010324440500189,19.44,25.45071884329805 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_100,spermidine,0.014136642748843633,0.5492812508996623,19.47,23.2593145693462 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_100,spermidine,0.042558307468135936,1.6536090483139871,64.74,70.02207515085578 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_100,spermidine,0.029616332135875542,1.1507467686402608,44.73,48.728371918071844 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_100,spermidine,0.022622704241101722,0.8790083688930956,38.92,37.22160938077813 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_100,spermidine,0.0061058006761189184,0.23724174775492163,10.86,10.046001808682156 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_100,spermidine,0.033631419236399944,1.8765155058497984,47.84,67.47949759035875 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_100,spermidine,0.009211740706523107,0.5139828964740637,32.39,18.48282495720733 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_100,spermidine,0.031339955427596655,1.7486598439139183,116.07,62.881807987144505 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_100,spermidine,0.01750534681266261,0.9767370951055956,60.25,35.12346593999722 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_100,spermidine,0.023302448851491242,1.3001951028807048,76.64,46.75501589959015 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_100,spermidine,0.006492237710798706,0.3622441457597158,36.59,13.02629948151938 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_100,spermidine,0.03294989329067905,1.8384887429649293,187.83,66.11205519701886 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_100,spermidine,0.00586761616184133,0.3273924490868072,23.61,11.773032469161587 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_101,spermidine_peak_2,0.021232281670958284,1.0564005511059493,98.99,36.37187097457784 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_101,spermidine_peak_2,0.02001954562826476,0.9960615332037973,56.98,34.29439858820674 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_101,spermidine_peak_2,0.01958696482269873,0.9745387120355539,34.18,33.55336785538412 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_101,spermidine_peak_2,0.01930852034672162,0.9606848595653802,29.29,33.07637971483604 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_101,spermidine_peak_2,0.019931645364636045,0.9916881037072046,36.06,34.143821410639056 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_101,spermidine_peak_2,0.02046995306393486,1.0184713085938313,68.93,35.06596715488561 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_101,spermidine_peak_2,0.0195973406011394,0.9750549532117374,31.17,33.571142039080115 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_101,spermidine_peak_2,0.020253066120276414,1.0076802174450237,49.91,34.694429886632165 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_101,spermidine_peak_2,0.01984067362285973,0.9871618544968328,33.73,33.987982650325954 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_101,spermidine_peak_2,0.02812384816304359,1.3992866691900088,60.47,48.177440020212 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_101,spermidine_peak_2,0.023471814764581485,1.167827294165768,104.43,40.20829373812739 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_101,spermidine_peak_2,0.016829480777597376,0.8373416029327968,44.27,28.829671388976195 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_101,spermidine_peak_2,0.01102920638463999,0.54875212582224,15.16,18.89353569205972 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_101,spermidine_peak_2,0.019671230937465867,0.9787313264450226,27.07,33.69771956950213 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_101,spermidine_peak_2,0.01866599216224099,0.9287162214931534,20.34,31.97569950600927 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_101,spermidine_peak_2,0.02249990804194752,1.11947060724321,19.65,38.543373007383714 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_101,spermidine_peak_2,0.02129963058840795,1.0597514596240638,13.63,36.48724275485652 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_101,spermidine_peak_2,0.019423925292670074,0.9664267694735864,15.45,33.27407367297558 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_101,spermidine_peak_2,0.019324867325507655,0.9614981945458645,17.34,33.104382838214114 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_101,spermidine_peak_2,0.02081125400413715,1.2268169168253205,17.77,39.33175035341978 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_101,spermidine_peak_2,0.019125270131733287,1.1274286946764516,7.12,36.14536395132704 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_101,spermidine_peak_2,0.020398307469371525,1.2024738477102084,19.36,38.55131155758928 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_101,spermidine_peak_2,0.025567631595033533,1.5072038887089245,93.31,48.32095667200812 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_101,spermidine_peak_2,0.015161658507308473,0.8937750286550196,22.35,28.65442741867993 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_101,spermidine_peak_2,0.014894197370268378,0.8780082782492586,40.83,28.148945400671234 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_101,spermidine_peak_2,0.025173313651131686,1.4839589692009316,197.01,47.575724552581875 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_101,spermidine_peak_2,0.018943182140165632,1.1166946645040488,34.62,35.801230943999805 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_102,succinic_acid,0.019297157481817564,0.9746413012695995,813.99,105.02247341830568 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_102,succinic_acid,0.020580484315463797,1.0394582742500857,973.05,112.00682634181798 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_102,succinic_acid,0.02033982380411926,1.027303236692764,1664.97,110.69706026982877 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_102,succinic_acid,0.020001850503202044,1.0102332232407458,952.21,108.85768097030656 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_102,succinic_acid,0.019719003692487316,0.9959474827675852,952.96,107.31832100562113 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_102,succinic_acid,0.01880743040260899,0.9499066615592411,875.46,102.35719231631602 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_102,succinic_acid,0.021377267494245865,1.0797013926953594,1245.9,116.34322356988844 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_102,succinic_acid,0.019631161290599053,0.9915108276299726,943.93,106.84024923126769 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_102,succinic_acid,0.020229447309129105,1.0217284523853785,1035.3,110.09634938678646 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_102,succinic_acid,0.020313017941566508,1.0259493533146196,41.41,110.55117256641682 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_102,succinic_acid,0.019877478875461315,1.0039515869315403,197.09,108.18080324980812 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_102,succinic_acid,0.021501443719252725,1.0859731598010314,207.33,117.01903783436013 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_102,succinic_acid,0.019023804698181275,0.9608350755081125,40.98,103.53478356137666 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_102,succinic_acid,0.020309542916902856,1.0257738402856504,219.93,110.53226015998025 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_102,succinic_acid,0.02018017312666243,1.0192397618430764,218.93,109.8281805374007 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_102,succinic_acid,0.017178196877136544,0.8676189834473371,133.55,93.4902835613678 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_102,succinic_acid,0.020493496389056506,1.0350647760953327,216.75,111.53340494815257 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_102,succinic_acid,0.020527917246574972,1.0368032699327916,249.94,111.72073635160795 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_102,succinic_acid,0.020323709392299803,1.026489346288454,252.25,110.60935950931234 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_102,succinic_acid,0.025427248738443126,1.2944931672289741,435.94,159.27443929585297 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_102,succinic_acid,0.018088012422434695,0.920854974537374,199.73,113.3019960670785 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_102,succinic_acid,0.021515039847746924,1.0953238536365844,302.26,134.76864695144533 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_102,succinic_acid,0.025711734849402364,1.3089762648930758,306.99,161.05643963244407 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_102,succinic_acid,0.015709523318761832,0.799766848774948,66.28,98.4033130732696 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_102,succinic_acid,0.019465857822049612,0.9910006467509299,309.28,121.93271957623442 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_102,succinic_acid,0.019143854858281954,0.9746075780114672,317.44,119.91571639853093 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_102,succinic_acid,0.014437256730413676,0.7349961603512171,303.19,90.43392756961376 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_105,myristic_acid,0.01988609192607295,1.0037036880747359,137.78,50.54149921300333 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_105,myristic_acid,0.01997259211126865,1.0080695813444056,139.3,50.76134376859755 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_105,myristic_acid,0.020051274040997713,1.0120408665696514,294.7,50.9613178361148 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_105,myristic_acid,0.01967977865855894,0.9932905114549969,158.88,50.017143704316375 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_105,myristic_acid,0.020044997260515514,1.011724060847208,183.37,50.945365083961164 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_105,myristic_acid,0.02045227935454251,1.0322806660052946,340.95,51.98049293669661 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_105,myristic_acid,0.020203700092910722,1.0197342128054279,291.36,51.348716285817325 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_105,myristic_acid,0.019932114706805604,1.0060265796176566,338.42,50.658468416647104 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_105,myristic_acid,0.019840750410358658,1.0014151817802606,329.74,50.42626147854502 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_105,myristic_acid,0.028462997047395692,1.4366027883374561,134.32,72.3401334067326 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_105,myristic_acid,0.015263010685194887,0.7703645428576409,58.41,38.79170655559651 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_105,myristic_acid,0.01243606981194212,0.6276813554822046,4.97,31.606894655306416 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_105,myristic_acid,0.013391164115242502,0.6758874926279796,43.98,34.03431469128192 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_105,myristic_acid,0.025443284879575673,1.2841899235557512,135.1,64.66538360064986 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_105,myristic_acid,0.021554731668058023,1.0879243519097759,91.27,54.78243074041677 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_105,myristic_acid,0.017685890219462767,0.8926536851056976,22.41,44.94957631349741 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_105,myristic_acid,0.02548556535358306,1.2863239309742287,124.83,64.7728415442073 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_105,myristic_acid,0.017876360282615827,0.9022672132722803,12,45.433665524325676 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_105,myristic_acid,0.019596349375356287,0.9890796147360623,36.66,49.80510400003442 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_105,myristic_acid,0.021130071336452748,1.0785986681125086,106.04,52.47382520367354 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_105,myristic_acid,0.019493145402193046,0.9950406855398034,27.43,48.40872935151143 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_105,myristic_acid,0.02068148067411154,1.0557000567815464,47.71,51.359807762422236 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_105,myristic_acid,0.021530576332094743,1.0990427143248194,85.91,53.468428051902464 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_105,myristic_acid,0.01772370097984279,0.9047182078322344,33.53,44.0145408110382 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_105,myristic_acid,0.021792755376265995,1.1124258195376386,257.92,54.11951612050612 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_105,myristic_acid,0.019105537974852642,0.975255004354779,176.81,47.44615596185999 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_105,myristic_acid,0.01856025979455018,0.9474209137991823,183.51,46.092027456330214 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_106,threonic_acid,0.020294806106478137,1.0626045461554103,6178.97,195.57767974263405 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_106,threonic_acid,0.020021664133720574,1.0483032564325487,5698.88,192.94545586269277 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_106,threonic_acid,0.019902474258505845,1.0420626595727227,9846.53,191.7968428076575 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_106,threonic_acid,0.019777772366414727,1.0355334620649965,5792.47,190.59511136037295 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_106,threonic_acid,0.019985890332240294,1.0464301957151037,6332.96,192.6007096723434 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_106,threonic_acid,0.020186365453300294,1.0569267618765028,7131.09,194.53265515717973 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_106,threonic_acid,0.019914944713783453,1.0427155932544288,6281.35,191.9170185164439 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_106,threonic_acid,0.019855758050726438,1.0396166714462485,6562.2,191.34664646303926 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_106,threonic_acid,0.020128276526722996,1.053885315846495,6752.63,193.97286180812662 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_106,threonic_acid,0.020676702770489316,1.0826000627033772,319.63,199.2579545408701 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_106,threonic_acid,0.01839111654282412,0.9629303155077145,836.92,177.23213922077238 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_106,threonic_acid,0.01904316267001591,0.9970704386220643,788.09,183.51579958058406 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_106,threonic_acid,0.02007107564153542,1.050890366285236,340.65,193.4216263666291 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_106,threonic_acid,0.02024881921493361,1.0601967438949504,986.01,195.1345116975851 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_106,threonic_acid,0.021630418854218698,1.1325351564902002,1178.54,208.4487582278038 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_106,threonic_acid,0.01999986230396112,1.0471617464671243,947.84,192.73535524600658 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_106,threonic_acid,0.01900731369524895,0.9951934419480127,823.9,183.1703289577415 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_106,threonic_acid,0.019066114078750373,0.9982721387582448,947.96,183.73697849914876 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_106,threonic_acid,0.021063353334576172,1.1028444860803073,1252.58,202.98404188551098 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_106,threonic_acid,0.020685071909846805,1.0343553710163418,631.79,356.666419033855 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_106,threonic_acid,0.020733829107664713,1.0367934708043658,1023.15,357.5071246027614 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_106,threonic_acid,0.019115796890824075,0.9558838988550467,841.74,329.60788600319717 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_106,threonic_acid,0.020198392491501314,1.0100190055193898,736.19,348.274753483196 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_106,threonic_acid,0.020127990721934403,1.0064985706474219,694.42,347.060837130644 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_106,threonic_acid,0.020012394324550403,1.0007181820161712,1341.49,345.0676435228162 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_106,threonic_acid,0.019626253391210567,0.9814092354430055,1297.41,338.40953256545714 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_106,threonic_acid,0.019393052652831515,0.9697480511203866,1348.97,334.3885229873317 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_107,L-threonine,0.019952455205112695,1.0330291748734608,16928.98,440.10141937134046 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_107,L-threonine,0.019501464395959022,1.0096793335298175,15801.35,430.15368646370814 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_107,L-threonine,0.021007663664503403,1.0876621066564405,31655.76,463.3766872988433 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_107,L-threonine,0.02012552202668048,1.0419896298171878,17170,443.9188419910165 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_107,L-threonine,0.019133704807315115,0.9906387502781248,18237.39,422.0418267809895 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_107,L-threonine,0.020011926000727213,1.0361082479144064,19811.64,441.4131968589745 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_107,L-threonine,0.020348092054603792,1.0535130904606813,18422.12,448.82818192896406 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_107,L-threonine,0.01963926910950008,1.0168141090779674,18404.55,433.1933148904864 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_107,L-threonine,0.0201662020419683,1.044095818864832,18679.96,444.8161417109843 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_107,L-threonine,0.02302397134788731,1.192055507921833,907.6,507.85140803993846 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_107,L-threonine,0.017442244595942524,0.9030641771981273,2543.77,384.73243141171815 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_107,L-threonine,0.020448297391202807,1.0587011755920928,2599.64,451.03846183749926 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_107,L-threonine,0.017522868503406338,0.9072384428584795,783.1,386.510793810998 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_107,L-threonine,0.02071878178430098,1.0727053804153044,3063.28,457.0046732183321 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_107,L-threonine,0.0194953207621839,1.0093612497218751,2976.35,430.0181732190104 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_107,L-threonine,0.02039140114462207,1.0557553986411121,3177.8,449.78347248307296 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_107,L-threonine,0.021358772647701127,1.1058406124831552,3312.29,471.1212761361986 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_107,L-threonine,0.019533299958043742,1.011327605088076,3396.34,430.85589959567295 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_107,L-threonine,0.019692208624817034,1.0195550280908847,3524.73,434.3610286175596 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_107,L-threonine,0.031578491229207174,1.8373050354080356,10228.81,1655.1913602983911 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_107,L-threonine,0.01966004561876425,1.1438640481435733,5498.12,1030.4842436915824 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_107,L-threonine,0.01925865691845247,1.1205103839394828,5535.17,1009.4453946834012 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_107,L-threonine,0.021809980817177922,1.2689519358825845,5071.55,1143.1734199979028 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_107,L-threonine,0.022267235590606827,1.2955560092560539,4964.24,1167.1404976185938 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_107,L-threonine,0.017604973792415844,1.0242955169154933,8330.35,922.7673452788296 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_107,L-threonine,0.01763296874735926,1.0259243240459615,8877.16,924.2347050465257 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_107,L-threonine,0.008091479736604597,0.47077982149494096,6694.11,424.1161255883624 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_108,trehalose,0.016821335121670403,1.0078452496345054,1682.82,115.23198661696118 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_108,trehalose,0.024648311401743304,1.4767961863952308,2399.32,168.84949197149874 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_108,trehalose,0.015201277948981667,0.9107800099361888,1902.32,104.13403243605416 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_108,trehalose,0.017761060707836795,1.0641486263360185,2196.69,121.66943319212868 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_108,trehalose,0.024638198903891663,1.4761902991188645,2013.09,168.7802178497554 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_108,trehalose,0.019745656198624336,1.183055070049843,3179.3,135.2646014341488 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_108,trehalose,0.022531012383790343,1.3499388506448333,3335.25,154.34525848847701 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_108,trehalose,0.01979639483338479,1.186095060136622,3141.42,135.61217870072068 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_108,trehalose,0.019476618294349306,1.166935744691067,3054.86,133.42159836925316 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_108,trehalose,0.025129617766990135,1.5056335129406102,53.74,172.14660770206467 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_108,trehalose,0.011280915932537439,0.6758926953121098,139.39,77.27819131851008 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_108,trehalose,0.02627243485383573,1.5741050560046723,289.59,179.97530157829422 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_108,trehalose,0.016055018487983713,0.9619316183210155,40.5,109.98245158073331 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_108,trehalose,0.01989039130707955,1.1917268306715074,308.11,136.2560871848268 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_108,trehalose,0.02116269401728077,1.267956466030325,339.02,144.97180254357724 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_108,trehalose,0.023732037559163956,1.4218979138783079,386.7,162.57269798327636 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_108,trehalose,0.01503365589896047,0.9007369850736603,242.82,102.98576318839696 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_108,trehalose,0.01741409623908817,1.0433603542344911,279.81,119.29260610140055 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_108,trehalose,0.022985945634668083,1.3771960399512422,374.61,157.46170922782528 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_108,trehalose,0.010273035852016556,0.6475455037947012,102.53,71.81279637083237 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_108,trehalose,0.02411984653233901,1.5203585774665094,284.27,168.6077662410359 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_108,trehalose,0.014562673754169071,0.9179364355951521,184.25,101.79915070750238 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_108,trehalose,0.02253933414889886,1.4207333350034828,317.97,157.55932685188625 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_108,trehalose,0.02084113532721787,1.3136899033081553,284.83,145.68821027687443 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_108,trehalose,0.01538415773284485,0.9697174538349029,442.67,107.54166563029074 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_108,trehalose,0.020185771621983047,1.2723800289157923,598.4,141.10694520676137 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_108,trehalose,0.031921059503249395,2.0120964100047174,869.34,223.14149186952318 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_109,L-tryptophan_peak_2,0.015250099465418585,0.7467210139235125,873.23,74.42194985268688 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_109,L-tryptophan_peak_2,0.025568044272824806,1.25193910942934,1405.5,124.77451134127517 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_109,L-tryptophan_peak_2,0.014958043143903527,0.7324204781782193,1302.58,72.99668695763224 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_109,L-tryptophan_peak_2,0.01934421438596154,0.9471893224430532,1091.28,94.4016238212869 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_109,L-tryptophan_peak_2,0.025125157621510817,1.2302531676377928,1406.66,122.61318195262062 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_109,L-tryptophan_peak_2,0.018696645680466573,0.9154811252966115,1096.31,91.24142635268679 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_109,L-tryptophan_peak_2,0.021181432544808212,1.0371486967726173,1123.55,103.36742486384291 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_109,L-tryptophan_peak_2,0.017865587488952107,0.8747883667474403,808.11,87.18578257188365 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_109,L-tryptophan_peak_2,0.02220042360498217,1.0870435869244834,972.96,108.34019909082865 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_109,L-tryptophan_peak_2,0.029862496144889023,1.4622169153823583,148.97,145.73184887158274 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_109,L-tryptophan_peak_2,0.025918259901490836,1.2690874152435,327.46,126.48359724024344 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_109,L-tryptophan_peak_2,0.012780806700684842,0.6258121109267042,136.67,62.37156403550998 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_109,L-tryptophan_peak_2,0.00935192716055013,0.4579170481674725,51.67,45.638302605611145 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_109,L-tryptophan_peak_2,0.019773401751855716,0.9682044788195998,184.3,96.49609938155542 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_109,L-tryptophan_peak_2,0.019587171486006184,0.9590857151516153,187.48,95.58727780058575 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_109,L-tryptophan_peak_2,0.018641196458466784,0.9127660545282639,187.51,90.97082882455942 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_109,L-tryptophan_peak_2,0.025441505344968744,1.2457431317097363,257.66,124.15698922185088 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_109,L-tryptophan_peak_2,0.0285554733646775,1.3982185540684646,419.13,139.35345219123354 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_109,L-tryptophan_peak_2,0.010829854605275371,0.53028375518687,167.79,52.8507304606994 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_109,L-tryptophan_peak_2,0.021280907591403272,1.0288054620448412,105.37,108.40523153566492 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_109,L-tryptophan_peak_2,0.020215630246468375,0.977305630735749,196.16,102.97869431062588 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_109,L-tryptophan_peak_2,0.018558122478925024,0.8971749766597353,197.46,94.53532729063632 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_109,L-tryptophan_peak_2,0.02495592789372428,1.2064708620713362,325.25,127.12583473645671 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_109,L-tryptophan_peak_2,0.01775008425524966,0.8581111287252587,223.7,90.41916963378051 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_109,L-tryptophan_peak_2,0.01722199260137801,0.8325810344080913,393.57,87.72906359558058 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_109,L-tryptophan_peak_2,0.018887350388906633,0.9130911903170661,436.18,96.21241872370926 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_109,L-tryptophan_peak_2,0.021154499241580024,1.022694369264251,305.24,107.76130568937413 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_110,L-tryptophan,0.02119965516478197,1.1206785901224579,16127.72,485.9094264982459 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_110,L-tryptophan,0.020467282802801804,1.0819631478339404,15041.86,469.1229914535791 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_110,L-tryptophan,0.016205884628682596,0.8566926110916299,17048.92,371.44906578016435 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_110,L-tryptophan,0.019341220071547024,1.0224360289141725,15863.2,443.31292559675154 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_110,L-tryptophan,0.023150710217352863,1.2238173255674942,15780.37,530.628835106182 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_110,L-tryptophan,0.019970284024539535,1.055690272837331,19087.91,457.73146694817416 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_110,L-tryptophan,0.019697605624949332,1.0412756589186456,17218.52,451.481506572241 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_110,L-tryptophan,0.019798192400243775,1.046592983405565,17656.81,453.78701870990193 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_110,L-tryptophan,0.020439025423558497,1.0804693763699804,17973.84,468.475314553378 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_110,L-tryptophan,0.017782043774609853,0.9400132026643062,511.81,407.57562447720323 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_110,L-tryptophan,0.017361563816230264,0.9177853464435876,2084.48,397.93795943774296 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_110,L-tryptophan,0.019543222667186447,1.0331145037441942,2061.68,447.9429521059265 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_110,L-tryptophan,0.023496022124989566,1.2420715687990387,773.3,538.5436011577312 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_110,L-tryptophan,0.020640925101797457,1.0911424106715428,2729.72,473.10298213102095 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_110,L-tryptophan,0.020523303182185298,1.0849245563709016,2811.5,470.40701377407737 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_110,L-tryptophan,0.02059201168938849,1.0885566981384627,2989.68,471.9818559623654 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_110,L-tryptophan,0.020060946961530823,1.060482992889332,2903.81,459.8095184719211 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_110,L-tryptophan,0.019859299341921422,1.049823283177599,3248.6,455.18762823655936 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_110,L-tryptophan,0.01976202289512952,1.0446809527766796,3325.84,452.95799090967665 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_110,L-tryptophan,0.018880771024367093,0.967902196391167,3301.85,1589.5277030014302 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_110,L-tryptophan,0.02062137088485088,1.0571321555822477,4185.42,1736.0647111833905 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_110,L-tryptophan,0.018646899222791294,0.9559130127859512,3955.98,1569.8385861176005 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_110,L-tryptophan,0.02099105775479348,1.0760837509875745,4115.14,1767.1877792218343 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_110,L-tryptophan,0.021411214623152847,1.0976226359827381,4041.44,1802.5597977162918 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_110,L-tryptophan,0.01897361661899584,0.972661824843333,7546.79,1597.3441552307152 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_110,L-tryptophan,0.0176270911592071,0.9036336613036061,7288.95,1483.9833439392341 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_110,L-tryptophan,0.022375810388113218,1.1470715890117134,10385.14,1883.7668463385962 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_111,tyramine,0.02081687145929328,1.129875101350987,8999.17,262.10842601140195 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_111,tyramine,0.020531130360480255,1.1143659623522264,8611.94,258.5106159464695 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_111,tyramine,0.015577016364561325,0.8454720479045615,8414.79,196.1326056729002 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_111,tyramine,0.019528403601785725,1.0599410695280196,9540.19,245.88512930911 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_111,tyramine,0.02384125302867149,1.2940291356835443,8435.41,300.18887889586864 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_111,tyramine,0.019567850028065346,1.0620820989799127,11203.64,246.38180532136016 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_111,tyramine,0.02012787659718501,1.0924786010566376,10528.99,253.43318587311882 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_111,tyramine,0.019559660389955137,1.0616375908698494,10114.58,246.2786883299877 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_111,tyramine,0.020624172444463386,1.1194159975737015,10474.63,259.6821231171473 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_111,tyramine,0.021102074910697093,1.1453550585189347,446.76,265.6994664752225 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_111,tyramine,0.016300013226403315,0.8847140710946254,1301.71,205.2359702125312 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_111,tyramine,0.018743492080381004,1.017338510995969,1306.19,236.0021877808449 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_111,tyramine,0.020421936177206387,1.1084392413684918,490.87,257.1357352126627 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_111,tyramine,0.022034331009006647,1.1959550228614317,1807.11,277.43764620339493 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_111,tyramine,0.020284919407845128,1.101002396861306,1721.73,255.4105360238858 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_111,tyramine,0.019278853732048254,1.0463962779913512,1619.57,242.74300856843365 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_111,tyramine,0.021556560820488447,1.1700231415395874,1793.58,271.4219683743535 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_111,tyramine,0.019635947680235993,1.0657782279490775,1673.6,247.23923331962703 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_111,tyramine,0.019648471174943616,1.0664579643292398,1708.46,247.39691856509705 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_111,tyramine,0.016538074638075488,0.9171678256495659,1515.19,218.25842746982718 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_111,tyramine,0.014352850584628958,0.7959797649159186,1621.36,189.41930465704115 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_111,tyramine,0.027159653776668596,1.5062189006205196,3142.49,358.43491178066506 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_111,tyramine,0.0183814748034493,1.0193990320310782,1726.51,242.58638765243566 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_111,tyramine,0.017681880616509365,0.9806009679689218,1600.98,233.35361234756434 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_111,tyramine,0.021569854771573926,1.196220069951475,4887.66,284.66449004635246 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_111,tyramine,0.022496773332379684,1.2476250792753034,5314.71,296.89734011514395 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_111,tyramine,0.022226904229898294,1.2326586903001924,5489.89,293.33578853073675 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_112,L-tyrosine,0.02003698902616431,1.062067845645584,60981.48,1141.797278818198 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_112,L-tyrosine,0.019588772212875607,1.0383099514505005,57822.11,1116.2558795058897 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_112,L-tyrosine,0.01683653597832037,0.8924266750497968,67708.33,959.421145545785 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_112,L-tyrosine,0.01942178708221974,1.029458844243777,70144.89,1106.7403196811574 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_112,L-tyrosine,0.02355319057720894,1.2484453797799389,61536.97,1342.1661744400187 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_112,L-tyrosine,0.020785541038048607,1.1017451155975462,92278.81,1184.453121425454 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_112,L-tyrosine,0.020451996123294288,1.0840654468321154,83083.56,1165.4462399258023 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_112,L-tyrosine,0.019580447726598223,1.0378687090465055,79224.98,1115.7815130346266 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_112,L-tyrosine,0.019945408349388908,1.057213578771524,79232.97,1136.5786021299023 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_112,L-tyrosine,0.020649545147851656,1.094536604282322,2599.41,1176.7034671657957 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_112,L-tyrosine,0.01817422790143102,0.963331518939288,9989.49,1035.6488160660604 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_112,L-tyrosine,0.018656972497528124,0.9889195707421015,9027.82,1063.157762917711 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_112,L-tyrosine,0.020485375013046755,1.0858347069481513,2961.44,1167.348318398749 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_112,L-tyrosine,0.020914161003352593,1.1085626633478114,12805.14,1191.7824624853315 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_112,L-tyrosine,0.020313963774860465,1.0767489923119735,12873.11,1157.5805391648332 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_112,L-tyrosine,0.020410530773973846,1.0818675610038506,13167.71,1163.0833588084097 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_112,L-tyrosine,0.020316895935654732,1.076904412554695,13003.89,1157.7476268051757 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_112,L-tyrosine,0.019063753449808395,1.0104811421475568,12614.45,1086.337961488574 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_112,L-tyrosine,0.02042502615340312,1.0826358938298135,13781.33,1163.9093703796175 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_112,L-tyrosine,0.016507794194984233,0.8636111199880213,13521.27,2616.3789768933098 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_112,L-tyrosine,0.02065019728296186,1.0803224096972892,17125.87,3272.9231659707134 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_112,L-tyrosine,0.020136936195015682,1.0534709734743837,17561.29,3191.574591818523 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_112,L-tyrosine,0.018859500300996326,0.9866414606929511,17043.3,2989.1092364861506 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_112,L-tyrosine,0.01867497426686994,0.97698791563923,16454.44,2959.8630494622985 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_112,L-tyrosine,0.021394227897122867,1.1192466356969202,48593,3390.8472225746755 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_112,L-tyrosine,0.02127325903497523,1.1129181066827445,50189.26,3371.674437643909 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_112,L-tyrosine,0.02259585293618452,1.182110076658947,50652.97,3581.2970460444126 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_113,unannotated_peak_5,0.01256700802753686,0.6364421867386127,81.15,NA -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_113,unannotated_peak_5,0.026931343080546975,1.3639080077321015,165.75,NA -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_113,unannotated_peak_5,0.01589916680825788,0.8051956733533595,203.96,NA -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_113,unannotated_peak_5,0.011032842426976403,0.558746071044221,83.16,NA -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_113,unannotated_peak_5,0.02580556775703694,1.3068943647789724,206.99,NA -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_113,unannotated_peak_5,0.02598359381991985,1.315910297331048,264.77,NA -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_113,unannotated_peak_5,0.027566731874547844,1.3960865686590165,255.98,NA -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_113,unannotated_peak_5,0.021257634152013188,1.0765693102886027,172.6,NA -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_113,unannotated_peak_5,0.013037974762798997,0.6602937748186539,102.06,NA -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_113,unannotated_peak_5,0.02796097577539967,1.4160526138637854,76.2,NA -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_113,unannotated_peak_5,0.009035873747618552,0.45761180659924644,42.5,NA -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_113,unannotated_peak_5,0.013249102539147638,0.6709861069446585,50.53,NA -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_113,unannotated_peak_5,0.013708948448133734,0.6942744931091797,40.65,NA -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_113,unannotated_peak_5,0.009807955844652858,0.49671304828712654,20.47,NA -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_113,unannotated_peak_5,0.05247224292107569,2.657398559354199,116.08,NA -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_113,unannotated_peak_5,0.015993104788487894,0.8099530581998078,39.13,NA -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_113,unannotated_peak_5,0.021722626619908775,1.1001183382223785,54.63,NA -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_113,unannotated_peak_5,0.027919436550265644,1.413948905867276,143.57,NA -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_113,unannotated_peak_5,0.011894237271628699,0.6023704578015618,66.25,NA -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_113,unannotated_peak_5,0.034599394619723,1.643027858892103,74.5,NA -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_113,unannotated_peak_5,0.015467758059446805,0.7345202910511911,88.39,NA -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_113,unannotated_peak_5,0.024533739199656776,1.1650382161557036,139.89,NA -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_113,unannotated_peak_5,4.536470910198104e-4,0.02154242341066941,1.27,NA -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_113,unannotated_peak_5,0.04726901739220323,2.244672581455329,120.49,NA -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_113,unannotated_peak_5,0.0029982194835071617,0.1423770037776111,6.68,NA -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_113,unannotated_peak_5,0.010877138536276436,0.5165246917338733,25.11,NA -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_113,unannotated_peak_5,0.006880007504411695,0.3267121902962835,36.11,NA -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_114,unannotated_peak_2,0.019009477213967386,1.438673028487677,3832.28,NA -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_114,unannotated_peak_2,0.018256107008359633,1.3816565528069191,3502.31,NA -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_114,unannotated_peak_2,0.02284249117003155,1.7287627418625702,8759.88,NA -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_114,unannotated_peak_2,0.021607685941731535,1.6353103571707115,4341.91,NA -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_114,unannotated_peak_2,0.01784077193836228,1.350223212675335,4302.18,NA -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_114,unannotated_peak_2,0.020131166702645916,1.523564601019415,4632.69,NA -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_114,unannotated_peak_2,0.019704758675365742,1.4912932386314015,4139.92,NA -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_114,unannotated_peak_2,0.019335419785084563,1.4633409759869203,4091.82,NA -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_114,unannotated_peak_2,0.020476862472533726,1.5497275077949073,4273.27,NA -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_114,unannotated_peak_2,0.026096607731415578,1.9750404104024712,75.72,NA -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_114,unannotated_peak_2,0.016266270358112362,1.231061968453826,381.5,NA -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_114,unannotated_peak_2,0.021139970069043213,1.5999127392636892,446.74,NA -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_114,unannotated_peak_2,0.015086482888307981,1.1417734313178254,53.97,NA -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_114,unannotated_peak_2,0.015547777099478941,1.1766850457898708,479.89,NA -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_114,unannotated_peak_2,0.028727302335901383,2.174136331403441,909.84,NA -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_114,unannotated_peak_2,0.01624782784927036,1.2296662046592728,499.62,NA -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_114,unannotated_peak_2,0.017176392434106177,1.299941720833415,521.73,NA -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_114,unannotated_peak_2,0.018603548516306998,1.407951580325808,525.3,NA -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_114,unannotated_peak_2,0.023816691236455224,1.8024920372103053,677.09,NA -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_114,unannotated_peak_2,0.02159437598713123,2.172802054845551,261.31,NA -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_114,unannotated_peak_2,0.016101562911527728,1.6201213223869648,186.91,NA -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_114,unannotated_peak_2,0.022913677524294834,2.3055487057614314,299.07,NA -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_114,unannotated_peak_2,0.026388030533661025,2.655134234998693,504.78,NA -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_114,unannotated_peak_2,0.014956225098373205,1.5048787075784846,279.56,NA -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_114,unannotated_peak_2,0.019377645382070246,1.9497570908889246,785.07,NA -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_114,unannotated_peak_2,0.019223858668000162,1.9342832430436083,799.56,NA -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_114,unannotated_peak_2,0.0191182652773776,1.9236585537143338,646.24,NA -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_115,unannotated,0.01919585009082642,0.9190221851124698,26111.13,NA -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_115,unannotated,0.020033510458470835,0.9591260855811748,25915.36,NA -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_115,unannotated,0.021780829155857075,1.0427808672012497,55909.81,NA -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_115,unannotated,0.020666532569233502,0.9894327071011895,26743.55,NA -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_115,unannotated,0.018353257633122632,0.878682155471986,29668.94,NA -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_115,unannotated,0.019054774608687573,0.912268043084501,27561.52,NA -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_115,unannotated,0.020572264885121146,0.9849195392743667,27159.14,NA -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_115,unannotated,0.020549206053443528,0.9838155726475054,27690.33,NA -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_115,unannotated,0.019512886213701553,0.9342006340493851,25987.17,NA -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_115,unannotated,0.020812754441576698,0.9964332381532787,1383.63,NA -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_115,unannotated,0.016803319597332122,0.8044771875387425,4088.56,NA -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_115,unannotated,0.02013095433764481,0.9637913171984555,4266.58,NA -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_115,unannotated,0.0201619980929607,0.9652775707224991,1518.37,NA -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_115,unannotated,0.02032515543771965,0.9730889059219325,4963.2,NA -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_115,unannotated,0.02069941404330534,0.9910069434079036,5218.52,NA -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_115,unannotated,0.02065570553498376,0.9889143510696823,5289.68,NA -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_115,unannotated,0.020513543412197594,0.9821081849397642,5227.16,NA -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_115,unannotated,0.01928708604909431,0.9233902057696147,5519.97,NA -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_115,unannotated,0.02008008814458355,0.9613560429243636,5918.45,NA -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_115,unannotated,0.03335209107054249,1.5749767559913133,14680.08,NA -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_115,unannotated,0.019186261872046254,0.9060276436317526,4433.51,NA -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_115,unannotated,0.01926298544321849,0.9096507400360331,4538.37,NA -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_115,unannotated,0.022055942218338648,1.0415417807506553,4215.25,NA -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_115,unannotated,0.02379844144897457,1.1238273495858955,4398.09,NA -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_115,unannotated,0.017534050773984376,0.8280057268069729,8380.16,NA -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_115,unannotated,0.01718542196121934,0.8115425228833442,8991,NA -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_115,unannotated,0.0057152060545156876,0.2698876263117801,6328.77,NA -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_116,unannotated_peak_3,0.023130989655892553,1.2349098733641521,8951.79,NA -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_116,unannotated_peak_3,0.01870413293040923,0.9985702631877579,6879.64,NA -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_116,unannotated_peak_3,0.021009788561415263,1.1216638681594615,11187.33,NA -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_116,unannotated_peak_3,0.01954095039913252,1.0432460064094375,8373.26,NA -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_116,unannotated_peak_3,0.01801676146031866,0.9618730951153387,6105.93,NA -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_116,unannotated_peak_3,0.020270458076705657,1.0821927288424973,10741.97,NA -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_116,unannotated_peak_3,0.01915655359352901,1.0227239527666319,9292.65,NA -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_116,unannotated_peak_3,0.021052103859428465,1.123922983748039,11364.05,NA -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_116,unannotated_peak_3,0.019307167685440472,1.0307648897060444,10287.25,NA -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_116,unannotated_peak_3,0.017325739958179882,0.9249810603000139,60.83,NA -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_116,unannotated_peak_3,0.01572927144024294,0.8397493099666193,365.91,NA -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_116,unannotated_peak_3,0.020493769219807972,1.0941147926863601,455.94,NA -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_116,unannotated_peak_3,0.024212190923108546,1.2926327006120009,107.84,NA -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_116,unannotated_peak_3,0.01787454809461527,0.9542806534583202,755.23,NA -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_116,unannotated_peak_3,0.026006331353799643,1.3884176957645031,1203.29,NA -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_116,unannotated_peak_3,0.017037408369852257,0.90958770573432,1171.66,NA -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_116,unannotated_peak_3,0.019469788009440686,1.0394468115219744,1388.03,NA -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_116,unannotated_peak_3,0.0206739083242103,1.103732001544034,2394.3,NA -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_116,unannotated_peak_3,0.020064140673114066,1.0711779213252923,2450.22,NA -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_116,unannotated_peak_3,0.0219479565936229,1.3043968139069173,2159.52,NA -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_116,unannotated_peak_3,0.02141146349726821,1.2725123018985676,2773.6,NA -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_116,unannotated_peak_3,0.01813213399549267,1.0776173040148083,2410.48,NA -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_116,unannotated_peak_3,0.01650853706983752,0.9811247377087046,1810.7,NA -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_116,unannotated_peak_3,0.025353448515693797,1.5067898154597683,2710.26,NA -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_116,unannotated_peak_3,0.01993541954028625,1.1847890085495525,4329.82,NA -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_116,unannotated_peak_3,0.01719702475202092,1.0220424940029338,3853.55,NA -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_116,unannotated_peak_3,0.01883696353066929,1.1195062787861092,4867.3,NA -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_117,unannotated_peak_4,0.019379010469507862,1.0150750730952414,12108.94,NA -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_117,unannotated_peak_4,0.020738585201001202,1.086289773253463,12436.13,NA -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_117,unannotated_peak_4,0.02025157736770208,1.0607802400003643,20434.2,NA -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_117,unannotated_peak_4,0.020137762983053153,1.054818627822148,13119.29,NA -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_117,unannotated_peak_4,0.019687164294109643,1.0312162102562128,12670.17,NA -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_117,unannotated_peak_4,0.019908959055933387,1.0428338485471167,15144.7,NA -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_117,unannotated_peak_4,0.019662558381363313,1.02992734936629,13688.18,NA -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_117,unannotated_peak_4,0.02004153402704657,1.0497781426691029,14523.53,NA -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_117,unannotated_peak_4,0.020121366183533444,1.0539597613440486,14414.93,NA -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_117,unannotated_peak_4,0.019707134452199782,1.0322622497180816,321.85,NA -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_117,unannotated_peak_4,0.018705552642847276,0.979799265091541,1611.59,NA -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_117,unannotated_peak_4,0.019333540426246555,1.0126933463522922,1480.18,NA -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_117,unannotated_peak_4,0.021100786719718906,1.1052619356177946,402.68,NA -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_117,unannotated_peak_4,0.02086971594411703,1.0931584185262841,2165.06,NA -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_117,unannotated_peak_4,0.020338635616563173,1.0653403623278312,2181.66,NA -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_117,unannotated_peak_4,0.01993827652579788,1.0443695014078491,2219.3,NA -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_117,unannotated_peak_4,0.01948193188444392,1.0204661101120005,2153.93,NA -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_117,unannotated_peak_4,0.02084780727459872,1.0920108395852588,2395.06,NA -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_117,unannotated_peak_4,0.019308503690170262,1.0113819188806628,2260.9,NA -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_117,unannotated_peak_4,0.020218493578258435,1.000510968518077,1571.88,NA -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_117,unannotated_peak_4,0.02063495856438066,1.0211197139226844,2175.87,NA -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_117,unannotated_peak_4,0.019005365169739837,0.9404793803957594,2069.55,NA -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_117,unannotated_peak_4,0.019725781798740197,0.9761291550156035,1784,NA -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_117,unannotated_peak_4,0.021602980985775032,1.0690222466523223,1872.98,NA -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_117,unannotated_peak_4,0.018347293919598554,0.9079147631910057,3316.67,NA -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_117,unannotated_peak_4,0.019875518584678963,0.9835388710828519,3729.42,NA -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_117,unannotated_peak_4,0.020328957663622388,1.0059772773014772,4202.11,NA -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_118,dehydroascorbic_acid_peak_2,0.01893096260693843,0.9635104916791223,10745.37,271.8785729895563 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_118,dehydroascorbic_acid_peak_2,0.02130427679274508,1.0843027179147546,11647.88,305.9631194275958 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_118,dehydroascorbic_acid_peak_2,0.015825537965970155,0.8054567632546016,13544.02,227.27976217136717 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_118,dehydroascorbic_acid_peak_2,0.019032374399925805,0.9686719474672985,11768.01,273.3350067765849 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_118,dehydroascorbic_acid_peak_2,0.02442283930677889,1.2430251116786888,13413.56,350.75061088793393 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_118,dehydroascorbic_acid_peak_2,0.01972205809257969,1.0037740966611521,14567.12,283.2399557253606 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_118,dehydroascorbic_acid_peak_2,0.021685648348712738,1.103713009035828,14645.88,311.44021832468474 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_118,dehydroascorbic_acid_peak_2,0.019437636007176566,0.9892981469146387,13191.04,279.1552046056381 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_118,dehydroascorbic_acid_peak_2,0.02002942212753039,1.0194177001370412,13373.59,287.65418953616955 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_118,dehydroascorbic_acid_peak_2,0.016750074387184115,0.8525119796360776,199.09,240.55756785381016 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_118,dehydroascorbic_acid_peak_2,0.018510951159478956,0.9421335841940156,1425.62,265.8465441199463 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_118,dehydroascorbic_acid_peak_2,0.021891779381878848,1.1142042564826649,1507.11,314.4005860729959 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_118,dehydroascorbic_acid_peak_2,0.023018745362756558,1.1715623300728133,327.94,330.58560048829605 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_118,dehydroascorbic_acid_peak_2,0.021280317940775076,1.083083307907932,1983.7,305.6190324089207 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_118,dehydroascorbic_acid_peak_2,0.019177850235831285,0.9760760872932018,1833.75,275.4242699319592 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_118,dehydroascorbic_acid_peak_2,0.017780508832030428,0.904956983052496,1631.42,255.356236692838 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_118,dehydroascorbic_acid_peak_2,0.02085239517414055,1.0613037458306391,1885.9,299.47338447976057 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_118,dehydroascorbic_acid_peak_2,0.01984760105974493,1.0101637329692341,1612.58,285.04295135059357 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_118,dehydroascorbic_acid_peak_2,0.020749145738978524,1.0560487613850995,1690.71,297.9905592438404 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_118,dehydroascorbic_acid_peak_2,0.011736639037323384,0.5425466263708948,1156.53,439.78286986998364 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_118,dehydroascorbic_acid_peak_2,0.021618712496367348,0.9993627216519833,1164.27,810.0734285438812 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_118,dehydroascorbic_acid_peak_2,0.022104201698918184,1.0218053074847602,1307.03,828.2651641940718 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_118,dehydroascorbic_acid_peak_2,0.017261921492176927,0.7979624524940381,1580.58,646.8203843671423 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_118,dehydroascorbic_acid_peak_2,0.015265329156926683,0.7056664866486876,1396.01,572.0061974125597 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_118,dehydroascorbic_acid_peak_2,0.023155650411373734,1.0704103595725576,7042.75,867.6639333659195 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_118,dehydroascorbic_acid_peak_2,0.02308745844077782,1.0672580666993814,7319.64,865.1087162858516 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_118,dehydroascorbic_acid_peak_2,0.025751132797921225,1.1903910634306498,7110.36,964.9190921062504 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_119,sinapic_acid,0.01989585796329562,1.0197178717083746,1.63,31.861084901528162 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_119,sinapic_acid,0.02008783121084144,1.0295570327927324,55.71,32.16850948960892 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_119,sinapic_acid,0.02008320706944863,1.029320032728284,157,32.16110442259524 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_119,sinapic_acid,0.020013913288873923,1.0257685343922673,25.09,32.05013785708639 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_119,sinapic_acid,0.019920309911924342,1.020971101856117,44.01,31.900242077494372 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_119,sinapic_acid,0.020044632817371042,1.0273429953819246,45.96,32.099331890708235 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_119,sinapic_acid,0.019932883807092502,1.021615548838178,5.91,31.920377823448867 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_119,sinapic_acid,0.019963051120470147,1.023161707272228,45.92,31.968687543720765 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_119,sinapic_acid,0.02004347235171504,1.0272835183002569,76.34,32.09747352929153 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_119,sinapic_acid,0.01896405811798255,0.9719605466976241,2.82,30.368907281567264 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_119,sinapic_acid,0.01862874416993775,0.9547747773739202,17.09,29.831937919048137 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_119,sinapic_acid,0.023882783257082495,1.224058844726017,195.86,38.2457186034644 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_119,sinapic_acid,0.020288850331055625,1.0398598199263989,16.68,32.49042007360033 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_119,sinapic_acid,0.018762389423250397,0.9616244670692986,6.29,30.045956473580233 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_119,sinapic_acid,0.019442612356983923,0.9964877779932917,31.47,31.135260623400395 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_119,sinapic_acid,0.020567786514083065,1.0541560725144468,58.37,32.93710648571388 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_119,sinapic_acid,0.019980076290654424,1.024034294437748,31.96,31.995951529707437 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_119,sinapic_acid,0.020170221621182066,1.0337797697079594,31.7,32.30044890452519 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_119,sinapic_acid,0.019823219715239333,1.0159949601431015,15.41,31.744762529671206 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_119,sinapic_acid,0.019983288282898966,0.9876821536190787,1.68,23.931538582190278 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_119,sinapic_acid,0.02067692769278785,1.0219655636612788,79.84,24.762225607512786 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_119,sinapic_acid,0.019342103017719305,0.955991311020195,19.39,23.163669466019325 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_119,sinapic_acid,0.019318946094422543,0.9548467706648166,15.43,23.135937253208507 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_119,sinapic_acid,0.02052653260167999,1.0145322250947595,64.54,24.582115814046023 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_119,sinapic_acid,0.0198055601515564,0.9788978684184623,67.11,23.718695351779342 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_119,sinapic_acid,0.02042784247267098,1.0096544253162325,126.71,24.463926725412314 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_119,sinapic_acid,0.019910512612173376,0.9840851864845538,6.45,23.84438406852074 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_120,uracil,0.026364749500801584,1.281450107249777,559.19,89.34270147745445 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_120,uracil,0.01570554334641183,0.7633628457218439,330.05,53.22165760372695 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_120,uracil,0.025630239755831744,1.2457494990782867,429.91,86.85365507573815 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_120,uracil,0.01992637021865102,0.9685147682898624,627.03,67.5248496451692 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_120,uracil,0.012597227530969817,0.6122841626134289,145.88,42.688451817408264 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_120,uracil,0.018717969676636782,0.9097808514696872,844.63,63.429920964466596 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_120,uracil,0.02085570423083996,1.0136847468460468,873.7,70.67410055010639 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_120,uracil,0.018113316428217327,0.8803918762392388,933.8,61.38092161139973 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_120,uracil,0.021899155510592308,1.0644013582179057,1128.99,74.21006269495238 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_120,uracil,0.018026350312783844,0.8761649163758065,46.78,61.086217969721226 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_120,uracil,0.018278857135122357,0.8884379286628055,124.92,61.941892386370796 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_120,uracil,0.0074179682155111485,0.3605479416769421,43.39,25.1374024937164 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_120,uracil,0.025500562914461667,1.2394465982190754,73.14,86.41421682783394 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_120,uracil,0.009306766583868184,0.4523523743961203,64.8,31.538007542897507 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_120,uracil,0.034786124570983984,1.6907683139919927,260.36,117.88036685152173 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_120,uracil,0.020534202659135005,0.9980582671205421,199.99,69.5846223836442 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_120,uracil,0.024532181725346693,1.192378744279772,241.53,83.1326460511857 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_120,uracil,0.018062608522906566,0.8779272349310818,243.45,61.209086819395026 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_120,uracil,0.019727614392721225,0.9588543057678683,277.82,66.85132219813578 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_120,uracil,0.02572318591683944,1.080652123462916,590.64,221.177070109155 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_120,uracil,0.01760040653695426,0.7394075041660763,214.14,151.33453387767082 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_120,uracil,0.021031798056279367,0.8835630743112121,259.73,180.83885441927575 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_120,uracil,0.022141613880433855,0.9301873467050981,212.43,190.3814442501324 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_120,uracil,0.024217608090228205,1.0174015649735413,224.4,208.23157830313468 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_120,uracil,0.018053298502767098,0.7584338668467014,455.53,155.22865952751437 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_120,uracil,0.015580200453812141,0.6545369908230513,430.93,133.9640859117539 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_120,uracil,0.014653585798733416,0.615609149696375,847.72,125.99672466835707 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_121,urea,0.01867683379483975,1.0135608612617018,454.05,64.98445461979401 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_121,urea,0.017937425598628806,0.973434402119436,409.75,62.411746691887636 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_121,urea,0.02193201598389409,1.1902142115749248,1264.03,76.3105841751263 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_121,urea,0.021094598915464967,1.144768973134843,475.77,73.39686271254045 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_121,urea,0.018867212015102625,1.023892372213436,672.42,65.64685944446445 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_121,urea,0.020470756955002282,1.1109141023530273,592.38,71.22625767236434 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_121,urea,0.020948357476752073,1.1368326922747036,560.08,72.88802806519261 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_121,urea,0.02139316264224723,1.1609715324863399,703.64,74.43568980536168 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_121,urea,0.018086882769831607,0.9815451954600023,597.39,62.931770206918046 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_121,urea,0.026103694850244927,1.416604319830534,103.52,90.82558596593468 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_121,urea,0.0024642112717324343,0.13372866762877084,21.19,8.574013525018641 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_121,urea,0.018808690090307265,1.0207164842042669,134.66,65.44323738475657 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_121,urea,0.016544722573580944,0.8978547137710128,72.09,57.56595497342848 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_121,urea,0.032518664814693066,1.7647341234983507,172.98,113.14592832809674 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_121,urea,0.03247951419530029,1.7626094841752962,177.42,113.00970707789911 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_121,urea,0.007660434941008622,0.41571912679295503,35.87,26.65383181433031 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_121,urea,0.012981505840252663,0.7044848385145248,60.94,45.168045421358755 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_121,urea,0.024195750638364464,1.3130633449589186,176.06,84.18705636204106 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_121,urea,0.019055353117558495,1.0341024784840496,148.22,66.301480408004835 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_121,urea,0.03434129063602438,3.392590416498604,231.37,193.14017241126552 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_121,urea,0.013538177682292764,1.3374422163860429,79.97,76.14058537885742 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_121,urea,0.025179336397152478,2.487477138240231,157.74,141.61207348001633 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_121,urea,0.01240799919359903,1.225791412392873,77.95,69.78430510752627 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_121,urea,0.0337840182137592,3.3375372416137736,203.75,190.00599516507214 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_121,urea,0.01742947686457397,1.7218652846235387,189.01,98.02579065361806 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_121,urea,0.01186988813746684,1.1726311968554015,135.27,66.757894036978 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_121,urea,0.006638014444303309,0.6557722138928268,114.54,37.33311213691863 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_122,L-valine,0.019239440829416175,0.9912482834071548,22336.65,294.36109024058874 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_122,L-valine,0.01986672815641426,1.023567179346127,21949.32,303.9585095786259 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_122,L-valine,0.022590536603508782,1.1639023622369016,49507.14,345.63244548987035 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_122,L-valine,0.02035083608602287,1.0485092324163299,23079.63,311.36530165835336 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_122,L-valine,0.01756012519329334,0.9047271232359905,24222.87,268.66776651615976 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_122,L-valine,0.01957998992849248,1.0087939445762213,25514.36,299.5714497813547 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_122,L-valine,0.020755935866600964,1.0693806530395682,24727.18,317.5632787266302 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_122,L-valine,0.019614314087955033,1.0105623828821115,24291.16,300.0966052206719 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_122,L-valine,0.020148016239521623,1.038059613507558,24687.93,308.26218282720447 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_122,L-valine,0.020795849730072296,1.0714370822778656,1231.09,318.173955953235 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_122,L-valine,0.017123443564666826,0.8822285527936702,3479.51,261.9865910376083 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_122,L-valine,0.02060838032987917,1.0617783441273951,3630.48,315.3056970720713 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_122,L-valine,0.01994256714043775,1.0274745310927373,1331.78,305.1188367532993 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_122,L-valine,0.019997874640012264,1.0303240663000681,3851.33,305.96503472846825 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_122,L-valine,0.019990502325761685,1.0299442322960335,3967.13,305.85223922263015 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_122,L-valine,0.0215523343807997,1.1104124411828342,4281.27,329.7480785336545 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_122,L-valine,0.020886856800578196,1.0761259192984802,4127.62,319.56635299487675 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_122,L-valine,0.019367320639486152,0.9978368658580796,4354.24,296.31763568521535 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_122,L-valine,0.019637066207622657,1.011734610275016,4555.9,300.4447098672688 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_122,L-valine,0.03355990278275165,1.7067855793039675,15782.9,2939.153038984604 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_122,L-valine,0.019053144312057516,0.9690025672223006,7131.45,1668.6611808594905 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_122,L-valine,0.0196265518308675,0.9981648592141699,7559.27,1718.879814161169 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_122,L-valine,0.022617851804703614,1.1502960406352265,7126.88,1980.8557938154854 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_122,L-valine,0.022400453058104307,1.139239600810104,6767.22,1961.8161621790314 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_122,L-valine,0.01725043591548999,0.8773206361133407,10899.53,1510.7812282126172 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_122,L-valine,0.016798786347422413,0.8543506956261233,11349.94,1471.2260718960094 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_122,L-valine,0.005962183471131579,0.3032240240851343,7118.95,522.1638984355646 -1,fruit,NA,1,15,Pooled Sample,21106rA_17,m_123,D-Xylose,0.020345248322772434,1.0072938601859798,1033.79,148.5204432151218 -1,fruit,NA,1,16,Pooled Sample,21106rA_18,m_123,D-Xylose,0.018692742409427067,0.9254782424050617,912.51,136.45713945141432 -1,fruit,NA,1,1,Pooled Sample,21106rA_3,m_123,D-Xylose,0.01941669444519323,0.9613211296054194,1569.86,141.74199395467105 -1,fruit,NA,1,30,Pooled Sample,21106rA_32,m_123,D-Xylose,0.020951721887993543,1.037320384754301,1133.18,152.94770413009792 -1,fruit,NA,1,2,Pooled Sample,21106rA_4,m_123,D-Xylose,0.020908186605081515,1.0351649515797814,1079.28,152.62989628568087 -1,fruit,NA,1,43,Pooled Sample,21106rA_45,m_123,D-Xylose,0.018830878103892647,0.9323173448185703,1196.59,137.4655309067741 -1,fruit,NA,1,44,Pooled Sample,21106rA_46,m_123,D-Xylose,0.020503735093148418,1.0151405449837143,1191.82,149.67739765512374 -1,fruit,NA,1,57,Pooled Sample,21106rA_59,m_123,D-Xylose,0.020159865325832166,0.9981155423970641,1201.53,147.1671461487351 -1,fruit,NA,1,58,Pooled Sample,21106rA_60,m_123,D-Xylose,0.01998730189323774,0.9895719216268805,1175.49,145.90743198427538 -1,fruit,NA,2,1,Pooled Sample,21108rA_1,m_123,D-Xylose,0.0021969123585408846,0.10876919735838236,11.64,16.037474304506688 -1,fruit,NA,2,15,Pooled Sample,21108rA_15,m_123,D-Xylose,0.020184645295621216,0.9993423994512572,276.82,147.34804008709062 -1,fruit,NA,2,16,Pooled Sample,21108rA_16,m_123,D-Xylose,0.011043916558320082,0.5467846430338468,128.61,80.62066169212554 -1,fruit,NA,2,2,Pooled Sample,21108rA_2,m_123,D-Xylose,0.04177686253781967,2.068373728576098,245.22,304.9713644099027 -1,fruit,NA,2,29,Pooled Sample,21108rA_29,m_123,D-Xylose,0.015085196158433923,0.7468685183401573,162.34,110.12202868666449 -1,fruit,NA,2,30,Pooled Sample,21108rA_30,m_123,D-Xylose,0.022939949670298335,1.1357576024276361,261.97,167.4617796899428 -1,fruit,NA,2,43,Pooled Sample,21108rA_43,m_123,D-Xylose,0.02354964250244536,1.1659435129988869,307.64,171.91254127412085 -1,fruit,NA,2,44,Pooled Sample,21108rA_44,m_123,D-Xylose,0.030750568534571605,1.522461578777193,402.22,224.4793474828032 -1,fruit,NA,2,57,Pooled Sample,21108rA_57,m_123,D-Xylose,0.01638237239377865,0.8110917530096201,266.85,119.59142352250343 -1,fruit,NA,2,58,Pooled Sample,21108rA_58,m_123,D-Xylose,0.018468041117803046,0.9143532746564306,312.56,134.8168185817174 -2,fruit,NA,3,42,Pooled Sample,21108rA_100,m_123,D-Xylose,0.026439854576598542,1.4407124080337064,148.02,160.66824774391893 -2,fruit,NA,3,1,Pooled Sample,21108rA_59,m_123,D-Xylose,0.00846462454358164,0.4612389063621545,73.1,51.437362837507465 -2,fruit,NA,3,2,Pooled Sample,21108rA_60,m_123,D-Xylose,0.030281221433137277,1.650029175567031,282.32,184.0112536592353 -2,fruit,NA,3,15,Pooled Sample,21108rA_73,m_123,D-Xylose,0.0185925561472499,1.0131117121239608,187.57,112.9822181360641 -2,fruit,NA,3,16,Pooled Sample,21108rA_74,m_123,D-Xylose,0.026713189143667465,1.4556064575141925,258.08,162.32923214198274 -2,fruit,NA,3,29,Pooled Sample,21108rA_87,m_123,D-Xylose,0.012514111937259688,0.681896199213218,189.42,76.04506413625806 -2,fruit,NA,3,30,Pooled Sample,21108rA_88,m_123,D-Xylose,0.016681056920345775,0.9089537771334615,257.45,101.36652522592362 -2,fruit,NA,3,41,Pooled Sample,21108rA_99,m_123,D-Xylose,0.01728074749937473,0.9416310241162278,258.47,105.01069180944172 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_9,L-arginine,0.018782528489112642,0.8270591594812822,31.29,32.722595644876925 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_9,L-arginine,0.029881791054610495,1.3157977642758274,35.72,52.059538543573105 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_9,L-arginine,0.01945976659964759,0.8568802766323833,10.57,33.902468144960245 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_9,L-arginine,0.017985254744010526,0.7919524615794065,20.92,31.333599142389215 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_9,L-arginine,0.01820185389838228,0.8014900653510657,7.43,31.710954435614912 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_9,L-arginine,0.017393372620164622,0.7658898613206744,5.4,30.30243236315248 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_9,L-arginine,0.019330497408481983,0.8511881107105148,26.11,33.67725760026152 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_9,L-arginine,0.020687517544231437,0.9109423623025028,53.35,36.04143456449852 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_9,L-arginine,0.01856790506134106,0.8176085537292052,18.07,32.348682428296 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_9,L-arginine,0.021539551671886516,0.9484603476938865,24.81,37.52583365650862 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_9,L-arginine,0.042418138820376615,1.8678161601020125,33.56,73.90014637443612 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_9,L-arginine,0.021193781758821983,0.9332349123197924,27.73,36.92343930593258 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_9,L-arginine,0.004784810216476668,0.21069160726738784,4.57,8.336013441534199 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_9,L-arginine,0.021338564166359406,0.939610178373827,12.12,37.17567670736046 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_9,L-arginine,0.007933478856886033,0.34933828844939896,20.5,13.821569382500469 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_9,L-arginine,0.049481822841339736,2.1788543982500608,154.59,86.20637426676365 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_9,L-arginine,0.00420456169717523,0.1851412745237489,2.64,7.325114526532125 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_9,L-arginine,0.0047892620340733326,0.21088763606733327,3.83,8.343769321004041 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_9,L-arginine,0.05750127689806133,2.53197846967077,4.2,100.17772815252401 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_9,L-arginine,33.31784826776664,1467.099150150993,8.58,58045.77787572403 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_9,L-arginine,0.00910132852337925,1.103745119236682,7.91,88.40998405085823 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_9,L-arginine,0.021978952030614566,2.665452737741716,61.33,213.50276429311143 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_9,L-arginine,0.0082349637533164,0.9986784925371731,24.88,79.99414725222756 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_9,L-arginine,0.029526801105871837,3.5808027941812917,85.18,286.82230381392145 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_9,L-arginine,0.005534758249794987,0.6712165579644376,18.63,53.76444629295145 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_9,L-arginine,0.036702775683356614,4.45105452669699,235.1,356.5294675884289 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_9,L-arginine,0.025491139751667554,3.091386165482209,93.31,247.6200318551249 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_21,citric_acid,0.01888710852860381,1.024329294211828,17392.06,7541.071290815709 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_21,citric_acid,0.0213435071518817,1.1575503780148102,9163.37,8521.839580929913 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_21,citric_acid,0.02068568832876749,1.1218740282030137,8793.78,8259.19172066946 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_21,citric_acid,0.020168950337295936,1.0938490999142354,15408.85,8052.873319604604 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_21,citric_acid,0.019485042462086186,1.0567578283700199,6526.75,7779.8088621469515 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_21,citric_acid,0.02143849420979661,1.1627019355359567,6696.35,8559.765141338292 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_21,citric_acid,0.019315394507992,1.0475570886793149,6671.19,7712.073384573569 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_21,citric_acid,0.016188281617646225,0.8779602795627959,9184.56,6463.508459730121 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_21,citric_acid,0.019571779170283198,1.0614619338690245,2137.09,7814.440298666404 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_21,citric_acid,0.022145046473444677,1.2010213098568228,2526.81,8841.870842313536 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_21,citric_acid,0.017383129837298224,0.9427620480109845,6525.31,6940.576486974947 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_21,citric_acid,0.02276731622681175,1.234769680408648,889.73,9090.32499638125 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_21,citric_acid,0.018045975458403404,0.9787110227420711,1073.67,7205.2314009862175 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_21,citric_acid,0.022690887232731636,1.2306246066698683,5383.41,9059.809129319303 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_21,citric_acid,0.01991315922895442,1.0799764457132859,1169.39,7950.743394283382 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_21,citric_acid,0.017133633724861742,0.92923079856782,898.4,6840.959969824348 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_21,citric_acid,0.02534170917185286,1.3743901048068132,2775.28,10118.204975983566 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_21,citric_acid,0.01942027892482171,1.053245422629548,1891.45,7753.950671581827 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_21,citric_acid,0.01650414419654161,0.8950908685048692,1642.3,6589.623170298107 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_21,citric_acid,0.022005170095388236,1.1934352110426782,2051.13,8786.022286287756 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_21,citric_acid,0.017895398501512772,1.1550427990595389,5053.42,5199.182600978712 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_21,citric_acid,0.019809763457836183,1.2786038059511353,2154.02,5755.366525689786 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_21,citric_acid,0.017719240422241933,1.1436728303527375,2407.78,5148.003074538474 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_21,citric_acid,0.023057441000284527,1.4882223041787794,2387.93,6698.920175576898 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_21,citric_acid,0.016854383999942425,1.0878514311973626,2925.6,4896.734768734376 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_21,citric_acid,0.022347347403261716,1.442389935828326,5179.89,6492.615394244686 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_21,citric_acid,0.02236668821256839,1.4436382713999407,7636.85,6498.234514669839 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_29,fructose,0.019407656458561594,1.115755835501205,341441.45,382621.79722066975 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_29,fructose,0.020757675080376407,1.193369078426302,168005.05,409237.40392532584 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_29,fructose,0.020051059572869984,1.1527454009802736,160672.22,395306.48465110135 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_29,fructose,0.020207000202670616,1.1617105054514543,294461.26,398380.85296349594 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_29,fructose,0.019341987357516,1.1119804861765616,124391.12,381327.13140063215 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_29,fructose,0.021122559388131124,1.2143464590043958,127512.5,416431.09523518727 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_29,fructose,0.02208756649293716,1.269825198067322,148524.12,435456.2028549543 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_29,fructose,0.01567498427490711,0.9011626526603032,172689.36,309032.1939424524 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_29,fructose,0.019931895739947567,1.1458946128777656,39537.28,392957.1706051819 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_29,fructose,0.021063243858801914,1.2109363796820305,43332.76,415261.69003247796 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_29,fructose,0.017340429853646942,0.9969099484327868,126877.25,341866.44066725665 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_29,fructose,0.025377332535613407,1.458955486280481,16872.8,500313.91498376883 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_29,fructose,0.017763920609945406,1.0212566429257421,17777.7,350215.5576576173 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_29,fructose,0.02226468066420413,1.2800075799825743,102145.3,438948.00737386226 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_29,fructose,0.017447927672340893,1.0030900515672132,14787.22,343985.7593327433 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_29,fructose,0.015930320086032353,0.9158420356081471,11950.94,314066.137487163 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_29,fructose,0.02620298864990116,1.5064228674967954,41001.11,516591.7189014928 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_29,fructose,0.022404047389986338,1.288019842457346,31390.76,441695.621296512 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_29,fructose,0.01584706718336819,0.911055784771098,26333.81,312424.807153992 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_29,fructose,0.021917472221721707,1.26004639370219,34580.12,432102.79561135656 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_29,fructose,0.017030836139504794,0.9642857205504315,135195.67,1033372.9642135594 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_29,fructose,0.022100934916513926,1.2513546473137813,34530.89,1341009.2399158638 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_29,fructose,0.015982983147062618,0.9049562977569005,39501.52,969792.8238146803 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_29,fructose,0.02125634046902331,1.2035337206898542,40756.11,1289762.1337484112 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_29,fructose,0.01787169301618704,1.0118950259638357,76328.41,1084393.2873508916 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_29,fructose,0.023595632525467293,1.3359844064781787,136347.87,1431702.3853442466 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_29,fructose,0.022420108541990925,1.2694262538340195,213287,1360375.6052989992 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_44,D-glucose,0.01789722518949307,1.0896112572989187,358055.9,74417.62133230346 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_44,D-glucose,0.022520877867675045,1.371106514504769,243332.87,93643.01691927058 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_44,D-glucose,0.02145837624814665,1.3064197424896227,231518.55,89225.07825280947 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_44,D-glucose,0.01994065560554345,1.214018519389058,335255.96,82914.31449621485 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_44,D-glucose,0.020000436613022553,1.2176580812782463,184738.98,83162.8871285833 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_44,D-glucose,0.02155561341717806,1.3123396944868018,185641.3,89629.39561194136 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_44,D-glucose,0.018513151338938758,1.127109811348224,198457.51,76978.67526512325 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_44,D-glucose,0.01459275432672573,0.8884298666998126,260350.97,60677.45442009311 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_44,D-glucose,0.02076744798689972,1.2643549417470699,85804.42,86352.16152025103 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_44,D-glucose,0.02146883267000294,1.3070563459208835,94047.54,89268.55661517868 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_44,D-glucose,0.014443089850700365,0.8793180576809085,134469.03,60055.14150924637 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_44,D-glucose,0.02916523297872302,1.775625318388386,40935.01,121270.60149822556 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_44,D-glucose,0.01903522063187004,1.1588942121503087,41465.2,79149.46735938556 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_44,D-glucose,0.022521702501849643,1.3711567195321004,136836.19,93646.44579235527 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_44,D-glucose,0.018358029488188553,1.1176657487608186,42735.46,76333.67029774588 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_44,D-glucose,0.016944290544542665,1.031595095261818,34439.15,70455.26801710996 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_44,D-glucose,0.02136432479927308,1.3006937421530969,80271.16,88834.00728879562 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_44,D-glucose,0.01841257743884833,1.1209867139088892,60937.72,76560.48359945453 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_44,D-glucose,0.01672885293997075,1.0184789145856714,48807.11,69559.466913418 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_44,D-glucose,0.023948525448922377,1.4580239477667643,64635.35,99579.25206032554 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_44,D-glucose,0.01983285603658104,1.1391921848364375,182257.59,29526.32352151093 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_44,D-glucose,0.017836988469315074,1.0245502628457681,68227.45,26554.95967010747 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_44,D-glucose,0.01794649402817299,1.0308402231327278,131392.92,26717.986949299077 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_44,D-glucose,0.025243249928817726,1.4499632824309796,140987.49,37581.09083017971 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_44,D-glucose,0.016113444991826435,0.9255505395502749,126173.94,23989.020491914733 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_44,D-glucose,0.020503705164456033,1.1777255197363603,210907.03,30525.055542114816 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_44,D-glucose,0.02184855917220584,1.2549734548067673,253093.01,32527.21773442742 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_45,D-glucose_peak_2,0.01828707734046758,1.101882748332007,51432.64,90023.94725524103 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_45,D-glucose_peak_2,0.021923447152750013,1.320991197873177,30936.29,107925.1327802263 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_45,D-glucose_peak_2,0.021135025818796404,1.2734850901378565,29672.11,104043.87831504823 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_45,D-glucose_peak_2,0.02013147873777557,1.2130166404710097,47247.49,99103.59902339513 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_45,D-glucose_peak_2,0.020150948421835596,1.2141897808576227,23493.39,99199.44472789257 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_45,D-glucose_peak_2,0.02145334716941622,1.292665454399648,23326.66,105610.91628097849 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_45,D-glucose_peak_2,0.0185420163433708,1.117244026897521,24414.37,91278.96548059054 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_45,D-glucose_peak_2,0.015095008458611994,0.9095455275219497,32991.63,74309.97419627896 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_45,D-glucose_peak_2,0.020428367221295637,1.2309055732992913,10013.85,100565.12689269302 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_45,D-glucose_peak_2,0.021664015055940632,1.305359189186624,11235.55,106647.99587285393 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_45,D-glucose_peak_2,0.015850638541648265,0.9550758075725431,19351.42,78029.80331239464 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_45,D-glucose_peak_2,0.02843860310363333,1.7135601038450803,4089.96,139998.05754355498 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_45,D-glucose_peak_2,0.0191176624870782,1.1519294248474383,4218.9,94112.76648191956 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_45,D-glucose_peak_2,0.02221089803382297,1.3383114705963757,17297.58,109340.201053543 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_45,D-glucose_peak_2,0.016701713098657388,1.0063570678009028,3759.93,82219.48817039655 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_45,D-glucose_peak_2,0.016283979329253063,0.9811866359526303,3237.57,80163.06099379303 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_45,D-glucose_peak_2,0.023996632503859666,1.445910403383791,10350.79,118131.0462361521 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_45,D-glucose_peak_2,0.020537154411532067,1.2374605151267515,7930.14,101100.66639381483 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_45,D-glucose_peak_2,0.01594371666352496,0.9606842038642849,6904.89,78488.00993439551 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_45,D-glucose_peak_2,0.023029565827050225,1.3876400703051952,9404.8,113370.35332254252 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_45,D-glucose_peak_2,0.018021004028867582,1.023157058291555,24286.47,421235.98114944965 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_45,D-glucose_peak_2,0.02004385845132084,1.138006251872219,9822.46,468519.6433693591 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_45,D-glucose_peak_2,0.0171557792950503,0.9740332252356665,11491.3,401011.59248162265 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_45,D-glucose_peak_2,0.023192290787273896,1.3167610405578836,11870.37,542113.3777691387 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_45,D-glucose_peak_2,0.017388958847085183,0.9872721826284719,15196.58,406462.0999687782 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_45,D-glucose_peak_2,0.022124854889193833,1.256156505336378,25788.86,517162.35910660337 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_45,D-glucose_peak_2,0.022105178201793443,1.2550393455174658,36314.92,516702.4219849204 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_46,L-glutamine_peak_2,0.019822767987066753,1.1888405579568946,7527.36,7991.826101592689 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_46,L-glutamine_peak_2,0.019022597261026956,1.1408515277151756,3298.76,7669.226084366665 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_46,L-glutamine_peak_2,0.020642548985981814,1.2380056846833187,3539.88,8322.3322745446 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_46,L-glutamine_peak_2,0.02022559136427236,1.2129992813414212,6361.49,8154.229978911129 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_46,L-glutamine_peak_2,0.020216971565959172,1.2124823219620444,2728.78,8150.754786687989 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_46,L-glutamine_peak_2,0.02091044762035881,1.2540725004870672,2646.62,8430.339355099246 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_46,L-glutamine_peak_2,0.020607784069843676,1.2359207113674855,2723.34,8308.316312475443 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_46,L-glutamine_peak_2,0.016932395888530776,1.0154948586797568,3637.56,6826.532173143036 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_46,L-glutamine_peak_2,0.0197798204450165,1.1862648440158743,661.46,7974.511199466992 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_46,L-glutamine_peak_2,0.021330827543604814,1.279284151192545,728.68,8599.821399452228 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_46,L-glutamine_peak_2,0.017482662506025124,1.0484962676148686,2216.61,7048.379854526164 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_46,L-glutamine_peak_2,0.021826995660682736,1.3090410843076474,253.14,8799.8585139172 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_46,L-glutamine_peak_2,0.01604094322746268,0.9620313323110976,281.15,6467.130567388153 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_46,L-glutamine_peak_2,0.023311020261400223,1.3980432173846133,1850.11,9398.163783249804 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_46,L-glutamine_peak_2,0.01654639383502086,0.9923449687669736,284.71,6670.91004769004 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_46,L-glutamine_peak_2,0.022759950007443856,1.364993611566981,353.74,9175.992104589526 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_46,L-glutamine_peak_2,0.02236997973911208,1.3416057339662024,842.5,9018.77013784238 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_46,L-glutamine_peak_2,0.021442889966423538,1.2860049256755401,728.57,8645.000932213481 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_46,L-glutamine_peak_2,0.015740998270772043,0.9440425867483635,657.42,6346.203563879596 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_46,L-glutamine_peak_2,0.022880387591205205,1.372216673672699,906.75,9224.548200597143 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_46,L-glutamine_peak_2,0.018898272588406418,1.1456932926574883,1708.3,6953.808353650479 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_46,L-glutamine_peak_2,0.01930479367151521,1.170338321776569,802.92,7103.391850789322 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_46,L-glutamine_peak_2,0.01940874707431782,1.1766404171550078,936.49,7141.642544730664 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_46,L-glutamine_peak_2,0.022188916802210405,1.345186076277841,811.87,8164.633793689882 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_46,L-glutamine_peak_2,0.020363179933961095,1.2345021778249239,1135.7,7492.835658351933 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_46,L-glutamine_peak_2,0.017872948117812447,1.0835337824026858,1326.59,6576.529962968751 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_46,L-glutamine_peak_2,0.021938385801442556,1.3299978263550105,2390.21,8072.448407018264 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_70,malic_acid,0.019989612860770566,1.0232229147272829,1107.83,880.8977234032915 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_70,malic_acid,0.021854120783252048,1.1186628436674608,550.22,963.0624354275353 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_70,malic_acid,0.018792221548618246,0.9619311710090208,469.83,828.131354777521 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_70,malic_acid,0.01908337321696387,0.9768345641256015,871.96,840.961760428551 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_70,malic_acid,0.020189402136014237,1.0334496742933608,434.06,889.7019918475257 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_70,malic_acid,0.025045090131591407,1.282001322514187,504.58,1103.6813485590762 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_70,malic_acid,0.018603096132724938,0.9522502702008248,520.39,819.797018867241 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_70,malic_acid,0.011992055926049867,0.6138461261701653,564.3,528.4631992505261 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_70,malic_acid,0.025530918221765946,1.3068697598344692,319.24,1125.0907105902936 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_70,malic_acid,0.01727694963740842,0.8843678408739354,231.33,761.3566960475753 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_70,malic_acid,0.015366674479987307,0.7865851910486599,320.58,677.1751238997465 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_70,malic_acid,0.01812374159797685,0.9277131994907034,57.45,798.672932007544 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_70,malic_acid,0.027224533152229568,1.3935620643650648,134.72,1199.724549022206 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_70,malic_acid,0.023653732553769135,1.210780885874259,320.81,1042.367318553579 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_70,malic_acid,0.01656598772740662,0.8479753142712927,105.88,730.0261879327272 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_70,malic_acid,0.015573495990897563,0.7971719147984332,90.43,686.2892873095451 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_70,malic_acid,0.026930817506466156,1.3785274270635668,360.64,1186.78115459616 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_70,malic_acid,0.02163124612474828,1.1072543957259493,256.83,953.2408455524484 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_70,malic_acid,0.019927829822548437,1.0200603812209728,206.58,878.1750824950416 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_70,malic_acid,0.017409192206657743,0.8911370378614303,165.6,767.1843315800946 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_70,malic_acid,0.021971121949477482,1.3725895162943098,382.35,5442.386061582753 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_70,malic_acid,0.0194892487045611,1.2175408481117285,147.68,4827.610339805409 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_70,malic_acid,0.008604924144153177,0.5375705754094787,114.13,2131.494210027354 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_70,malic_acid,0.03350536796637873,2.0931619657833793,339.02,8299.491852429388 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_70,malic_acid,0.01590577569211999,0.9936725586310798,236.27,3939.9613786001632 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_70,malic_acid,0.021072617544252523,1.3164577570791023,411.74,5219.820829706495 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_70,malic_acid,0.019312586081133735,1.2065043036241485,424.48,4783.8498890849305 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_89,pyroglutamic_acid,0.019494681780667936,1.2861470636150236,14195.81,16460.007228379982 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_89,pyroglutamic_acid,0.021475368756487697,1.4168214068308904,7343.15,18132.36701890919 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_89,pyroglutamic_acid,0.02061584299649006,1.3601148370720195,7003.49,17406.64087566074 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_89,pyroglutamic_acid,0.019315633190859192,1.2743344666915237,11644.81,16308.830557960786 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_89,pyroglutamic_acid,0.019166786696141837,1.2645144304239937,5527.56,16183.154519411837 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_89,pyroglutamic_acid,0.02315453311600609,1.5276030207407527,6259.76,19550.141251198493 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_89,pyroglutamic_acid,0.019437845628711998,1.2823973409589813,6870.91,16412.018577805768 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_89,pyroglutamic_acid,0.014331399628479995,0.9455033817449392,8467.71,12100.476639301192 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_89,pyroglutamic_acid,0.020299858240928996,1.3392679789347923,2941.22,17139.84445296916 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_89,pyroglutamic_acid,0.021515399406885783,1.419462399079102,3319.1,18166.16622642242 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_89,pyroglutamic_acid,0.01667228018878849,1.0999412275527052,6380.4,14076.959834921317 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_89,pyroglutamic_acid,0.026313631435460675,1.7360221718174758,1188.51,22217.47287314631 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_89,pyroglutamic_acid,0.02015652339079288,1.329811569300085,1399.19,17018.822078976944 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_89,pyroglutamic_acid,0.02169272929715719,1.431161606084877,5290.89,18315.89174174577 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_89,pyroglutamic_acid,0.018945868305496855,1.2499395046763797,1413.56,15996.625785687933 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_89,pyroglutamic_acid,0.015035335769381947,0.9919450426440337,998.7,12694.833300154933 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_89,pyroglutamic_acid,0.023318035066969042,1.5383899397831995,3596.98,19688.191378150204 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_89,pyroglutamic_acid,0.020577793336942523,1.357604539214932,2851.68,17374.514284509565 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_89,pyroglutamic_acid,0.01863903060702515,1.229696116795736,2972.61,15737.552527062488 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_89,pyroglutamic_acid,0.020618711268235352,1.3603040691571782,3103.12,17409.062652748034 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_89,pyroglutamic_acid,0.01990743767948614,1.142918392644372,5851.77,25304.590376215972 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_89,pyroglutamic_acid,0.01948722988060653,1.118793579104606,2690.79,24770.459043257084 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_89,pyroglutamic_acid,0.01726865655006344,0.9914216739035228,2754.05,21950.403029376383 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_89,pyroglutamic_acid,0.024243741928650774,1.3918726760768005,2931.92,30816.52036632347 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_89,pyroglutamic_acid,0.017998732156383312,1.0333365025177452,3333.82,22878.411166788712 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_89,pyroglutamic_acid,0.0203805789278598,1.1700822016584373,5020.07,25906.006071844353 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_89,pyroglutamic_acid,0.020686121318413152,1.1876238875106455,7349.89,26294.384785368573 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_99,shikimic_acid,0.018128652459212382,1.0507564672084744,21807.49,15043.08140983742 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_99,shikimic_acid,0.022119539021487535,1.2820726047228785,13874.84,18354.70270043276 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_99,shikimic_acid,0.02093411488916923,1.213364129218651,13102.11,17371.042620469772 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_99,shikimic_acid,0.020159017545194155,1.1684386418593269,20289.98,16727.870025474123 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_99,shikimic_acid,0.019873651835456762,1.1518985341099655,10749.96,16491.074730687935 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_99,shikimic_acid,0.022144706249085728,1.2835313246812432,11200.72,18375.58636260629 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_99,shikimic_acid,0.01959407620682322,1.1356940257759063,12674.79,16259.08402143896 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_99,shikimic_acid,0.013678597404134534,0.7928264230931071,14758.02,11350.443988362853 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_99,shikimic_acid,0.020588410628569344,1.1933267332575261,5279.63,17084.178643810046 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_99,shikimic_acid,0.02151022109229748,1.2467558730395387,5858.81,17849.093183459445 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_99,shikimic_acid,0.015048442365952035,0.8722241310000312,9304.52,12487.135715772776 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_99,shikimic_acid,0.029897674744143173,1.7329018338558175,2293.1,24808.96780126844 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_99,shikimic_acid,0.02056729486092703,1.1921028403366292,2426.23,17066.656866480527 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_99,shikimic_acid,0.0220478795113423,1.277919141364722,8736.95,18295.239933008146 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_99,shikimic_acid,0.016116413740982237,0.9341249166006872,1924.55,13373.333979769577 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_99,shikimic_acid,0.014597372340075562,0.8460796203741051,1529.48,12112.83965951245 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_99,shikimic_acid,0.024687015523756253,1.43088634282252,5481.26,20485.18416497461 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_99,shikimic_acid,0.02058849394549007,1.193331562397115,4088.81,17084.24777984893 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_99,shikimic_acid,0.015807500686236372,0.9162199790544662,3509.08,13116.999194734732 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_99,shikimic_acid,0.023160410260909474,1.3424026369089235,4848.18,19218.41338312202 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_99,shikimic_acid,0.017881099813227722,1.0223692739454173,10755.74,11872.396101696771 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_99,shikimic_acid,0.020308048832605646,1.161132444710139,4700.38,13483.801461414301 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_99,shikimic_acid,0.017223849497053537,0.9847903478409774,5707.64,11436.005937048569 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_99,shikimic_acid,0.02265191734266814,1.2951454065461572,5740.43,15040.0444024201 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_99,shikimic_acid,0.017391984116680585,0.9944036082549723,7519.44,11547.64117332994 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_99,shikimic_acid,0.02256039102187927,1.2899123001316068,12968.16,14979.274273877301 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_99,shikimic_acid,0.022007878018049896,1.2583218317336526,16387.14,14612.425852845166 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_103,sucrose_peak_2,0.01815968407570258,1.5832083594424256,3731.13,8393.014979661348 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_103,sucrose_peak_2,0.021090059757375528,1.8386861120393918,2135.53,9747.371525171067 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_103,sucrose_peak_2,0.02043106049199666,1.7812328468027896,2061.1,9442.796253770226 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_103,sucrose_peak_2,0.02128858873197855,1.8559943829802716,3636.93,9839.127342661826 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_103,sucrose_peak_2,0.01982225753211847,1.7281558256765204,1773.3,9161.420633984168 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_103,sucrose_peak_2,0.019534106151376567,1.7030340409101292,1658.21,9028.243270055642 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_103,sucrose_peak_2,0.022141353010860988,1.9303405846725679,2422.93,10233.256631307144 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_103,sucrose_peak_2,0.017440553905810216,1.520512725985664,3163.53,8060.648498886021 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_103,sucrose_peak_2,0.019916368122028738,1.7363606310044584,762.29,9204.916522325006 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_103,sucrose_peak_2,0.020368125429914362,1.7757460048524918,818.69,9413.70902314437 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_103,sucrose_peak_2,0.015691974546968544,1.368067042100081,1170.91,7252.492768273896 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_103,sucrose_peak_2,0.03136557228039956,2.7345319459310575,343.96,14496.492169005938 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_103,sucrose_peak_2,0.01766685620395585,1.540242347310111,301.24,8165.240548524673 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_103,sucrose_peak_2,0.021031174220220272,1.833552318175698,1019.02,9720.155897775283 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_103,sucrose_peak_2,0.01725744377074044,1.5045487094679437,339.74,7976.018937041126 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_103,sucrose_peak_2,0.017279213952248233,1.5064466903582516,300.96,7986.080646195489 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_103,sucrose_peak_2,0.02067293516119143,1.802320107826174,807.64,9554.585518015661 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_103,sucrose_peak_2,0.020826824014250053,1.815736537185394,728.59,9625.709632484813 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_103,sucrose_peak_2,0.01734924609974951,1.5125522746234579,662.26,8018.447996893099 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_103,sucrose_peak_2,0.022498537717220112,1.9614808738216165,806.82,10398.339711964321 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_103,sucrose_peak_2,0.020925619579789386,1.2625300202257428,1324.88,22448.162518619774 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_103,sucrose_peak_2,0.019054665048459193,1.1496475197446971,958.35,20441.077795316636 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_103,sucrose_peak_2,0.016431045333413007,0.9913535853992053,926.31,17626.56415447349 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_103,sucrose_peak_2,0.026274332996890304,1.5852402383354274,1115.69,28186.0470096754 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_103,sucrose_peak_2,0.01572341601380236,0.9486593532980331,859.06,16867.44789944502 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_103,sucrose_peak_2,0.02108453857359406,1.2721182668101476,1507.18,22618.644419364467 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_103,sucrose_peak_2,0.020608758425671798,1.2434124635010086,1638.76,22108.24662478698 -1,fruit,NA,1_split,1,Pooled Sample,21107rA_1,m_104,sucrose,0.01815968407570258,1.5520717893937697,3731.13,8227.95161495951 -1,fruit,NA,1_split,15,Pooled Sample,21107rA_15,m_104,sucrose,0.021090059757375528,1.8025251237629227,2135.53,9555.67236285067 -1,fruit,NA,1_split,16,Pooled Sample,21107rA_16,m_104,sucrose,0.02043106049199666,1.746201777786091,2061.1,9257.08709852407 -1,fruit,NA,1_split,2,Pooled Sample,21107rA_2,m_104,sucrose,0.02128858873197855,1.8194929971892506,3636.93,9645.623641209459 -1,fruit,NA,1_split,29,Pooled Sample,21107rA_29,m_104,sucrose,0.01982225753211847,1.69416860940126,1773.3,8981.24522396062 -1,fruit,NA,1_split,30,Pooled Sample,21107rA_30,m_104,sucrose,0.019534106151376567,1.6695408886072203,1658.21,8850.687026546799 -1,fruit,NA,1_split,43,Pooled Sample,21107rA_43,m_104,sucrose,0.022141353010860988,1.8923770503885597,2422.93,10032.001685913361 -1,fruit,NA,1_split,44,Pooled Sample,21107rA_44,m_104,sucrose,0.017440553905810216,1.490609175565302,3163.53,7902.121704149069 -1,fruit,NA,1_split,57,Pooled Sample,21107rA_57,m_104,sucrose,0.019916368122028738,1.7022120528375018,762.29,9023.885689345863 -1,fruit,NA,1_split,58,Pooled Sample,21107rA_58,m_104,sucrose,0.020368125429914362,1.7408228442091365,818.69,9228.57191932057 -1,fruit,NA,2_split,1,Pooled Sample,21109rA_1,m_104,sucrose,0.015691974546968544,1.3411616035116891,1170.91,7109.859773848413 -1,fruit,NA,2_split,15,Pooled Sample,21109rA_15,m_104,sucrose,0.03136557228039956,2.6807525776142076,343.96,14211.39321712887 -1,fruit,NA,2_split,16,Pooled Sample,21109rA_16,m_104,sucrose,0.01766685620395585,1.5099507792717655,301.24,8004.656767630033 -1,fruit,NA,2_split,2,Pooled Sample,21109rA_2,m_104,sucrose,0.021031174220220272,1.7974922949625443,1019.02,9528.991978516087 -1,fruit,NA,2_split,29,Pooled Sample,21109rA_29,m_104,sucrose,0.01725744377074044,1.4749591194404743,339.74,7819.156531116204 -1,fruit,NA,2_split,30,Pooled Sample,21109rA_30,m_104,sucrose,0.017279213952248233,1.4768197732066617,300.96,7829.0203591072805 -1,fruit,NA,2_split,43,Pooled Sample,21109rA_43,m_104,sucrose,0.02067293516119143,1.766874320824901,807.64,9366.677830759423 -1,fruit,NA,2_split,44,Pooled Sample,21109rA_44,m_104,sucrose,0.020826824014250053,1.7800268925623148,728.59,9436.403164733823 -1,fruit,NA,2_split,57,Pooled Sample,21109rA_57,m_104,sucrose,0.01734924609974951,1.482805280445349,662.26,7860.7511490665165 -1,fruit,NA,2_split,58,Pooled Sample,21109rA_58,m_104,sucrose,0.022498537717220112,1.922904911117406,806.82,10193.83811815937 -2,fruit,NA,3_split,42,Pooled Sample,21109rA_100,m_104,sucrose,0.020925619579789386,1.2625300202257428,1324.88,22448.162518619774 -2,fruit,NA,3_split,2,Pooled Sample,21109rA_60,m_104,sucrose,0.019054665048459193,1.1496475197446971,958.35,20441.077795316636 -2,fruit,NA,3_split,15,Pooled Sample,21109rA_73,m_104,sucrose,0.016431045333413007,0.9913535853992053,926.31,17626.56415447349 -2,fruit,NA,3_split,16,Pooled Sample,21109rA_74,m_104,sucrose,0.026274332996890304,1.5852402383354274,1115.69,28186.0470096754 -2,fruit,NA,3_split,29,Pooled Sample,21109rA_87,m_104,sucrose,0.01572341601380236,0.9486593532980331,859.06,16867.44789944502 -2,fruit,NA,3_split,30,Pooled Sample,21109rA_88,m_104,sucrose,0.02108453857359406,1.2721182668101476,1507.18,22618.644419364467 -2,fruit,NA,3_split,41,Pooled Sample,21109rA_99,m_104,sucrose,0.020608758425671798,1.2434124635010086,1638.76,22108.24662478698 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_1,adenine,0.0023573865868882905,0.31692019610110067,52.74,38.829062426306855 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_1,adenine,0.0017208023252242143,0.231339659517258,31.39,28.343735084054448 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_1,adenine,0.003871787572002869,0.5205118597881883,74.54,63.77311306124882 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_1,adenine,0.04552010871163551,6.119591016455785,1178.39,749.7722913361628 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_1,adenine,0.08257961042541778,11.10176263644622,1212.9,1360.1879582173908 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_1,adenine,0.0010651143649244587,0.14319087725341104,16.68,17.54374628108792 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_1,adenine,3.1775470538545887e-4,0.042718018378026475,5.1,5.2338116116758036 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_1,adenine,0.00410771468391194,0.5522292145010971,70.25,67.65912336067441 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_1,adenine,0.0028168452408454153,0.3786884811682711,93.14,46.39691271273657 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_1,adenine,0.040585851771129756,5.4562438650399265,1596.48,668.4989983446918 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_1,adenine,0.0018974039855759078,0.2550814730754306,42.3,31.25258208120176 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_1,adenine,0.03482246269092546,4.681430600357581,1141.81,573.5688771558108 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_1,adenine,9.844420633019697e-4,0.13234552766487623,31.04,16.214974049500636 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_1,adenine,0.0406512892668112,5.4650410916293515,1111.02,669.5768345464281 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_1,adenine,0.004183944393970999,0.5624773150014635,141.6,68.9147206339793 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_1,adenine,0.035793726478967836,4.812004479026585,1268.67,589.5667887703371 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_1,adenine,5.944601677201355e-4,0.07991749591518571,17.02,9.791491599528554 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_1,adenine,0.050132124829980224,6.739617049002523,1362.89,825.7378808437891 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_1,adenine,0.006286257245465492,0.8451061400177955,49.34,103.5424042749803 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_1,adenine,0.013750970233755457,1.8486404424717668,86.55,226.49542701164086 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_1,adenine,0.021476291624430554,1.053289214809871,80.87,129.22805376502305 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_1,adenine,0.018341066874894653,0.899524380897177,68.12,110.36264629227465 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_1,adenine,0.018934993785821586,0.9286530973722806,44.37,113.93644851660511 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_1,adenine,0.021123033290473988,1.0359639149068427,52.02,127.10241271992052 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_1,adenine,0.019606582292779645,0.9615906707457259,64.43,117.97755939379311 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_1,adenine,0.020323776232547556,0.9967649296399017,74.18,122.29308921751954 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_2,adenosine-5-monophosphate,0.0216914043189373,1.0520275170178233,1174.48,817.4043401725083 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_2,adenosine-5-monophosphate,0.020605734040675897,0.9993727884282936,1094.46,776.4926691530155 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_2,adenosine-5-monophosphate,0.019185558147815182,0.9304946237725151,1085.21,722.9757127787689 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_2,adenosine-5-monophosphate,0.01826799990207999,0.8859932854180735,1162.83,688.3990629041348 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_2,adenosine-5-monophosphate,0.020455150456758303,0.9920695234315609,832.75,770.8181783158542 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_2,adenosine-5-monophosphate,0.018389713325843434,0.8918963550905984,792.54,692.9856299782931 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_2,adenosine-5-monophosphate,0.023548407609288793,1.142091697829613,729.47,887.3824073796527 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_2,adenosine-5-monophosphate,0.01966429588903328,0.9537132807940293,609.85,741.0161449113449 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_2,adenosine-5-monophosphate,0.018463846992959256,0.8954918188326668,475.37,695.7792333966055 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_2,adenosine-5-monophosphate,0.020107134199411444,0.9751908246753529,579.38,757.7037669562557 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_2,adenosine-5-monophosphate,0.0217661033338615,1.0556503999828406,1498.21,820.2192477786675 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_2,adenosine-5-monophosphate,0.021007009667701387,1.0188345528826515,1189.93,791.6140708987625 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_2,adenosine-5-monophosphate,0.01856685862806123,0.9004878565767821,974.69,699.6610548030282 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_2,adenosine-5-monophosphate,0.018134531375791754,0.879520096303782,1460.92,683.3695244261125 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_2,adenosine-5-monophosphate,0.020532334589439732,0.995812933967094,776.98,773.7267334337528 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_2,adenosine-5-monophosphate,0.019944393466012126,0.9672979410630976,759.37,751.5711542472056 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_2,adenosine-5-monophosphate,0.01996255230046731,0.9681786398524861,570.1,752.2554395925847 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_2,adenosine-5-monophosphate,0.019870028021360175,0.9636912361702836,554.35,748.768816679587 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_2,adenosine-5-monophosphate,0.019211353786937658,0.9317457056193559,585.66,723.9477783521271 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_2,adenosine-5-monophosphate,0.020727246916911638,1.0052661315974298,697.1,781.071678928571 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_2,adenosine-5-monophosphate,0.018808534283943856,1.0368097618598875,442.63,32.483249839070275 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_2,adenosine-5-monophosphate,0.021386855305051387,1.1789382426620771,497.45,36.93613514260287 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_2,adenosine-5-monophosphate,0.016895600272792813,0.9313603617836517,216.42,29.179520134681805 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_2,adenosine-5-monophosphate,0.02323153368067811,1.2806250896257092,306.8,40.121984057973464 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_2,adenosine-5-monophosphate,0.014946740953689017,0.8239305995260293,189.63,25.813745683150497 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_2,adenosine-5-monophosphate,0.024459914445238685,1.3483388810753991,342.73,42.243457144092254 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_3,2-aminoadipic_acid,0.007587244251757516,0.3787312662179418,8.85,22.864006541577144 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_3,2-aminoadipic_acid,0.012100830303227072,0.6040352242473317,33.76,36.465606487811414 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_3,2-aminoadipic_acid,0.033495154972100975,1.6719723306405316,103.96,100.93696960076889 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_3,2-aminoadipic_acid,0.028923974957136504,1.4437934638831293,43.41,87.16181141462451 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_3,2-aminoadipic_acid,0.01656366102704482,0.8268056366478956,53.1,49.914256284433456 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_3,2-aminoadipic_acid,0.02331874685179702,1.1639981828383847,78.91,70.27057029795328 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_3,2-aminoadipic_acid,0.012259708712806593,0.61196593258334,34.9,36.944383350056235 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_3,2-aminoadipic_acid,0.020865642377583614,1.0415469564305184,60.37,62.878189759710395 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_3,2-aminoadipic_acid,0.010631561307445301,0.5306939571517989,29.17,32.0379941932541 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_3,2-aminoadipic_acid,0.0317959799163834,1.5871548792676184,98.04,95.81654006138612 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_3,2-aminoadipic_acid,0.0223276971107158,1.1145281103232276,51.42,67.28406202021326 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_3,2-aminoadipic_acid,0.01749059367676491,0.8730751864974239,74.99,52.707549008849476 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_3,2-aminoadipic_acid,0.03190778379621555,1.5927357757791678,133.18,96.15345878378835 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_3,2-aminoadipic_acid,0.012027309442683503,0.6003652951290422,34.73,36.24405286694028 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_3,2-aminoadipic_acid,0.0033203727038679464,0.1657425168776006,16.08,10.005875743900749 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_3,2-aminoadipic_acid,0.0391570988716847,1.954598684978284,190.44,117.99912261213899 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_3,2-aminoadipic_acid,0.007095726146879871,0.3541962350455589,37.55,21.382826709700392 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_3,2-aminoadipic_acid,0.02167217409512049,1.081806472071776,116.32,65.30865671897311 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_3,2-aminoadipic_acid,0.0015959862726871576,0.07966659328006281,13.6,4.809472236317392 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_3,2-aminoadipic_acid,0.039198425743364955,1.9566615918679184,374.96,118.12366030106624 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_3,2-aminoadipic_acid,0.02808084518332167,1.741944944719665,72.5,113.8361021374301 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_3,2-aminoadipic_acid,0.013725245340576876,0.8514210159975992,44.93,55.6403633954431 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_3,2-aminoadipic_acid,0.00832522321378859,0.516440313539252,74.49,33.749374489790114 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_3,2-aminoadipic_acid,0.03149715294913815,1.953869479163703,302.27,127.68537046334798 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_3,2-aminoadipic_acid,0.023670717682118293,1.4683705826896662,151.59,95.95801757876968 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_3,2-aminoadipic_acid,0.01585725619609754,0.9836764914869007,99.46,64.28325871866896 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_4,adipic_acid,0.027829272850238777,1.3805409312461812,412.91,290.4105902969467 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_4,adipic_acid,0.011529739904273353,0.5719616876132363,98.31,120.3178606063204 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_4,adipic_acid,0.01773608507441877,0.879843017712534,153.74,185.08377720600868 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_4,adipic_acid,0.013246809886947148,0.6571412539516003,224.21,138.23623418125865 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_4,adipic_acid,0.019742418702933008,0.9793722332549306,92.32,206.02074298750722 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_4,adipic_acid,0.02086141493825515,1.0348828501900527,110.15,217.69795636597948 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_4,adipic_acid,0.029346391996528907,1.455801434468881,174.5,306.24238975487384 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_4,adipic_acid,0.025831571799979646,1.2814399564159116,160.71,269.56370923165116 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_4,adipic_acid,0.019272775456567377,0.9560744012138205,188.89,201.11981103933928 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_4,adipic_acid,0.016758964009144037,0.8313704746944701,193,174.88709305672876 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_4,adipic_acid,0.02097902808938342,1.040717345760929,2063.44,218.925300854269 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_4,adipic_acid,0.010881021635741813,0.539780389619054,499.49,113.54820276026419 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_4,adipic_acid,0.014111864976673008,0.7000544829668219,565.11,147.26346103690068 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_4,adipic_acid,0.021193206209494428,1.051342188996388,2373.01,221.16034287728021 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_4,adipic_acid,0.02746830045282094,1.3626339894310948,332.92,286.6436860167251 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_4,adipic_acid,0.025027717459470047,1.2415627441795205,324.68,261.17513886560397 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_4,adipic_acid,0.03463282382192826,1.7180481541183905,320.89,361.40860970034464 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_4,adipic_acid,0.04591979890489117,2.277966883430513,426.8,479.1931135984427 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_4,adipic_acid,0.015643008173879362,0.7760106844356066,317.02,163.24160757787422 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_4,adipic_acid,0.01569625927956784,0.7786523391936263,370.32,163.79730607277125 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_4,adipic_acid,0.013466604290567947,0.6236418585377891,176.99,19.470098823549776 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_4,adipic_acid,0.02726061671418776,1.2624460707165672,355.59,39.41356632777123 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_4,adipic_acid,0.027542435671526568,1.2754971780732345,247.61,39.82102189944638 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_4,adipic_acid,0.012082987543254129,0.5595662162169432,114.91,17.469657270292966 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_4,adipic_acid,0.028387433835556104,1.3146292572600786,402.99,41.04272541165965 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_4,adipic_acid,0.012726589097905345,0.5893715673685784,201.07,18.400180333247018 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_5,L-alanine,0.01330324777483178,0.6764570689984508,8728.08,13539.254413150544 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_5,L-alanine,0.019935856548154048,1.0137187036425312,19146.15,20289.529167470082 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_5,L-alanine,0.02054859159408483,1.0448756782594466,21606.8,20913.13445657891 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_5,L-alanine,0.02687325785951393,1.3664787391600879,21828.41,27350.003640352203 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_5,L-alanine,0.02085935937400777,1.060677914307665,21344.52,21229.4154209722 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_5,L-alanine,0.01886187707857118,0.9591079035991769,20704.86,19196.496735142344 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_5,L-alanine,0.019745225471294196,1.0040253008212594,20154.67,20095.516194672466 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_5,L-alanine,0.020273916852852895,1.0309087377403663,21138.9,20633.586840436546 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_5,L-alanine,0.020410564815376918,1.037857152276288,21253.38,20772.65900995229 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_5,L-alanine,0.019666063649136388,1,23075.39,20014.95 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_5,L-alanine,0.014303533376378274,0.7273206083112823,11787,14557.2856093199 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_5,L-alanine,0.021221193903623425,1.079076844366632,24893.64,21597.669086155925 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_5,L-alanine,0.02023556784534939,1.0289587284152826,22765.84,20594.55750129546 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_5,L-alanine,0.025303873564188777,1.286677090832052,25910.46,25752.77763914898 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_5,L-alanine,0.020176000575728503,1.02592979132428,23891.56,20533.9334768659 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_5,L-alanine,0.019421563151792984,0.9875673901139773,23567.26,19766.11193476175 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_5,L-alanine,0.0198101369444941,1.0073259854095935,22091.67,20161.579231673742 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_5,L-alanine,0.01947676295358227,0.9903742457600339,21306.47,19822.29101017479 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_5,L-alanine,0.020393376782616716,1.0369831577104789,21556.42,20755.16605241735 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_5,L-alanine,0.02002342751363879,1.0181716011337172,22794.43,20378.653688111295 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_5,L-alanine,0.020113934735166396,1.1197489385734376,18889.42,16830.89030825041 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_5,L-alanine,0.019898024619346085,1.1077291559600255,19159.75,16650.221556777346 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_5,L-alanine,0.01919860084642708,1.0687920192112517,17664.35,16064.959401163364 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_5,L-alanine,0.020791389484308434,1.157463053005611,20260.13,17397.769276574687 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_5,L-alanine,0.020731941477677904,1.1541535641760357,19922.23,17348.024515451783 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_5,L-alanine,0.01930775265564861,1.0748685340318695,19795.31,16156.29519160633 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_6,L-alanine_peak_2,0.02679848173952191,1.3310727556345634,52.97,194.16358286441377 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_6,L-alanine_peak_2,0.019586420616576054,0.9728517875202813,113.67,141.90989024558345 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_6,L-alanine_peak_2,0.01047129441926256,0.5201061333692293,69.02,75.86788167456947 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_6,L-alanine_peak_2,0.02071630720408556,1.02897292409097,53.06,150.0962804371498 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_6,L-alanine_peak_2,0.022024406088024983,1.0939458133393891,222.97,159.5738757918167 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_6,L-alanine_peak_2,0.020198864429326554,1.0032716927012115,229.14,146.34724181432574 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_6,L-alanine_peak_2,0.023532874671575894,1.1688710070056443,316.81,170.50321379191334 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_6,L-alanine_peak_2,0.018118811013150493,0.8999560474550361,251.54,131.27658864226612 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_6,L-alanine_peak_2,0.020812811192190587,1.0337662489750152,307.68,150.79548273798548 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_6,L-alanine_peak_2,0.018491391771035443,0.9184620248053479,308.44,133.9760555583561 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_6,L-alanine_peak_2,0.018686525063731394,0.9281542384221286,37.69,135.3898587586359 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_6,L-alanine_peak_2,0.010459956495319027,0.5195429820006786,58.36,75.78573478443899 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_6,L-alanine_peak_2,0.023490672364800798,1.1667748307625543,130.4,170.1974445633338 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_6,L-alanine_peak_2,0.025581619935372682,1.270631585473546,67.3,185.34702937302615 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_6,L-alanine_peak_2,0.02414106915960362,1.1990798494695405,216.76,174.90977764212187 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_6,L-alanine_peak_2,0.01872926007694012,0.9302768740380831,178.47,135.6994876159352 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_6,L-alanine_peak_2,0.019511613904255425,0.9691361599830044,234.66,141.36789165672084 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_6,L-alanine_peak_2,0.018846610924374757,0.9361056563321379,227.32,136.54973208916897 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_6,L-alanine_peak_2,0.02046993154838672,1.0167355172803938,309.67,148.31120990569104 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_6,L-alanine_peak_2,0.01992668323334901,0.9897525322471536,331.22,144.3752018788923 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_6,L-alanine_peak_2,0.017271217804932692,0.9940938456460849,242.34,377.3878466226232 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_6,L-alanine_peak_2,0.02282089244108794,1.3135210836932174,335.41,498.6520090024561 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_6,L-alanine_peak_2,0.023025144203184942,1.325277372216486,424.21,503.11504881454454 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_6,L-alanine_peak_2,0.01696149808419301,0.97626705012188,334.64,370.6202602377693 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_6,L-alanine_peak_2,0.020802503101033373,1.197346969989848,521.33,454.548830217246 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_6,L-alanine_peak_2,0.019335087691550498,1.1128857209888348,527.25,422.48480625899134 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_7,beta-cyano-L-alanine,0.021981354606051613,1.1942154867204198,219.26,368.8453952284689 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_7,beta-cyano-L-alanine,0.030901238838995756,1.6788200109476277,548.89,518.5203485812843 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_7,beta-cyano-L-alanine,0.011181057672825684,0.607450835951964,219.65,187.61726519212363 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_7,beta-cyano-L-alanine,0.01662266564633239,0.9030855969158748,204.53,278.9270174634371 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_7,beta-cyano-L-alanine,0.02357430502965758,1.280758199830756,503.74,395.57497759972733 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_7,beta-cyano-L-alanine,0.01542597757114929,0.8380712491757284,357.04,258.84668602041546 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_7,beta-cyano-L-alanine,0.018771406039595567,1.0198235823842572,422.54,314.9827116552017 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_7,beta-cyano-L-alanine,0.022609099924594443,1.2283199900395056,519.8,379.3789121236017 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_7,beta-cyano-L-alanine,0.01891474998933035,1.0276112536979176,423.5,317.3880118171389 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_7,beta-cyano-L-alanine,0.02059241704413255,1.1187564999446549,517.67,345.5391325729061 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_7,beta-cyano-L-alanine,0.017065334341730527,0.9271351525963624,307.24,286.3549632309125 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_7,beta-cyano-L-alanine,0.014835314636604148,0.8059813786237405,263.83,248.9354086017285 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_7,beta-cyano-L-alanine,0.023196280142550613,1.2602206495914914,389.04,389.23174983282803 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_7,beta-cyano-L-alanine,0.023644199883021307,1.2845554870236955,503.13,396.7478077221386 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_7,beta-cyano-L-alanine,0.022637323884753067,1.229853357337476,353.37,379.85250794725283 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_7,beta-cyano-L-alanine,0.020881200567352477,1.1344456948063752,333.55,350.38489729789706 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_7,beta-cyano-L-alanine,0.014010561453226482,0.7611737204077899,223.53,235.09611528514998 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_7,beta-cyano-L-alanine,0.021565999943340696,1.1716498632827106,343.75,361.875776773498 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_7,beta-cyano-L-alanine,0.014536758192914718,0.7897612350018396,310.2,243.92565504266818 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_7,beta-cyano-L-alanine,0.02600488236690117,1.412807982468304,616.75,436.3598734651604 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_7,beta-cyano-L-alanine,0.021761313447948738,1.381694265764443,344.21,122.3075764054685 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_7,beta-cyano-L-alanine,0.01804709163427599,1.1458666355065559,308.66,101.43211457504032 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_7,beta-cyano-L-alanine,0.023671021371733506,1.5029476310031602,568.45,133.04092429639974 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_7,beta-cyano-L-alanine,0.01634753172910376,1.0379562292290807,416.76,91.87988541135822 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_7,beta-cyano-L-alanine,0.021522480837942788,1.3665300318356368,461.51,120.96523841809056 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_7,beta-cyano-L-alanine,0.01866015196309484,1.1847917648615818,415.94,104.87776702554721 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_8,beta-alanine,0.014406783785065259,0.7151204234201569,81.98,265.00932651104176 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_8,beta-alanine,0.018608955753864363,0.9237068117802789,280.85,342.30727030953574 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_8,beta-alanine,0.020854435617775304,1.0351673941710595,373.44,383.6123329319112 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_8,beta-alanine,0.025990586350301225,1.290114392848256,311.65,478.09059170170667 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_8,beta-alanine,0.02084518009946398,1.0347079710081584,413.36,383.4420798962033 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_8,beta-alanine,0.019967309260674186,0.9911324321988403,419.71,367.2938567242462 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_8,beta-alanine,0.018755081446356205,0.9309601633017792,370.93,344.9952173163733 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_8,beta-alanine,0.020145954881505036,1,422.64,370.58 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_8,beta-alanine,0.021705876144708723,1.0774309915999947,460.75,399.274376867126 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_8,beta-alanine,0.01874321061874733,0.9303709220531665,413.74,344.77685629446245 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_8,beta-alanine,0.022603832610411496,1.1220035358643095,393.25,415.79207032059577 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_8,beta-alanine,0.01895907034486299,0.9410857145455208,390.44,348.7475440962791 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_8,beta-alanine,0.02615026891161421,1.2980406769212725,591.16,481.0279140534851 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_8,beta-alanine,0.0154721431947212,0.7680024742299695,262.93,284.6063569001421 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_8,beta-alanine,0.019507416626368842,0.9683043936665219,386.95,358.83424220493964 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_8,beta-alanine,0.017655462233162243,0.876377532711086,334.13,324.7679860720742 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_8,beta-alanine,0.01916253019728402,0.9511850051285556,356.67,352.4901392005401 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_8,beta-alanine,0.0205131842421822,1.0182284415326621,392.79,377.33509586317393 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_8,beta-alanine,0.01915013425964548,0.9505696985962295,406.52,352.2621189057907 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_8,beta-alanine,0.02119575674685107,1.0521098092158343,518.99,389.89085309920387 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_8,beta-alanine,0.021659037731193265,1.1730275445740037,376.17,137.15038051159252 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_8,beta-alanine,0.018265900409188192,0.9892592908485999,296.56,115.6641962860183 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_8,beta-alanine,0.017739875754310987,0.9607704255096132,312.71,112.33327815058398 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_8,beta-alanine,0.022286261609864952,1.2069972386771175,471.45,141.12211714612857 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_8,beta-alanine,0.019792751046857772,1.0719516928225505,363.89,125.3325919248126 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_8,beta-alanine,0.02012990453381071,1.0902115218996007,395.15,127.46753114050131 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_10,ascorbic_acid,0.019527198122987224,1.0323162185566321,196.18,347.9421814645129 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_10,ascorbic_acid,0.02058658620515087,1.0883213603120043,456.76,366.81871449316105 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_10,ascorbic_acid,0.021226039750586668,1.1221264285972403,612.71,378.21271275869987 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_10,ascorbic_acid,0.019893055814093365,1.0516574894257975,287.18,354.46115681096506 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_10,ascorbic_acid,0.019241164630615183,1.01719489846932,259.98,342.8455405290843 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_10,ascorbic_acid,0.019465366264738587,1.02904744288838,320.62,346.8404406255285 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_10,ascorbic_acid,0.018663578424210986,0.9866604815637143,235.31,332.55391531104993 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_10,ascorbic_acid,0.022153878799796606,1.1711771573642131,908.28,394.74526088960806 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_10,ascorbic_acid,0.019946969018698496,1.054507641053169,668.33,355.42180041697065 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_10,ascorbic_acid,0.019819097287123427,1.0477476306528817,743.71,353.14333891155377 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_10,ascorbic_acid,0.019595363460593134,1.0359198171431152,309.32,349.156774368087 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_10,ascorbic_acid,0.020137491756114127,1.064579731815972,672.04,358.8165986085734 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_10,ascorbic_acid,0.020598022910701452,1.0889259681288743,736.81,367.0224975578371 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_10,ascorbic_acid,0.0202153827078643,1.0686974804179006,499.34,360.2044857748534 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_10,ascorbic_acid,0.019890613254893944,1.0515283621715716,669.6,354.41763446992826 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_10,ascorbic_acid,0.019147914800194236,1.0122651941812337,535.51,341.18398369878486 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_10,ascorbic_acid,0.02134557231033907,1.128445584028594,864.81,380.34258409683764 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_10,ascorbic_acid,0.019672578311491364,1.040001823296463,514.81,350.53261454207285 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_10,ascorbic_acid,0.019764300557053912,1.0448507709591175,304.72,352.1669523517706 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_10,ascorbic_acid,0.019930718018302995,1.053648522854522,337.05,355.1322346281167 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_10,ascorbic_acid,0.020441894583392854,1.0586010855379662,340.11,58.61474210623718 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_10,ascorbic_acid,0.019518831537936942,1.0107994721428233,181.66,55.967966772548124 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_10,ascorbic_acid,0.019874768303484627,1.0292319635566947,201.97,56.98857382213418 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_10,ascorbic_acid,0.020141216689431453,1.043030222296973,258.35,57.75258340858339 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_10,ascorbic_acid,0.01955483509156359,1.012663947120762,100.1,56.07120275207659 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_10,ascorbic_acid,0.02040331775068925,1.056603351090699,267.21,58.504127549892 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_11,L-asparagine_peak_2,0.016284038516249297,1.1619341588510181,2076.92,2029.3412471164802 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_11,L-asparagine_peak_2,0.019155791653154505,1.3668457391219722,2617.96,2387.223420291307 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_11,L-asparagine_peak_2,0.02062584904214966,1.4717404735602593,3030.89,2570.424171882464 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_11,L-asparagine_peak_2,0.024163385200593007,1.7241584530783203,3638.57,3011.2772214703477 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_11,L-asparagine_peak_2,0.020510124763593283,1.4634830629597582,2542.23,2556.002439120477 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_11,L-asparagine_peak_2,0.018740604570081636,1.337220406704913,2498.34,2335.4821847182643 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_11,L-asparagine_peak_2,0.018476222391964302,1.3183556340970966,2330.63,2302.534482063261 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_11,L-asparagine_peak_2,0.023414029963790273,1.6706888272305218,3032.3,2917.891450534651 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_11,L-asparagine_peak_2,0.020961267309258555,1.495673967801724,3116.5,2612.224498245067 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_11,L-asparagine_peak_2,0.018459390306790877,1.3171545945203247,3142.91,2300.4368424216373 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_11,L-asparagine_peak_2,0.01901071378423098,1.3564938272527303,2728.34,2369.1435991734384 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_11,L-asparagine_peak_2,0.02074548705297303,1.4802771453038164,3543.55,2585.3336398160213 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_11,L-asparagine_peak_2,0.022049651615652296,1.5733347337286976,3584.02,2747.860579151845 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_11,L-asparagine_peak_2,0.0202155614816007,1.442464742538266,3486.5,2519.293522137932 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_11,L-asparagine_peak_2,0.01915297260043858,1.366644587936843,3001.36,2386.8721057234548 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_11,L-asparagine_peak_2,0.018056516781742235,1.2884078858961943,2893.54,2250.230140875421 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_11,L-asparagine_peak_2,0.022353934406032012,1.5950465816673949,3118.89,2785.7807558137383 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_11,L-asparagine_peak_2,0.019904712890373637,1.42028439728687,2714.95,2480.555105549464 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_11,L-asparagine_peak_2,0.018557923997985712,1.324185384915638,2340.11,2312.71625846286 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_11,L-asparagine_peak_2,0.02078965150201072,1.4834284631966426,2817.23,2590.8374795422 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_11,L-asparagine_peak_2,0.01960860140523915,1.0738208102222713,2219.17,805.9562091123256 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_11,L-asparagine_peak_2,0.020682604911249288,1.1326361887987986,2256.98,850.1000915029382 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_11,L-asparagine_peak_2,9.58954680242584e-5,0.005251498923474454,NA,3.9415125170137513 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_11,L-asparagine_peak_2,0.04010426658594356,2.196219666497048,2021.51,1648.3726706893592 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_11,L-asparagine_peak_2,0.019022121492565783,1.041703561164532,1706.94,781.8506078320395 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_11,L-asparagine_peak_2,0.02059683366720554,1.1279391201568596,2101.89,846.5747066337309 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_12,L-asparagine,0.008305808911018784,0.44850369987461414,26.29,60.9651079239563 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_12,L-asparagine,0.015927035271037015,0.8600407646769931,132.18,116.90534114254368 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_12,L-asparagine,0.019030539376512817,1.0276262568059251,176.84,139.68523708762942 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_12,L-asparagine,0.03391393495194351,1.8313117320908778,139.16,248.93020374311303 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_12,L-asparagine,0.023529340288476187,1.2705560997184038,258.56,172.70669063472263 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_12,L-asparagine,0.021935650838568962,1.184498784604125,260.53,161.00891979123872 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_12,L-asparagine,0.013157946308379935,0.7105132883843412,144.63,96.58007129008351 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_12,L-asparagine,0.020610405826327016,1.1129371465266622,230.45,151.2815463273692 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_12,L-asparagine,0.014982791867884381,0.8090527556301769,150.13,109.97454107280994 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_12,L-asparagine,0.02693636441842037,1.4545313084202163,300.39,197.71444075356 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_12,L-asparagine,0.008410722553112834,0.454168910470066,51.42,61.73518000019608 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_12,L-asparagine,0.015222105833632848,0.8219754221903793,140.62,111.73111913833827 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_12,L-asparagine,0.026440834540658927,1.4277732905130645,234.15,194.07722337944085 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_12,L-asparagine,0.031236050782947996,1.6867092050526262,235.67,229.27438224280348 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_12,L-asparagine,0.017367874607207057,0.9378443573336753,143.67,127.4811834923665 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_12,L-asparagine,0.023802938969911414,1.2853300997247998,197.33,174.71492045559205 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_12,L-asparagine,0.01835605138943608,0.9912047160546592,98.72,134.73445705330982 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_12,L-asparagine,0.013962316112330876,0.7539482911642408,71.04,102.48419121795526 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_12,L-asparagine,0.02208792739623438,1.1927215357231045,44.49,162.1266383508416 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_12,L-asparagine,0.026687839292547498,1.441111250282602,50.27,195.8902522509141 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_12,L-asparagine,0.016632974933469734,1.0016029688292154,57.44,154.65751441691916 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_12,L-asparagine,0.02335448132541162,1.4063580282279102,84.51,217.15574313867162 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_12,L-asparagine,0.02594964002209193,1.5626330581353665,116.25,241.28617050668194 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_12,L-asparagine,0.014252800881091585,0.8582738646414233,67.95,132.52606743928217 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_12,L-asparagine,0.010947025906462047,0.6592070084648078,70.11,101.78815417705097 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_12,L-asparagine,0.028203078179996705,1.6983303917788333,198.61,262.23919579456964 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_13,L-aspartic_acid,0.018054342723052362,0.9134861453914361,62275.31,93822.95619144248 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_13,L-aspartic_acid,0.019764221728087547,1,104894.05,102708.68 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_13,L-aspartic_acid,0.020309281881946882,1.0275781238117123,118413.65,105541.19269357753 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_13,L-aspartic_acid,0.021993810028484106,1.1128093142786404,92196.71,114295.1757612643 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_13,L-aspartic_acid,0.019966484508747804,1.0102337842310691,120257.12,103759.77846977791 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_13,L-aspartic_acid,0.020159039080817957,1.0199763673046292,131233.17,104760.42631705361 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_13,L-aspartic_acid,0.02015871518261991,1.0199599791967389,125921.29,104758.7431161245 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_13,L-aspartic_acid,0.019458159371581723,0.9845143228649945,124278.27,101118.1665425574 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_13,L-aspartic_acid,0.01964520969579371,0.9939784103856362,127047.24,102090.21047920697 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_13,L-aspartic_acid,0.020494069745241976,1.0369277387794744,149587.09,106501.47930542463 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_13,L-aspartic_acid,0.019416293080180086,0.98239603599402,78516.01,100900.60009417828 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_13,L-aspartic_acid,0.020122116269729068,1.0181082031240778,116617.95,104568.5496400459 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_13,L-aspartic_acid,0.01993611902625719,1.0086973977794103,111237.79,103601.97824535816 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_13,L-aspartic_acid,0.02056536421792245,1.040534987962434,101430.23,106871.97510743747 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_13,L-aspartic_acid,0.020062075678358,1.0150703606935942,124835.45,104256.53685396294 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_13,L-aspartic_acid,0.020025490494908527,1.0132192792823045,128828.22,104066.41472563683 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_13,L-aspartic_acid,0.020026113925104623,1.013250822654195,123896.11,104069.65450372646 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_13,L-aspartic_acid,0.019742566181867892,0.9989043056429143,120139.48,102596.14267890027 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_13,L-aspartic_acid,0.02007894662178438,1.0159239710030965,119734.41,104344.21004208631 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_13,L-aspartic_acid,0.02002059861254207,1.01297176726621,128689.92,104040.99309317963 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_13,L-aspartic_acid,0.01993873001628685,1.0184867471938077,47690.53,8135.916573403462 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_13,L-aspartic_acid,0.02006868228434577,1.0251248160516373,49041.46,8188.943060576331 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_13,L-aspartic_acid,0.01992083289870554,1.0175725476908983,45277.05,8128.613728366341 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_13,L-aspartic_acid,0.0200801084547127,1.0257084742425249,48206.42,8193.605462283107 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_13,L-aspartic_acid,0.01987864892604544,1.0154177556322665,49920.52,8111.400732251896 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_13,L-aspartic_acid,0.020109194360001005,1.0271942062345862,54410.22,8205.473846011371 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_14,4-hydroxy-benzoic_acid,0.009475009887962925,0.5028884516568299,43.86,44.81741881165669 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_14,4-hydroxy-benzoic_acid,0.044367968141092874,2.3548406878159724,219.09,209.86340209815947 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_14,4-hydroxy-benzoic_acid,0.0037734373551137064,0.20027610433925921,19.96,17.84860641871478 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_14,4-hydroxy-benzoic_acid,0.028337557005452037,1.504022722373405,155.2,134.03850501791786 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_14,4-hydroxy-benzoic_acid,0.026858611731811567,1.4255273426808628,99.07,127.0429967797185 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_14,4-hydroxy-benzoic_acid,0.006347738296465472,0.336907752200625,24.22,30.025218876119702 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_14,4-hydroxy-benzoic_acid,0.034531807047996105,1.8327840482088076,115.86,163.33771437636895 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_14,4-hydroxy-benzoic_acid,0.007378593822641436,0.3916206596878352,25.68,34.90123319137987 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_14,4-hydroxy-benzoic_acid,0.02091730969745374,1.1101912938309817,105.5,98.9402481062171 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_14,4-hydroxy-benzoic_acid,0.019751314914551527,1.0483058374623764,116.5,93.42501623464699 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_14,4-hydroxy-benzoic_acid,0.03260292353514304,1.7304080871623317,84.26,154.213968727907 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_14,4-hydroxy-benzoic_acid,0.026252535093855865,1.3933596778814703,138.68,124.17621449279665 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_14,4-hydroxy-benzoic_acid,0.010390346755729864,0.5514701782849478,53.66,49.14702228875455 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_14,4-hydroxy-benzoic_acid,0.009807965409987195,0.5205601468762822,32.16,46.39232028961427 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_14,4-hydroxy-benzoic_acid,0.019443050357625963,1.0319446212139463,133,91.9669046425869 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_14,4-hydroxy-benzoic_acid,0.018841176123146793,1,136.49,89.12 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_14,4-hydroxy-benzoic_acid,0.014432557462493771,0.7660114935586777,98.51,68.26694430594937 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_14,4-hydroxy-benzoic_acid,0.033850665472645466,1.7966322936209482,223.21,160.11587000749893 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_14,4-hydroxy-benzoic_acid,0.019739780597635478,1.047693650789917,73.46,93.37045815839741 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_14,4-hydroxy-benzoic_acid,0.013453073316384819,0.7140251345486562,49.38,63.633919990976246 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_14,4-hydroxy-benzoic_acid,0.024027834774666124,1.1918867935095607,118.32,39.6063981483227 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_14,4-hydroxy-benzoic_acid,0.01571399400938854,0.7794835493386151,82.56,25.902238344522175 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_14,4-hydroxy-benzoic_acid,0.021550078189991318,1.0689791167047,148.19,35.52217604809718 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_14,4-hydroxy-benzoic_acid,0.018536838400500525,0.9195091064248616,135.26,30.555287606498148 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_14,4-hydroxy-benzoic_acid,0.01818610689768292,0.9021112738612377,116.14,29.977157630408925 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_14,4-hydroxy-benzoic_acid,0.021732932892369602,1.078049518051291,145.38,35.82358548484439 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_15,benzoic_acid,0.0180230340299446,0.7825822381128769,273.7,500.2187407793698 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_15,benzoic_acid,0.01596972289220356,0.6934249506636216,376.69,443.2302942146803 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_15,benzoic_acid,0.01948351506519362,0.8459981155610151,506.2,540.7535354854454 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_15,benzoic_acid,0.023683981522999935,1.0283875199313646,436.45,657.335018864929 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_15,benzoic_acid,0.022950732073895735,0.9965489297127805,656.35,636.9841103831122 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_15,benzoic_acid,0.021004104179124575,0.9120239594923446,653.61,582.9565946679118 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_15,benzoic_acid,0.017837641069203138,0.7745322484215534,569.88,495.07326786857277 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_15,benzoic_acid,0.018815026949720082,0.8169715418614952,618.21,522.2000398424492 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_15,benzoic_acid,0.02214356323636893,0.9615006690061099,800.65,614.5816126220154 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_15,benzoic_acid,0.018850079515817415,0.8184935672642367,774.88,523.1729032596276 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_15,benzoic_acid,0.016952328788417622,0.7360909035861148,412.4,470.5019446632088 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_15,benzoic_acid,0.021784096124747784,0.9458921662272183,686.44,604.6048137307757 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_15,benzoic_acid,0.019143399499348512,0.8312298806293236,577.96,531.3138273994574 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_15,benzoic_acid,0.023031472270096685,1.000054768038538,676.97,639.2250071825532 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_15,benzoic_acid,0.016322584724602855,0.7087466441190547,528.76,453.02376745445866 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_15,benzoic_acid,0.02182996507305187,0.947883852208838,732.54,605.8778794933672 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_15,benzoic_acid,0.022404966985661665,0.9728511403436616,726.95,621.8367203962652 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_15,benzoic_acid,0.02022908253462857,0.8783715693271871,645.53,561.4463233982448 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_15,benzoic_acid,0.019328211407719915,0.8392546403142305,604.68,536.443173542453 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_15,benzoic_acid,0.01973867961057853,0.857077673014139,665.65,547.8354778139076 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_15,benzoic_acid,0.01892066930833876,0.9137585541268985,773.96,48.12766304586375 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_15,benzoic_acid,0.02119016359461629,1.0233619610589282,902.17,53.90047448897375 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_15,benzoic_acid,0.019179730209978995,0.9262696926630637,888.64,48.786624712563565 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_15,benzoic_acid,0.020772578896172855,1.003195042856567,1019.23,52.83828290725538 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_15,benzoic_acid,0.021733223820727416,1.049588619266861,1021.33,55.281832576785575 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_15,benzoic_acid,0.01837859897628863,0.8875797020589691,917.21,46.748822907445906 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_16,benzyl_alchohol,0.030373711078556437,1.1793691171464367,51.45,60.96158966529931 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_16,benzyl_alchohol,0.04281633456931919,1.6624989475228902,172.3,85.93457059745819 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_16,benzyl_alchohol,2.076094003325864e-4,0.008061185363496925,0.93,0.41668267143915605 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_16,benzyl_alchohol,0.005878532131133959,0.22825525770234328,12.79,11.798514270634124 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_16,benzyl_alchohol,0.032931301664274784,1.2786768159422615,156.11,66.0948046160555 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_16,benzyl_alchohol,0.011167928021976097,0.43363517146680125,56.26,22.414602013118955 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_16,benzyl_alchohol,0.002775982091922476,0.1077875383912596,11.97,5.571537859444208 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_16,benzyl_alchohol,0.029415019305674285,1.1421444439125557,128.19,59.03744630584 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_16,benzyl_alchohol,0.040775108957908805,1.583240985234399,144.58,81.83772652676608 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_16,benzyl_alchohol,0.0031304261463409,0.12155010992741867,12.24,6.282925182148271 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_16,benzyl_alchohol,0.012769329881802585,0.4958153868753027,11.16,25.628697347584396 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_16,benzyl_alchohol,0.0532177206754332,2.0663703584723194,48.53,106.81068382943418 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_16,benzyl_alchohol,0.01858189521552596,0.7215092452339212,16.14,37.294812886141386 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_16,benzyl_alchohol,0.016221297940764018,0.6298505237601477,16.75,32.55697357316203 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_16,benzyl_alchohol,0.019925482400938877,0.7736788740478465,16.16,39.99146099953318 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_16,benzyl_alchohol,0.014291170546752868,0.5549063513220898,11.02,28.68310929983882 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_16,benzyl_alchohol,0.025323486390808565,0.9832758898165276,37.24,50.82553074461631 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_16,benzyl_alchohol,0.0015521568576653592,0.06026810020557365,2.44,3.115258099626102 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_16,benzyl_alchohol,0.017540594374867345,0.6810769763565628,69.87,35.20486890787073 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_16,benzyl_alchohol,0.024594568848492843,0.9549730315938338,112.51,49.36255600308527 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_16,benzyl_alchohol,0.030531726491612267,1.3669993395686568,108.68,37.7565217588863 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_16,benzyl_alchohol,0.008225482388090656,0.36828015589759,30.19,10.171897905891436 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_16,benzyl_alchohol,0.03388027203565344,1.5169240268763786,108.93,41.89744162232558 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_16,benzyl_alchohol,0.006180694540344733,0.2767287122478311,20.56,7.643247032285094 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_16,benzyl_alchohol,0.002955863319685246,0.13234309586046528,4.46,3.655316307666051 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_16,benzyl_alchohol,0.038023296844364035,1.7024199954348496,55.53,47.020840273910544 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_17,4-aminobutyric_acid,0.018536604556109736,0.9423317110679699,23257.49,31996.995752435352 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_17,4-aminobutyric_acid,0.01993791515444429,1.0135691056981013,35529.15,34415.87074796277 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_17,4-aminobutyric_acid,0.019670997312720914,1,38354.65,33955.13 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_17,4-aminobutyric_acid,0.0216707549073478,1.1016602037423733,32803.3,37407.01543389877 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_17,4-aminobutyric_acid,0.020492731887562225,1.0417739152610177,39979.88,35373.568723296834 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_17,4-aminobutyric_acid,0.019799828879730256,1.0065493154699394,41742.57,34177.5128581928 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_17,4-aminobutyric_acid,0.019853002872169078,1.0092524825536153,39935.16,34269.299247930736 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_17,4-aminobutyric_acid,0.01999789840832144,1.0166184301895624,41128.96,34519.41095748251 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_17,4-aminobutyric_acid,0.020382285993247873,1.0361592586903043,42753.47,35182.922329532914 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_17,4-aminobutyric_acid,0.019673434611018382,1.000123903138144,46631.02,33959.33714716308 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_17,4-aminobutyric_acid,0.018944749143918492,0.9630802568239502,27201.75,32701.515320890612 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_17,4-aminobutyric_acid,0.019996438407411762,1.0165442091988082,39229.21,34516.890774092724 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_17,4-aminobutyric_acid,0.019788073713378027,1.0059517267373832,37281.32,34157.22165509232 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_17,4-aminobutyric_acid,0.021156445546514878,1.075514637625076,36888.21,36519.23933746234 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_17,4-aminobutyric_acid,0.020051044246528676,1.0193201660173068,41105.53,34611.14874873923 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_17,4-aminobutyric_acid,0.020318063040103654,1.032894403730323,43005.07,35072.063754935596 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_17,4-aminobutyric_acid,0.019920070042275216,1.012661926876134,40099.04,34385.06737312963 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_17,4-aminobutyric_acid,0.019563420948561533,0.9945312196199725,38721.88,33769.436851254715 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_17,4-aminobutyric_acid,0.02051388842750132,1.0428494346972088,39866.85,35410.08812557023 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_17,4-aminobutyric_acid,0.019695054737529034,1.0012229895833784,41287.71,33996.656770292255 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_17,4-aminobutyric_acid,0.020319853059105344,1.1757594703238012,59550.8,5117.011033201512 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_17,4-aminobutyric_acid,0.019657081648287066,1.1374097952221758,58915.53,4950.109795688479 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_17,4-aminobutyric_acid,0.019672957403346427,1.1383284076405475,55300.13,4954.107679608351 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_17,4-aminobutyric_acid,0.020337938859810275,1.1768059617228954,60383.3,5121.565457954596 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_17,4-aminobutyric_acid,0.01972458144360724,1.1413155086819022,60260.11,4967.10781217942 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_17,4-aminobutyric_acid,0.020243172184693674,1.1713225157838256,66511.54,5097.70100771763 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_18,calystegine_a_3,0.018561690233272855,0.9615383642997385,869.03,1313.9517901992356 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_18,calystegine_a_3,0.020062672454736565,1.0392927051992593,1448.21,1420.2038745818397 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_18,calystegine_a_3,0.021564012583384966,1.1170655865164152,1709.51,1526.4812946305465 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_18,calystegine_a_3,0.020883547315859702,1.0818159162506025,1189.02,1478.3122677156107 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_18,calystegine_a_3,0.019483853777427083,1.009308562741767,1574.46,1379.2302440722522 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_18,calystegine_a_3,0.019686202947963357,1.019790716468591,1714.98,1393.5542119614945 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_18,calystegine_a_3,0.020346942630770918,1.0540185559514337,1690.69,1440.3268968931936 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_18,calystegine_a_3,0.019517792967871258,1.0110666910832717,1658.37,1381.6327440322016 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_18,calystegine_a_3,0.020641122130490963,1.0692577325251424,1787.19,1461.1513840729324 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_18,calystegine_a_3,0.01955600810918856,1.0130463235419502,1912.69,1384.3379315833104 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_18,calystegine_a_3,0.020361744442822634,1.0547853239542402,1335.43,1441.3746930367088 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_18,calystegine_a_3,0.020373787473154336,1.0554091807011652,1792.96,1442.2271995199492 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_18,calystegine_a_3,0.020120296252427186,1.0422777508217134,1698.75,1424.2829692753796 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_18,calystegine_a_3,0.01930415979480009,1,1534.96,1366.51 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_18,calystegine_a_3,0.020328058316962317,1.053040304941841,1841,1438.9901071060754 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_18,calystegine_a_3,0.02033991320217869,1.0536544153378589,1895.12,1439.8292951033375 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_18,calystegine_a_3,0.01890010714774792,0.9790691409858195,1680.72,1337.9077718485323 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_18,calystegine_a_3,0.019339404208483176,1.0018257419156145,1695.51,1369.0048945851063 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_18,calystegine_a_3,0.01935374311959178,1.0025685305819445,1767.87,1370.019922725533 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_18,calystegine_a_3,0.02123486764487641,1.1000151195700518,2106.03,1503.1816610436715 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_18,calystegine_a_3,0.020149131654218482,1.1817014153530372,941.64,73.67908324726187 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_18,calystegine_a_3,0.019922692978144266,1.168421294472416,972.57,72.85106771035514 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_18,calystegine_a_3,0.01720245600940624,1.0088854925719715,931.9,62.90401046186242 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_18,calystegine_a_3,0.022790805683790057,1.3366296769385695,1305.99,83.33886035711981 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_18,calystegine_a_3,0.02031679285439612,1.191534368998373,1034.46,74.29216790704857 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_18,calystegine_a_3,0.01962813457883487,1.1511461044869875,1051.84,71.77395961476367 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_19,calystegine_b_2,0.020058285015459032,1.0231564365348191,1530.02,2261.0427144052005 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_19,calystegine_b_2,0.020096576025325327,1.025109629102176,2404.69,2265.3590160640256 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_19,calystegine_b_2,0.01928995778974984,0.9839647037549012,2490.65,2174.4340798868434 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_19,calystegine_b_2,0.02012264925613623,1.0264396029212175,1871.65,2268.298085307511 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_19,calystegine_b_2,0.02085187588694849,1.0636368468746826,2907.85,2350.4991588029548 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_19,calystegine_b_2,0.019706991430469306,1.0052372429288545,2903.5,2221.4436260311877 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_19,calystegine_b_2,0.020190142037649777,1.0298823535737285,2843.46,2275.906116691975 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_19,calystegine_b_2,0.01932364266266658,0.9856829411072999,2723.16,2178.231161064789 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_19,calystegine_b_2,0.02019661271974947,1.0302124176860876,2810.18,2276.6355154719545 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_19,calystegine_b_2,0.019975235951249705,1.0189201728398682,3106.73,2251.6811223536397 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_19,calystegine_b_2,0.020366932244829536,1.0389002750088305,2146.71,2295.834550733764 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_19,calystegine_b_2,0.01990174885160654,1.0151716570049287,2792.47,2243.3973896654816 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_19,calystegine_b_2,0.020077638298952177,1.0241436314300374,2714.54,2263.2242867882965 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_19,calystegine_b_2,0.019644488617554665,1.0020490264245094,2468.78,2214.3980820247307 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_19,calystegine_b_2,0.0203200025236852,1.0365064289638368,3013.31,2290.544462174314 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_19,calystegine_b_2,0.01952537177320124,0.9959729752613119,2944.14,2200.9707988407154 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_19,calystegine_b_2,0.019600298602063738,0.9997949304863337,2833.21,2209.416823033834 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_19,calystegine_b_2,0.020779102335898195,1.0599247285600202,3027.32,2342.2958599029316 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_19,calystegine_b_2,0.02042992419284508,1.0421134418878681,2875.5,2302.935231824743 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_19,calystegine_b_2,0.019434556888226266,0.9913405835077946,2879.44,2190.73381527637 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_19,calystegine_b_2,0.019983612108789836,0.9925334613917648,2406.21,3.662448472535612 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_19,calystegine_b_2,0.02001738256872343,0.9942107513285494,2477.29,3.6686376724023475 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_19,calystegine_b_2,0.020033977083390175,0.9950349572324989,2398.49,3.6716789921879207 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_19,calystegine_b_2,0.019963744487608875,0.9915466888947303,2519.6,3.658807282021555 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_19,calystegine_b_2,0.02011681334959721,0.9991492167357182,2534.29,3.6868606097548002 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_19,calystegine_b_2,0.01989371601116208,0.9880685586275221,2668.37,3.6459729813355564 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_20,4-hydroxy-cinnamic_acid,0.028992814757011553,1.5468914464195858,90.72,66.93399288657548 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_20,4-hydroxy-cinnamic_acid,0.03515303836310011,1.8755658881443544,56.5,81.15573598000623 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_20,4-hydroxy-cinnamic_acid,0.002889614752351686,0.15417338334766817,4.7,6.671082297453602 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_20,4-hydroxy-cinnamic_acid,0.00924465000872635,0.4932418650446193,32.74,21.342575500480677 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_20,4-hydroxy-cinnamic_acid,0.031266277327252616,1.6681904590589327,29.49,72.18260116348003 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_20,4-hydroxy-cinnamic_acid,0.028648670264637847,1.5285298566240813,28.46,66.139486896124 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_20,4-hydroxy-cinnamic_acid,0.013747589723518576,0.733493078558499,33.97,31.738245509226253 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_20,4-hydroxy-cinnamic_acid,0.01379314396282845,0.735923593281791,38.34,31.8434138813031 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_20,4-hydroxy-cinnamic_acid,0.010353263548985818,0.5523911686629436,80.44,23.901965868045572 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_20,4-hydroxy-cinnamic_acid,0.0299726985562029,1.5991724643255016,280.15,69.19619253136446 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_20,4-hydroxy-cinnamic_acid,0.023156918191577294,1.2355212481508404,129.67,53.46100440748687 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_20,4-hydroxy-cinnamic_acid,0.01258338014468267,0.6713774870081655,48.36,29.05050386284332 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_20,4-hydroxy-cinnamic_acid,0.02550371109900937,1.360732749878071,89.48,58.87890608722414 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_20,4-hydroxy-cinnamic_acid,0.01709866496481559,0.9122873650227746,110.9,39.47467428453546 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_20,4-hydroxy-cinnamic_acid,0.031203616626976686,1.6648472410203994,67.52,72.03794011895269 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_20,4-hydroxy-cinnamic_acid,0.008695824463079184,0.4639596601516691,18.94,20.075534494762724 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_20,4-hydroxy-cinnamic_acid,0.03310917386904636,1.7665169210126677,57.35,76.43718717221813 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_20,4-hydroxy-cinnamic_acid,0.008343106709657057,0.44514064998167274,14.34,19.26123592470698 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_20,4-hydroxy-cinnamic_acid,0.026682134389138384,1.4236067040987923,66.46,61.59946208635475 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_20,4-hydroxy-cinnamic_acid,0.013816560706852705,0.7371729773563523,38.8,31.897474730209368 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_20,4-hydroxy-cinnamic_acid,0.026818492040236716,1.5416928517764492,125.79,62.484811282499486 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_20,4-hydroxy-cinnamic_acid,0.012094082662648921,0.6952426990236827,57.75,28.178186591429863 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_20,4-hydroxy-cinnamic_acid,0.036708416210878746,2.1102268832803084,156.68,85.5274955793509 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_20,4-hydroxy-cinnamic_acid,0.003471753433480462,0.19957786752129145,15.6,8.088890970637943 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_20,4-hydroxy-cinnamic_acid,0.014745148898759292,0.8476423887476684,71.41,34.354946015943 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_20,4-hydroxy-cinnamic_acid,0.025086315051095025,1.4421166012488364,132.14,58.448985848615344 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_22,decanoic_acid,0.024135408510189534,1.2043149318064923,89.53,58.65013717897618 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_22,decanoic_acid,0.004829016444248402,0.24095952663457837,11.26,11.734728947103967 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_22,decanoic_acid,0.011051162136149165,0.5514337811502182,26.59,26.85482514201563 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_22,decanoic_acid,0.019785311394241268,0.9872526471829239,83.88,48.0792039178084 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_22,decanoic_acid,0.021858458448199305,1.090699081572391,39.98,53.11704527257544 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_22,decanoic_acid,0.028366317214300066,1.4154299218560373,59.9,68.93143719438902 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_22,decanoic_acid,0.02617662055671098,1.3061678648352095,61.63,63.61037501747471 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_22,decanoic_acid,0.022920259672538898,1.1436811170139176,55.58,55.69727039857779 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_22,decanoic_acid,0.016031505522953036,0.7999442591775288,45.11,38.957285421945656 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_22,decanoic_acid,0.019600779568983796,0.9780448298610313,63.14,47.630783214232224 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_22,decanoic_acid,0.024751333041206844,1.2350484952867582,29.92,60.146861720465125 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_22,decanoic_acid,0.005700961634881916,0.2844680760073171,11.54,13.853595301556345 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_22,decanoic_acid,0.0036477972964787282,0.18201874438951388,7.26,8.864312851769327 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_22,decanoic_acid,0.029862311722942937,1.4900774474572098,43.98,72.56677169116612 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_22,decanoic_acid,0.04345387137923736,2.1682726490716178,146,105.59487800978779 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_22,decanoic_acid,0.0038008323441187037,0.18965492725688615,13.93,9.236194957410357 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_22,decanoic_acid,0.04228672631085209,2.110034138923871,179.95,102.75866256559252 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_22,decanoic_acid,9.161037515984651e-4,0.04571198480722601,3.85,2.226173660111907 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_22,decanoic_acid,0.014807449985443463,0.7388660155438715,58.45,35.982774956986546 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_22,decanoic_acid,0.023830599529306683,1.1891054934880583,100.32,57.90943753286844 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_22,decanoic_acid,0.01979315457416715,0.48666062935689086,24.93,11.655522073097536 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_22,decanoic_acid,0.02004609388441568,0.492879729170081,24.87,11.80446951362344 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_22,decanoic_acid,0.027510027130486545,0.676397845870461,22.05,16.19972840859754 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_22,decanoic_acid,0.012909024418081623,0.31739831688509,10.82,7.601689689397905 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_22,decanoic_acid,0.0032794310696116057,0.08063242179458806,4.88,1.931146501980384 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_22,decanoic_acid,0.03454857812015297,0.8494569528236416,58.48,20.344494020126216 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_23,dehydroascorbic_acid,0.020655403247972656,1.0047296707333633,96574.2,135157.8529218219 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_23,dehydroascorbic_acid,0.020450383370924755,0.9947569991235582,129216.96,133816.31308086962 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_23,dehydroascorbic_acid,0.019609829544881753,0.9538703914531538,135156.3,128316.18078960848 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_23,dehydroascorbic_acid,0.019243060601595495,0.9360298470106533,108123.62,125916.24202792675 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_23,dehydroascorbic_acid,0.02119978193881826,1.0312095905994276,141323.95,138719.97437487586 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_23,dehydroascorbic_acid,0.01886295563058695,0.9175406053444073,135496.18,123429.03947130426 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_23,dehydroascorbic_acid,0.020030047235447147,0.9743108145622762,134180.14,131065.85941532883 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_23,dehydroascorbic_acid,0.01981513008970951,0.963856715434818,135602.49,129659.55716960355 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_23,dehydroascorbic_acid,0.019594015793395803,0.9531011716450101,136657.48,128212.70410257309 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_23,dehydroascorbic_acid,0.020458456301463448,0.9951496863417459,161350.92,133869.13799768666 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_23,dehydroascorbic_acid,0.020620573381817442,1.003035460287133,112280.68,134929.94500491617 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_23,dehydroascorbic_acid,0.020558169873590028,1,142762.75,134521.61 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_23,dehydroascorbic_acid,0.020155183108046253,0.9803977315090936,133956.1,131884.68128295097 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_23,dehydroascorbic_acid,0.019077539825832657,0.9279785089401632,125357.77,124833.16306803013 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_23,dehydroascorbic_acid,0.019530504468280932,0.9500118244168572,137246.99,127797.12013959292 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_23,dehydroascorbic_acid,0.02017356448198816,0.9812918467953731,146180.82,132004.9591107869 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_23,dehydroascorbic_acid,0.019597095164197165,0.9532509598226686,136076.22,128232.85384939068 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_23,dehydroascorbic_acid,0.02031494649287269,0.988169015908863,138951.66,132930.08697217584 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_23,dehydroascorbic_acid,0.021276016389465364,1.0349178219797432,148969.87,139218.81163040843 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_23,dehydroascorbic_acid,0.018845818539683656,0.9167070150487404,142997.22,123316.90356265078 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_23,dehydroascorbic_acid,0.019785613940597534,0.9719586250489053,66942.93,7002.300961612329 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_23,dehydroascorbic_acid,0.02024286178687744,0.9944207022586947,69942.18,7164.12495369636 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_23,dehydroascorbic_acid,0.019625007661460744,0.964068919997918,61660.94,6945.4610017194 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_23,dehydroascorbic_acid,0.020377883091838186,1.0010535579444453,67461.85,7211.910168570325 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_23,dehydroascorbic_acid,0.019625563318493897,0.9640962163783874,64604.1,6945.657653579144 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_23,dehydroascorbic_acid,0.020334989721244777,0.9989464420555549,71844.7,7196.729831429675 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_24,erythritol,0.012497023005026288,0.623190918144685,57.04,76.83320829805821 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_24,erythritol,2.3812063730399666e-4,0.011874397488985262,NA,1.463994466416993 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_24,erythritol,0.025350428090722223,1.2641535948892784,110.18,155.85749671389914 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_24,erythritol,0.03236964961793342,1.6141821662093712,171.78,199.01251927195338 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_24,erythritol,0.01566152686658625,0.780995706226197,64.44,96.28896062062783 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_24,erythritol,0.02698749614524252,1.345789512783605,124.67,165.92238903109066 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_24,erythritol,0.03389983046775258,1.6904879238560269,170.62,208.42025613220957 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_24,erythritol,0.01209320853630289,0.6030538415447118,62.63,74.35050812404752 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_24,erythritol,0.016904531076244008,0.8429807833411844,96.79,103.93110077813463 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_24,erythritol,0.020661361852025825,1.030323226379982,134.54,127.02855058038799 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_24,erythritol,0.009516675963875927,0.4745695058117418,51.5,58.50967437152965 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_24,erythritol,0.01743123289451998,0.8692459018088277,176.83,107.16932723401037 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_24,erythritol,0.02094069376889989,1.0442527129204044,206.19,128.74591697595667 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_24,erythritol,0.03160092711916254,1.5758481662147468,215.54,194.28632041261613 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_24,erythritol,0.013479704427049703,0.6721944398144611,151.37,82.87485248472491 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_24,erythritol,0.027841811444009688,1.3883917817567542,322.6,171.17482277279024 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_24,erythritol,0.013289266472547766,0.6626978418112467,128.65,81.70401691690861 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_24,erythritol,0.026163361913950814,1.3046922876231348,244.14,160.8555121410563 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_24,erythritol,0.019471429888973785,0.9709847109362755,108.71,119.71270501133341 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_24,erythritol,0.020208382675534958,1.0077344459332924,113.5,124.24357983911563 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_24,erythritol,0.022703204325319554,1.301251741222662,216.64,202.34464576012394 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_24,erythritol,0.017011924664557997,0.9750516391475618,170.27,151.62052988744585 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_24,erythritol,0.022627643426490037,1.2969209097787235,262.92,201.6712014705915 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_24,erythritol,0.01751984260153655,1.0041633491256317,215.31,156.14740078903571 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_24,erythritol,0.013670597835501501,0.7835409038345383,162.08,121.84061054627071 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_24,erythritol,0.025894914234680034,1.4841870668938983,327.23,230.7910889020012 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_25,erythronic_acid,0.020323146680244396,1.0592288443853586,3574.49,4131.680991851749 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_25,erythronic_acid,0.0197028347273657,1.0268985993035362,4302.57,4005.5720213733384 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_25,erythronic_acid,0.019088557491524424,0.9948828796470484,4492.45,3880.6899044952593 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_25,erythronic_acid,0.0200830463554476,1.0467149756635292,4206.93,4082.8687698219455 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_25,erythronic_acid,0.020777535271316882,1.0829112745619542,4706.48,4224.057863120087 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_25,erythronic_acid,0.019504803730903617,1.0165773559038163,4701.11,3965.312463306221 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_25,erythronic_acid,0.02089052186639352,1.0888000605072137,4738.85,4247.027956017463 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_25,erythronic_acid,0.01982945128000257,1.0334977695422662,4526.34,4031.3130747650407 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_25,erythronic_acid,0.02052748181697956,1.0698786553696835,4668.82,4173.222177067756 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_25,erythronic_acid,0.019186738340794863,1,4830.56,3900.65 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_25,erythronic_acid,0.021154587620883313,1.102562991433745,4344.14,4300.712332536037 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_25,erythronic_acid,0.019182552117353712,0.9997818168274984,4455.72,3899.798943808182 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_25,erythronic_acid,0.019985235585896467,1.0416171436186128,4468.6,4062.983911255942 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_25,erythronic_acid,0.019107814746821928,0.9958865549437798,4586.85,3884.6048905414546 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_25,erythronic_acid,0.019826513654177785,1.0333446624444047,4558.9,4030.7158575637673 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_25,erythronic_acid,0.02031764435514124,1.0589420668724001,4864.01,4130.562373145827 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_25,erythronic_acid,0.020064607839316278,1.045753972505837,4579.67,4079.120232854893 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_25,erythronic_acid,0.020499117841938322,1.0684003439163536,4632.31,4167.4558014973245 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_25,erythronic_acid,0.02036756263769849,1.0615437744513854,4677.54,4140.710723813796 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_25,erythronic_acid,0.01938668413474111,1.0104210413669488,4759.47,3941.2988350079886 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_25,erythronic_acid,0.020238533303028838,1.0041216922902834,2856.48,66.2720316911587 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_25,erythronic_acid,0.019721609863243297,0.9784748713783998,2808.65,64.57934151097439 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_25,erythronic_acid,0.020738668732662502,1.0289355869761658,2780.75,67.90974874042695 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_25,erythronic_acid,0.019260415150254333,0.9555929950710637,2643.49,63.069137674690204 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_25,erythronic_acid,0.020341376775339343,1.0092242044096758,3063.15,66.6087974910386 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_25,erythronic_acid,0.019704188328477836,0.9776105132399387,3162.43,64.52229387383596 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_26,ethanolamine,0.017638350035426142,0.8776915379447765,2408.63,3548.9545105950833 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_26,ethanolamine,0.019915950308301792,0.9910258624314022,3971.8,4007.2229849999994 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_26,ethanolamine,0.020778147981563265,1.0339291725674054,4538.57,4180.70294856803 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_26,ethanolamine,0.022258226719398234,1.1075784981041266,3677.71,4478.504732869017 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_26,ethanolamine,0.019779318414834143,0.9842270033278541,4314.83,3979.7317302262113 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_26,ethanolamine,0.01968344062743227,0.9794560852708658,4632.77,3960.4404753535987 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_26,ethanolamine,0.020211160668435365,1.0057156511294645,4493.89,4066.621292498501 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_26,ethanolamine,0.020069149346463713,0.9986491094554116,4558.15,4038.047660574052 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_26,ethanolamine,0.020221375434014893,1.0062239420576542,4612.18,4068.6765719495456 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_26,ethanolamine,0.01974612113979291,0.9825750932949997,5081.47,3973.0522154892647 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_26,ethanolamine,0.0169816274878358,0.8450127544055058,2675.36,3416.817522566207 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_26,ethanolamine,0.020419324666480804,1.0160739771192695,4440.17,4108.505287221537 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_26,ethanolamine,0.019183076989031645,0.95455778523501,4009.21,3859.7639501756157 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_26,ethanolamine,0.023328059724530625,1.160813827584084,4465.93,4693.762319974519 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_26,ethanolamine,0.01982103179941388,0.9863026784670331,4563.09,3988.1247434082334 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_26,ethanolamine,0.02021641690888031,1.005977203811584,4816.97,4067.678883384178 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_26,ethanolamine,0.020572246784923563,1.0236834445043834,4730.35,4139.274244687919 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_26,ethanolamine,0.01976116461545424,0.9833236628189467,4469.54,3976.0790638450394 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_26,ethanolamine,0.020531090291984924,1.0216354805218582,4554.18,4130.993281844939 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_26,ethanolamine,0.01936822248623086,0.9637707011740831,4631.42,3897.0164679044174 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_26,ethanolamine,0.020283987989365784,1.0972957645515988,4725.7,658.5530260532876 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_26,ethanolamine,0.019692701661972945,1.0653091560490902,4706.6,639.355943094422 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_26,ethanolamine,0.019958568563419387,1.0796916643134702,4591.64,647.9877492543723 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_26,ethanolamine,0.02003839167067933,1.0840098268737914,4871.11,650.5793376965746 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_26,ethanolamine,0.020491465366579257,1.1085195952586557,5006.23,665.2891202904348 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_26,ethanolamine,0.019547136380968513,1.0574345622366867,5118.56,634.6299268719699 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_27,fructose-6-phosphate,0.01702425822604512,0.8117298354612065,471,560.4507475958354 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_27,fructose-6-phosphate,0.013827610768423102,0.6593112055068485,436.84,455.21482873014855 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_27,fructose-6-phosphate,0.017815906345821034,0.8494762317785371,609.19,586.5123694691732 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_27,fructose-6-phosphate,0.025668774865449776,1.2239070931234755,840.55,845.0344133761724 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_27,fructose-6-phosphate,0.025546725692051752,1.2180876938800484,841.38,841.0164673625408 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_27,fructose-6-phosphate,0.019677103998176314,0.9382195793034123,707.24,647.784326334248 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_27,fructose-6-phosphate,0.01998770036958389,0.9530290551765991,705.67,658.0093808561311 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_27,fructose-6-phosphate,0.018448214417155117,0.8796251710092389,667.99,607.3284030716189 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_27,fructose-6-phosphate,0.018428896110080244,0.8787040591455052,721.77,606.6924305964227 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_27,fructose-6-phosphate,0.021598792083398193,1.029847157581006,961.88,711.0476714802298 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_27,fructose-6-phosphate,0.01663335434232343,0.7930912351180145,596.01,547.581912374882 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_27,fructose-6-phosphate,0.01988597275184723,0.9481786034675838,780.69,654.6604349781586 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_27,fructose-6-phosphate,0.018834904829956037,0.8980628697911515,701.57,620.0585278186027 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_27,fructose-6-phosphate,0.02395849698891285,1.1423597175561602,1023.04,788.7308433894752 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_27,fructose-6-phosphate,0.020267234802648512,0.966357473739362,738.4,667.2118541686051 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_27,fructose-6-phosphate,0.02097281322223708,1,786.92,690.44 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_27,fructose-6-phosphate,0.014973813768671596,0.7139630535018137,535.26,492.94865065979224 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_27,fructose-6-phosphate,0.024645698935379504,1.1751260393263854,869.65,811.3540225925096 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_27,fructose-6-phosphate,0.018368969467913828,0.8758467103706219,705.48,604.7196027082922 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_27,fructose-6-phosphate,0.02142095514793787,1.0213677545759876,897.97,705.193152469445 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_27,fructose-6-phosphate,0.017935311492116503,0.8017685550352507,615.7,129.349320983837 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_27,fructose-6-phosphate,0.022330070770052505,0.998229028975015,783.43,161.0442892445392 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_27,fructose-6-phosphate,0.01679421029710367,0.7507575058724534,535.21,121.11970842240291 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_27,fructose-6-phosphate,0.023223060157037616,1.0381486484797877,778.44,167.48452145924418 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_27,fructose-6-phosphate,0.017293666467511595,0.7730848712057747,575.51,124.72178227162765 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_27,fructose-6-phosphate,0.022409302904506125,1.001770971024985,801.06,161.61571075546084 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_28,fructose-6-phosphate_peak_2,0.008570278866086101,0.41288743510184417,170.79,125.88525008820126 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_28,fructose-6-phosphate_peak_2,0.010725610814927455,0.5167241356404548,186.32,157.54402171541827 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_28,fructose-6-phosphate_peak_2,0.012857565540957589,0.619434599598302,236.77,188.8594150715263 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_28,fructose-6-phosphate_peak_2,0.03627814943145171,1.7477601724568013,841.28,532.8745989803541 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_28,fructose-6-phosphate_peak_2,0.02246439214991451,1.0822594457928134,326.51,329.9700824277709 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_28,fructose-6-phosphate_peak_2,0.02974244665920126,1.4328918237848678,474.2,436.87438815376834 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_28,fructose-6-phosphate_peak_2,0.01949839109648569,0.93936741315364,288.79,286.4037305964133 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_28,fructose-6-phosphate_peak_2,0.01757859743904648,0.8468781614582798,266.3,258.2046826470149 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_28,fructose-6-phosphate_peak_2,0.018793776666423182,0.9054214413468769,309.85,276.05394325224927 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_28,fructose-6-phosphate_peak_2,0.020957660826916386,1.0096701589025012,394.46,307.83833474778356 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_28,fructose-6-phosphate_peak_2,0.012069382937323134,0.581462592071884,338.3,177.28212969679672 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_28,fructose-6-phosphate_peak_2,0.017666089137442005,0.851093219510379,354.39,259.48981169651944 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_28,fructose-6-phosphate_peak_2,0.008501306214627375,0.40956456292954435,156.81,124.87213959158878 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_28,fructose-6-phosphate_peak_2,0.031552935846633635,1.520115150885303,1024.77,463.46790835342 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_28,fructose-6-phosphate_peak_2,0.0183395486681138,0.8835382522343791,254.96,269.38197772373985 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_28,fructose-6-phosphate_peak_2,0.031825301784032735,1.5332368328117607,463.41,467.4685779559777 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_28,fructose-6-phosphate_peak_2,0.016805584149690852,0.8096369608709011,228.68,246.85021299992903 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_28,fructose-6-phosphate_peak_2,0.024236502040143704,1.1676337864330835,325.69,355.9998651455828 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_28,fructose-6-phosphate_peak_2,0.017429795541336227,0.8397093826071044,272.78,256.01899366308004 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_28,fructose-6-phosphate_peak_2,0.020886555992716316,1.0062445652812266,360.31,306.7939055085932 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_28,fructose-6-phosphate_peak_2,0.019278160724104158,0.9644584914041646,257.69,95.60677025289483 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_28,fructose-6-phosphate_peak_2,0.0208835946114594,1.0447760262150334,286.49,103.56864747869626 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_28,fructose-6-phosphate_peak_2,0.01575487115178851,0.7881934112273584,206.47,78.13361285496804 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_28,fructose-6-phosphate_peak_2,0.024296381203328093,1.2155128021442108,335.55,120.49378407655561 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_28,fructose-6-phosphate_peak_2,0.016616594852264282,0.831304201310612,223.76,82.40718547592097 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_28,fructose-6-phosphate_peak_2,0.023008450850546144,1.1510795098372013,331.58,114.10651181016176 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_30,fucose,0.020147654670730125,1.0113524471657855,5279.12,7545.599473059209 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_30,fucose,0.019921496929376024,1,7457.88,7460.9 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_30,fucose,0.0198285862906825,0.9953361617842825,8120.02,7426.103569456353 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_30,fucose,0.0199123038555745,0.9995385349889059,6290.02,7457.457055698727 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_30,fucose,0.02033490624188389,1.0207519200978445,8378.04,7615.728000658008 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_30,fucose,0.019958127097470354,1.0018387256853332,8861.31,7474.618548465702 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_30,fucose,0.01990225975022186,0.9990343507206129,8372.78,7453.69538729142 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_30,fucose,0.01978008038722914,0.9929013094423464,8496.99,7407.937379618402 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_30,fucose,0.02005361518356413,1.0066319441082405,8725.8,7510.380271797171 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_30,fucose,0.02005001088953465,1.006451019248916,9850.47,7509.030409514237 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_30,fucose,0.01928678094301912,0.9681391419225651,6347.61,7223.189323970066 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_30,fucose,0.019898690218067547,0.9988551708042157,8521.04,7452.358543853173 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_30,fucose,0.020287166291974093,1.0183555163497204,8343.83,7597.848671933629 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_30,fucose,0.02071428430904397,1.0397955727161703,8310.19,7757.810788478075 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_30,fucose,0.01985214948730851,0.9965189642970426,8755.14,7434.9283407238045 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_30,fucose,0.019860902716300956,0.9969583504045965,9053.89,7438.206556533653 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_30,fucose,0.019960841271508475,1.0019749691638098,8828.04,7475.635047434268 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_30,fucose,0.020407813779486327,1.0244116620269226,8917.55,7643.032969216666 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_30,fucose,0.020003843109146806,1.0041335337431072,8912.81,7491.739881903948 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_30,fucose,0.019873112868045363,0.9975712637708809,9582.23,7442.779441868165 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_30,fucose,0.020158036580879793,1.0130874236341627,9063.04,752.81513362831 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_30,fucose,0.019821324903609612,0.9961652216992412,9116.29,740.2404145924892 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_30,fucose,0.02023938061921504,1.0171755510613756,8894.14,755.8529802381976 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_30,fucose,0.019764040535930845,0.9932862670831333,9146.94,738.1010922068056 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_30,fucose,0.01997393088698855,1.003834778300759,9361.55,745.9395854075111 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_30,fucose,0.020028857112809374,1.0065952191990333,10078.11,747.9908414346097 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_31,fucose_peak_2,0.01954269899392076,1.0089904589055656,157.19,598.7046686007955 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_31,fucose_peak_2,0.01936856669102539,1,454.69,593.37 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_31,fucose_peak_2,0.020729649154117003,1.0702727509373362,614.52,635.0677422236872 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_31,fucose_peak_2,0.020309308326040828,1.0485705344139553,244.46,622.1902980052087 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_31,fucose_peak_2,0.019710813185980194,1.0176702024684865,667.29,603.8549680387258 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_31,fucose_peak_2,0.021215369426330913,1.0953505112054192,855.82,649.9481328339596 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_31,fucose_peak_2,0.019175862295079105,0.9900506630655548,688.85,587.4663619432082 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_31,fucose_peak_2,0.018913956866397238,0.9765284735891789,683.98,579.4427003736112 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_31,fucose_peak_2,0.02074232267762922,1.0709270855463133,884.8,635.456004750616 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_31,fucose_peak_2,0.01995851074310038,1.030458838874657,918.57,611.4433612230551 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_31,fucose_peak_2,0.0192885406124205,0.9958682498358554,273.96,590.9183434051015 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_31,fucose_peak_2,0.020365714755600978,1.05148280099826,645.44,623.9183496283375 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_31,fucose_peak_2,0.021659793738709902,1.118296159144609,730.32,663.5633919516366 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_31,fucose_peak_2,0.019935773323805205,1.029284904857861,390.79,610.746783995509 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_31,fucose_peak_2,0.01863580252102554,0.9621673517876063,624.17,570.9212415302119 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_31,fucose_peak_2,0.020319728458415384,1.0491085263335838,799.68,622.5095262705586 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_31,fucose_peak_2,0.019949773394079825,1.030007729137941,803.79,611.17568623858 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_31,fucose_peak_2,0.0200877698485155,1.0371324925051557,809.05,615.4033070777842 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_31,fucose_peak_2,0.02072921822640982,1.0702505021197515,941.8,635.0545404427969 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_31,fucose_peak_2,0.0193948246655216,1.0013557004457319,886,594.1744319734839 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_31,fucose_peak_2,0.018958446817270602,0.8778237106099485,428.6,191.78692429406152 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_31,fucose_peak_2,0.021114663956450917,0.9776619804977414,617.16,213.59958949914653 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_31,fucose_peak_2,0.02054356130478888,0.9512184931354509,699.71,207.8222163802333 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_31,fucose_peak_2,0.019433599172679644,0.899824458231861,651.02,196.593647634497 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_31,fucose_peak_2,0.02042285941983336,0.9456296926630016,847.43,206.60117525301257 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_31,fucose_peak_2,0.019628755317822433,0.9088606779775374,835.47,198.56788092453237 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_32,fumaric_acid,0.014223925566096458,0.715393464593349,867.83,1844.456046153156 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_32,fumaric_acid,0.02074502231033231,1.0433725426002634,2147.53,2690.064824233703 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_32,fumaric_acid,0.01889055447019965,0.9501019354837827,2164.72,2449.5908141417076 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_32,fumaric_acid,0.026335502942147752,1.3245462094162124,1965.61,3414.998018965255 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_32,fumaric_acid,0.020429370615118892,1.0274968155519066,2702.29,2649.1333897285476 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_32,fumaric_acid,0.018547457276121313,0.9328458348930286,2687.96,2405.100445354602 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_32,fumaric_acid,0.02065849775690138,1.0390207833222982,3222.63,2678.8449443928816 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_32,fumaric_acid,0.021493045175400374,1.0809944119322852,3450.82,2787.0630326202945 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_32,fumaric_acid,0.019973892811816933,1.004588523306183,3491.76,2590.0703143289334 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_32,fumaric_acid,0.019315456396034283,0.9714724115469983,3828.78,2504.6890303469327 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_32,fumaric_acid,0.018105356696077168,0.9106103511521427,1105.21,2347.7720317545004 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_32,fumaric_acid,0.02143012733477919,1.0778299541475787,2791.33,2778.904300981453 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_32,fumaric_acid,0.02195141922691148,1.104048371211419,2802.8,2846.5016725921287 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_32,fumaric_acid,0.020058692575538464,1.008853534148903,1558.92,2601.066535884068 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_32,fumaric_acid,0.02062896654396337,1.0375355086251554,3477.86,2675.0155497577207 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_32,fumaric_acid,0.017235870454947302,0.866879471686577,3032.24,2235.0233290812002 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_32,fumaric_acid,0.020470426136516822,1.0295617062571532,3935.11,2654.4571735404425 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_32,fumaric_acid,0.020788538086086647,1.0455611719935136,3965.07,2695.7076360805563 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_32,fumaric_acid,0.020653376398462257,1.0387632041933748,4294.83,2678.1808435795265 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_32,fumaric_acid,0.019120136135704086,0.9616487635608227,4319.4,2479.3613081630556 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_32,fumaric_acid,0.020648777399981718,1.0951738355646723,3377,114.27043800281791 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_32,fumaric_acid,0.01922219722969948,1.019510601535626,3314.27,106.3757361642272 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_32,fumaric_acid,0.022814071753681792,1.2100171348328574,4781.37,126.25318784846036 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_32,fumaric_acid,0.01720607377670822,0.9125790572502832,3828.3,95.21849883349455 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_32,fumaric_acid,0.020224894262641777,1.07269184002763,4382.64,111.9246665884829 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_32,fumaric_acid,0.019858213272557428,1.0532437430018136,4571.03,109.89545214480923 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_33,galactinol,0.019369007679053862,1.0045772272798863,1453.96,1778.5637978099476 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_33,galactinol,0.0203838137788203,1.057210336565735,1978.21,1871.7486124761713 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_33,galactinol,0.018847945117626084,0.9775522195008589,1989.77,1730.7171025374907 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_33,galactinol,0.020957739919345048,1.086977123820164,1884.1,1924.4495186386475 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_33,galactinol,0.02054023373799821,1.0653230871767077,2045.92,1886.111912922874 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_33,galactinol,0.019338923703368295,1.0030169162210785,2078.73,1775.8013294927707 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_33,galactinol,0.021313945155778894,1.1054517754227993,2084.58,1957.1581503150492 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_33,galactinol,0.01978812068150588,1.0263146020022635,1969.72,1817.0489502609275 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_33,galactinol,0.020983664457943953,1.0883217048919327,1992.96,1926.8300456429713 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_33,galactinol,0.018631218648653455,0.9663116604135634,1988.15,1710.8161422957976 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_33,galactinol,0.02164581699931431,1.1226643710247728,2293.94,1987.6323623245194 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_33,galactinol,0.020390306746566705,1.0575470955594626,2344.83,1872.3448308042061 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_33,galactinol,0.01921838319811241,0.9967650602379852,2094.54,1764.7326685489434 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_33,galactinol,0.018380974774157177,0.9533327147829566,2320.84,1687.8374382146333 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_33,galactinol,0.019818184091861406,1.02787384643636,2082.44,1819.809530161718 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_33,galactinol,0.020091214297092427,1.042034609397451,2171.77,1844.8805945538113 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_33,galactinol,0.018927484861431983,0.9816775632776333,1858.91,1738.0208586805188 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_33,galactinol,0.021983711904454764,1.1401893538500456,2119.54,2018.6596434173518 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_33,galactinol,0.01928075528000939,1,1849.55,1770.46 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_33,galactinol,0.020256928215500146,1.050629392952405,2103.9,1860.0973150465152 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_33,galactinol,0.01958195682354845,1.0714081814751195,2157.7,78.52350562031151 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_33,galactinol,0.02046478788738426,1.1197114451978036,2293.26,82.06365181854703 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_33,galactinol,0.019778979585143533,1.0821880948725358,1857.31,79.31356547320816 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_33,galactinol,0.020215203731764594,1.1060556850147407,1988.07,81.06282115473036 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_33,galactinol,0.019904155864194334,1.089036996170304,1741.05,79.81552144932158 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_33,galactinol,0.020084611259075347,1.0989104418228004,1870.53,80.53914628119306 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_34,galactinol_peak_2,0.021849698385536367,1.0856922569811347,29429.28,49302.240798699466 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_34,galactinol_peak_2,0.02000120040982893,0.9938420216204785,42750.18,45131.24078276495 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_34,galactinol_peak_2,0.019396316527177576,0.9637858745662023,45544.03,43766.36469562086 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_34,galactinol_peak_2,0.01834001864673432,0.9112993637857161,29549.64,41382.9060529495 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_34,galactinol_peak_2,0.020552561749976356,1.021238680706311,52596.93,46375.3471809126 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_34,galactinol_peak_2,0.01942383252553774,0.9651531202753015,53789.34,43828.45252644728 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_34,galactinol_peak_2,0.02053439503766504,1.0203359927816,56272.38,46334.3553278861 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_34,galactinol_peak_2,0.020060121962210437,0.9967697816316765,56098.26,45264.192941302266 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_34,galactinol_peak_2,0.02031377407463464,1.0093735315584105,56419.4,45836.54031677519 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_34,galactinol_peak_2,0.019464730659685965,0.9671853125182434,60599.48,43920.73616452845 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_34,galactinol_peak_2,0.022214808418023497,1.1038342527296805,41667.56,50126.08479059719 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_34,galactinol_peak_2,0.02029692098517039,1.008536116395295,50304.34,45798.51255729277 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_34,galactinol_peak_2,0.020125130528508534,1,47840.42,45410.88 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_34,galactinol_peak_2,0.017446364141768027,0.8668944589976267,38671.22,39366.44025020615 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_34,galactinol_peak_2,0.019913552319672588,0.9894868652634957,51897.34,44933.46930005677 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_34,galactinol_peak_2,0.02035005855174588,1.011176475249128,54882.27,45918.41357636111 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_34,galactinol_peak_2,0.019209166796619385,0.9544865693868854,50838.93,43344.07506403952 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_34,galactinol_peak_2,0.01994415220359444,0.9910073465283752,52326.1,45002.51569231846 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_34,galactinol_peak_2,0.01982786211565598,0.985228994543342,55496.79,44740.11564372836 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_34,galactinol_peak_2,0.020446486755715504,1.0159679077237163,62401.1,46135.99674149275 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_34,galactinol_peak_2,0.019920171778688007,0.9977647073780269,51617.52,1410.799385644235 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_34,galactinol_peak_2,0.020109896266272173,1.0072676574499428,53111.29,1424.2361769279212 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_34,galactinol_peak_2,0.019018264063000768,0.9525898113970881,43144.41,1346.9238897230266 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_34,galactinol_peak_2,0.02098691811031487,1.051196065965054,50478.26,1486.349189431948 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_34,galactinol_peak_2,0.01989874463275083,0.9966914611112038,43851.37,1409.2818583527978 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_34,galactinol_peak_2,0.02006853702554628,1.005196049274134,47226.06,1421.3070058316546 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_35,galactonolactone,0.020190374502941047,1.0589250558712997,8902.87,11547.76834078658 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_35,galactonolactone,0.019431847789001026,1.0191425871101676,11247.43,11113.933358102058 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_35,galactonolactone,0.01913579497515985,1.003615498081088,12072.8,10944.60765736392 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_35,galactonolactone,0.02024895477670563,1.061997416894622,10695.8,11581.272990770894 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_35,galactonolactone,0.02079440192489896,1.0906044965598025,12854.77,11893.238343794028 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_35,galactonolactone,0.02022932487861863,1.0609678871587818,13524.31,11570.045783686204 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_35,galactonolactone,0.01961018714793417,1.0284959557460402,12614.64,11215.933526682604 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_35,galactonolactone,0.019926173717290913,1.0450685109288045,13130.02,11396.66022401058 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_35,galactonolactone,0.019066858783814592,1,13332.25,10905.18 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_35,galactonolactone,0.020948874588948774,1.098706128076628,16622.65,11981.588093778682 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_35,galactonolactone,0.02155377838189161,1.130431531815199,11300.74,12327.559332120472 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_35,galactonolactone,0.02001494027182723,1.0497240525438538,13138.05,11447.429743320185 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_35,galactonolactone,0.019550071889449093,1.0253430893422617,12281.52,11181.550951033445 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_35,galactonolactone,0.01855025749388426,0.9729057997550775,11708.82,10609.712869373077 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_35,galactonolactone,0.02006378826373041,1.0522859843469385,13625.38,11475.368070780547 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_35,galactonolactone,0.019841733126905195,1.0406398532593306,13966.78,11348.364914966587 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_35,galactonolactone,0.019313123519119527,1.0129158524798003,13394.88,11046.02969614567 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_35,galactonolactone,0.02143352055993066,1.1241243669421346,14661.22,12258.778563890028 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_35,galactonolactone,0.020449872790178146,1.0725349687667254,14460.84,11696.186890695519 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_35,galactonolactone,0.01924764461396383,1.0094816787704277,14754.26,11008.579413693693 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_35,galactonolactone,0.020058690555303817,1.0078503985698457,10996.76,460.1844919869916 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_35,galactonolactone,0.019940629578072612,1.0019184159895296,11230.71,457.4759487408192 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_35,galactonolactone,0.019803349974792665,0.9950207921142451,10809.8,454.3264936793643 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_35,galactonolactone,0.020200051359570953,1.0149530826922206,11641.97,463.42757755726797 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_35,galactonolactone,0.01986426722757908,0.9980815840104705,11300.94,455.7240512591809 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_35,galactonolactone,0.020119799889770928,1.0109208416244015,12248.78,461.5864562857018 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_36,galactonic_glucoronic_acid,0.021057882055076176,1.1021286557850227,7468.31,NA -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_36,galactonic_glucoronic_acid,0.020210618815650342,1.0577845430807082,10222.43,NA -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_36,galactonic_glucoronic_acid,0.01953401930835962,1.0223726387151704,10814.42,NA -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_36,galactonic_glucoronic_acid,0.018921068521175494,0.9902919847645627,8098,NA -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_36,galactonic_glucoronic_acid,0.020566518186017495,1.0764116250271063,11462.42,NA -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_36,galactonic_glucoronic_acid,0.019881696038414262,1.04056936363464,11969.15,NA -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_36,galactonic_glucoronic_acid,0.01981104684242815,1.0368717219059602,11400.84,NA -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_36,galactonic_glucoronic_acid,0.019610900929025402,1.0263964734492304,11546.21,NA -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_36,galactonic_glucoronic_acid,0.019552262971605658,1.0233274766232452,11884.39,NA -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_36,galactonic_glucoronic_acid,0.020611302356921556,1.078755541568658,14174.25,NA -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_36,galactonic_glucoronic_acid,0.02143454393761735,1.1218424073011914,9309.66,NA -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_36,galactonic_glucoronic_acid,0.020440646741365646,1.0698237580358758,11527.58,NA -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_36,galactonic_glucoronic_acid,0.01955834974527996,1.0236460465378348,10575.03,NA -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_36,galactonic_glucoronic_acid,0.018455844879847597,0.9659430827660102,9681.63,NA -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_36,galactonic_glucoronic_acid,0.02032281956780472,1.0636569125728796,11988.51,NA -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_36,galactonic_glucoronic_acid,0.019837037170013016,1.0382320051827685,12107.24,NA -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_36,galactonic_glucoronic_acid,0.019538048316822324,1.0225835091944302,11785.96,NA -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_36,galactonic_glucoronic_acid,0.020253848890314036,1.060047121242841,12061.38,NA -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_36,galactonic_glucoronic_acid,0.021160056045059435,1.107476244015497,13250.79,NA -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_36,galactonic_glucoronic_acid,0.01895855018145337,0.9922537020802265,12891.4,NA -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_36,galactonic_glucoronic_acid,0.019744997347335126,1.1811016810843267,15767.62,NA -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_36,galactonic_glucoronic_acid,0.020283106015972715,1.213290140872582,16621.41,NA -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_36,galactonic_glucoronic_acid,0.019766285041566106,1.1823750634505195,15534.39,NA -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_36,galactonic_glucoronic_acid,0.020234222246236257,1.210366022849276,16785.21,NA -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_36,galactonic_glucoronic_acid,0.019693389554930194,1.1780146181035487,16293.49,NA -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_36,galactonic_glucoronic_acid,0.02027673067329521,1.2129087820999558,17979.16,NA -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_37,galacturonic_acid,0.02435468116025639,1.1369750182643288,272.38,365.4919893712511 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_37,galacturonic_acid,0.02259517218062527,1.0548340228191933,363.2,339.08694497545787 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_37,galacturonic_acid,0.022083226904896117,1.0309343468023975,388.55,331.4041551230987 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_37,galacturonic_acid,0.013609764864676983,0.6353588681276102,183.91,204.24246174830157 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_37,galacturonic_acid,0.021420594796740126,1,372.22,321.46 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_37,galacturonic_acid,0.016229703497423337,0.7576681997594782,302.6,243.56001949468185 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_37,galacturonic_acid,0.019137629095554266,0.8934219276892679,350.16,287.19941287499205 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_37,galacturonic_acid,0.02072123270563753,0.967350949040452,389.92,310.9646360785437 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_37,galacturonic_acid,0.021036112384658925,0.9820508059776326,450.4,315.69005208956975 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_37,galacturonic_acid,0.019306692255284183,0.9013144797558261,472.02,289.7365526623079 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_37,galacturonic_acid,0.020334862602519002,0.9493136299657582,285.28,305.1663594887926 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_37,galacturonic_acid,0.01890434386053455,0.8825312294041195,300.39,283.69848900424824 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_37,galacturonic_acid,0.02122063658589638,0.9906651419934345,320.6,318.4592165452094 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_37,galacturonic_acid,0.019183401403727925,0.8955587641594029,321.46,287.88632032668164 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_37,galacturonic_acid,0.02270741691083922,1.0600740607956847,337.01,340.7714075833808 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_37,galacturonic_acid,0.022205782613546374,1.0366557429547074,335.26,333.2433551302202 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_37,galacturonic_acid,0.004862213458788374,0.22698778931798502,73.54,72.96749475415946 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_37,galacturonic_acid,0.026865677695803603,1.2541984921862268,405.86,403.1746472981844 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_37,galacturonic_acid,0.021951105238825038,1.0247663730684848,439.01,329.4213982865951 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_37,galacturonic_acid,0.02003873864192937,0.935489365821856,444.91,300.7224115370938 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_37,galacturonic_acid,0.020196246759068302,1.4422832354960058,1552.61,1479.6383712953525 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_37,galacturonic_acid,0.019794016526453243,1.4135585953076066,1562.44,1450.1697629260739 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_37,galacturonic_acid,0.0196085574737404,1.400314328400509,1475.89,1436.5824695060824 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_37,galacturonic_acid,0.020405895704514326,1.4572549855921193,1618.91,1494.9978897189553 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_37,galacturonic_acid,0.01937784031642311,1.3838380250502043,1462.99,1419.6794298990046 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_37,galacturonic_acid,0.020562827855887943,1.4684620486537183,1656.42,1506.4952157138498 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_38,6-phosphogluconic_acid,0.021486749346021634,1.395469693201153,114.62,86.40748340301539 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_38,6-phosphogluconic_acid,0.024888079069713215,1.6163710715138608,120.41,100.08569674813826 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_38,6-phosphogluconic_acid,0.02677261970455339,1.7387636819164412,137.07,107.66424718426605 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_38,6-phosphogluconic_acid,0.015344601762870492,0.9965642717515785,95.8,61.70725970685774 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_38,6-phosphogluconic_acid,0.01982997961500537,1.2878697993775534,60.79,79.74489797745811 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_38,6-phosphogluconic_acid,0.015911600637208104,1.0333883502790178,48.78,63.987406649276785 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_38,6-phosphogluconic_acid,0.008270694793402955,0.5371451837617007,24.06,33.26002977852451 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_38,6-phosphogluconic_acid,0.019020271164198865,1.2352828033069476,59.04,76.4887111807662 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_38,6-phosphogluconic_acid,0.030413894035560177,1.9752484052090362,194.85,122.30738125054353 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_38,6-phosphogluconic_acid,0.013159034948156853,0.854621337374501,100.7,52.9181532102291 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_38,6-phosphogluconic_acid,0.02148436230510258,1.3953146654114519,170.52,86.3978840822771 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_38,6-phosphogluconic_acid,0.012289768939831934,0.7981663403708725,78.34,49.422459795764425 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_38,6-phosphogluconic_acid,0.020954797567465547,1.360921769117098,123.64,84.26827594373071 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_38,6-phosphogluconic_acid,0.02002207986322759,1.3003458640504146,185.69,80.51741590200167 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_38,6-phosphogluconic_acid,0.034840334222356904,2.262726191167673,152.42,140.10800575710232 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_38,6-phosphogluconic_acid,0.009432020974930577,0.6125682021133751,42.04,37.93022307486019 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_38,6-phosphogluconic_acid,0.03111840309302716,2.0210031642211486,96.94,125.14051592857352 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_38,6-phosphogluconic_acid,0.008604068417479288,0.5587963317049932,25.86,34.60066885917318 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_38,6-phosphogluconic_acid,4.394697331981328e-4,0.028541622740656206,1.14,1.7672972801014324 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_38,6-phosphogluconic_acid,0.03835090353903209,2.490722199703471,107.49,154.22551860563894 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_38,6-phosphogluconic_acid,0.015254012090022067,0.7353080560025966,106.83,19.625372014709306 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_38,6-phosphogluconic_acid,0.025396698961050485,1.2242285656865624,173.42,32.67466041817435 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_38,6-phosphogluconic_acid,0.027151470971057856,1.3088160163711136,72.05,34.93229947694502 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_38,6-phosphogluconic_acid,0.01193231037082751,0.5751879499382321,31.75,15.351766383851414 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_38,6-phosphogluconic_acid,0.04013061772657264,1.9344659183803483,91.97,51.6308953615715 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_38,6-phosphogluconic_acid,0.0024386636709596067,0.11755392827506736,6.21,3.137514345661548 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_39,methyl_alpha-D-glucopyranoside,0.021103769924979598,1.0779273702127867,2023.71,2768.074369611628 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_39,methyl_alpha-D-glucopyranoside,0.019792434953648106,1.0109476854389166,2534.47,2596.0732182997203 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_39,methyl_alpha-D-glucopyranoside,0.019271899126471873,0.9843600275330434,2664.6,2527.797176303754 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_39,methyl_alpha-D-glucopyranoside,0.019114417087838863,0.9763162419742131,2115.83,2507.1410567401003 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_39,methyl_alpha-D-glucopyranoside,0.020800274223348666,1.0624255748135352,2967.96,2728.266379098166 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_39,methyl_alpha-D-glucopyranoside,0.02002120880370414,1.022632877015634,3040.77,2626.080322861068 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_39,methyl_alpha-D-glucopyranoside,0.01958512486537607,1.000358808709117,2822.4,2568.8814064126645 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_39,methyl_alpha-D-glucopyranoside,0.019819065647427362,1.012307914147553,2938.08,2599.5662312143504 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_39,methyl_alpha-D-glucopyranoside,0.01958323345653758,1.0002622003134365,3004.32,2568.6333199168926 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_39,methyl_alpha-D-glucopyranoside,0.02054013174327813,1.0491381526884886,3639.61,2694.1448105779314 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_39,methyl_alpha-D-glucopyranoside,0.02114605746018903,1.080087310914525,2481.19,2773.6210109360636 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_39,methyl_alpha-D-glucopyranoside,0.019955774479326463,1.0192906566706998,2923.63,2617.4976347040906 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_39,methyl_alpha-D-glucopyranoside,0.019578100072562065,1,2723.84,2567.96 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_39,methyl_alpha-D-glucopyranoside,0.018949902398649025,0.9679132463525695,2559.14,2485.562500103544 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_39,methyl_alpha-D-glucopyranoside,0.019641392613053518,1.0032328234229508,2943.6,2576.261761237201 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_39,methyl_alpha-D-glucopyranoside,0.02073310405654412,1.0589946920130797,3287,2719.456009301908 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_39,methyl_alpha-D-glucopyranoside,0.019961557258682927,1.0195860264632246,2994.96,2618.2561325165025 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_39,methyl_alpha-D-glucopyranoside,0.019792636946001262,1.0109580026991414,2912.47,2596.099712611287 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_39,methyl_alpha-D-glucopyranoside,0.02098003571585757,1.071607338715173,3177.59,2751.8447815270156 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_39,methyl_alpha-D-glucopyranoside,0.019120150169119877,0.9766090733143209,3006.09,2507.8930359082437 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_39,methyl_alpha-D-glucopyranoside,0.020205123223255076,1.0572650826116172,4145.9,137.0955632622484 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_39,methyl_alpha-D-glucopyranoside,0.019775050909503128,1.034760867452732,4143.11,134.17744168259574 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_39,methyl_alpha-D-glucopyranoside,0.0200558568163242,1.0494544813937403,4113.53,136.08276260232628 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_39,methyl_alpha-D-glucopyranoside,0.019947757543819212,1.0437980157037068,4314.44,135.34928869629965 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_39,methyl_alpha-D-glucopyranoside,0.020011066166406407,1.0471107396772306,4284.9,135.77884961394648 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_39,methyl_alpha-D-glucopyranoside,0.019990408768147366,1.046029808586855,4578.91,135.63868527945746 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_40,glucose 1-phosphate,0.018770533471488656,0.941288391503823,3586.03,7267.734735220593 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_40,glucose 1-phosphate,0.020020296993346696,1.0039604459255458,7306.38,7751.628801013436 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_40,glucose 1-phosphate,0.02001770316883695,1.0038303730693678,8061.67,7750.624501987243 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_40,glucose 1-phosphate,0.021293461238994994,1.0678059794969164,6386.71,8244.583357994667 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_40,glucose 1-phosphate,0.020180413502949926,1.011989829427435,8995.49,7813.624072500697 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_40,glucose 1-phosphate,0.019650793800379353,0.9854309210885422,9141.24,7608.56141327069 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_40,glucose 1-phosphate,0.020067776576765596,1.0063414107912239,9721.88,7770.012349789579 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_40,glucose 1-phosphate,0.020222632149375322,1.0141069733991603,10152.91,7829.970646963588 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_40,glucose 1-phosphate,0.019862933935730024,0.9960691401397453,10108.41,7690.699634475981 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_40,glucose 1-phosphate,0.020036003284232926,1.0047480713442505,11665.47,7757.7100962525255 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_40,glucose 1-phosphate,0.01981569312051299,0.993700148814245,5062.22,7672.408534002227 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_40,glucose 1-phosphate,0.01985810966820481,0.9958272169666031,7593.35,7688.831733559991 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_40,glucose 1-phosphate,0.020018593669778845,1.0038750291363092,7506.36,7750.9692937129 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_40,glucose 1-phosphate,0.02026979396281464,1.016472003012204,6632.9,7848.231158857378 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_40,glucose 1-phosphate,0.01993563436576148,0.9997148580917625,8817.45,7718.848405069403 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_40,glucose 1-phosphate,0.01994238845472792,1.0000535562725548,9195.82,7721.463510658209 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_40,glucose 1-phosphate,0.02024473568037832,1.0152154020528248,9900.1,7838.528880019963 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_40,glucose 1-phosphate,0.020078766497424537,1.0068925237766657,9591.48,7774.267520705825 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_40,glucose 1-phosphate,0.020329909759429207,1.0194866377100005,10375.39,7871.507304090799 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_40,glucose 1-phosphate,0.01957283069168259,0.981521294902729,10239.25,7578.3749940087155 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_40,glucose 1-phosphate,0.0200205851253467,1.0740766296458313,8053.96,235.620190245406 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_40,glucose 1-phosphate,0.019983186708308714,1.0720702564317242,8366.17,235.18005215342734 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_40,glucose 1-phosphate,0.01980212343286686,1.0623564627827558,9365.32,233.04913724065312 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_40,glucose 1-phosphate,0.020196796466000012,1.0835301237215198,10432.48,237.6940032407898 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_40,glucose 1-phosphate,0.02005369232155919,1.0758527848132402,10469.07,236.0098254044805 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_40,glucose 1-phosphate,0.01994613139179706,1.0700822900850806,11039.21,234.74395197596414 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_41,glucose-6-phosphate,0.022680240488946617,1.1058736665795232,1207.85,1701.043815195957 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_41,glucose-6-phosphate,0.020258565926137978,0.987794401532015,1510.72,1519.4154704925302 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_41,glucose-6-phosphate,0.020926095505090076,1.0203427064490556,1705.4,1569.4809476328728 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_41,glucose-6-phosphate,0.01659900717335186,0.8093567144193448,1065.59,1244.944404552692 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_41,glucose-6-phosphate,0.020508889192647834,1,1632.54,1538.19 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_41,glucose-6-phosphate,0.020083970369434937,0.9792812365788575,1715.57,1506.3206052932328 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_41,glucose-6-phosphate,0.01850533567186478,0.9023080430167177,1494.98,1387.9212086878852 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_41,glucose-6-phosphate,0.019107439948532916,0.931666253059804,1582.65,1433.07971379406 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_41,glucose-6-phosphate,0.02001624946732567,0.9759792097614547,1807.87,1501.241460662972 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_41,glucose-6-phosphate,0.02080992490461228,1.0146783040825227,2139.55,1560.7680205566955 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_41,glucose-6-phosphate,0.02119908444468128,1.0336534682863698,1546.35,1589.9554283834113 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_41,glucose-6-phosphate,0.018166276613857783,0.8857757454933324,1538.19,1362.491393960389 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_41,glucose-6-phosphate,0.01925833414014229,0.9390237549796772,1553.6,1444.3969496721897 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_41,glucose-6-phosphate,0.019476034379062986,0.949638675996401,1699.65,1460.724715030904 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_41,glucose-6-phosphate,0.021816575122129343,1.0637619091506085,1824.02,1636.2679310363746 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_41,glucose-6-phosphate,0.02074253328949909,1.0113923330833057,1790.89,1555.71357282541 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_41,glucose-6-phosphate,0.016609230699176695,0.8098552068403044,1383.41,1245.711180609688 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_41,glucose-6-phosphate,0.021338406914029728,1.0404467406103723,1754.8,1600.4047719394687 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_41,glucose-6-phosphate,0.018659076954471082,0.9098043672282414,1652.16,1399.4519796268087 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_41,glucose-6-phosphate,0.02171123247890396,1.058625470885432,2094.89,1628.3671130612627 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_41,glucose-6-phosphate,0.01947260093343984,0.9436662433786918,1436.67,287.71440094372934 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_41,glucose-6-phosphate,0.020523173709310765,0.9945782950450693,1567.9,303.2369763762912 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_41,glucose-6-phosphate,0.02162990321733657,1.0482117711710843,1676.14,319.5892869123519 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_41,glucose-6-phosphate,0.018375165578348437,0.8904831733599543,1500.16,271.49941472571646 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_41,glucose-6-phosphate,0.018806707182946913,0.9113962114417715,1403.97,277.8755909064817 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_41,glucose-6-phosphate,0.021149885777466033,1.0249495343601298,1675.93,312.49686353105994 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_42,glucose-6-phosphate_peak_2,0.020589337671365008,1.0687411884576385,195.26,176.97285339670037 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_42,glucose-6-phosphate_peak_2,0.021346356727044213,1.1080361603584046,291.66,183.47970779374822 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_42,glucose-6-phosphate_peak_2,0.020398276095864136,1.058823658397729,256.32,175.33060959407996 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_42,glucose-6-phosphate_peak_2,0.018775070253208678,0.9745670898241967,140.66,161.37856440398875 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_42,glucose-6-phosphate_peak_2,0.020081075059751045,1.0423585434082858,212.97,172.60415120297804 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_42,glucose-6-phosphate_peak_2,0.018577786968438138,0.964326606347075,125.44,159.68284274501215 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_42,glucose-6-phosphate_peak_2,0.02006661508108192,1.041607961964891,226.99,172.4798624217663 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_42,glucose-6-phosphate_peak_2,0.02082230463224828,1.0808339226009047,284.89,178.97528924348381 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_42,glucose-6-phosphate_peak_2,0.020035846973993885,1.0400108662321037,284.35,172.21539933937404 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_42,glucose-6-phosphate_peak_2,0.019762648707399143,1.0258298253076497,304.91,169.86716077269372 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_42,glucose-6-phosphate_peak_2,0.020494054447437727,1.063795273848557,205.37,176.15385939658256 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_42,glucose-6-phosphate_peak_2,0.020299901129677576,1.0537172591558084,242.04,174.4850409436103 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_42,glucose-6-phosphate_peak_2,0.020236353708923027,1.050418670970765,226.53,173.93882772604897 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_42,glucose-6-phosphate_peak_2,0.019265036188114596,1,170.27,165.59 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_42,glucose-6-phosphate_peak_2,0.020886084008067844,1.0841445509950995,258.62,179.52349619927853 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_42,glucose-6-phosphate_peak_2,0.018915392264914486,0.9818508556233172,128.12,162.5846831826651 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_42,glucose-6-phosphate_peak_2,0.018446126829375215,0.957492456762443,62.53,158.55117591529293 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_42,glucose-6-phosphate_peak_2,0.021565678620895458,1.1194206130897497,257.88,185.36485932153167 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_42,glucose-6-phosphate_peak_2,0.020354876918013493,1.0565709152714318,149.64,174.9575778597964 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_42,glucose-6-phosphate_peak_2,0.019648748532163772,1.019917551168988,110.41,168.8881472980727 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_42,glucose-6-phosphate_peak_2,0.02073339479032667,1.0868125966555586,228.58,51.49318082954037 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_42,glucose-6-phosphate_peak_2,0.0191755825629897,1.0051544808951922,132.75,47.62421930481421 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_42,glucose-6-phosphate_peak_2,0.0207967198030039,1.0901319962115394,212.07,51.65045398050274 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_42,glucose-6-phosphate_peak_2,0.019236465446782855,1.0083458678193435,119.86,47.7754272172805 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_42,glucose-6-phosphate_peak_2,0.01876164698585537,0.9834566159780891,41.21,46.59617446504186 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_42,glucose-6-phosphate_peak_2,0.021152831123462112,1.1087988027234281,204.47,52.53488727303603 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_43,levoglucosan,0.01581879750018947,0.755668245987293,106.48,250.67027055890486 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_43,levoglucosan,0.024981998030392458,1.1933968199958667,288.67,395.8735931290289 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_43,levoglucosan,0.019930020212038234,0.9520624697257705,255.02,315.8181624574326 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_43,levoglucosan,0.022358409233144756,1.0680672717426358,184.4,354.29927538246716 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_43,levoglucosan,0.015529880848545534,0.7418666191960227,225.97,246.09199491970466 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_43,levoglucosan,0.020933521534336738,1,331.72,331.72 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_43,levoglucosan,0.023946335870821452,1.1439229578044414,421.73,379.46212356288936 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_43,levoglucosan,0.018093675782126388,0.8643397983682668,329.7,286.7187979147215 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_43,levoglucosan,0.021534589591487685,1.0287131840748833,467.24,341.24473742132034 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_43,levoglucosan,0.018222661432787498,0.8705014778759186,452.03,288.76275024099976 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_43,levoglucosan,0.019568119814881605,0.9347743896211873,307.55,310.0833605251403 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_43,levoglucosan,0.016914039786202015,0.8079882669744951,297.96,268.02586792077955 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_43,levoglucosan,0.020571054534756272,0.9826848531439911,345.03,325.97621948492474 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_43,levoglucosan,0.02157112803007966,1.0304586351941345,404.15,341.82373846659834 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_43,levoglucosan,0.02098874236728448,1.0026379141635182,376.29,332.5950488863223 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_43,levoglucosan,0.018106984273081224,0.8649755485898913,339.69,286.9296889782388 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_43,levoglucosan,0.02044116054845523,0.9764797821965167,387.63,323.91787335022855 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_43,levoglucosan,0.023612519665453777,1.1279764671568873,441.36,374.1723536852827 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_43,levoglucosan,0.020604925872420143,0.9843028961286993,389.41,326.51295670381216 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_43,levoglucosan,0.017806884164302563,0.8506396850188045,363.75,282.17419631443784 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_43,levoglucosan,0.01683362603171281,0.5954018333226936,279.48,44.62536740753588 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_43,levoglucosan,0.02373310482633483,0.8394349558091989,401.18,62.91564993789946 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_43,levoglucosan,0.01095663004932327,0.3875337141335922,198.23,29.04565187431274 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_43,levoglucosan,0.02882873290009501,1.0196662554312623,561.61,76.42398584457311 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_43,levoglucosan,0.01957039021027443,0.6922006101410512,579.62,51.88043573007179 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_43,levoglucosan,0.02025593723519723,0.7164482650847331,662.2,53.69779746810075 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_47,L-glutamine,0.010828006442301157,0.6504705778761364,264.99,295.72994352560664 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_47,L-glutamine,0.015702350755619782,0.9432869498599168,388.38,428.85597888431255 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_47,L-glutamine,0.018758123743062703,1.126856329098101,500.27,512.3139614611606 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_47,L-glutamine,0.031965880949467555,1.9202856189935054,916.02,873.0386538192073 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_47,L-glutamine,0.0190012362852113,1.1414608231592192,514.15,518.9537486411074 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_47,L-glutamine,0.019000072415893278,1.141390906064886,574.51,518.9219615333398 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_47,L-glutamine,0.021133635551953675,1.2695603944599714,767.17,577.1929377372813 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_47,L-glutamine,0.026167901582792797,1.571983740041783,985.26,714.6866875725963 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_47,L-glutamine,0.02031855836242493,1.2205962815079159,941.96,554.9318934247589 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_47,L-glutamine,0.017377220768375258,1.0439013769818253,923.55,474.59932203101704 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_47,L-glutamine,0.022958160776616977,1.379165055628247,431.32,627.0236008908263 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_47,L-glutamine,0.019501728959158932,1.1715269078609845,498.22,532.622993389918 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_47,L-glutamine,0.02284996016559603,1.3726651228518505,562.74,624.0684714533653 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_47,L-glutamine,0.01635135201229866,0.9822743871803302,371.63,446.5812273876653 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_47,L-glutamine,0.018340261466207985,1.1017540983092022,542.43,500.9014832552957 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_47,L-glutamine,0.018176048698830306,1.0918893485734145,562.89,496.41657343541715 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_47,L-glutamine,0.024929086777376323,1.4975644471964495,858.4,680.8527002733938 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_47,L-glutamine,0.01855580984106436,1.1147027307929571,635.59,506.78844952771 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_47,L-glutamine,0.020242377838312044,1.216019890663796,798.56,552.8512830913882 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_47,L-glutamine,0.01890423068414912,1.1356334079543637,814.87,516.3043725923719 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_47,L-glutamine,0.021962340665061652,1.3217549336585876,635.61,403.99439547274727 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_47,L-glutamine,0.01782023804654241,1.0724716420804041,535.41,327.8009574018755 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_47,L-glutamine,0.022079855080101594,1.3288272790075577,745.28,406.15605782866 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_47,L-glutamine,0.017978473374901816,1.0819946855996612,645.97,330.7116756535364 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_47,L-glutamine,0.019398712473487338,1.1674686368582607,776.21,356.8367888557274 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_47,L-glutamine,0.020586162765019594,1.2389327082540715,888.32,378.67978227785693 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_48,oxoglutaric_acid,0.018294013891716664,0.9202851636505366,2056.06,2811.793274759667 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_48,oxoglutaric_acid,0.017921096833190278,0.9015254732804847,2897.51,2754.475854787529 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_48,oxoglutaric_acid,0.020036986808722505,1.0079658730705432,3546.62,3079.688530286084 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_48,oxoglutaric_acid,0.022495088941031617,1.131621345100446,3053.58,3457.4992767526473 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_48,oxoglutaric_acid,0.021484532795346355,1.0807850533268233,3827.61,3302.1766126821094 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_48,oxoglutaric_acid,0.02030642769845524,1.021520167648515,3909.29,3121.10164422489 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_48,oxoglutaric_acid,0.01940840360682623,0.9763448303486384,3508.8,2983.075177405712 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_48,oxoglutaric_acid,0.019003485113479116,0.9559752994124121,3507.07,2920.839131059713 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_48,oxoglutaric_acid,0.02095702481884023,1.0542486263098025,3837.01,3221.098540395655 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_48,oxoglutaric_acid,0.019560668772129336,0.9840045693976338,4036.67,3006.47836110906 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_48,oxoglutaric_acid,0.019470484662456877,0.9794678341234698,2628.8,2992.6170469891435 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_48,oxoglutaric_acid,0.017355212978463902,0.8730585376513464,3108.23,2667.4994030130415 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_48,oxoglutaric_acid,0.01950092080906618,0.9809989324559094,3347.86,2997.295088279163 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_48,oxoglutaric_acid,0.02185806264410409,1.0995755702700745,3574.96,3359.5882186246718 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_48,oxoglutaric_acid,0.02034172690979214,1.0232959037266767,3772.98,3126.5271394513015 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_48,oxoglutaric_acid,0.02073415016402101,1.0430368583840803,3988.62,3186.8426652638 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_48,oxoglutaric_acid,0.020781352735612203,1.0454113961196836,3582.39,3194.097709134275 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_48,oxoglutaric_acid,0.02015995021608049,1.0141515795061717,3384.67,3098.588028444182 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_48,oxoglutaric_acid,0.019661727397313197,0.9890883500247896,2649.77,3022.0110902482406 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_48,oxoglutaric_acid,0.019645032908968307,0.9882485294130049,2789.94,3019.4451443420244 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_48,oxoglutaric_acid,0.0204310544560626,1.2945214229312516,2756.01,63.159700224815765 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_48,oxoglutaric_acid,0.019509002568538804,1.2360997724960943,2691.25,60.30930790008444 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_48,oxoglutaric_acid,0.02077601514524358,1.3163782978749428,2672.14,64.22609715331846 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_48,oxoglutaric_acid,0.019232778121709482,1.2185980588803398,2611.05,59.45539929277178 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_48,oxoglutaric_acid,0.01994765942296667,1.2638932814700774,2755.88,61.665353202925075 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_48,oxoglutaric_acid,0.02006418701581769,1.2712765257188094,2979.1,62.02558168982071 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_49,glutaric_acid,0.01995273697349329,1.0304390132098256,3.2,32.85039574112924 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_49,glutaric_acid,0.020523498143522695,1.0599153992116512,96,33.79010292686744 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_49,glutaric_acid,0.019718200003228003,1.0183265875048988,4.2,32.46425160965617 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_49,glutaric_acid,0.019931723252286135,1.0293537807340338,3.72,32.815798529801 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_49,glutaric_acid,0.01995023287818639,1.0303096917287449,41.2,32.846272972312384 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_49,glutaric_acid,0.020076293458082636,1.036819963463671,60.52,33.05382043522183 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_49,glutaric_acid,0.019813379839456764,1.0232420543228762,31.88,32.62095669181329 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_49,glutaric_acid,0.01994958658062734,1.0302763143419797,52.13,32.845208901222314 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_49,glutaric_acid,0.020548318300922873,1.0611972112524317,156.8,33.83096709472752 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_49,glutaric_acid,0.019573087141323758,1.010832379846906,26.63,32.22533626951937 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_49,glutaric_acid,0.020029521004372334,1.0344044471808334,74.01,32.97681377612496 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_49,glutaric_acid,0.019682661848957207,1.0164912553062762,12.35,32.405741219164085 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_49,glutaric_acid,0.020123254173867698,1.039245202351823,66.86,33.131137050976115 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_49,glutaric_acid,0.020010520739571595,1.0334231976340666,83.68,32.945531540574045 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_49,glutaric_acid,0.02045167254632899,1.0562060385563279,103.35,33.67184850917573 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_49,glutaric_acid,0.019893976819748277,1.0274044042275339,26.21,32.75365240677378 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_49,glutaric_acid,0.019793107306860725,1.0221950997867002,21.08,32.5875797812 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_49,glutaric_acid,0.019709076565269733,1.0178554167367335,12.33,32.449230685567066 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_49,glutaric_acid,0.019519956980672704,1.0080885261898525,47.49,32.1378622149325 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_49,glutaric_acid,0.02061692090700555,1.0647401237766319,227.56,33.94391514599902 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_49,glutaric_acid,0.019932132579073863,0.9901493786777089,24.88,20.793136952231887 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_49,glutaric_acid,0.020071153808014032,0.9970554025520753,42.59,20.93816345359358 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_49,glutaric_acid,0.02013623670882687,1.0002884632166442,37.31,21.00605772754953 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_49,glutaric_acid,0.01986038541063999,0.9865852636004658,2.29,20.718290535609782 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_49,glutaric_acid,0.02012462293175009,0.9997115367833557,58.45,20.993942272450468 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_49,glutaric_acid,0.019889371979850374,0.9880252015187894,29.85,20.748529231894576 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_50,glyceric_acid,0.018535866421957772,0.9468747983769792,3468.04,5148.631716174825 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_50,glyceric_acid,0.0195628038322045,0.9993342373445181,5479.43,5433.879915560817 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_50,glyceric_acid,0.01997297951863154,1.0202873997995872,6135.14,5547.812736410255 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_50,glyceric_acid,0.02167798621743915,1.1073849132048623,4918.23,6021.405465551439 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_50,glyceric_acid,0.02024214064981262,1.0340370614564112,6298.35,5622.576521669235 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_50,glyceric_acid,0.020375026157587767,1.0408253029940586,6844.06,5659.487585030194 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_50,glyceric_acid,0.01949655970878365,0.9959502632922735,6135.01,5415.479556651738 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_50,glyceric_acid,0.019749849179427747,1.008889146805322,6340.25,5485.834735753939 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_50,glyceric_acid,0.020689049643807213,1.0568666855995914,6500.9,5746.712602947779 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_50,glyceric_acid,0.01959107946925494,1.0007786525944793,6927.22,5441.733923482481 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_50,glyceric_acid,0.017685390012591236,0.9034295846323789,4113.45,4912.3983664385605 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_50,glyceric_acid,0.020311287890269,1.0375693365535117,6405.58,5641.78326750972 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_50,glyceric_acid,0.020777509869146837,1.061385533336518,6289.55,5771.283837517317 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_50,glyceric_acid,0.022064764608002,1.1271428625903268,6228.92,6128.839315334902 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_50,glyceric_acid,0.01957583669322466,1,6384.53,5437.5 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_50,glyceric_acid,0.019451279174099625,0.9936371803117797,6546.38,5402.902167945303 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_50,glyceric_acid,0.020490899857171452,1.0467445237864852,6582.96,5691.673348089013 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_50,glyceric_acid,0.020269277302925402,1.0354232935515215,6405.84,5630.114158686399 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_50,glyceric_acid,0.019487208547918175,0.9954725743427784,6109.65,5412.882122988857 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_50,glyceric_acid,0.02029367185170209,1.0366694496754705,6870.04,5636.8901326103705 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_50,glyceric_acid,0.02023411657249831,1.009945887294691,4537.4,72.43331903677523 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_50,glyceric_acid,0.019768738440920905,0.9867174587967398,4535.53,70.76737614490217 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_50,glyceric_acid,0.01910399836566556,0.9535382733987184,4165.99,68.38776496815609 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_50,glyceric_acid,0.02088508808939431,1.0424378423488931,4818.25,74.76364205326261 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_50,glyceric_acid,0.020785010404195163,1.0374426627365434,5014.74,74.40538777146489 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_50,glyceric_acid,0.0192616595866695,0.9614076212483403,4999.73,68.95215459593096 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_51,glycerophosphoric_acid,0.01840082713064164,0.9237158559289274,121.63,241.9766056191418 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_51,glycerophosphoric_acid,0.0203812425880974,1.0231321020786641,300.44,268.01968546052683 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_51,glycerophosphoric_acid,0.019715137934334614,0.9896938535684039,301.12,259.26020188077905 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_51,glycerophosphoric_acid,0.021424241932676537,1.0754903480135376,249.31,281.7354515656263 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_51,glycerophosphoric_acid,0.022701146997911623,1.139590589100498,428.07,298.52715072076643 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_51,glycerophosphoric_acid,0.018629577943254337,0.9351990762845552,262.42,244.98475002350207 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_51,glycerophosphoric_acid,0.018413354946353346,0.9243447484200582,213.11,242.14135029611842 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_51,glycerophosphoric_acid,0.018870981305284428,0.9473174507249313,237.11,248.159279391903 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_51,glycerophosphoric_acid,0.022025309180593707,1.1056637387768307,371,289.63967300997854 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_51,glycerophosphoric_acid,0.019074421101567766,0.9575300658546576,268.54,250.8345760512861 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_51,glycerophosphoric_acid,0.017554845999307747,0.881247863632618,152.2,230.8516903572006 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_51,glycerophosphoric_acid,0.01818000897850017,0.9126308526863101,203.38,239.07277816970577 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_51,glycerophosphoric_acid,0.020705441537207447,1.0394067894958272,301.54,272.28300257632685 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_51,glycerophosphoric_acid,0.023170429206441506,1.1631484114661321,423.24,304.69835786766794 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_51,glycerophosphoric_acid,0.019421517378100682,0.9749541920578457,265.99,255.39900015147325 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_51,glycerophosphoric_acid,0.019967457258570586,1.0023602059502446,305.11,262.57827955072605 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_51,glycerophosphoric_acid,0.021493304353532913,1.0789572602746522,362.95,282.6436439015479 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_51,glycerophosphoric_acid,0.020590321292281347,1.0336277886486542,314.78,270.76913551440146 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_51,glycerophosphoric_acid,0.01897268267429009,0.9524228281328725,203.03,249.49668405768725 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_51,glycerophosphoric_acid,0.02016243875616077,1.0121482170900753,270.77,265.1423469489161 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_51,glycerophosphoric_acid,0.020142007889608578,1.0087751905881879,308.72,49.7124413921859 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_51,glycerophosphoric_acid,0.01981688599025472,0.9924920619258124,307.45,48.91000881170404 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_51,glycerophosphoric_acid,0.021206349651782083,1.0620807780883035,414.4,52.339340744191595 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_51,glycerophosphoric_acid,0.01878236193166911,0.9406798389296052,318.51,46.35670246245094 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_51,glycerophosphoric_acid,0.020951470665020358,1.049315635712397,416.36,51.710274527906925 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_51,glycerophosphoric_acid,0.019153518231811818,0.9592685153647698,346.47,47.27275243717585 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_52,glycerol,0.019379375823883476,0.9558698253270033,913.99,1587.298314541515 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_52,glycerol,0.020108783932810112,0.9918472070552908,1639.02,1647.0416350918747 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_52,glycerol,0.019741124311654243,0.9737127355920284,1751.78,1616.9278944694104 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_52,glycerol,0.02068823165486175,1.0204279311145776,1259.17,1694.5022138502452 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_52,glycerol,0.019476089033444353,0.9606401151221905,1793.65,1595.219762369607 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_52,glycerol,0.020815874781576472,1.0267238105250294,2157.33,1704.9570252816532 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_52,glycerol,0.019468753274764838,0.9602782855962371,1768.76,1594.6189154953993 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_52,glycerol,0.020167133832283756,0.9947252619898044,1904.99,1651.8208755550293 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_52,glycerol,0.02058380306239394,1.0152770871788133,1754.88,1685.9488254273936 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_52,glycerol,0.019549784393187962,0.9642750707206427,1783.94,1601.2558969372847 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_52,glycerol,0.018768988398596802,0.9257630289630296,1171.29,1537.3035706354276 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_52,glycerol,0.019659475500831813,0.9696854833601578,1610.69,1610.2403199582109 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_52,glycerol,0.019155182896362023,0.944811716107336,1471.98,1568.9354395335201 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_52,glycerol,0.021666014418813568,1.0686561634518916,1808.76,1774.5890519049422 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_52,glycerol,0.019622019563003475,0.9678380037986485,1645.59,1607.1724323479596 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_52,glycerol,0.021612930255748557,1.0660378361054532,2004.67,1770.2411098799935 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_52,glycerol,0.019032676519819616,0.9387692021579075,1561.48,1558.901361719378 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_52,glycerol,0.019854752397384406,0.9793173360418156,1660.58,1626.234781884318 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_52,glycerol,0.01976932181513278,0.9751035514247792,1729.66,1619.2374554249598 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_52,glycerol,0.020506690346079867,1.011473573621747,2000.53,1679.6327868848007 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_52,glycerol,0.0193106117670741,0.9879378927924467,1718.19,226.95897211120877 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_52,glycerol,0.02073557384101174,1.0608394686521745,1976.07,243.70665113346402 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_52,glycerol,0.02081210278717578,1.0647547172586345,1828.04,244.60610119582608 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_52,glycerol,0.019168455638433998,0.9806651337586962,1677.25,225.28820117838526 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_52,glycerol,0.020330858168954816,1.0401340682715536,1936.69,238.949999504024 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_52,glycerol,0.01971870596877947,1.0088161399736704,1983.17,231.75533183615127 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_53,L-glycine,0.010409751924174804,0.46943644138508317,216.31,152.71706311139525 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_53,L-glycine,0.022770338048298634,1.0268473773812838,411.65,334.05398880967925 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_53,L-glycine,0.008652958810423736,0.3902123913235351,165.39,126.94389514537242 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_53,L-glycine,0.0321599133988162,1.4502781056801692,778.76,471.80447333987263 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_53,L-glycine,0.023149499061213906,1.043945959356283,307.23,339.616499497786 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_53,L-glycine,0.025473149841655184,1.1487329284730803,362.15,373.70579629086245 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_53,L-glycine,0.014795620014585585,0.6672208193168405,182.63,217.06027694015455 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_53,L-glycine,0.022174997521412245,1,280.9,325.32 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_53,L-glycine,0.018540318218093734,0.836091106670526,289.59,271.9971588220555 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_53,L-glycine,0.02147523762876841,0.968443744267924,388.15,315.05411888524105 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_53,L-glycine,0.01709811121076691,0.7710535793411892,194.55,250.83915043127567 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_53,L-glycine,0.019698038745920847,0.8882994790371616,325.32,288.9815865203694 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_53,L-glycine,0.02506790192611306,1.1304579358760882,399.75,367.760575699209 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_53,L-glycine,0.02181337234342386,0.9836922111202403,302.59,320.01475012163655 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_53,L-glycine,0.017686581534005742,0.79759113916145985,334.36,259.4723493920061 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_53,L-glycine,0.01536453906544807,0.6928766982098656,304.13,225.4066474616335 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_53,L-glycine,0.027905489615149513,1.2584213183430522,588.55,409.38962328336174 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_53,L-glycine,0.019581285925718565,0.8830344132760698,408.45,287.268755326971 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_53,L-glycine,0.016394114526466254,0.7393062619572357,356.61,240.51111313992791 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_53,L-glycine,0.021255962772639338,0.9585553618265127,500.26,311.8372303094011 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_53,L-glycine,0.019537023927754193,0.9569647834067998,586.77,176.91407950841509 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_53,L-glycine,0.02057948886263095,1.0080269223642246,631.22,186.35393713747422 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_53,L-glycine,0.016613802945132393,0.8137792324841291,479.16,150.44336670934095 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_53,L-glycine,0.023439025442737925,1.1480930764593973,714.41,212.2479670450488 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_53,L-glycine,0.016538626277884595,0.8100969202058586,552.03,149.76261763845707 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_53,L-glycine,0.023073225204411844,1.130175406545374,833.78,208.9355274080433 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_54,L-glycine_peak_2,0.017625579826853324,0.8939982380262407,5105.41,7533.535412217146 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_54,L-glycine_peak_2,0.02049284348732182,1.0394305407133932,8635.96,8759.062886178215 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_54,L-glycine_peak_2,0.01974908208721331,1.0017057459695689,9113.5,8441.163963078903 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_54,L-glycine_peak_2,0.02235524805079102,1.1338947464070304,7832.16,9555.0929100753 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_54,L-glycine_peak_2,0.020562500452186706,1.0429636559054727,9448.95,8788.835705947678 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_54,L-glycine_peak_2,0.019609590555086442,0.9946305073013345,9714.7,8381.542412621813 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_54,L-glycine_peak_2,0.01928237701364555,0.9780337012739491,9008.87,8241.684613558302 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_54,L-glycine_peak_2,0.020232050493290795,1.0262026934911357,9659.23,8647.594595484168 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_54,L-glycine_peak_2,0.020166962102622685,1.0229013038548864,9764.31,8619.77447831132 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_54,L-glycine_peak_2,0.020024061776995183,1.015653165604721,10951.65,8558.695939386207 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_54,L-glycine_peak_2,0.01810291034152952,0.9182092224743399,6226.24,7737.556293854544 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_54,L-glycine_peak_2,0.0193440338732596,0.9811610380423663,8641.84,8268.038023765033 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_54,L-glycine_peak_2,0.020234261545340207,1.02631484166758,8662.62,8648.539644615948 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_54,L-glycine_peak_2,0.02215964107198451,1.123973240498202,9208.93,9471.486463297844 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_54,L-glycine_peak_2,0.020600365598145556,1.0448842380424783,9494.08,8805.020048293976 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_54,L-glycine_peak_2,0.01966026929526634,0.9972010158957351,9364.97,8403.203548740023 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_54,L-glycine_peak_2,0.019837281494038645,1.0061793641467522,9161.16,8478.862203998211 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_54,L-glycine_peak_2,0.020039810223220787,1.016451952556166,9121.25,8565.427149280775 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_54,L-glycine_peak_2,0.01991315577524445,1.0100278317929714,9303.67,8511.292432674694 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_54,L-glycine_peak_2,0.02011057852605348,1.0200414366277277,10181.31,8595.67497776017 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_54,L-glycine_peak_2,0.020167341209162262,1.0200134837686714,14080.13,1620.1690173484824 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_54,L-glycine_peak_2,0.019813965869496835,1.002140646315695,14148.02,1591.7801597949237 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_54,L-glycine_peak_2,0.020144770066602046,1.0188718920478437,13528.85,1618.355735890954 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_54,L-glycine_peak_2,0.019854649173063142,1.0041983056656065,14090.3,1595.0485047531363 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_54,L-glycine_peak_2,0.02022065109419524,1.022709763907329,14921.92,1624.4517347951235 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_54,L-glycine_peak_2,0.01980107709010274,1.001488764214086,15727.05,1590.74472330237 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_55,glycolic_acid,0.00806512566468344,0.48924313271034015,43.68,64.1544519923069 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_55,glycolic_acid,0.01907740273044422,1.1572650773056083,127.55,151.7521695870844 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_55,glycolic_acid,0.03536029487785391,2.1450107734039463,257.42,281.27526271645945 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_55,glycolic_acid,0.029266048947407683,1.7753242868591912,188.76,232.79827373584573 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_55,glycolic_acid,0.008342025567319963,0.5060403137395583,59.51,66.35706634066827 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_55,glycolic_acid,0.015767568633820415,0.9564853660514394,122.81,125.42392605032525 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_55,glycolic_acid,0.029535952774907063,1.7916970750321688,280.65,234.9452374489683 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_55,glycolic_acid,0.021519897319019817,1.3054306179090829,212.94,171.18111692641804 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_55,glycolic_acid,0.02922054308272171,1.7725638299585444,379.45,232.43629502246392 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_55,glycolic_acid,0.009168970302800599,0.5562040743287431,137.17,72.93504026672808 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_55,glycolic_acid,0.020585497087487515,1.2487484389218477,306.17,163.7483827958219 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_55,glycolic_acid,0.017540703803127763,1.0640465177331169,231.32,139.5284198703436 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_55,glycolic_acid,0.00790666503261948,0.4796306630148323,97.48,62.893968841134956 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_55,glycolic_acid,0.022869323032437314,1.3872888915232455,399.33,181.9151923454432 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_55,glycolic_acid,0.02700819166478001,1.6383591339164718,295.71,214.83803323046695 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_55,glycolic_acid,0.02387893538447684,1.448533555335221,272.39,189.94620511110753 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_55,glycolic_acid,0.014410629370170276,0.8741713087326668,127.9,114.63008371411459 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_55,glycolic_acid,0.022749185768099273,1.3800011772328942,194.05,180.9595543705494 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_55,glycolic_acid,0.012302756286270256,0.7463044317863013,67.07,97.8629001401377 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_55,glycolic_acid,0.026934753582976447,1.6339042650532196,151.06,214.25386627642868 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_55,glycolic_acid,0.020448054640229998,1.2904772606396027,231.82,67.16934141629132 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_55,glycolic_acid,0.019611039844558743,1.237653235095992,228.57,64.41985088674637 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_55,glycolic_acid,0.015300661296571762,0.9656251327266714,165.33,50.260788158423246 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_55,glycolic_acid,0.024835361383071977,1.5673603033887828,281.03,81.58110379138614 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_55,glycolic_acid,0.013557144356829335,0.8555917332730673,123.38,44.53354971686315 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_55,glycolic_acid,0.025889033096851158,1.6338575526741017,247.41,85.042285616687 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_56,guanidine,0.015362561072845352,0.7449839326374508,944.08,2083.4444155318743 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_56,guanidine,0.025535661539774313,1.2383129001860191,2461.03,3463.1030060472267 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_56,guanidine,0.01968674109837994,0.9546784377124704,2083.32,2669.8823592598264 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_56,guanidine,0.022693266807972144,1.1004753094766886,1700.66,3077.6222647417917 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_56,guanidine,0.018740505516081397,0.9087921885408866,1954.43,2541.5554982391 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_56,guanidine,0.018049306778898058,0.875273561599766,2016.88,2447.8163005767537 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_56,guanidine,0.021340624186255083,1.0348809717226144,2253.31,2894.179171948615 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_56,guanidine,0.019792685357618744,0.9598160427324821,2138.35,2684.2503395869417 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_56,guanidine,0.021052803135113585,1.0209235294993744,2369.52,2855.1453703038355 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_56,guanidine,0.01897223756510255,0.9200296802832669,2418.16,2572.982604770593 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_56,guanidine,0.01504493596680696,0.7295811882982192,2026.73,2040.3686386304487 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_56,guanidine,0.02277591034824062,1.1044829817225041,4089.51,3088.8302411746067 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_56,guanidine,0.021639339278259024,1.049366703816634,3719.6,2934.6904048947135 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_56,guanidine,0.023302981082935385,1.1300424718914368,3809.99,3160.310678165749 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_56,guanidine,0.020598418573849676,0.9988888442815252,3530.27,2793.522508583042 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_56,guanidine,0.018507736813562155,0.8975044258706234,3219.58,2509.9878025225617 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_56,guanidine,0.016537017029070334,0.8019373802318441,2659.22,2242.7221356777823 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_56,guanidine,0.02050484494450746,0.9943511340619874,3257.44,2780.832212051776 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_56,guanidine,0.020422178394784975,0.9903423460078469,3622.81,2769.621115115925 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_56,guanidine,0.020779031353710113,1.0076473851515657,4034.5,2818.016906736423 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_56,guanidine,0.019950093072430317,1.660277248335183,5271.91,670.9512415972142 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_56,guanidine,0.020066068054847896,1.6699288636928111,5409.73,674.8516523955388 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_56,guanidine,0.019577059763310953,1.6292328459981358,4726.93,658.4055777247667 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_56,guanidine,0.02041526426118581,1.6989895058904654,5190.55,686.5956391204548 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_56,guanidine,0.02048459622737914,1.7047594181227148,5060.91,688.9273760517515 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_56,guanidine,0.019544988258740823,1.626563806351837,5171.21,657.3269654229044 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_57,L-gulonolactone,0.021093379332854944,1.0920476390908354,48631.01,78760.4632579342 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_57,L-gulonolactone,0.020070790665227493,1.0391061202084526,73891.43,74942.22456257239 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_57,L-gulonolactone,0.020052086182623535,1.038137750667198,81272.26,74872.38398882454 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_57,L-gulonolactone,0.018702886885794016,0.9682869276428026,52570.85,69834.61550380723 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_57,L-gulonolactone,0.018780445439662972,0.972302293521705,80437.69,70124.21099895958 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_57,L-gulonolactone,0.022014899349158523,1.1397566259866332,101874.82,82201.32222321529 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_57,L-gulonolactone,0.019126620766052937,0.9902245022835239,86043.66,71416.7933132819 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_57,L-gulonolactone,0.01927246175424095,0.9977749902503961,88819.59,71961.34824734082 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_57,L-gulonolactone,0.01867449989130881,0.9668172745436346,89945.72,69728.6214475266 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_57,L-gulonolactone,0.021777467375731326,1.1274642843028149,118741.04,81314.77616891645 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_57,L-gulonolactone,0.022496925662126153,1.164712119781601,67168.14,84001.15785470708 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_57,L-gulonolactone,0.02038510135430157,1.0553786311479267,81274.77,76115.82766749717 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_57,L-gulonolactone,0.019180843517977143,0.9930317256918474,73495.42,71619.2553746368 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_57,L-gulonolactone,0.017468428770256075,0.9043764916070766,63094.07,65225.27853991709 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_57,L-gulonolactone,0.02078596768665456,1.0761323057929004,90159.94,77612.62045458052 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_57,L-gulonolactone,0.019760821919956352,1.0230584006314358,88943.88,73784.8338198283 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_57,L-gulonolactone,0.019681514784059783,1.0189525070639691,90876.99,73488.70930301632 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_57,L-gulonolactone,0.01979006082264592,1.0245721587707972,90490.39,73894.00881187887 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_57,L-gulonolactone,0.02069964772896601,1.071663344015241,103843.39,77290.3107976653 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_57,L-gulonolactone,0.019486507657936313,1.0088565869968928,106513.57,72760.57317320425 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_57,L-gulonolactone,0.019489259044318943,1.167560744090491,70390.72,692.6437358242429 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_57,L-gulonolactone,0.020557402364145,1.231550976169372,76036.28,730.6053011027182 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_57,L-gulonolactone,0.020038936691437713,1.2004907821807271,70415.26,712.1791516208946 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_57,L-gulonolactone,0.01995097351315131,1.1952210921602346,74072.4,709.0529607131376 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_57,L-gulonolactone,0.020024729621160003,1.1996396663170061,77410.29,711.6742356459007 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_57,L-gulonolactone,0.01998011273566267,1.1969667620310194,83132.99,710.0885619072819 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_58,hexose,0.021944311587396296,1.1242041585283142,223681.29,NA -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_58,hexose,0.019433410544157835,0.9955710326624285,235205.81,NA -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_58,hexose,0.01880808798792763,0.9635358414313984,246557.81,NA -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_58,hexose,0.018494785168188622,0.9474853797239764,224137.45,NA -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_58,hexose,0.020767582116380804,1.063920464528169,252156.46,NA -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_58,hexose,0.019768178970919693,1.0127211745573248,259547.41,NA -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_58,hexose,0.020684118966874974,1.059644658500505,253150.84,NA -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_58,hexose,0.020224444763471686,1.0360956103120456,252788.7,NA -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_58,hexose,0.020187972521871437,1.034227142234815,257833.31,NA -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_58,hexose,0.019394271409120964,0.9935659399898052,280313.33,NA -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_58,hexose,0.021826894514196966,1.118188897514215,239199.25,NA -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_58,hexose,0.019719786414339347,1.0102420303320538,257704.98,NA -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_58,hexose,0.019821217075954814,1.0154383096109116,247143.83,NA -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_58,hexose,0.018240700968515104,0.9344686800315893,239741.45,NA -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_58,hexose,0.02014035364138838,1.0317876333329152,262614.01,NA -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_58,hexose,0.01991245395925967,1.0201123629852444,268436.8,NA -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_58,hexose,0.020136737916987196,1.0316024002536401,262667.79,NA -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_58,hexose,0.020231441036553815,1.036454028449785,260181.47,NA -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_58,hexose,0.020337176172867233,1.0418708253938447,272084.03,NA -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_58,hexose,0.019519863381508393,1,283472.57,NA -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_58,hexose,0.020085715266872396,1.2009543892568306,354939,NA -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_58,hexose,0.01990261283474701,1.1900064261585355,361052.15,NA -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_58,hexose,0.020188350913520448,1.2070911251757892,351772.38,NA -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_58,hexose,0.01980865920098297,1.1843888005297556,364323.42,NA -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_58,hexose,0.020270903631196838,1.21202707330217,366389.4,NA -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_58,hexose,0.019755216492078884,1.1811933825434222,381999.57,NA -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_59,L-histidine,0.020047106901227955,1.0496539196481935,1675.51,1668.1100091049093 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_59,L-histidine,0.018629592462001143,0.9754337543832896,1749.44,1550.1593224659239 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_59,L-histidine,0.019637052979449805,1.028183753983781,1987.13,1633.9896218310248 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_59,L-histidine,0.020397566205074012,1.0680037485672311,2020.65,1697.2715572230438 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_59,L-histidine,0.0199979039558005,1.0470776843449836,1717.84,1664.015855961048 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_59,L-histidine,0.02222231888738404,1.1635466523294669,2041.37,1849.1083398819887 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_59,L-histidine,0.017462335865036618,0.914316932475986,1389.59,1453.032469090837 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_59,L-histidine,0.020218497484252,1.0586278228726513,1639.8,1682.3713361092175 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_59,L-histidine,0.020565745740944164,1.0768095233805486,1728.44,1711.2656945563679 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_59,L-histidine,0.020063556095692357,1.0505151891335953,1916.38,1669.4787385711097 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_59,L-histidine,0.022415550479374977,1.1736641370584342,2306.35,1865.1870466132636 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_59,L-histidine,0.020300524076725487,1.0629226837086507,2115.09,1689.1967289497877 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_59,L-histidine,0.018652371823218054,0.9766264674219449,1834.27,1552.0547820269549 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_59,L-histidine,0.01767116841308256,0.9252512734602761,2154.56,1470.409323783071 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_59,L-histidine,0.020458682129602022,1.0712037399699716,1879.59,1702.3569835602789 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_59,L-histidine,0.020378462978257943,1.067003515615703,1923.69,1695.6819870164752 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_59,L-histidine,0.019764859599903168,1.0348756283164133,1721.37,1644.624348520444 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_59,L-histidine,0.019926620634690632,1.043345334446459,1710.13,1658.0844055023126 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_59,L-histidine,0.0207418257419488,1.086028961583617,1916.71,1725.9172257486841 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_59,L-histidine,0.019315878403922994,1.0113672550368726,1948.56,1607.264841704598 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_59,L-histidine,0.02053589892231302,1.0652523359912802,2165.89,2401.2065956046645 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_59,L-histidine,0.019439169290140924,1.0083620188426705,2052.73,2272.96899391364 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_59,L-histidine,0.017959187036073444,0.9315913569235061,1353.14,2099.9187094684135 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_59,L-histidine,0.022075369293395274,1.1451088066132162,1738.44,2581.212663162983 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_59,L-histidine,0.020048260781958507,1.039957233493153,1557.07,2344.188399161586 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_59,L-histidine,0.01990457359239078,1.0325037923305296,1672.13,2327.3874483680934 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_60,L-homoserine,0.015397966296442496,0.6501160118253246,37.64,44.591457251099015 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_60,L-homoserine,0.014573003883764,0.6152853554054407,37.78,42.20242252725918 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_60,L-homoserine,0.02600090812469999,1.0977817699063286,89.17,75.29685159787508 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_60,L-homoserine,0.02459506223137274,1.0384256895113428,81.52,71.22561804358301 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_60,L-homoserine,0.024769962123373,1.0458101205502752,59.71,71.73211616854339 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_60,L-homoserine,0.0180859419769467,0.7636047671356017,38.39,52.37565097783092 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_60,L-homoserine,0.0198918017107381,0.8398497923191969,26.35,57.60529725517372 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_60,L-homoserine,0.009587618119145866,0.4047978761950791,NA,27.765086328220477 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_60,L-homoserine,0.009292461585510654,0.3923361013855418,NA,26.910333194034315 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_60,L-homoserine,0.033858372941502936,1.4295310146710696,75.12,98.05153229628867 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_60,L-homoserine,0.018170798876506012,0.767187501897796,54.32,52.621390755169834 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_60,L-homoserine,0.015357021233615528,0.6483872743780192,40.75,44.47288314958834 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_60,L-homoserine,0.01684253121325853,0.7111068442809195,44.53,48.77481844922827 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_60,L-homoserine,0.025144134583839958,1.0616080189902692,96.6,72.81569402254257 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_60,L-homoserine,0.015562256622226793,0.6570524974185582,49.11,45.06723079793891 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_60,L-homoserine,0.02143168856752332,0.9048652029729229,83.2,62.06470427191279 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_60,L-homoserine,0.02876549097518138,1.2145049489621818,134.46,83.30289444931606 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_60,L-homoserine,0.021565578041396704,0.9105181372048978,93.41,62.452439030883944 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_60,L-homoserine,0.01843120985326341,0.778182287987448,68.59,53.37552313305906 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_60,L-homoserine,0.017164661826049234,0.7247074890181875,66.03,49.707686671757486 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_60,L-homoserine,0.020611776650694153,1.052280229000184,48,56.254901042349836 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_60,L-homoserine,0.0193912565537067,0.9899697746942459,43.2,52.92378415515439 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_60,L-homoserine,0.017446579870473787,0.8906894040477527,32.69,47.61625554039286 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_60,L-homoserine,0.02242287172837977,1.1447409409215867,52.83,61.19785070166803 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_60,L-homoserine,0.0229057889973854,1.1693950162606126,108.11,62.51585756929235 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_60,L-homoserine,0.01739774058055553,0.8881960421192621,85.87,47.48296041169575 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_61,myo-inositol_1-phosphate,0.016194957931148005,0.8012677984055194,210.35,492.5553410358409 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_61,myo-inositol_1-phosphate,0.023502300700606923,1.1628086235173627,645.07,714.8017170485932 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_61,myo-inositol_1-phosphate,0.01790492613301685,0.8858708249944109,547.03,544.5625135405643 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_61,myo-inositol_1-phosphate,0.02339973979709878,1.157734281879315,382.5,711.6824177568526 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_61,myo-inositol_1-phosphate,0.018356388576626925,0.9082075497819744,645.44,558.2933450019754 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_61,myo-inositol_1-phosphate,0.019005782286582142,0.9403371959648419,728.37,578.0440811035077 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_61,myo-inositol_1-phosphate,0.02529467885427961,1.251488995717728,926.12,769.3153154476017 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_61,myo-inositol_1-phosphate,0.018449560112980188,0.9128173395773682,685.76,561.1270749849998 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_61,myo-inositol_1-phosphate,0.01825645196417337,0.9032630485500969,568.44,555.2538612047156 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_61,myo-inositol_1-phosphate,0.0202838278605219,1.0035702569981804,695.76,616.9147083819215 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_61,myo-inositol_1-phosphate,0.019955362983364616,0.9873190058314723,327.23,606.9247392647227 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_61,myo-inositol_1-phosphate,0.019653696597003417,0.9723936468228087,560.27,597.749822574917 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_61,myo-inositol_1-phosphate,0.023357831339481817,1.1556608033490172,646.03,710.407809034708 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_61,myo-inositol_1-phosphate,0.01854953326040616,0.9177636484272116,378.92,564.1676699611755 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_61,myo-inositol_1-phosphate,0.019619351949047837,0.9706943981695317,632.58,596.7052604427746 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_61,myo-inositol_1-phosphate,0.0194270278541558,0.9611788992871242,645.19,590.855892969781 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_61,myo-inositol_1-phosphate,0.019040390935551096,0.94204950643104,614.72,579.096672593289 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_61,myo-inositol_1-phosphate,0.019883269877101917,0.9837521003303331,632.54,604.7320911150624 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_61,myo-inositol_1-phosphate,0.019505797949770556,0.965076158011831,624.85,593.2516158530328 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_61,myo-inositol_1-phosphate,0.021012788803323027,1.0396366013656748,727.28,639.0854115915076 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_61,myo-inositol_1-phosphate,0.019083394487719424,1.0002236264810083,675.48,158.43542243459171 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_61,myo-inositol_1-phosphate,0.021000935579631765,1.1007282775855678,784.13,174.35535916955394 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_61,myo-inositol_1-phosphate,0.019087070786609265,1.0004163134272428,865.37,158.46594404687528 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_61,myo-inositol_1-phosphate,0.02089942509956593,1.09540777862703,1005.26,173.51259213452155 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_61,myo-inositol_1-phosphate,0.01976695896912175,1.03605149478619,904.54,164.1105567741325 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_61,myo-inositol_1-phosphate,0.020196367881446325,1.058558231719441,978.73,167.67562390435947 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_62,myo-inositol,0.02279614172240978,1.120954000500711,1253664.76,1087958.3159525325 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_62,myo-inositol,0.020885157069060988,1.026985208845017,1196694.47,996755.5295079888 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_62,myo-inositol,0.01349976805384062,0.6638236939415145,830765.97,644283.8045338163 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_62,myo-inositol,0.018330500310328623,0.9013651478505681,1187083.06,874833.1402321334 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_62,myo-inositol,0.022702957598634704,1.116371860347312,1212501.89,1083511.0527441192 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_62,myo-inositol,0.021575866930873114,1.0609494643849124,1245688.98,1029720.0349589353 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_62,myo-inositol,0.02289579811626749,1.1258544013988356,1210890.44,1092714.4717860764 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_62,myo-inositol,0.015331129584340979,0.7538771801399884,828962.31,731686.533946783 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_62,myo-inositol,0.021243964000096344,1.04462881141817,1226778.51,1013879.7862877041 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_62,myo-inositol,0.01914600978735612,0.9414661711663496,1258614.01,913753.7754902465 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_62,myo-inositol,0.02332933185677116,1.147172543156653,1245463.59,1113405.1063667214 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_62,myo-inositol,0.015659236083763402,0.7700111513003928,805133.9,747345.5958578512 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_62,myo-inositol,0.016881645290015027,0.8301206429276367,819173.14,805685.7429596302 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_62,myo-inositol,0.018898084794742784,0.9292749628610939,1188901.95,901921.419790291 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_62,myo-inositol,0.02399161965031799,1.1797392011770889,1211446.14,1145013.1530843289 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_62,myo-inositol,0.015533954466357223,0.76385068204508,831927.63,741366.4622328376 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_62,myo-inositol,0.02391299636732298,1.1758730608153136,1258323.61,1141260.813955913 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_62,myo-inositol,0.024576594265853915,1.208504140589259,1264816.82,1172931.3861495235 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_62,myo-inositol,0.018532564866170092,0.9113012622592281,817910.25,884476.7815361733 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_62,myo-inositol,0.017275192951930946,0.8494725504295398,808782.64,824468.0200975282 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_62,myo-inositol,0.02001019950776163,1.00973750513965,943769.02,23931.576564438765 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_62,myo-inositol,0.019977840822256333,1.0081046489375396,967498.26,23892.87658249235 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_62,myo-inositol,0.020485830688057274,1.0337383973432517,948446.95,24500.416670368966 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_62,myo-inositol,0.019507433810001373,0.9843673742157018,952561.02,23330.284419137763 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_62,myo-inositol,0.02038588880257748,1.0286952157365827,959898.33,24380.889282177443 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_62,myo-inositol,0.01965661745211301,0.9918953510624605,988516.6,23508.703417507655 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_63,isocitric_acid,0.020211365058985672,1.1078458261230701,7480.85,9712.44004378791 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_63,isocitric_acid,0.019601439083068703,1.0744139453623371,9746.44,9419.344082433794 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_63,isocitric_acid,0.01951991098777423,1.069945144773156,10588.66,9380.166286420468 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_63,isocitric_acid,0.02004053031484647,1.0984818589838354,8905.84,9630.346518436925 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_63,isocitric_acid,0.02094070794182815,1.1478233074169613,11115.72,10062.921023192202 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_63,isocitric_acid,0.019832984913196586,1.0871056700783444,11367.64,9530.61192535004 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_63,isocitric_acid,0.019300725712153074,1.0579309392983718,10494.31,9274.838227591252 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_63,isocitric_acid,0.020162040848012663,1.1051422174804184,11214.05,9688.737614962129 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_63,isocitric_acid,0.019601917756116173,1.0744401828745571,11317.91,9419.574105653926 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_63,isocitric_acid,0.020498045880305158,1.1235596658563802,13404,9850.20264817625 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_63,isocitric_acid,0.02173481982157476,1.1913509726134741,9806.02,10444.526322863421 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_63,isocitric_acid,0.01962362112734661,1.0756298100551194,11044.53,9430.003519560829 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_63,isocitric_acid,0.020074704540055263,1.10035505125205,10803.24,9646.76872012467 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_63,isocitric_acid,0.018243842764399602,1,9911.36,8766.96 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_63,isocitric_acid,0.020260567161807293,1.1105427416499696,11523.52,9736.083794335616 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_63,isocitric_acid,0.02018859960794019,1.106597983147252,11848.71,9701.500254332632 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_63,isocitric_acid,0.0198123024420967,1.0859720015104348,11134.45,9520.67309836192 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_63,isocitric_acid,0.019586125770693096,1.0735745765641425,10846.04,9411.985369754773 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_63,isocitric_acid,0.019932493255952127,1.0925600222146015,11382.11,9578.430012354522 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_63,isocitric_acid,0.02025296418344026,1.1101259994939876,12544.05,9732.430232523808 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_63,isocitric_acid,0.020209341517285512,1.3432349403962955,9901.26,9830.182831952805 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_63,isocitric_acid,0.019782644163228714,1.314874056175822,9900.74,9622.629656570956 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_63,isocitric_acid,0.019532660793105772,1.298258651018759,9016.16,9501.033303164075 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_63,isocitric_acid,0.020467606623538435,1.3604007997741168,9971.52,9955.80756897892 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_63,isocitric_acid,0.020242484708350297,1.34543783712286,10001.87,9846.304269037855 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_63,isocitric_acid,0.019766431681939617,1.3137964767148878,10492.07,9614.743617577797 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_64,L-isoleucine,0.018223138957822488,0.929605841102931,3702.1,5373.1589458085855 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_64,L-isoleucine,0.01962518035899081,1.0011273215136773,5676.62,5786.555963441915 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_64,L-isoleucine,0.02041882291749661,1.0416129239031695,6460.36,6020.564364677276 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_64,L-isoleucine,0.021846737481487463,1.114454256143137,5357.79,6441.590178677578 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_64,L-isoleucine,0.020407753323488775,1.0410482374749894,6382.32,6017.300454534938 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_64,L-isoleucine,0.01974845114625153,1.0074156587831318,6659.9,5822.902804392853 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_64,L-isoleucine,0.01956767641231798,0.9981939078555113,6198.36,5769.600715161169 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_64,L-isoleucine,0.020060376599147802,1.0233277211162009,6490.57,5914.875161160486 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_64,L-isoleucine,0.020563876978041885,1.0490124779685082,6707.93,6063.334083157096 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_64,L-isoleucine,0.019603081383612695,1,7219.95,5780.04 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_64,L-isoleucine,0.01788114017592247,0.9121596664323554,4700.75,5272.319358365671 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_64,L-isoleucine,0.0200026189893826,1.020381367497862,6706.88,5897.845119392342 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_64,L-isoleucine,0.020336990235952743,1.0374384433741912,6527.27,5996.43570024056 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_64,L-isoleucine,0.022171852052107355,1.1310391268712499,7033.02,6537.451394880899 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_64,L-isoleucine,0.019769854831193034,1.008507511871055,6737.75,5829.213758915173 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_64,L-isoleucine,0.019625126285319233,1.0011245630865444,6910.99,5786.54001962275 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_64,L-isoleucine,0.02011413490395281,1.0260700606368616,6836.07,5930.725993283485 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_64,L-isoleucine,0.020722340736300617,1.0570960927409898,6936.62,6110.057699886631 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_64,L-isoleucine,0.020332443404375296,1.0372064986360927,6916.5,5995.095050376562 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_64,L-isoleucine,0.0194084204421631,0.990069880462144,7147.22,5722.64351186641 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_64,L-isoleucine,0.02018494758802335,1.0496356731739331,7461.96,2684.3487669317483 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_64,L-isoleucine,0.019812638310724016,1.030275251394148,7496.44,2634.836230667908 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_64,L-isoleucine,0.01940169001794673,1.0089055655900143,6938.04,2580.1851824955584 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_64,L-isoleucine,0.020601216952002222,1.0712820595307102,7783.21,2739.7074518644336 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_64,L-isoleucine,0.020024075415282012,1.0412701735562626,7751.74,2662.9547545545215 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_64,L-isoleucine,0.019963584939412318,1.0381246136739188,8304.54,2654.910268255817 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_65,itaconic_acid,0.01601353350108857,0.7565864905708796,645.37,1358.61749284794 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_65,itaconic_acid,0.024191885817882536,1.142986586314567,1911.78,2052.483872776794 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_65,itaconic_acid,0.016755654953736692,0.791649274521607,1337.26,1421.5804352439402 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_65,itaconic_acid,0.023801844923319108,1.1245584441698735,1336.53,2019.3920893647253 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_65,itaconic_acid,0.01901704263327736,0.8984923624739064,1739.33,1613.4407051416433 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_65,itaconic_acid,0.019346832152187642,0.9140738264101719,1935.13,1641.4206515612739 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_65,itaconic_acid,0.021955290992905427,1.0373148787340138,2251.96,1862.7270740402435 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_65,itaconic_acid,0.020550297100472976,0.9709335645614281,2127.64,1743.5248205542478 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_65,itaconic_acid,0.017903560690196572,0.8458840236852019,1764.57,1518.9708590119908 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_65,itaconic_acid,0.021165502821766772,1,2433.26,1795.72 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_65,itaconic_acid,0.035116473125088664,1.6591372017382267,10632.09,2979.3458559053684 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_65,itaconic_acid,0.012165563277702227,0.5747826253005935,1728.52,1032.148655904782 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_65,itaconic_acid,0.011925769375407074,0.5634531565743157,1489.16,1011.8041023236302 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_65,itaconic_acid,0.006022888347606282,0.2845615527457394,1748.23,510.9928714965792 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_65,itaconic_acid,0.02614905273964872,1.235456249721449,2292.89,2218.5334967498 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_65,itaconic_acid,0.022306526401963827,1.0539095900440227,2042.83,1892.5265290338525 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_65,itaconic_acid,0.027793592200136805,1.313155299648901,2106.88,2358.0592346855246 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_65,itaconic_acid,0.02383625187033598,1.126184058609871,1683.4,2022.3112377269176 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_65,itaconic_acid,0.017034148835934477,0.804807189291833,910.44,1445.2083659551304 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_65,itaconic_acid,0.015818729191387704,0.7473826312843178,879.62,1342.0899386498752 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_65,itaconic_acid,0.010361541399372811,0.5488219336013702,349.31,41.90804284980063 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_65,itaconic_acid,0.030616130785192975,1.6216510120723087,1878.53,123.82927128184149 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_65,itaconic_acid,0.02290116822719719,1.2130109743074917,898.68,92.62551799812007 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_65,itaconic_acid,0.016797800935507066,0.8897326405735273,563.97,67.93998443419454 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_65,itaconic_acid,0.02138247267871662,1.1325699090892076,895.01,86.48303825805189 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_65,itaconic_acid,0.018859333250299152,0.9989262544941729,807.65,76.27800879317505 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_66,L-leucine,0.018069939868325714,0.9061381778555782,2939.1,4250.811990283639 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_66,L-leucine,0.02073758542121429,1.0399103706837418,4671.83,4878.354737225622 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_66,L-leucine,0.01910671722511116,0.9581285857797488,4702.59,4494.705752608953 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_66,L-leucine,0.022077525195920888,1.1071032110991732,4323.67,5193.565086683664 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_66,L-leucine,0.020254636021889545,1.01569231064096,4900.99,4764.744669217127 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_66,L-leucine,0.019790388382539714,0.992412072131058,5170.65,4655.53404393617 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_66,L-leucine,0.019648443053240622,0.985294058292415,4862.54,4622.142515677297 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_66,L-leucine,0.02057079146455751,1.03154629348904,5202.62,4839.117763775241 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_66,L-leucine,0.02044809566518286,1.0253935697452958,5256.75,4810.254536839249 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_66,L-leucine,0.019480688258783865,0.9768817987672997,5658.56,4582.679512651243 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_66,L-leucine,0.017640690805839188,0.8846129837397111,3751.36,4149.834506410871 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_66,L-leucine,0.020528982230830252,1.0294497207752833,5530.51,4829.282468620555 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_66,L-leucine,0.020043228577308465,1.0050910381401261,5165.64,4715.0127217502895 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_66,L-leucine,0.02234336876361539,1.1204342463865442,5730.92,5256.102706251309 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_66,L-leucine,0.019873196192800868,0.9965645662095679,5386.77,4675.01393348269 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_66,L-leucine,0.019219865881561615,0.9638025569235343,5379.03,4521.3230888606995 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_66,L-leucine,0.020889779222581034,1.0475423060889677,5587.78,4914.157138363139 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_66,L-leucine,0.020276409688591658,1.016784176514032,5337.49,4769.866753970271 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_66,L-leucine,0.02010349348378945,1.0081130920564778,5313.23,4729.189569538905 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_66,L-leucine,0.019544821634796438,0.9800978415932986,5586.12,4597.766387633571 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_66,L-leucine,0.020244329551188104,1.1414449067792527,6598.88,3037.841474902303 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_66,L-leucine,0.019739269484750657,1.11296788367039,6572.94,2962.052725600376 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_66,L-leucine,0.019721020030626136,1.111938916699206,6062.25,2959.3142329032667 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_66,L-leucine,0.02028255399884414,1.1436001325663607,6580.65,3043.5773928121125 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_66,L-leucine,0.02008082795428047,1.1322261245731737,6629.9,3013.3066079390446 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_66,L-leucine,0.01991868418517637,1.1230839013673177,7067.76,2988.9754950989795 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_67,L-lysine,0.02175023787378219,1.186399800634153,562.66,774.2682378898609 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_67,L-lysine,0.018383993204761934,1.0027828660798213,667.01,654.436154061013 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_67,L-lysine,0.020104303800866793,1.0966198236382405,797.87,715.6760293027885 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_67,L-lysine,0.018844173895329653,1.02788412164831,587.35,670.81773547012 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_67,L-lysine,0.020636123281257968,1.1256287259394884,832.31,734.6078191226289 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_67,L-lysine,0.019133525743092013,1.0436672582048157,838.59,681.1181260496268 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_67,L-lysine,0.02008815258964396,1.0957388312607794,828.72,715.1010760574098 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_67,L-lysine,0.021879958595469068,1.193475614666189,918.95,778.8860556434482 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_67,L-lysine,0.018824859877075696,1.026830609151623,735.96,670.1301921445322 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_67,L-lysine,0.020234735996269442,1.1037344460860488,884.92,720.3191742046771 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_67,L-lysine,0.020460617793663996,1.1160555122256892,579.15,728.3601483887293 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_67,L-lysine,0.023278767614284258,1.2697757797806137,957.65,828.6810694004241 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_67,L-lysine,0.01771254776784113,0.9661578536490476,702.23,630.5339384484414 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_67,L-lysine,0.019026644091126844,1.0378372359623567,657.6,677.3133369337532 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_67,L-lysine,0.018412590358020415,1.0043427412922878,823.11,655.4541598221729 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_67,L-lysine,0.021329800253925633,1.1634663912952978,986.61,759.3014362871372 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_67,L-lysine,0.01790561427240529,0.9766889597387035,813.78,637.4067489046727 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_67,L-lysine,0.022221644008149813,1.2121133651053544,995.08,791.0494243350564 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_67,L-lysine,0.020699308393364688,1.1290752539655942,932.17,736.857092243026 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_67,L-lysine,0.019237769321080893,1.049353382690492,936,684.8290046114688 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_67,L-lysine,0.021834147205808844,1.1548156149403004,763.77,3004.934163480006 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_67,L-lysine,0.018032710006459847,0.9537562836257609,649.05,2481.759688059756 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_67,L-lysine,0.01887747369295888,0.9984361278581969,671.26,2598.0206639385356 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_67,L-lysine,0.021160244194626414,1.1191726510574833,795.09,2912.187963590167 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_67,L-lysine,0.019685449281632458,1.0411702368433462,706.7,2709.218661587703 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_67,L-lysine,0.02025558486135849,1.0713249053034684,774.68,2787.683822841102 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_68,pectin,0.019856085084398276,1.0022495280826609,669.74,996.9877180602269 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_68,pectin,0.018763770672170853,0.9471142081281232,962.95,942.1418585354505 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_68,pectin,0.01884217002091219,0.9510714690858603,1061.84,946.0783438731595 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_68,pectin,0.02102212415903808,1.061106150992781,860.64,1055.535343700069 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_68,pectin,0.01952289956580834,0.9854317602623002,1143.55,980.2582435209231 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_68,pectin,0.02231701683679037,1.1264667479925725,1415.68,1120.5527975656114 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_68,pectin,0.020276187626476806,1.0234544923419735,1207.46,1018.0813562571782 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_68,pectin,0.018336372649124164,0.9255409994577704,1113.09,920.681909210617 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_68,pectin,0.019842368466122664,1.0015571723571899,1150.68,996.2989972023146 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_68,pectin,0.020538066493575445,1.0366730079682318,1336.38,1031.2304746763987 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_68,pectin,0.020067879203888427,1.0129399816845381,916.23,1007.6220467806943 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_68,pectin,0.018478844871076573,0.9327323826841087,1067.5,927.8355376750171 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_68,pectin,0.020542806758908006,1.0369122761156209,1136.03,1031.4684866660139 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_68,pectin,0.020336711130235545,1.0265094577504248,1119.04,1021.1202830972351 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_68,pectin,0.020494765702385585,1.0344873708020341,1221.32,1029.0563121053235 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_68,pectin,0.01978388937653848,0.9986054001579208,1220.81,993.3627218070917 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_68,pectin,0.02043979036877771,1.0317124530913937,1223.87,1026.2959627126638 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_68,pectin,0.019840926942735527,1.0014844104744554,1170.38,996.2266173194645 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_68,pectin,0.019561501512294504,0.9873802200157905,1173.27,982.1964738607076 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_68,pectin,0.02027654312217491,1.0234724362314231,1316.48,1018.0992059412082 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_68,pectin,0.019074634601883862,1.0040635512707656,1251.79,605.8820687433181 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_68,pectin,0.021006111532730985,1.1057339437506504,1421.67,667.233033677455 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_68,pectin,0.019981544760804756,1.0518021032197353,1375.09,634.6889431458849 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_68,pectin,0.01999625356485521,1.052576355221836,1456.49,635.1561500315124 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_68,pectin,0.020341538885547045,1.0707517180810158,1527.99,646.1237092416272 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_68,pectin,0.019689726349226465,1.0364411677800307,1587.07,625.4196938735039 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_69,citramalic_acid,0.0297467097903609,1.4626758573248897,186.25,239.11824915547294 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_69,citramalic_acid,0.02839440628420593,1.3961817238839664,222.31,228.24778822055083 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_69,citramalic_acid,0.016588271237582,0.8156621026312736,141.19,133.3444405381606 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_69,citramalic_acid,0.008071508311323541,0.39688424105968656,60.33,64.88263572843755 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_69,citramalic_acid,0.014141802951847311,0.6953667784601721,115.26,113.67856094266894 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_69,citramalic_acid,0.02101377309309784,1.0332685124234264,185.25,168.91873641098175 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_69,citramalic_acid,0.020767029188950143,1.021135864675746,179.9,166.93529115719096 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_69,citramalic_acid,0.0240429863772859,1.1822179985580392,213.45,193.26899840426825 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_69,citramalic_acid,0.021421788249475878,1.053331031030112,202.57,172.1985569528027 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_69,citramalic_acid,0.017195610262517428,0.8455255777935634,184.47,138.22652145769175 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_69,citramalic_acid,0.016056947810316812,0.7895363914192142,126.05,129.07340926921313 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_69,citramalic_acid,0.009794147316582229,0.4815881461851709,83.84,78.73003013835174 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_69,citramalic_acid,0.015095413005420834,0.7422567509140757,123.25,121.3441336394331 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_69,citramalic_acid,0.029369447077472778,1.4441254675204631,273.44,236.0856314302453 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_69,citramalic_acid,0.02111531209379173,1.0382612879585538,204.87,169.73495535546436 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_69,citramalic_acid,0.023808557114186057,1.170690874186869,246.62,191.3845441120693 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_69,citramalic_acid,0.02966111471886051,1.4584670609412915,321.61,238.43019512268233 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_69,citramalic_acid,0.012564542872473983,0.6178113024065055,133.88,100.99979171741552 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_69,citramalic_acid,0.026552969419003133,1.3056364076287572,257.45,213.4454399191492 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_69,citramalic_acid,0.012311344110533291,0.6053612627616097,127.31,98.96445923626796 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_69,citramalic_acid,0.023121471377887858,1.2140408792361834,174.59,83.61099535299596 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_69,citramalic_acid,0.01673086513267883,0.8784888246984438,135.37,60.50152535698183 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_69,citramalic_acid,0.020472153389676048,1.0749329354891053,208.39,74.03063126713468 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_69,citramalic_acid,0.019538698561030167,1.0259199508751464,209.62,70.65510701677134 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_69,citramalic_acid,0.02294747446465148,1.204904809905756,153.43,82.98179425820942 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_69,citramalic_acid,0.017088720688875264,0.8972787739617833,113.56,61.79558916274802 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_71,cellobiose,0.022257027998669278,1.155387297224379,2450.87,3241.2773081413843 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_71,cellobiose,0.01964322039913158,1.019701611872545,2859.36,2860.630113882763 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_71,cellobiose,0.01955420422306613,1.0150806822911265,3103.83,2847.666742872235 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_71,cellobiose,0.017859647738113667,0.9271143537561428,2357.34,2600.889523453333 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_71,cellobiose,0.02121849748797403,1.1014760131163222,3316.7,3090.0367481560056 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_71,cellobiose,0.019263694565569478,1,3257.01,2805.36 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_71,cellobiose,0.019485143166168187,1.0114956453366173,3170.27,2837.609423601533 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_71,cellobiose,0.02047002267917407,1.0626218459547574,3410.31,2981.0368217676382 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_71,cellobiose,0.01966056028615079,1.020601744864178,3446.88,2863.1553109721704 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_71,cellobiose,0.020275448055462206,1.0525212589126627,4030.13,2952.7010389032275 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_71,cellobiose,0.021995135599480277,1.1417921689224027,3337.87,3203.1380790081516 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_71,cellobiose,0.019354381498697792,1.0047076604552483,3341.19,2818.5666823347356 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_71,cellobiose,0.019814816293893225,1.0286093473112257,3254.15,2885.6195185730203 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_71,cellobiose,0.018135226558553447,0.9414199595422899,3288.54,2641.0218977015584 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_71,cellobiose,0.02035801092692501,1.056807190211136,3394.56,2964.7246191307127 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_71,cellobiose,0.020297087330508803,1.0536445779609867,3491.8,2955.8523532286335 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_71,cellobiose,0.019125507800663008,0.9928265699792886,3146.4,2785.2359463570974 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_71,cellobiose,0.02054471159167646,1.0664990312085088,3333.25,2991.9137221911024 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_71,cellobiose,0.019991070514194617,1.0377589016556148,3434.62,2911.2873123485956 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_71,cellobiose,0.02003590924842943,1.0400865306616807,3745.6,2917.8171496570526 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_71,cellobiose,0.02002226286086438,1.0236357890972467,2806.54,358.2520534682544 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_71,cellobiose,0.0199832486519679,1.0216411923432598,2860.98,357.5539844962941 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_71,cellobiose,0.019659018854499978,1.0050649828065927,2519.47,351.75264268265136 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_71,cellobiose,0.02034509124931867,1.0401403517660506,2741.42,364.0283203110824 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_71,cellobiose,0.019864882711551325,1.0155897478255982,2495.12,355.4360999440029 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_71,cellobiose,0.020115737233293126,1.0284146551847804,2695.67,359.92456102156945 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_72,D-maltose,0.024356816168958198,1.203284378640557,371.11,480.844470548553 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_72,D-maltose,0.020259175739245117,1.000851241068019,400.88,399.9501644431911 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_72,D-maltose,0.02017390613082448,0.9966387205532847,434.51,398.2667991202981 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_72,D-maltose,0.015299952229415053,0.7558538597119668,279.24,302.04676087949906 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_72,D-maltose,0.02025559408714457,1.0006742989754065,417.9,399.8794566135622 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_72,D-maltose,0.01883047454927122,0.9302700201187993,419.69,371.7452027396734 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_72,D-maltose,0.01770168490724387,0.8745051396187847,364.5,349.46099884306255 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_72,D-maltose,0.024031787508276573,1.1872271933624947,504.14,474.42785873958655 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_72,D-maltose,0.02075113356896466,1.0251551224679976,421.14,409.6622384894365 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_72,D-maltose,0.018546376080202716,0.9162348832004732,423.34,366.1366216757411 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_72,D-maltose,0.025312401006692173,1.2504925317807234,553.17,499.7093206248949 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_72,D-maltose,0.01529978572789446,0.7558456341426905,400.63,302.0434738597605 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_72,D-maltose,0.02861543604759004,1.4136702820763516,713.12,564.9167814205309 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_72,D-maltose,0.013158777722357722,0.6500747702606512,345.82,259.77637894385884 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_72,D-maltose,0.01736661373285569,0.8579518303899748,414.89,342.84613094213785 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_72,D-maltose,0.021359586849091915,1.0552141548978116,517.65,421.6741284387145 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_72,D-maltose,0.016485169243928413,0.8144063859933164,346.08,325.44493590678917 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_72,D-maltose,0.020706465454189527,1.022948411855272,426.79,408.78041486148527 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_72,D-maltose,0.020827521585793294,1.028928871332694,440.9,411.1702662732579 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_72,D-maltose,0.02038412950146923,1.0070242527249476,469.37,402.4169616314163 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_72,D-maltose,0.021587808301346195,1.2931435998543495,671.64,160.05238335397283 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_72,D-maltose,0.01824017187010433,1.0926149234240643,576.05,135.23294907219645 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_72,D-maltose,0.02037351345302191,1.2204054325736655,561.38,151.04958038964259 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_72,D-maltose,0.019660726668917813,1.1777083854691894,571.57,145.76496686952157 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_72,D-maltose,0.019912351355015248,1.1927810990976484,605.49,147.63051663531593 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_72,D-maltose,0.0200819971467963,1.202943148288636,659.11,148.88827346368447 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_73,Methyl alpha-D-mannopyranoside,0.01942970519630353,0.9773877795480453,744.13,1790.5450904986326 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_73,Methyl alpha-D-mannopyranoside,0.019882703231799016,1.0001752968870523,1545.13,1832.2911386381732 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_73,Methyl alpha-D-mannopyranoside,0.020204128610217902,1.0163442111206553,1831.97,1861.912104446707 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_73,Methyl alpha-D-mannopyranoside,0.02054492108593025,1.0334873637191078,1222.78,1893.3178457124939 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_73,Methyl alpha-D-mannopyranoside,0.020078068660885445,1.0100029180993166,2040.82,1850.2950458704051 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_73,Methyl alpha-D-mannopyranoside,0.020082153417636833,1.0102083968387465,2219.27,1850.6714767566784 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_73,Methyl alpha-D-mannopyranoside,0.019710241586400327,0.9914998227637756,2188.02,1816.397930308554 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_73,Methyl alpha-D-mannopyranoside,0.019901870870518888,1.001139501730014,2334.44,1834.0575329843336 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_73,Methyl alpha-D-mannopyranoside,0.02026997179144931,1.0196563725792034,2789.72,1867.9798848739233 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_73,Methyl alpha-D-mannopyranoside,0.019879218466684775,1,2982.85,1831.97 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_73,Methyl alpha-D-mannopyranoside,0.019547815949781343,0.9833291979028842,1089.19,1801.4295906821467 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_73,Methyl alpha-D-mannopyranoside,0.020040846916510122,1.008130523345081,1833.17,1846.8648748524881 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_73,Methyl alpha-D-mannopyranoside,0.019999241359897935,1.0060376062275438,1756.45,1843.0307134806735 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_73,Methyl alpha-D-mannopyranoside,0.020480133951914104,1.0302283254362536,1660.2,1887.3473853494536 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_73,Methyl alpha-D-mannopyranoside,0.020129738305919163,1.012602096991601,2147.76,1855.0566636257033 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_73,Methyl alpha-D-mannopyranoside,0.01968170876190591,0.9900645135969571,2050.71,1813.7684869742175 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_73,Methyl alpha-D-mannopyranoside,0.019951394487418807,1.0036307272770804,2282.84,1838.621383449793 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_73,Methyl alpha-D-mannopyranoside,0.020392289930590616,1.0258094383723229,2441.58,1879.2521168149444 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_73,Methyl alpha-D-mannopyranoside,0.019935461739614455,1.002829249702343,2434.97,1837.1531005772013 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_73,Methyl alpha-D-mannopyranoside,0.01994172677362934,1.0031444046479656,2649.01,1837.7304549829337 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_73,Methyl alpha-D-mannopyranoside,0.020022699527589997,1.272342093680389,4146.22,135.17362403260452 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_73,Methyl alpha-D-mannopyranoside,0.019976066010293995,1.2693787676338528,4233.44,134.8588002734205 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_73,Methyl alpha-D-mannopyranoside,0.01995464297448579,1.268017441195545,4155.95,134.7141729526147 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_73,Methyl alpha-D-mannopyranoside,0.02004740736102208,1.2739121525266484,4446.87,135.34042708443113 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_73,Methyl alpha-D-mannopyranoside,0.01990367968922866,1.2647789801191283,4605.65,134.3701188478562 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_73,Methyl alpha-D-mannopyranoside,0.020086980640605222,1.2764268358903592,5063.43,135.60758704499176 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_74,L-methionine,0.01983870193836948,0.9699688163584859,649.85,916.901822415513 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_74,L-methionine,0.019821258001590108,0.9691159342111013,873.21,916.0956014504119 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_74,L-methionine,0.0196414949126799,0.9603268213388549,943.91,907.7873409434062 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_74,L-methionine,0.020392125923836324,0.9970272403317526,802.21,942.4798800132024 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_74,L-methionine,0.018858915861739566,0.9220643746270853,884.5,871.6182326912375 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_74,L-methionine,0.021309731225837944,1.0418914926115534,1080,984.8896090507753 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_74,L-methionine,0.019630194571276304,0.95977431650211,936.74,907.2650636462795 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_74,L-methionine,0.020669336001790488,1.0105808050776295,1007.14,955.2919292318323 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_74,L-methionine,0.021029147168427374,1.0281729647108333,1027.25,971.9216218115035 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_74,L-methionine,0.01884758493411124,0.9215103743455129,1038.98,871.0945417650698 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_74,L-methionine,0.019000908232918418,0.9290067730073902,854.19,878.1808124561559 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_74,L-methionine,0.021316859955202928,1.04224003583811,1179.89,985.219083477407 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_74,L-methionine,0.019927465950247504,0.9743087335468196,1053.48,921.0043027344731 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_74,L-methionine,0.020718984080961782,1.013008236506251,1120.85,957.5865558869939 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_74,L-methionine,0.019083959499748022,0.9330673783450801,1045.53,882.0192620758207 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_74,L-methionine,0.019208780662730362,0.9391702290300994,1086.56,887.7882257998626 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_74,L-methionine,0.020238544758930326,0.9895182338855844,1088.1,935.381691309704 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_74,L-methionine,0.02197884619336911,1.0746063675605388,1162.03,1015.8146531913018 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_74,L-methionine,0.01979445543040817,0.9678054826339028,1039.92,914.8568446790019 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_74,L-methionine,0.019443359824788196,0.9506394508002766,1103.59,898.6299664469934 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_74,L-methionine,0.02034864508410437,1.087079746602787,1126.66,519.5806356862681 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_74,L-methionine,0.019602155504987773,1.047200250982629,1110.67,500.5198319596573 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_74,L-methionine,0.02058349015112494,1.099625806298283,1115.72,525.5771503783274 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_74,L-methionine,0.019433920163090968,1.0382126632546542,1114.52,496.2241245291945 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_74,L-methionine,0.019458219601202097,1.0395108050677948,1201.8,496.8445843902032 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_74,L-methionine,0.020504848486377413,1.0954245555205129,1367.34,523.5691205565843 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_75,nicotinic_acid,0.014156546317719492,0.6313827863850496,1138.72,5547.891091858928 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_75,nicotinic_acid,0.02136026632526973,0.9526691163009677,6837.28,8370.99873133381 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_75,nicotinic_acid,0.020702989364429717,0.9233545257470255,7465.43,8113.41464874128 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_75,nicotinic_acid,0.023972731734034518,1.069185224969073,3073.71,9394.812961428497 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_75,nicotinic_acid,0.020606898015491332,0.9190688460142311,9622.44,8075.756852353987 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_75,nicotinic_acid,0.018875422283771866,0.8418449280108152,9532.8,7397.198779488952 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_75,nicotinic_acid,0.019489697172324554,0.8692416236480348,10345.07,7637.93053041668 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_75,nicotinic_acid,0.020035117016172065,0.8935673803000722,10935.62,7851.678278284901 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_75,nicotinic_acid,0.020308780648485226,0.9057727941647422,11308.97,7958.925907318231 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_75,nicotinic_acid,0.019966559360152115,0.8905097048674899,12499.69,7824.810820603098 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_75,nicotinic_acid,0.015133106055205528,0.6749374072853196,1789.16,5930.600754701301 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_75,nicotinic_acid,0.021283211824616833,0.9492324811052181,7448.37,8340.801395898628 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_75,nicotinic_acid,0.022643994658892056,1.0099234743946068,7851.77,8874.086477923227 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_75,nicotinic_acid,0.02206917509258529,0.9842864884166683,3833.11,8648.817102203539 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_75,nicotinic_acid,0.019787306735657567,0.8825150274242678,8881.33,7754.562469324024 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_75,nicotinic_acid,0.01911104356182739,0.8523536506703876,8850.36,7489.537769539122 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_75,nicotinic_acid,0.01890830783786125,0.8433116256294838,9105.03,7410.0864901274545 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_75,nicotinic_acid,0.020059632521368647,0.8946607732529339,9607.1,7861.285801888472 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_75,nicotinic_acid,0.02062355930171981,0.9198119403458286,10376.21,8082.286340505357 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_75,nicotinic_acid,0.01992967614823256,0.8888647114778627,10826.58,7810.356444637717 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_75,nicotinic_acid,0.020236313809851598,0.994896179446743,9624.93,337.7274570749914 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_75,nicotinic_acid,0.019734668377795042,0.9702333318313334,9546.11,329.3554068234644 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_75,nicotinic_acid,0.02028344577650977,0.9972133709075316,8715.04,338.5140508882707 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_75,nicotinic_acid,0.019716168091007406,0.9693237855168891,8893.67,329.04665223156314 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_75,nicotinic_acid,0.02026265154165985,0.9961910451519074,8930.65,338.16701218726644 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_75,nicotinic_acid,0.019764980281715944,0.9717235833507569,9314.99,329.86128760424793 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_76,6-hydroxy-nicotinic_acid,0.022409783993821028,1.1056340534974478,107.18,201.54603161204975 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_76,6-hydroxy-nicotinic_acid,0.02520428585873334,1.24350670881894,254.71,226.67883795060456 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_76,6-hydroxy-nicotinic_acid,0.010081851369638678,0.49740944400204334,113.49,90.67276754713248 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_76,6-hydroxy-nicotinic_acid,0.0203872930204244,1.0058501870534395,122.6,183.3564305979715 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_76,6-hydroxy-nicotinic_acid,0.017048868477677864,0.8411419569111971,229.96,153.3317673253421 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_76,6-hydroxy-nicotinic_acid,0.022780434413221876,1.1239208752600174,338.9,204.87953635114857 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_76,6-hydroxy-nicotinic_acid,0.018016397412171085,0.8888770416409186,245.96,162.03339592072305 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_76,6-hydroxy-nicotinic_acid,0.027717754026431844,1.3675139727602406,379.79,249.28412209446424 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_76,6-hydroxy-nicotinic_acid,0.01868772773015566,0.9219985416479546,153.55,168.07111415700564 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_76,6-hydroxy-nicotinic_acid,0.016784560579789082,0.8281017681885061,143.97,150.95467132308278 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_76,6-hydroxy-nicotinic_acid,0.020311764788284857,1.002123842101745,169.38,182.6771551767271 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_76,6-hydroxy-nicotinic_acid,0.020787477557135628,1.0255941369100303,221.12,186.95555521732942 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_76,6-hydroxy-nicotinic_acid,0.025288142898261364,1.2476439730849957,256.81,227.43301985366386 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_76,6-hydroxy-nicotinic_acid,0.01769066396297618,0.8728062935296308,178.45,159.1038592475164 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_76,6-hydroxy-nicotinic_acid,0.010949953679602917,0.5402391060853952,108.24,98.48018664830668 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_76,6-hydroxy-nicotinic_acid,0.02474533744761265,1.2208635190285568,248.63,222.5512108837156 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_76,6-hydroxy-nicotinic_acid,0.02682692952897928,1.323563263536766,234.91,241.27234731011706 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_76,6-hydroxy-nicotinic_acid,0.014051673747477058,0.6932690207157027,120.52,126.37600978626544 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_76,6-hydroxy-nicotinic_acid,0.022378544218630794,1.104092773167238,184.69,201.26507162065582 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_76,6-hydroxy-nicotinic_acid,0.018021878269016335,0.8891474512964568,160.52,162.0826888968311 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_76,6-hydroxy-nicotinic_acid,0.016245667660570326,0.9773837444061878,183.54,40.639616092409284 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_76,6-hydroxy-nicotinic_acid,0.02421786416464379,1.4570128635715924,282.88,60.58259486730681 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_76,6-hydroxy-nicotinic_acid,0.013895455545236001,0.8359885635230152,161.69,34.76040447128697 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_76,6-hydroxy-nicotinic_acid,0.026094315276850105,1.5699052883436857,319.53,65.27666188933046 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_76,6-hydroxy-nicotinic_acid,0.017695783551269342,1.064626677641507,196.12,44.26717725633386 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_76,6-hydroxy-nicotinic_acid,0.02199137426403391,1.323061149095596,258.32,55.012882579394876 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_77,nonanoic_acid,0.016221778115477398,0.7514145661369729,7667.97,11708.759679770492 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_77,nonanoic_acid,0.023351145795990527,1.0816564597412532,16652.67,16854.684636061535 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_77,nonanoic_acid,0.01717249589830998,0.7954530917055262,13442.56,12394.980756352104 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_77,nonanoic_acid,0.023800599481314806,1.102475758559943,13647.89,17179.096987851015 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_77,nonanoic_acid,0.020532998673555732,0.951116097134883,16538.67,14820.566849223917 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_77,nonanoic_acid,0.017999370998230967,0.8337550577436252,15725.28,12991.813098727915 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_77,nonanoic_acid,0.021699034938694975,1.0051284642152594,18224.41,15662.203216656795 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_77,nonanoic_acid,0.02090824524295928,0.9684980226017175,17923.11,15091.417052606517 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_77,nonanoic_acid,0.017855379846370156,0.8270851940497173,14883.2,12887.88134838897 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_77,nonanoic_acid,0.021150489067564053,0.9797190821593675,19803.96,15266.266856741093 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_77,nonanoic_acid,0.0030351650254095345,0.14059292356774422,1012.35,2190.759706980425 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_77,nonanoic_acid,0.02142235433430211,0.9923122467310602,15648.34,15462.497199114934 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_77,nonanoic_acid,0.02006502961414055,0.9294391413016329,14324.05,14482.790237113022 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_77,nonanoic_acid,0.035658060428610874,1.6517292873514358,15271.21,25737.724757003405 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_77,nonanoic_acid,0.021946103135386627,1.0165729951724527,19007.64,15840.535216945758 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_77,nonanoic_acid,0.01819531278381256,0.8428313446187626,16244.85,13133.2424329395 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_77,nonanoic_acid,0.02073687229403241,0.9605597972636064,17802.78,14967.721323302721 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_77,nonanoic_acid,0.01756254499068861,0.8135206899327617,14820.24,12676.515311532374 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_77,nonanoic_acid,0.018761888974309995,0.8690759153024147,15024.91,13542.192944257664 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_77,nonanoic_acid,0.022039204833227858,1.0208855909552317,18938.27,15907.735335085797 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_77,nonanoic_acid,0.02080498339843027,0.9836538460126056,16200.24,2835.923220746643 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_77,nonanoic_acid,0.01913509993895769,0.9047022190948465,15306.75,2608.3017327613975 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_77,nonanoic_acid,0.019816333384441043,0.9369107474963966,14885.68,2701.160530569486 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_77,nonanoic_acid,0.02015678322467017,0.9530071215382535,15937.42,2747.567181750862 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_77,nonanoic_acid,0.022978768922317226,1.0864298228076297,15550.83,3132.231500645537 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_77,nonanoic_acid,0.017210373835900877,0.8137017026543703,12267.2,2345.9426938376823 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_78,ornithine_peak_2,0.01991603784422931,1.0289538551603945,48.04,103.43044152072285 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_78,ornithine_peak_2,0.019967665491810525,1.0316211762122545,79.87,103.69856063285582 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_78,ornithine_peak_2,0.020034284049722136,1.035062996443995,142.86,104.04453240255037 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_78,ornithine_peak_2,0.020089832900099927,1.0379329048159815,173.31,104.33301559210246 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_78,ornithine_peak_2,0.0199868267943464,1.032611136979973,75.3,103.79807148922688 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_78,ornithine_peak_2,0.020005568737217677,1.0335794317041258,96.96,103.89540447489873 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_78,ornithine_peak_2,0.02000455821993451,1.0335272237467825,72.88,103.89015653102658 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_78,ornithine_peak_2,0.020004202923315367,1.033508867493955,73.04,103.88831136049235 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_78,ornithine_peak_2,0.019975318424543392,1.0320165618155737,36.52,103.73830479370146 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_78,ornithine_peak_2,0.020020705743041108,1.0343614788472084,88.18,103.97401585372138 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_78,ornithine_peak_2,0.020079886281195204,1.0374190168655832,128.64,104.28135957532842 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_78,ornithine_peak_2,0.019969287742821296,1.0317049891395358,94.35,103.70698550830613 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_78,ornithine_peak_2,0.019957353988571985,1.0310884366637167,81.75,103.6450096534368 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_78,ornithine_peak_2,0.019939324407151116,1.0301569457991668,36.86,103.55137619173225 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_78,ornithine_peak_2,0.020006480224588202,1.0336265233220052,159.16,103.90013812432797 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_78,ornithine_peak_2,0.020062481632780512,1.0365198129062376,220.28,104.19097159333501 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_78,ornithine_peak_2,0.019960468383025048,1.0312493405645846,119.08,103.66118371355203 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_78,ornithine_peak_2,0.01998214510280658,1.0323692593235712,136.47,103.77375794720537 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_78,ornithine_peak_2,0.020052976812411485,1.0360287502943963,185.47,104.14160997959272 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_78,ornithine_peak_2,0.019964388082697345,1.0314518502264174,108.04,103.68153998475947 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_78,ornithine_peak_2,0.02003741584188588,0.9913243890268982,131.28,53.452211056330356 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_78,ornithine_peak_2,0.019957196170310373,0.9873556279081969,65.6,53.238215456809975 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_78,ornithine_peak_2,0.020074980519690176,0.9931828512940482,197.36,53.55241934177508 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_78,ornithine_peak_2,0.019926096412259852,0.9858170089120352,69.56,53.15525312053694 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_78,ornithine_peak_2,0.019979887677359552,0.9884782599151948,71.98,53.2987477746273 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_78,ornithine_peak_2,0.020020001358768538,0.9904628307315201,112.47,53.405755833043564 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_79,ornithine,0.019939370350402854,1.0169059383409769,158.44,263.9074291182503 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_79,ornithine,0.019763854711274544,1.0079546579061016,317.9,261.58439281979145 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_79,ornithine,0.020302576870546863,1.0354294353565756,507.24,268.7146470637385 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_79,ornithine,0.020027229693567083,1.021386756252092,220.08,265.0702909825429 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_79,ornithine,0.020148277452744404,1.0275601801349479,531.37,266.67241794862167 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_79,ornithine,0.019971901504355863,1.018565024011916,519.74,264.3379950315724 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_79,ornithine,0.01972278061924233,1.005859883228391,442.35,261.04075689543197 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_79,ornithine,0.019964364869090995,1.0181806563502862,526.2,264.23824393602627 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_79,ornithine,0.02020231108419588,1.0303158900559497,616.81,267.38757978732 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_79,ornithine,0.019918948923074997,1.0158644475439178,598.26,263.6371414265975 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_79,ornithine,0.019919157216175504,1.0158750704716784,129.34,263.63989828880995 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_79,ornithine,0.020115768638974334,1.0259022338111545,362.05,266.2421477186708 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_79,ornithine,0.019676719028148916,1.003510746586201,230.84,260.43110895405084 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_79,ornithine,0.020133947751705576,1.0268293667830237,225.76,266.4827572675303 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_79,ornithine,0.01996695887439381,1.0183129503671065,374.71,264.27257687927147 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_79,ornithine,0.02033783442546032,1.0372275672099294,499.89,269.18129824232085 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_79,ornithine,0.01992269886807389,1.0160556943722185,313.38,263.68677380347816 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_79,ornithine,0.01970712073746819,1.0050612307890214,240.38,260.83349061436684 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_79,ornithine,0.020134692632328265,1.0268673556219516,265.29,266.49261613100884 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_79,ornithine,0.019992254671788813,1.0196030335610087,230.32,264.6073792697529 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_79,ornithine,0.02019945137300407,1.0158476682286464,264.96,154.08377431692108 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_79,ornithine,0.01978078856105058,0.9947927577044232,153.02,150.89016548860693 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_79,ornithine,0.020089785720874397,1.0103324888832514,249.6,153.2472319138116 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_79,ornithine,0.01990957203440116,1.0012693886135384,212.69,151.8725408649015 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_79,ornithine,0.020257856196491376,1.018784896703682,302.9,154.52929313201452 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_79,ornithine,0.01976521283983308,0.9940094413762913,164.59,150.7713520679559 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_80,palatinose,0.019566690205021168,1.0022438055790275,252.88,138.45998174074265 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_80,palatinose,0.018358056350182946,0.9403352363968029,76.13,129.90731290821833 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_80,palatinose,0.019195475521267494,0.9832294698158629,141.5,135.83315125506147 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_80,palatinose,0.021299254084399186,1.0909890863435272,413.36,150.72014227835828 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_80,palatinose,0.021579056620744573,1.1053211146988133,266.61,152.70011199564107 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_80,palatinose,0.01943604901089356,0.9955521103461649,113.07,137.53552404432267 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_80,palatinose,0.020329062754779595,1.0412940055634272,175.13,143.8547668685875 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_80,palatinose,0.020220570554737808,1.035736824747143,169.32,143.0870423388178 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_80,palatinose,0.020700199264554953,1.0603043371038694,209.6,146.48104417089957 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_80,palatinose,0.01901127379735029,0.9737943004111966,77.73,134.52968260180683 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_80,palatinose,0.020982571840197684,1.0747680078544135,573.22,148.47920028508724 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_80,palatinose,0.01960417241815373,1.004163717201171,259.89,138.7252175313418 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_80,palatinose,0.019720149919665638,1.0101043096702549,242.06,139.5459103809457 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_80,palatinose,0.01923059149604502,0.9850281781221155,490.16,136.08164280757026 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_80,palatinose,0.019565998423468647,1.002208371186774,100.8,138.45508647945283 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_80,palatinose,0.0201025104001734,1.0296895547511413,148.83,142.25161198887017 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_80,palatinose,0.021338673689775392,1.0930082349523467,206.91,150.9990876586667 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_80,palatinose,0.019985879454923337,1.0237154916269804,95.04,141.42629516826736 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_80,palatinose,0.019927059609164903,1.0207026250951958,114.88,141.0100676569013 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_80,palatinose,0.019585779969529146,1.0032216203258044,98.49,138.59506684800988 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_80,palatinose,0.01951146557823872,0.9550228746411819,157.59,38.24866612937933 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_80,palatinose,0.020545092876355784,1.0056155740771648,237.91,40.274903741790446 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_80,palatinose,0.019439857986935056,0.9515179155996003,44.31,38.10829251976399 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_80,palatinose,0.02058130934962486,1.0073882528271083,136.46,40.345899525725684 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_80,palatinose,0.018326629378562238,0.8970289905397237,38.21,35.92601107111593 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_80,palatinose,0.02150950948479375,1.0528206350219134,353.88,42.165466432627625 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_81,L-phenylalanine,0.019418165316010764,0.9735561934293988,4781.63,6991.6619520467675 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_81,L-phenylalanine,0.019574264715353656,0.98138244964607535,7181.57,7047.866758904765 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_81,L-phenylalanine,0.02020308164327035,1.0129090436751096,8128.67,7274.277200785857 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_81,L-phenylalanine,0.02067582859224856,1.036610856519555,6170.01,7444.493428855141 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_81,L-phenylalanine,0.020302748405806738,1.017905972703536,8306.9,7310.1629963885325 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_81,L-phenylalanine,0.020051304235608743,1.0052994764041079,8862.18,7219.628560759449 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_81,L-phenylalanine,0.01957013458567594,0.98117537996354,8181.04,7046.379673484759 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_81,L-phenylalanine,0.019948452348141212,1.0001428567945634,8515.49,7182.595936070133 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_81,L-phenylalanine,0.020393241623410736,1.0224429735492897,8651.29,7342.745785552373 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_81,L-phenylalanine,0.01978368230621404,0.9918818860901089,9457.72,7123.269196688143 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_81,L-phenylalanine,0.02003968513733786,1.004716937070469,6470.24,7215.4450137571675 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_81,L-phenylalanine,0.019519828772116797,0.9786532294122915,8140.55,7028.26667275043 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_81,L-phenylalanine,0.02038938175627203,1.0222494538476317,8145.85,7341.356010268536 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_81,L-phenylalanine,0.02002498743022479,1.0039800474850586,7809.03,7210.152989617272 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_81,L-phenylalanine,0.019958243591548065,1.000633754132442,8566.51,7186.121349664921 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_81,L-phenylalanine,0.019945602983233394,1,8849.34,7181.57 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_81,L-phenylalanine,0.020037535965759003,1.0046091854231176,8563.34,7214.671187759099 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_81,L-phenylalanine,0.020197082589082104,1.0126082729140908,8498.79,7272.117194511647 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_81,L-phenylalanine,0.020399798263468334,1.022771699638098,8658.95,7345.106554969975 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_81,L-phenylalanine,0.01952980664685504,0.9791534837664281,8967.03,7031.859284412467 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_81,L-phenylalanine,0.02005213906413396,1.0688951262784108,8473.09,1296.2598085890916 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_81,L-phenylalanine,0.01993851256861344,1.0628381761002017,8639.58,1288.9144845384756 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_81,L-phenylalanine,0.020197354770026255,1.0766359642903007,8352.04,1305.6472002544906 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_81,L-phenylalanine,0.019801526829620487,1.055536042980593,8645.04,1280.0591146829947 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_81,L-phenylalanine,0.02012059329450511,1.072544133149091,8785.48,1300.6849957112343 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_81,L-phenylalanine,0.019893839147567084,1.0604568240719763,9311.63,1286.0265951203264 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_82,phosphate,0.018342272618105587,0.9228039785918127,58662.83,112712.7267474504 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_82,phosphate,0.0198766726668167,1,110595.34,122141.57 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_82,phosphate,0.020453683217916793,1.0290295343074893,126434.99,125687.28289668562 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_82,phosphate,0.021501354525090177,1.0817381201324412,88137.44,132125.192321825 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_82,phosphate,0.02052199799902529,1.0324664667485284,136373.91,126107.07522101807 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_82,phosphate,0.019912554077703287,1.0018052020822625,142134.76,122362.06021649482 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_82,phosphate,0.01899107740710877,0.9554454976165907,131290.99,116699.61312832165 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_82,phosphate,0.019907948984014046,1.001573518753446,142400.95,122333.76205097034 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_82,phosphate,0.019411131078410873,0.9765784949921206,143342.06,119280.83060657475 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_82,phosphate,0.020946413290022243,1.0538188982198933,177596.57,128715.09472424797 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_82,phosphate,0.019236258043598343,0.9677805921567797,78475.56,118206.24094155876 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_82,phosphate,0.020344894718245517,1.0235563597226458,129679.41,125018.78076000873 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_82,phosphate,0.020705315532396185,1.0416892142598329,128062.58,127233.55608176238 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_82,phosphate,0.020376012569023078,1.025121905993854,103696.78,125209.99903948176 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_82,phosphate,0.019681052474043816,0.9901583028481691,139873.76,120939.48965841085 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_82,phosphate,0.019668524470728196,0.9895280161032183,144813.91,120862.50544583237 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_82,phosphate,0.020156188574460505,1.0140625099748433,149981.77,123859.18704646803 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_82,phosphate,0.02008550562798456,1.0105064345863328,147476.46,123424.842415477 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_82,phosphate,0.0193917045420466,0.9756011414536331,146769.65,119161.45511093883 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_82,phosphate,0.020552628756441413,1.0340075072400419,170483.4,126295.30032608508 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_82,phosphate,0.019682723327198358,1.0143572603377096,247758.55,58855.3818407831 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_82,phosphate,0.02035552439651707,1.0490303407891,263159.08,60867.19510358102 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_82,phosphate,0.01964272331147178,1.0122958430383153,240440.25,58735.77358535576 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_82,phosphate,0.020353409890544363,1.0489213688521488,264570.14,60860.87229680479 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_82,phosphate,0.019855538234814712,1.0232633478399917,275046.32,59372.13387791026 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_82,phosphate,0.020124983477618395,1.0371493194993961,301190.1,60177.83044676259 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_83,L-pipecolic acid,0.018005275618125004,0.9052632561844451,1274.47,1829.0210406927386 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_83,L-pipecolic acid,0.020698358078369585,1.040665159984244,2197.33,2102.591109186966 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_83,L-pipecolic acid,0.01968853956639219,0.9898938408611002,2292.2,2000.0112128909927 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_83,L-pipecolic acid,0.02193033199973498,1.1026059348572974,1882.92,2227.7381089637297 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_83,L-pipecolic acid,0.02056256037570813,1.033837568277182,2416.89,2088.796438074267 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_83,L-pipecolic acid,0.01912994476188519,0.9618089971552541,2427.19,1943.2677521223902 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_83,L-pipecolic acid,0.02023333117623951,1.0172846921389274,2408.83,2055.3525105382532 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_83,L-pipecolic acid,0.02002390978694015,1.0067554732137272,2432.13,2034.078960745211 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_83,L-pipecolic acid,0.019778588346244033,0.9944212834503185,2351.78,2009.1585937215273 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_83,L-pipecolic acid,0.020160787196351664,1.013637350057491,2697.31,2047.9833111766563 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_83,L-pipecolic acid,0.01716786816780107,0.8631603630484889,1507.48,1743.9550923140584 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_83,L-pipecolic acid,0.02058503377377465,1.0349674783070373,2452.1,2091.0793421958874 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_83,L-pipecolic acid,0.02013842850441656,1.012513207184342,2302.5,2045.71205919146 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_83,L-pipecolic acid,0.02269216679391823,1.140909211134984,2418.59,2305.1271974534557 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_83,L-pipecolic acid,0.02002752278019742,1.0069371260864748,2461.97,2034.4459776588963 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_83,L-pipecolic acid,0.019520204665540872,0.9814303547303602,2474.87,1982.9113316078617 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_83,L-pipecolic acid,0.020249563488118974,1.0181008149142217,2445.63,2057.001429477141 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_83,L-pipecolic acid,0.01990710240614264,1.0008826705902178,2365.11,2022.213374140594 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_83,L-pipecolic acid,0.020607182160220727,1.036081047510789,2430.92,2093.3292308222235 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_83,L-pipecolic acid,0.019430847826540462,0.9769377013130234,2475.53,1973.834239863872 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_83,L-pipecolic acid,0.02018815037416967,1.085084780526176,2987.43,422.6188203193351 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_83,L-pipecolic acid,0.01978926555362408,1.0636452806247527,3019.47,414.2685638977287 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_83,L-pipecolic acid,0.0202845157158808,1.0902642825470616,3066.45,424.63613276642957 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_83,L-pipecolic acid,0.019713718790629296,1.059584748023978,3144.5,412.68706766037894 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_83,L-pipecolic acid,0.020309778395162726,1.0916221161423179,3038.76,425.16498179510995 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_83,L-pipecolic acid,0.019720123805404208,1.0599290085888384,3138.42,412.8211502651808 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_84,L-proline,0.01855761477606482,1.4903754948389143,571155.8,660710.9691937255 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_84,L-proline,0.020160580173084895,1.6191108078423264,880515.79,717781.7099020161 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_84,L-proline,0.02014562609920231,1.6179098353288026,961441.89,717249.2966168184 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_84,L-proline,0.021385638453184135,1.7174961263458812,794922.85,761397.7377876216 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_84,L-proline,0.020221438206677232,1.6239983606353225,931299.47,719948.4522793759 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_84,L-proline,0.01978906091948881,1.5892738272765587,979888.72,704554.4256265501 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_84,L-proline,0.01962685450321319,1.576246912404146,873508.81,698779.3537867609 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_84,L-proline,0.020034514867822192,1.6089864117935817,907019.58,713293.3782372565 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_84,L-proline,0.020320731952243112,1.631972713318461,869281.11,723483.6300303616 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_84,L-proline,0.01984706355884478,1.5939320612885943,952919.2,706619.5067550853 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_84,L-proline,0.01875249494485328,1.5060264624604107,681074.57,667649.3320571971 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_84,L-proline,0.02058597939382869,1.6532749276266128,993910.69,732927.2948720414 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_84,L-proline,0.020592794292039293,1.6538222370419373,952619.04,733169.9272391866 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_84,L-proline,0.020873977648554122,1.6764042762297946,919135.63,743180.9620756072 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_84,L-proline,0.01972852208442555,1.5844119095488158,954779.68,702399.0477468404 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_84,L-proline,0.019536610518388068,1.5689993525661519,972171,695566.3767206236 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_84,L-proline,0.019976271831455096,1.604308871323322,910508.73,711219.7381993933 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_84,L-proline,0.020257664786024473,1.626907743482875,905338.95,721238.2354029032 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_84,L-proline,0.019866335564377256,1.595479810022933,840084.53,707305.6523404593 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_84,L-proline,0.020123398396454818,1.6161247124085796,915110.15,716457.9186729144 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_84,L-proline,0.020593095486244727,1.1532475912741538,20144.96,1478.3019573506867 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_84,L-proline,0.01934052683363075,1.0831016638443773,19050.35,1388.3846988155535 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_84,L-proline,0.020015561901087327,1.1209047501307432,14873.97,1436.8429630025944 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_84,L-proline,0.019997386938567275,1.119886922006664,15532.52,1435.5382498434624 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_84,L-proline,0.02009136170437302,1.125149665161447,14497.21,1442.2843497838523 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_84,L-proline,0.019913652485968093,1.1151976534199588,15429.39,1429.5272640129083 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_85,4-hydroxyproline,0.0191901022342792,1.0050529689224936,698.78,702.3109136236601 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_85,4-hydroxyproline,0.019093622751896053,1,856.77,698.78 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_85,4-hydroxyproline,0.01977439920805931,1.0356546510324058,991.9,723.6947570484245 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_85,4-hydroxyproline,0.02128136894832609,1.1145799424686331,991.31,778.8461721982314 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_85,4-hydroxyproline,0.020368479436014452,1.0667687164810984,995.43,745.4366437026619 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_85,4-hydroxyproline,0.020013016823073708,1.0481518925519966,1044.02,732.4275794774842 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_85,4-hydroxyproline,0.020021785445293143,1.0486111360561432,991.38,732.7484896533117 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_85,4-hydroxyproline,0.020392798978243892,1.068042416215583,1047.9,746.3266796031251 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_85,4-hydroxyproline,0.019446094790327873,1.0184601970517522,992.58,711.6796164958233 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_85,4-hydroxyproline,0.020310942175534707,1.0637552883209536,1216.69,743.3309203729159 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_85,4-hydroxyproline,0.019451623200261968,1.0187497392725204,762.01,711.8819428088518 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_85,4-hydroxyproline,0.018895849859368485,0.9896419398718911,945.34,691.54199474368 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_85,4-hydroxyproline,0.020698417968325025,1.0840487547743975,1068.34,757.5115888612535 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_85,4-hydroxyproline,0.020761582484357725,1.0873569020471003,1036.93,759.8232560124727 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_85,4-hydroxyproline,0.019665030692032407,1.029926638205922,1041.24,719.6921362455341 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_85,4-hydroxyproline,0.02058834108558534,1.0782836422983615,1167.04,753.483043565249 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_85,4-hydroxyproline,0.019870347302426768,1.0406797893005184,1026.84,727.2062231674162 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_85,4-hydroxyproline,0.019943900591728386,1.0445320330709842,1014.82,729.8980940693423 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_85,4-hydroxyproline,0.020851210100546348,1.092051014702056,1054.12,763.1034080535026 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_85,4-hydroxyproline,0.019229245870737745,1.0071030584716159,973.71,703.7434751987957 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_85,4-hydroxyproline,0.02089930008729912,1.0629454915971601,258.87,40.47696432001985 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_85,4-hydroxyproline,0.019039524590470314,0.9683566789824062,165.4,36.87502233565002 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_85,4-hydroxyproline,0.019012591212722713,0.9669868382542139,129.12,36.82285880072047 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_85,4-hydroxyproline,0.021011985177493288,1.0686766935078358,237.71,40.695208488778384 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_85,4-hydroxyproline,0.01967217058447846,1.0005332688346489,105.23,38.100306877223424 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_85,4-hydroxyproline,0.0202737846652893,1.0311315650554815,138.88,39.265489997312734 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_86,1_4-diaminobutane,0.019928636451545186,0.9992462701289598,11225.25,16078.402086898133 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_86,1_4-diaminobutane,0.01958478528595306,0.9820051510221488,15129.67,15800.983342676416 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_86,1_4-diaminobutane,0.019213006215922635,0.963363692538866,16213.69,15501.0323957074 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_86,1_4-diaminobutane,0.0204846047025933,1.0271232000193073,13875.64,16526.956663606667 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_86,1_4-diaminobutane,0.020767678279951043,1.041316856320607,17430.53,16755.34011613242 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_86,1_4-diaminobutane,0.01994366859029982,1,18110.07,16090.53 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_86,1_4-diaminobutane,0.02003670109263426,1.0046647637526271,17336.72,16165.58852110456 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_86,1_4-diaminobutane,0.019813309084037854,0.9934636144964136,17523.77,15985.356092962978 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_86,1_4-diaminobutane,0.020245815104203268,1.0151499967288067,18205.17,16334.301476864766 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_86,1_4-diaminobutane,0.01975630861658386,0.990605541158707,20070.43,15939.368178180412 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_86,1_4-diaminobutane,0.01996778069736342,1.0012090106167995,14137.32,16109.983621599931 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_86,1_4-diaminobutane,0.019589514888268978,0.9822422990821711,16798.87,15804.799180650647 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_86,1_4-diaminobutane,0.019281238723176823,0.9667849541259832,15785.33,15556.082307912757 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_86,1_4-diaminobutane,0.02045385224307913,1.0255812339875852,17393.39,16502.14561291426 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_86,1_4-diaminobutane,0.019852004815839902,0.9954038659414697,17016.31,16016.575767047198 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_86,1_4-diaminobutane,0.02053739647747726,1.0297702443504408,18206.91,16569.5490098281 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_86,1_4-diaminobutane,0.020377553537707947,1.0217555233353186,17210.38,16440.587900892646 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_86,1_4-diaminobutane,0.020028931714274344,1.0042751975940873,16640.51,16159.320195143591 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_86,1_4-diaminobutane,0.020331077790367726,1.0194251723705603,16866.84,16403.09131878367 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_86,1_4-diaminobutane,0.019468331566743883,0.9761660187340291,17460.48,15707.028609420458 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_86,1_4-diaminobutane,0.020332860947504992,1.1411068168725653,18815.53,1323.3758087316203 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_86,1_4-diaminobutane,0.019637713168595094,1.1020942120406199,18602.52,1278.131720529868 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_86,1_4-diaminobutane,0.01993481554195574,1.118767986795001,17821.59,1297.4687973257664 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_86,1_4-diaminobutane,0.020071026739579292,1.1264123378061008,18950.28,1306.3341805238692 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_86,1_4-diaminobutane,0.020029814851103427,1.1240994725877032,19212.88,1303.651881344137 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_86,1_4-diaminobutane,0.019969960197059666,1.1207403509211937,20570.35,1299.756207173836 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_87,2-hydroxypyridine,0.013887006298499031,0.6786058471314396,10712.81,19737.237491700977 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_87,2-hydroxypyridine,0.02048753016563993,1.0011486611904035,26256.48,29118.38878774966 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_87,2-hydroxypyridine,0.020456373475704965,0.9996261507577976,28902.48,29074.106602267526 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_87,2-hydroxypyridine,0.0258374998517264,1.2625815886995264,24405.28,36722.160255693954 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_87,2-hydroxypyridine,0.02046402393554568,1,30453.02,29084.98 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_87,2-hydroxypyridine,0.019878338320293006,0.9713797434415942,31918.98,28252.560410403898 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_87,2-hydroxypyridine,0.018186669417511684,0.8887142369845322,28661.71,25848.23580841038 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_87,2-hydroxypyridine,0.02043064238386396,0.9983687689289819,33012.62,29037.535676924057 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_87,2-hydroxypyridine,0.02094024230801625,1.0232710034922987,35818.24,29761.81667115344 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_87,2-hydroxypyridine,0.019605123580386317,0.9580287651214351,38003.65,27864.247472981635 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_87,2-hydroxypyridine,0.011925290573164557,0.5827441665786228,14495.06,16949.102430055915 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_87,2-hydroxypyridine,0.021676561714777328,1.0592521677579496,35792,30808.328114196607 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_87,2-hydroxypyridine,0.020462490059941524,0.9999250452594765,32411.95,29082.799942870966 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_87,2-hydroxypyridine,0.027641799302673953,1.3507509270774745,40810.03,39286.5636990298 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_87,2-hydroxypyridine,0.018245725188805705,0.8916000707521248,30295.95,25932.170225824135 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_87,2-hydroxypyridine,0.02066446095725293,1.0097946045381179,35254.15,29369.855877099068 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_87,2-hydroxypyridine,0.01828205229701631,0.8933752401090912,29657.47,25983.800991068114 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_87,2-hydroxypyridine,0.02191954074657688,1.0711256405688125,35020.28,31153.6678334311 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_87,2-hydroxypyridine,0.020496721609963454,1.0015978125573328,33517.27,29131.452346273774 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_87,2-hydroxypyridine,0.01953716537561307,0.954707902861535,34622.18,27767.660260569686 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_87,2-hydroxypyridine,0.020440552047164808,0.9923470995537435,15607.64,4525.985962883673 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_87,2-hydroxypyridine,0.019551359164559783,0.9491785992137872,15340.38,4329.09918136817 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_87,2-hydroxypyridine,0.018910832450227823,0.9180823340205888,14823.08,4187.272536411164 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_87,2-hydroxypyridine,0.02107906881606033,1.0233457859966464,17512.49,4667.367561894245 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_87,2-hydroxypyridine,0.020797095901177256,1.0096565762536178,18162.45,4604.932582069363 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_87,2-hydroxypyridine,0.019244980308922122,0.9343045308395527,18061.85,4261.260191660807 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_88,4-hydroxypyridine,0.016811835847537062,0.8250959160900433,826.44,1253.221685030845 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_88,4-hydroxypyridine,0.021462835805553197,1.0533589746813674,1521.49,1599.9258794640355 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_88,4-hydroxypyridine,0.01780474314172268,0.8738260940978536,1384.37,1327.236977803348 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_88,4-hydroxypyridine,0.023707839343690248,1.16353987745267,1406.04,1767.2774490653114 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_88,4-hydroxypyridine,0.02004126735157692,0.9835908460572649,1638.86,1493.9564642594587 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_88,4-hydroxypyridine,0.019355454627181183,0.9499323400360794,1724.5,1442.8332326340003 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_88,4-hydroxypyridine,0.02098636676986294,1.0299746959472287,1901.76,1564.4079661803269 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_88,4-hydroxypyridine,0.02093019307723174,1.0272177879687054,1946.06,1560.2205537899074 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_88,4-hydroxypyridine,0.019678007180526518,0.9657626632026383,1936.59,1466.8775938852234 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_88,4-hydroxypyridine,0.0196350318896681,0.96365351002617206,2188.24,1463.6740433085524 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_88,4-hydroxypyridine,0.01529034238675965,0.750423640424857,834.06,1139.803458968507 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_88,4-hydroxypyridine,0.021132291012484147,1.0371364061695498,1674.82,1575.285744602806 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_88,4-hydroxypyridine,0.018887524014786185,0.92696711239515,1444.33,1407.9518076747454 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_88,4-hydroxypyridine,0.02489085739673675,1.2216003637125605,1655.65,1855.464360435734 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_88,4-hydroxypyridine,0.018791035186927752,0.9222316070918448,1665.33,1400.7591433796613 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_88,4-hydroxypyridine,0.021257362505304286,1.043274699386367,1956.66,1584.6090754039653 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_88,4-hydroxypyridine,0.01903461261256111,0.9341859671608108,1815.17,1418.9163818012125 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_88,4-hydroxypyridine,0.021078844750477707,1.0345133557833985,1990.82,1571.3016458322884 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_88,4-hydroxypyridine,0.018911156067299744,0.928126932785653,1947.89,1409.7134356694726 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_88,4-hydroxypyridine,0.020949181769681583,1.0281497202534564,2348.52,1561.63604709857 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_88,4-hydroxypyridine,0.019315269606282673,1.1727419721329495,1158.49,168.92175366603004 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_88,4-hydroxypyridine,0.020763242725106212,1.2606568128562845,1260.22,181.5850073238192 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_88,4-hydroxypyridine,0.019727868177221358,1.1977932228607404,1044.94,172.53013582086103 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_88,4-hydroxypyridine,0.020259845955124887,1.2300926771839957,1136.11,177.18254922158275 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_88,4-hydroxypyridine,0.019870362302041436,1.2064448670968895,1341.11,173.77631865663594 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_88,4-hydroxypyridine,0.020113787422498693,1.2212246170900702,1482.77,175.9051938456537 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_90,pyruvic_acid,0.01581630570201435,0.7836368424355213,1542.67,2370.1096299462342 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_90,pyruvic_acid,0.02116949242367208,1.048866562862167,3018.83,3172.296919376624 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_90,pyruvic_acid,0.019818698356392078,0.9819399355190241,3094.55,2969.8773349772887 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_90,pyruvic_acid,0.02398547504383759,1.1883876223557728,2831.82,3594.278363815035 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_90,pyruvic_acid,0.02070028243132409,1.0256190204985955,3186.2,3101.984727498002 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_90,pyruvic_acid,0.018847545783449538,0.9338230775041402,3123.17,2824.347897911272 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_90,pyruvic_acid,0.019775458935261975,0.9797975892542565,3073.53,2963.397808699499 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_90,pyruvic_acid,0.020183208401557174,1,3204.56,3024.5 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_90,pyruvic_acid,0.020301143067187874,1.0058432070503518,3261.4,3042.172779723789 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_90,pyruvic_acid,0.019809719192807544,0.981495052653729,3594.46,2968.5317867512035 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_90,pyruvic_acid,0.01368013442536923,0.6777978086137079,1735.61,2049.9994721521593 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_90,pyruvic_acid,0.020124777143349242,0.997104956900538,3550.51,3015.7439421456775 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_90,pyruvic_acid,0.021310905413422225,1.05587303016591,3609.9,3193.487979736795 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_90,pyruvic_acid,0.025947801025897034,1.2856132934689963,4008.07,3888.3374060969795 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_90,pyruvic_acid,0.020532721056012716,1.0173170017126008,3661.73,3076.8752716797608 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_90,pyruvic_acid,0.019544449112066768,0.9683519450038912,3572.91,2928.780457664269 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_90,pyruvic_acid,0.018747930183948186,0.9288875094061728,3204.27,2809.4202721989695 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_90,pyruvic_acid,0.019542139630431336,0.9682375191113629,3287.72,2928.434376552317 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_90,pyruvic_acid,0.02065398176542175,1.0233250013822506,3544.54,3095.046466680617 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_90,pyruvic_acid,0.020089250128190895,0.9953447305553744,3736.7,3010.42013756473 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_90,pyruvic_acid,0.01989636509600562,1.0298569292237734,2797.55,85.0455852152992 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_90,pyruvic_acid,0.020123313217538952,1.0416040043506942,2899.46,86.01565867928032 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_90,pyruvic_acid,0.019674470306657272,1.0183714199226337,2684.61,84.09711185721109 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_90,pyruvic_acid,0.02031267756165632,1.0514057033543145,2926.07,86.82508298299929 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_90,pyruvic_acid,0.020657734827491798,1.0692662328774192,2960.55,88.30000551101728 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_90,pyruvic_acid,0.019388976741880656,1.0035939706490968,2976.73,82.87679009620241 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_91,quinic_acid,0.022244940544018998,1.1299217217166369,729272.43,795866.9521347508 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_91,quinic_acid,0.019646418463577644,0.9979309646615262,713399.08,702898.4928968699 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_91,quinic_acid,0.01860361092928393,0.9449620262983693,728272.54,665589.5123518697 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_91,quinic_acid,0.018159787258048635,0.9224182030973844,704355.83,649710.6390497667 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_91,quinic_acid,0.02064961766069251,1.0488880154023767,716446.04,738790.3886657938 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_91,quinic_acid,0.019389578120673538,0.9848848752873505,727243.86,693709.4037874682 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_91,quinic_acid,0.020941453951623522,1.063711708172229,722827.06,749231.543090368 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_91,quinic_acid,0.02111523360071765,1.072538767067495,743792.78,755448.9334850021 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_91,quinic_acid,0.02045558457797036,1.0390321924809554,736344.05,731848.382331643 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_91,quinic_acid,0.018722798823470277,0.9510161216258134,763252.97,669853.7496911307 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_91,quinic_acid,0.0219675215535559,1.1158303492213646,738879.66,785941.6117650041 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_91,quinic_acid,0.019438270801327737,0.9873581980391428,740513.55,695451.5030871647 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_91,quinic_acid,0.02035836153229767,1.0340937917268764,737631.47,728369.9909696311 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_91,quinic_acid,0.018053310930383457,0.9170097860580388,725381.38,645901.1889770323 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_91,quinic_acid,0.0201378291119329,1.0228919469019913,740500.49,720479.906260468 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_91,quinic_acid,0.01926107122356644,0.9783574254097308,731963.71,689111.756411134 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_91,quinic_acid,0.02046942509142648,1.0397352151194217,744288.58,732343.5604256687 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_91,quinic_acid,0.020886847642587046,1.060938005334004,748127.01,747277.8693255768 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_91,quinic_acid,0.020306781678859586,1.0314738163357389,751398.65,726524.5960284269 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_91,quinic_acid,0.019218341700892438,0.9761869985779575,771695.54,687583.0036185861 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_91,quinic_acid,0.02010370934027736,1.0618228199701747,638141.97,299.67825448018243 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_91,quinic_acid,0.01987931635526364,1.0499709975977016,647728.79,296.33331465199933 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_91,quinic_acid,0.0203558765520222,1.0751416008651251,634200.69,303.4372140121643 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_91,quinic_acid,0.019638388514989287,1.0372458494949632,645556.06,292.7418961029635 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_91,quinic_acid,0.02044782870031864,1.0799982612830525,653278.96,304.80790928191595 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_91,quinic_acid,0.01959625133034618,1.0350202789066683,669115.95,292.113773315829 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_92,chlorogenic_acid,0.021895451832996408,1.1226163144882915,83630.75,81385.92203574759 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_92,chlorogenic_acid,0.0204586140134178,1.0489472443162884,95748.44,76045.16123966244 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_92,chlorogenic_acid,0.019503949435276776,1,98838.76,72496.65 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_92,chlorogenic_acid,0.01800189897608404,0.9229873690876177,82086.89,66913.49225116584 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_92,chlorogenic_acid,0.020618261880227865,1.0571326565754746,91912.76,76638.57620732237 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_92,chlorogenic_acid,0.01903122387756428,0.9757625726378537,90866.18,70739.51771162605 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_92,chlorogenic_acid,0.02081456943562414,1.067197672178992,82585.65,77368.25612077511 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_92,chlorogenic_acid,0.020018488807037823,1.0263812913106922,80256.52,74409.20524269929 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_92,chlorogenic_acid,0.020962989095683247,1.074807395560999,72432.5,77919.93557339729 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_92,chlorogenic_acid,0.018736042794000242,0.9606281464261991,72113.66,69642.3225116089 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_92,chlorogenic_acid,0.0225270328578838,1.1549985264594245,109459.52,83733.52392324463 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_92,chlorogenic_acid,0.020729221513472843,1.062821741938067,106858.29,77051.01583767436 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_92,chlorogenic_acid,0.020119278715625875,1.0315489579375219,98002.49,74783.84376146123 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_92,chlorogenic_acid,0.016975154549837657,0.8703444708041905,98211.86,63097.05847932662 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_92,chlorogenic_acid,0.019713098355870942,1.010723413803354,86619.96,73274.06157730693 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_92,chlorogenic_acid,0.020397122176124934,1.0457944553133776,91171.46,75816.59459879457 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_92,chlorogenic_acid,0.018683122871751626,0.9579148537967125,69803.24,69445.61788550143 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_92,chlorogenic_acid,0.020019937382250386,1.0264555621765683,73131.16,74414.5896316679 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_92,chlorogenic_acid,0.019534812507873565,1.0015824011797818,69155.49,72611.36878449022 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_92,chlorogenic_acid,0.020951755874343773,1.0742314495775072,80322.81,77878.18141901318 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_92,chlorogenic_acid,0.01983153079043339,1.2575136505158586,60651.65,67.33985598512423 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_92,chlorogenic_acid,0.020215107439373794,1.2818361739336863,62348.1,68.6423271141489 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_92,chlorogenic_acid,0.018531021063001613,1.1750485724461905,42945.14,62.9238510544935 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_92,chlorogenic_acid,0.021490337986080747,1.3626983038915195,51913.88,72.97249417339087 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_92,chlorogenic_acid,0.019577498068417163,1.2414054832246475,40624.75,66.47726362667987 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_92,chlorogenic_acid,0.020349699096933106,1.290370605713811,45008.05,69.09934593597457 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_93,raffinose,0.01007398929289965,0.5789201080083205,24.71,38.70659842143631 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_93,raffinose,3.3022831103765143e-4,0.018977170208833456,1.34,1.268813600162605 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_93,raffinose,0.025851375684519926,1.4855962983794515,116.04,99.32696850965013 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_93,raffinose,0.037531780185869265,2.1568319766095287,112.24,144.2057859561131 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_93,raffinose,0.003745119185278635,0.21522008215490948,20.46,14.389614692877247 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_93,raffinose,0.039206774475105524,2.253088568377145,239.65,150.6415016816959 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_93,raffinose,0.00869592954104711,0.49972739922246867,51.41,33.411773912014255 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_93,raffinose,0.035945560301561784,2.0656769674022564,213.84,138.11116204051487 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_93,raffinose,0.02251375459732844,1.2937938352132847,84.76,86.50305582236021 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_93,raffinose,0.012455908864479802,0.7158014462303316,49.4,47.85848469495997 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_93,raffinose,0.021154044234039583,1.2156556073982099,134.19,81.2787339106443 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_93,raffinose,0.02883946013785496,1.6573120034658113,152.32,110.80788055172414 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_93,raffinose,0.014666436868134512,0.8428334564324045,71.84,56.35184489707056 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_93,raffinose,0.01783842065388461,1.0251172709626986,132.65,68.53934073656602 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_93,raffinose,0.021628019588554225,1.2428934627751553,74.65,83.09985692114688 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_93,raffinose,0.012008480901528916,0.6900891849695383,41.72,46.13936290706333 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_93,raffinose,0.012901778906721872,0.7414241787454817,33.02,49.571620590922905 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_93,raffinose,0.0387521521144732,2.2269628679750446,96.39,148.8947373528115 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_93,raffinose,0.005414852008837417,0.3111743142326621,13.48,20.80511464959579 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_93,raffinose,0.029625227969133142,1.7024675803209157,80.67,113.82698242025643 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_93,raffinose,0.025199765342496724,1.8589075368040646,102.25,82.03358959916338 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_93,raffinose,0.014336591808112397,1.0575653464217178,57.48,46.67035873759041 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_93,raffinose,0.011288089475227523,0.8326869046765533,34.61,36.746473103376296 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_93,raffinose,0.028290564698415784,2.0869060970834292,93.73,92.09516606429173 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_93,raffinose,0.03441550089850599,2.538723402127575,163.59,112.03386373588988 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_93,raffinose,0.006934083501855448,0.5115055599621201,36.18,22.57274036112836 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_94,rhamnose,0.02003019388746213,1.050119551194549,3348.84,4552.247252037345 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_94,rhamnose,0.02039646897570525,1.0693221926387924,4668.41,4635.490318645312 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_94,rhamnose,0.019300719299687626,1.0118755116697449,4823.49,4386.46010557811 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_94,rhamnose,0.02004348825378924,1.050816532665586,4030.61,4555.268652774662 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_94,rhamnose,0.02035915631222483,1.0673660080083252,4992.25,4627.010297395929 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_94,rhamnose,0.0199333368872515,1.0450416458001883,5276.17,4530.2346337109 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_94,rhamnose,0.019434435238904983,1.0188858143591455,4856.92,4416.849627530608 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_94,rhamnose,0.02043109837024945,1.0711377019873891,5218.42,4643.360515361292 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_94,rhamnose,0.020092903321452447,1.053407207971491,5234.78,4566.499178412253 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_94,rhamnose,0.019923671202956298,1.0445349046217907,5867.93,4528.03792083737 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_94,rhamnose,0.019094299318513856,1.0010535665999336,3792.56,4339.547190139379 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_94,rhamnose,0.020530839678541402,1.0763668225085172,5249.54,4666.0286482379715 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_94,rhamnose,0.01956117012693937,1.0255301226714413,4790.5,4445.652571178244 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_94,rhamnose,0.020946275879389936,1.0981468252002589,5023.6,4760.4445243066175 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_94,rhamnose,0.019685736288770017,1.0320607315457522,5162.75,4473.962630036204 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_94,rhamnose,0.019977849601181947,1.0473753062449007,5416.53,4540.3510050655195 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_94,rhamnose,0.020237932699745192,1.0610106383975006,5295.55,4599.4598972403965 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_94,rhamnose,0.02038087260885319,1.0685045245797127,5251.31,4631.945743962562 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_94,rhamnose,0.020294016789445868,1.0639509493818338,5278.75,4612.206086551261 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_94,rhamnose,0.0195039364499594,1.0225295424713143,5487.91,4432.645116022298 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_94,rhamnose,0.020267501712610502,1.0267699125935603,3283.63,572.3728877752802 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_94,rhamnose,0.01970323498534474,0.9981836513735288,3275.11,556.4374764581737 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_94,rhamnose,0.020163147133163157,1.0214832154990083,3255.89,569.4258184799222 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_94,rhamnose,0.01984592668397679,1.0054125414957433,3388.84,560.4672212568022 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_94,rhamnose,0.01977494111628252,1.0018163486264713,3499.71,558.4625235418265 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_94,rhamnose,0.020208577426019014,1.023784755100985,3845.17,570.7088117310442 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_97,O-acetylserine,0.010776208875782725,0.5518224162915573,31.13,48.08028713148338 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_97,O-acetylserine,0.01922471248548742,0.9844489299101103,51.11,85.7750352630679 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_97,O-acetylserine,0.026032866460866742,1.3330772852514419,73.78,116.15102386395813 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_97,O-acetylserine,0.029113255644020276,1.4908162286739441,98.18,129.89481800436076 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_97,O-acetylserine,0.012783686290285923,0.6546202601614332,28.88,57.03706326786567 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_97,O-acetylserine,0.020518610875638665,1.050706195737018,49.97,91.54803083456638 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_97,O-acetylserine,0.024096049073048596,1.2338977627327972,71.04,107.50951206690861 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_97,O-acetylserine,0.020251150870436444,1.0370102449594008,62.86,90.35470264331258 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_97,O-acetylserine,0.022578286649707548,1.156176985652578,111.04,100.73770075990912 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_97,O-acetylserine,0.016966315304976647,0.8688021191011491,97.68,75.69872863728312 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_97,O-acetylserine,0.012313618958514178,0.6305493003435567,32.1,54.939760538934095 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_97,O-acetylserine,0.01741424158053968,0.8917392913990196,117.8,77.69724445959658 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_97,O-acetylserine,0.016728675326426964,0.8566331765089673,111.25,74.63844866922632 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_97,O-acetylserine,0.031911563822539374,1.6341105168970531,109.42,142.38004933724022 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_97,O-acetylserine,0.0175953432768961,0.9010130514782703,156.42,78.50526717530168 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_97,O-acetylserine,0.023917671235838166,1.224763484595007,223.44,106.71364241276297 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_97,O-acetylserine,0.012959989410535368,0.663648297288147,111.26,57.823676142716245 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_97,O-acetylserine,0.029863019725766913,1.529209752037048,248.02,133.240045694988 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_97,O-acetylserine,0.012449126227847997,0.6374882850691499,62.58,55.544354278075026 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_97,O-acetylserine,0.02484824820260685,1.272415978738989,125.15,110.86560422752811 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_97,O-acetylserine,0.022602501714029253,1.2739407641040628,145.62,135.16511507144105 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_97,O-acetylserine,0.017315998141847703,0.9759785081824702,114.56,103.55131971816009 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_97,O-acetylserine,0.013141240441905795,0.7406773861428592,80.9,78.58587066975736 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_97,O-acetylserine,0.027036587957487767,1.5238583744891423,174.62,161.681373533298 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_97,O-acetylserine,0.013886039729191857,0.7826563752456642,70.94,83.03984141356497 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_97,O-acetylserine,0.025523288243028203,1.4385645331724324,136.4,152.63169696959505 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_98,L-serine,0.018584612765564227,0.9272020322316255,24550.94,40917.43495440196 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_98,L-serine,0.01993882650957829,0.9947649000387189,39947.68,43898.98498635767 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_98,L-serine,0.020224873956652144,1.00903604884269,44473.86,44528.7709257884 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_98,L-serine,0.02138322397718173,1.0668271100081212,34290.95,47079.09103292949 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_98,L-serine,0.020485620952710986,1.022044936770235,45981.19,45102.85328011984 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_98,L-serine,0.019714243920251777,0.9835602849168357,47773.92,43404.525208982806 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_98,L-serine,0.01938333233762316,0.9670508264862167,44618.34,42675.96264334501 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_98,L-serine,0.020092874806773714,1.0024504997347254,47258.47,44238.150577798435 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_98,L-serine,0.020157696854426792,1.005684526457559,47619.72,44380.86820941734 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_98,L-serine,0.020043757584130902,1,53413,44130.01 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_98,L-serine,0.01830622641380005,0.9133131019451914,30476.71,40304.51632197232 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_98,L-serine,0.020338439555151216,1.014701932498606,46477.9,44778.806428182805 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_98,L-serine,0.020454132073241583,1.0204739299698766,44902.83,45033.524734309955 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_98,L-serine,0.021477748158499708,1.07154300127358,43438.69,47287.2033616331 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_98,L-serine,0.019804410239619995,0.9880587587678469,47362.52,43603.04290501267 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_98,L-serine,0.01970104840939906,0.9829019497320615,48640.11,43375.47287069537 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_98,L-serine,0.02007082618643342,1.0013504754379963,47740.11,44189.60649458353 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_98,L-serine,0.02009800592012689,1.0027064953149771,47071.35,44249.447665314896 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_98,L-serine,0.019945599520300904,0.9951028112659019,47017.81,43913.89701219237 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_98,L-serine,0.020045185282940508,1.000071229099814,51091.11,44133.15334088708 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_98,L-serine,0.019919816751391893,1.0759400234338425,26348.95,6413.925945894524 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_98,L-serine,0.02009438277149267,1.0853689539356686,27158.26,6470.133969269925 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_98,L-serine,0.01976189099052277,1.0674098924105007,24825.28,6363.075872934249 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_98,L-serine,0.020232487859788772,1.0928285000646387,26844.93,6514.602039440326 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_98,L-serine,0.02023183440302984,1.092793204545142,27856.66,6514.391634730637 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_98,L-serine,0.01978314867568985,1.0685580954568576,29320.77,6369.9205753802835 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_100,spermidine,0.02162515962985628,1.090621210970273,1684.15,2798.075966441113 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_100,spermidine,0.019982912234997707,1.0077977833910086,2466.37,2585.5858371123036 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_100,spermidine,0.02005751725043671,1.0115603365316663,2722.83,2595.2389681989125 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_100,spermidine,0.01819409898922048,0.9175826034015053,1727.27,2354.131575634834 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_100,spermidine,0.019864291909788476,1.0018154070784302,2806.11,2570.2375720922787 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_100,spermidine,0.020829815712748376,1.05050964828768,3176.17,2695.166543453906 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_100,spermidine,0.018788742503888987,0.9475722470001592,2705.14,2431.0724054586685 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_100,spermidine,0.019885008237271806,1.002860193177282,2923.21,2572.918054411771 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_100,spermidine,0.019720610386240435,0.9945691198885003,2866.44,2551.6466426035386 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_100,spermidine,0.020715514252274626,1.04474508518751,3390.85,2680.3770956553717 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_100,spermidine,0.022816066026512715,1.150682167684807,2737.92,2952.167155768787 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_100,spermidine,0.018944283845873558,0.9554166601584764,2786.15,2451.1978749693835 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_100,spermidine,0.020096571219035332,1.0135299444908799,2823.71,2600.2921549869116 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_100,spermidine,0.017323104166122875,0.8736557402025833,2499.06,2241.4336939489435 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_100,spermidine,0.019984813181677087,1.0078936537940457,2961.36,2585.8318003009276 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_100,spermidine,0.02103652409162374,1.0609345675181259,3218.45,2721.9125077331532 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_100,spermidine,0.019144319853533417,0.9655050718347746,2798.5,2477.080502197861 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_100,spermidine,0.019828295481817578,1,2855.07,2565.58 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_100,spermidine,0.02074936941387889,1.0464525018252795,3064.96,2684.7576096329003 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_100,spermidine,0.019561393570927944,0.986539341662808,3132.81,2531.0456041832667 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_100,spermidine,0.01930340858975593,1.0770626502501617,1727.32,38.731172902995816 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_100,spermidine,0.02075970112937482,1.1583186779080878,1898.91,41.65313965757484 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_100,spermidine,0.02017780838272464,1.125851098881605,1664.12,40.48560551578252 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_100,spermidine,0.0198012060066597,1.1048380041543726,1717.4,39.72997462939124 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_100,spermidine,0.020392558096169612,1.1378333814110364,1667.92,40.91648839554087 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_100,spermidine,0.01964597804283494,1.0961768269673158,1715.99,39.41851869774467 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_101,spermidine_peak_2,0.04062386788093257,5.363863633926299,134.15,353.85408393011795 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_101,spermidine_peak_2,0.008714697265104687,1.1506646259774842,43.97,75.90934537573463 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_101,spermidine_peak_2,0.008069949582807316,1.0655339176887157,39.85,70.29327254992458 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_101,spermidine_peak_2,0.029806447833101234,3.935561282768303,94.66,259.62897782422493 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_101,spermidine_peak_2,0.03568206833305072,4.711362031697566,2806.11,310.8085532310884 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_101,spermidine_peak_2,0.004044560284090845,0.5340326008996334,53.08,35.23013068134882 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_101,spermidine_peak_2,0.02476372061503243,3.269733468930192,2705.14,215.70431694532476 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_101,spermidine_peak_2,0.025983022169091607,3.4307266880834466,2923.21,226.32503961286497 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_101,spermidine_peak_2,0.0037204433735460174,0.49123709667272203,58.15,32.406911267499474 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_101,spermidine_peak_2,0.03092038407664159,4.082642356504343,3390.85,269.33191625859155 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_101,spermidine_peak_2,0.09192957502515842,12.13812790561948,247.37,800.7522979337172 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_101,spermidine_peak_2,0.005173223198183625,0.683058143657099,42.78,45.06134573705882 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_101,spermidine_peak_2,0.005021934666211344,0.6630824225550447,45.88,43.7435474159563 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_101,spermidine_peak_2,0.031586806832547804,4.1706349818177015,68.12,275.13678975051374 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_101,spermidine_peak_2,0.03043570646259572,4.018646859182951,2961.36,265.11013330029925 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_101,spermidine_peak_2,0.03184571083175673,4.2048199528328984,3218.45,277.3919722883863 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_101,spermidine_peak_2,0.004809546838180617,0.6350393186733161,21.21,41.893543852878665 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_101,spermidine_peak_2,0.005132389282137659,0.6776665458419495,27.39,44.70566202919341 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_101,spermidine_peak_2,0.06267579889333966,8.275539872190654,61.17,545.9373653684174 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_101,spermidine_peak_2,21.87959361519664,2888.921282966352,36.27,190582.13703729023 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_101,spermidine_peak_2,0.019073180040379556,1.1243580000773163,1727.32,36.04691748247876 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_101,spermidine_peak_2,0.021264911688940485,1.253559895506658,1898.91,40.18913024994346 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_101,spermidine_peak_2,0.006276154165597042,0.36997732579821974,29.91,11.861473065090925 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_101,spermidine_peak_2,0.03369912233108911,1.9865527252575643,1717.4,63.68888037175752 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_101,spermidine_peak_2,0.02075013547055103,1.2232139983793633,1667.92,39.21624078804239 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_101,spermidine_peak_2,0.019153213076989358,1.1290759225628277,1715.99,36.19817407736426 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_102,succinic_acid,0.019621048335470626,0.9857699459587544,345.92,576.3994028010029 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_102,succinic_acid,0.020643431684009762,1.03713492712628,622.22,606.4335345892785 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_102,succinic_acid,0.02047166009912003,1.028505048484786,667.21,601.3874719500241 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_102,succinic_acid,0.019953182341100346,1.0024565019053495,444.25,586.156365794096 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_102,succinic_acid,0.020549464619392242,1.032413981199937,676.19,603.6731030872272 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_102,succinic_acid,0.018965078082483038,0.9528137170263203,568.97,557.1292366196301 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_102,succinic_acid,0.02049385404510446,1.0296200819202896,690,602.0394543004318 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_102,succinic_acid,0.019259968332694482,0.9676291306089467,587.13,565.7921052496633 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_102,succinic_acid,0.021433897425344992,1.0768482675042057,841.34,629.6547189750592 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_102,succinic_acid,0.0188277542493644,0.9459145083175028,658.09,553.0951313034103 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_102,succinic_acid,0.020339825852063207,1.0218816389515766,525,597.5146319277659 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_102,succinic_acid,0.018955632705462536,0.9523391772037856,478.37,556.8517636945975 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_102,succinic_acid,0.020408749056791617,1.0253443705364942,585.21,599.5393603400989 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_102,succinic_acid,0.019947505399349374,1.002171289898968,591.6,585.9895966297247 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_102,succinic_acid,0.019778409681022572,0.9936758479497461,582.41,581.0221418131755 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_102,succinic_acid,0.020085900706889818,1.0091243299456845,639.59,590.0551782058407 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_102,succinic_acid,0.02014877206631151,1.0122830142075971,674.52,591.9021240674663 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_102,succinic_acid,0.0206645537788103,1.0381961102951947,718,607.0540296118063 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_102,succinic_acid,0.019751193180438616,0.992308479201088,689.82,580.2226139584602 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_102,succinic_acid,0.019912226055388435,1.0003988404153712,769.16,584.9532099676759 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_102,succinic_acid,0.020685960582476893,1.0531156912426458,884.66,129.57535465049514 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_102,succinic_acid,0.01922186229518689,0.9785789118787377,731.71,120.40434931755989 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_102,succinic_acid,0.020970026100162586,1.0675773766366121,651.31,131.35472042136877 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_102,succinic_acid,0.019040813822772108,0.9693617915803923,497.38,119.27027483605147 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_102,succinic_acid,0.020012267388009163,1.018818184421602,567.16,125.35538941123392 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_102,succinic_acid,0.020008642319504517,1.0186336333339765,613.25,125.33268224541247 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_105,myristic_acid,0.020589978041402373,1.1827779892443824,52.97,110.75533091284397 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_105,myristic_acid,0.018735100664909184,1.076225756441997,17.24,100.7777798332286 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_105,myristic_acid,0.019402227602805622,1.1145484324831887,56.2,104.36631521772578 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_105,myristic_acid,0.02129513402563308,1.223285219288773,88.16,114.54842793420072 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_105,myristic_acid,0.01610680709985901,0.9252451302478828,38.18,86.63995399641175 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_105,myristic_acid,0.016328698410693974,0.9379915332762128,90.86,87.83352717598456 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_105,myristic_acid,0.03798073829874261,2.1817789793011464,1624.93,204.30178362175934 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_105,myristic_acid,0.014937285346101684,0.8580627085131367,93.64,80.34899202517012 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_105,myristic_acid,0.01740815117345587,1,43.08,93.64 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_105,myristic_acid,0.01721463457546698,0.9888835640235036,4.7,92.59905693516087 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_105,myristic_acid,0.01717545911363102,0.986633154922295,287.61,92.38832862692371 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_105,myristic_acid,0.014866747065430324,0.8540106825415954,69.62,79.96956031319499 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_105,myristic_acid,0.03407194428948137,1.9572408321818013,1284.85,183.27603152550387 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_105,myristic_acid,0.02192543163959505,1.2594922586051054,658.88,117.93885509578207 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_105,myristic_acid,0.012070324039633937,0.6933719680719967,19.17,64.92735109026178 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_105,myristic_acid,0.012334946554713138,0.7085730375274769,85.1,66.35077923407295 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_105,myristic_acid,0.02749787059261678,1.5795974149481087,2027.6,147.9135019357409 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_105,myristic_acid,0.028598636777535286,1.6428302174410563,2143.43,153.8346215611805 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_105,myristic_acid,0.027265390718815043,1.5662427587594479,2261.71,146.6629719302347 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_105,myristic_acid,0.008211978087719144,0.47173177702183866,23.43,44.17296360032497 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_105,myristic_acid,0.02081543740896463,1.0625379681873628,84.65,51.6924721523152 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_105,myristic_acid,0.019133714191375523,0.9766932782313844,6.89,47.51612798595685 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_105,myristic_acid,0.0190941645089347,0.974674438156228,19.5,47.41791141630049 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_105,myristic_acid,0.020922083426251313,1.067981785691494,112.14,51.95731387389118 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_105,myristic_acid,0.019884962184742068,1.0150412360856234,35.24,49.381756135565574 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_105,myristic_acid,0.02008127773650143,1.0250622951386577,44.69,49.8692806584957 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_106,threonic_acid,0.019663349717746307,1.017087710816647,2287.6,3429.0196791243516 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_106,threonic_acid,0.0198435110108148,1.0264065623742444,3634.04,3460.437348454151 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_106,threonic_acid,0.020180962877309864,1.0438612764148796,4159.37,3519.284345917889 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_106,threonic_acid,0.020343317864464517,1.0522590959418223,3035.62,3547.596838649219 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_106,threonic_acid,0.019975821493906046,1.033250328482054,4185.95,3483.5104899476814 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_106,threonic_acid,0.020073976502777736,1.0383274010414865,4576.25,3500.6273831452777 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_106,threonic_acid,0.01993158624979893,1.0309622583509654,4257.52,3475.7964674270283 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_106,threonic_acid,0.01992797960311731,1.0307757043777215,4343.53,3475.1675174960938 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_106,threonic_acid,0.0201431673699992,1.0419063019796204,4370.98,3512.693325557112 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_106,threonic_acid,0.019916556044220286,1.0301848202438004,4783.07,3473.175404818151 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_106,threonic_acid,0.020211892340166036,1.0454611043701736,3177.6,3524.6780218846466 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_106,threonic_acid,0.01997716876163944,1.033320015970426,4046.76,3483.7454350428543 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_106,threonic_acid,0.01991448523162246,1.0300777073624814,3849.23,3472.8142833789434 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_106,threonic_acid,0.019828506190371277,1.0256304373144156,3660.95,3457.8207126661937 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_106,threonic_acid,0.019930610063060787,1.0309117650449378,4176.77,3475.6262337901535 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_106,threonic_acid,0.02002602628601244,1.035847173770801,4372.19,3492.265520122616 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_106,threonic_acid,0.020171363817733323,1.043364764596149,4264.26,3517.6104010071026 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_106,threonic_acid,0.020015000277314298,1.035276852940057,4114.02,3490.342734770637 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_106,threonic_acid,0.01997197032539847,1.0330511266055902,4031.31,3482.8388987493527 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_106,threonic_acid,0.01995517770019978,1.032182527258729,4340.15,3479.9104942253516 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_106,threonic_acid,0.019810010799052848,0.9905980099657193,2282.08,341.57800579637933 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_106,threonic_acid,0.020209611783152056,1.0105800253035375,2496.9,348.4682043251658 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_106,threonic_acid,0.019965257678860527,0.9983611178080547,2184.71,344.2548806425734 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_106,threonic_acid,0.020025975843112716,1.0013973247686216,2334.81,345.30182552671613 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_106,threonic_acid,0.020293528546974013,1.014776276385277,2625.02,349.9151556231712 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_106,threonic_acid,0.01973165184502777,0.9866796767195836,2566.47,340.2268861264468 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_107,L-threonine,0.01867912897005185,0.9451251368330846,5500.07,8611.55494051149 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_107,L-threonine,0.019796893104671465,1.0016816808974915,8699.26,9126.872719581539 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_107,L-threonine,0.020117486377969063,1.0179030347828337,9695.53,9274.674396575529 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_107,L-threonine,0.021382512312324787,1.0819107201102527,7630.97,9857.883621820572 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_107,L-threonine,0.020949587199703787,1.0600056084232774,10265.11,9658.294101429112 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_107,L-threonine,0.019339290189598703,0.9785279236523451,10233.82,8915.906102754525 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_107,L-threonine,0.019763656940330335,1,9943.25,9111.55 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_107,L-threonine,0.01974186028525361,0.9988971345160192,10149.74,9101.501185999434 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_107,L-threonine,0.020371028046064964,1.030731716684234,10550.29,9391.563573154232 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_107,L-threonine,0.019834390874445572,1.003578990180248,11591.61,9144.16014797684 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_107,L-threonine,0.018500486389964838,0.9360861932495989,6837.35,8529.196154103382 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_107,L-threonine,0.020105610108597998,1.0173021202149013,10014.21,9269.199133444083 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_107,L-threonine,0.020214722650927247,1.0228229882738176,9665.21,9319.502798806301 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_107,L-threonine,0.021470166263154476,1.0863458280001705,9621.56,9898.294329114953 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_107,L-threonine,0.019804653074899897,1.0020743192767074,10299.69,9130.450263805682 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_107,L-threonine,0.019910327032961198,1.0074212021122246,10699.55,9179.168654105639 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_107,L-threonine,0.020072804888695187,1.01564224421109,10417.52,9254.075090241557 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_107,L-threonine,0.020158763510380776,1.0199915719668344,10302.42,9293.704207554409 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_107,L-threonine,0.019894614303111603,1.0066261706108666,10242.43,9171.92468482944 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_107,L-threonine,0.02003968146439816,1.0139662677257142,11156.12,9238.80434669623 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_107,L-threonine,0.01976343329025919,1.149879366863458,6202.89,1035.903324019952 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_107,L-threonine,0.020258855331359717,1.1787040945605254,6498.46,1061.870944707686 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_107,L-threonine,0.020026560630028344,1.1651886855640377,5969.16,1049.6951830509302 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_107,L-threonine,0.01996664305998433,1.1617025515257697,6283.58,1046.5545946185355 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_107,L-threonine,0.020126084603729364,1.1709792059754618,6549.3,1054.9117470791741 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_107,L-threonine,0.019886287498813077,1.1570272908842345,6964.8,1042.3427458117892 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_108,trehalose,0.012681027004867909,0.6731995657457507,151.03,198.28420009475343 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_108,trehalose,0.022848854121177112,1.2129805153998772,347.24,357.27128100587987 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_108,trehalose,0.013868828157862717,0.7362565421311373,229.29,216.85700191930522 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_108,trehalose,0.027783151396542843,1.474928288380844,395.29,434.42537805969386 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_108,trehalose,0.03407036865376565,1.8086987255612728,518.47,532.7341226268173 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_108,trehalose,0.01592436400818427,0.8453790793893652,255.6,248.99795404334364 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_108,trehalose,0.01612468317504414,0.8560134527795368,266.05,252.13020238168477 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_108,trehalose,0.009199440770033391,0.48837207973083585,159.05,143.8451123639204 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_108,trehalose,0.018183317743099312,0.965300492126739,481.7,284.3196069510097 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_108,trehalose,0.024972267594152532,1.3257064821024944,774.25,390.4735872384687 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_108,trehalose,0.01452364919449215,0.7710191238471841,204.54,227.0959727379496 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_108,trehalose,0.022722671713847432,1.2062818511839202,450.11,355.2982564477119 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_108,trehalose,0.029948633032976832,1.5898875339307628,567.89,468.2854742439669 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_108,trehalose,0.020546294881401334,1.0907442107436467,353.96,321.2677998324337 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_108,trehalose,0.006488980494548758,0.34448147215410596,112.34,101.46357280827037 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_108,trehalose,0.029653762184467025,1.5742336813609605,506.95,463.67478850805736 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_108,trehalose,0.017012720006464675,0.9031567960630932,254.22,266.01580271242346 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_108,trehalose,0.014688776723597127,0.7797852735323371,217.91,229.67795446621457 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_108,trehalose,0.02998120264885469,1.5916165619706102,565.35,468.7947421628236 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_108,trehalose,0.013769911091858924,0.7310053171433635,287.96,215.3103061114063 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_108,trehalose,0.03225032566678783,2.032851211878517,754.75,225.44319939732753 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_108,trehalose,0.006609277590837171,0.4166059623395139,155.82,46.201601223452094 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_108,trehalose,0.010900479858997668,0.6870955016197157,216.97,76.19889112962647 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_108,trehalose,0.029183733777934043,1.8395531626742234,617.3,204.0064457405714 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_108,trehalose,0.028535638055638097,1.7987014147540659,519.34,199.47598689622592 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_108,trehalose,0.011679853457356488,0.7362221547983362,222.86,81.64703696713549 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_109,L-tryptophan_peak_2,0.02129054714301529,1.1056913477173314,1711.71,1645.8657987311565 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_109,L-tryptophan_peak_2,0.019844141732664414,1.030574539456198,1924.76,1534.051424962129 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_109,L-tryptophan_peak_2,0.01883353025365842,0.9780900090805974,1976.5,1455.9261021168325 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_109,L-tryptophan_peak_2,0.019023856463264013,0.987974303823759,1823.34,1470.639270213818 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_109,L-tryptophan_peak_2,0.020877098165281383,1.0842195201343126,1926.45,1613.9041245007295 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_109,L-tryptophan_peak_2,0.019869731500120093,1.0319035041030802,1966.53,1536.029641997599 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_109,L-tryptophan_peak_2,0.01978390437392198,1.0274462062140577,1628.92,1529.3947757978733 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_109,L-tryptophan_peak_2,0.02041289537891663,1.0601118726876773,1698.2,1578.0189269705152 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_109,L-tryptophan_peak_2,0.02054233906886283,1.0668343287630755,1471.02,1588.0255717369882 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_109,L-tryptophan_peak_2,0.01925541624881937,1,1535.88,1488.54 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_109,L-tryptophan_peak_2,0.02384000148044367,1.2380932809959588,2490.92,1842.9513724937244 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_109,L-tryptophan_peak_2,0.018320096901659876,0.9514256490187876,1781.97,1416.235135590426 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_109,L-tryptophan_peak_2,0.020018330862687228,1.0396207801487873,1826.43,1547.5171160826758 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_109,L-tryptophan_peak_2,0.01638448160172519,0.8509024884221753,2017.47,1266.602390115945 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_109,L-tryptophan_peak_2,0.019897675050238237,1.0333547087800945,1597,1538.1898182075217 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_109,L-tryptophan_peak_2,0.020396032743186465,1.059236138010625,1682.13,1576.7153608743356 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_109,L-tryptophan_peak_2,0.021052784206437046,1.0933435005710603,1524.19,1627.4855343400461 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_109,L-tryptophan_peak_2,0.020443280117828654,1.0616898566958852,1451.49,1580.367819286093 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_109,L-tryptophan_peak_2,0.02039233830389336,1.0590442730701135,1467.62,1576.4297622357867 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_109,L-tryptophan_peak_2,0.01894646136942629,0.9839549103794616,1482.27,1464.6562422962438 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_109,L-tryptophan_peak_2,0.018702836042888037,0.904171017801198,1319.11,95.27250014571224 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_109,L-tryptophan_peak_2,0.021469158088627874,1.0379062552767786,1546.74,109.36418211851417 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_109,L-tryptophan_peak_2,0.01777267889542262,0.859203445353346,1140.34,90.53426703688207 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_109,L-tryptophan_peak_2,0.022239862040774442,1.0751652129684253,1498.45,113.29015849048298 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_109,L-tryptophan_peak_2,0.018337329154001637,0.886500931030404,1153.53,93.41060310267366 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_109,L-tryptophan_peak_2,0.021479738162255728,1.0384177389853761,1443.02,109.41807715688908 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_110,L-tryptophan,0.020893244391148966,1.1989113033829488,2866.99,5129.170349019897 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_110,L-tryptophan,0.021121821554531007,1.2120276839576207,4852.53,5185.284717230653 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_110,L-tryptophan,0.018471861783791184,1.059965770394978,4687.36,4534.7349592460905 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_110,L-tryptophan,0.019163399239233648,1.0996480742306562,3217.56,4704.503394692851 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_110,L-tryptophan,0.020085730029199292,1.1525739285808014,5646.89,4930.930255515098 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_110,L-tryptophan,0.0203816774108171,1.1695561958814455,6229.16,5003.583621658041 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_110,L-tryptophan,0.019280650134436257,1.1063762501404604,5963.81,4733.287809588416 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_110,L-tryptophan,0.02042020962293516,1.1717672792243592,6479.8,5013.043056304861 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_110,L-tryptophan,0.019549337945866135,1.1217942890133974,6515.19,4799.249109314226 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_110,L-tryptophan,0.02047965922654671,1.1751786594971958,7721.57,5027.637589274307 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_110,L-tryptophan,0.02251551174558867,1.2920014253350405,4093.62,5527.427577854116 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_110,L-tryptophan,0.019704247678600052,1.1306834316521253,5517,4837.278550459805 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_110,L-tryptophan,0.021493300160810355,1.233344138774084,5820.09,5276.480561061898 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_110,L-tryptophan,0.016848415107846165,0.9668079757609144,3758.47,4136.188213820586 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_110,L-tryptophan,0.019941574991413403,1.1443019196478894,6358.97,4895.541029618404 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_110,L-tryptophan,0.01976367419180747,1.1340934869346448,6532.22,4851.867414868928 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_110,L-tryptophan,0.019410673430522878,1.1138373412215274,6565.3,4765.207774840526 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_110,L-tryptophan,0.02004932231230096,1.1504847545634684,6709.92,4921.992372125885 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_110,L-tryptophan,0.02013847279653681,1.1556004523101382,7238.19,4943.87829906871 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_110,L-tryptophan,0.02009234853787561,1.152953716646026,7848.86,4932.555061017862 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_110,L-tryptophan,0.019548664307991383,1.0021410193365095,13081.63,1645.7560675951893 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_110,L-tryptophan,0.02049411603204492,1.0506085739248374,14055.44,1725.351424442325 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_110,L-tryptophan,0.019984155033044206,1.0244659778216592,12727.02,1682.4190074178416 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_110,L-tryptophan,0.020002888400371878,1.0254263235278198,13411.05,1683.9961255503267 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_110,L-tryptophan,0.020267437247511236,1.0389881325168953,12786.34,1706.2678707445461 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_110,L-tryptophan,0.019754885608447167,1.0127127300678243,13291.68,1663.1173538265837 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_111,tyramine,0.0215969866488751,1.1132391435804962,38210.11,49063.45480328013 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_111,tyramine,0.019799178699886774,1.0205692626386464,46331.13,44979.24294149427 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_111,tyramine,0.019287284423540153,0.9941831396545148,49213.87,43816.33525905153 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_111,tyramine,0.01857985064266446,0.9577177294949455,39405.13,42209.20617671188 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_111,tyramine,0.02091697881673578,1.07818743247902,52437.73,47518.6312554181 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_111,tyramine,0.019754685275795908,1.0182758028085708,53537.41,44878.1639744413 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_111,tyramine,0.01980209309334137,1.0207194880810286,51563.41,44985.863782348744 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_111,tyramine,0.019876312636207587,1.0245452116266618,53008.78,45154.473748458375 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_111,tyramine,0.01919338655590134,0.9893430763876463,54165.7,43603.02060270982 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_111,tyramine,0.0208152502924806,1.0729437298708395,66641.1,47287.52712347855 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_111,tyramine,0.02134056806537204,1.1000217809484765,45242.87,48480.929945207914 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_111,tyramine,0.019967282802641678,1.029234363489324,52536.5,45361.13733175593 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_111,tyramine,0.019482605157035683,1.0042511500494467,49023.44,44260.059660784245 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_111,tyramine,0.0187792116692706,0.9679940010012721,47902.06,42662.10920792876 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_111,tyramine,0.019909479201498877,1.026254816736887,53538.53,45229.8206615998 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_111,tyramine,0.020390771789513276,1.0510635438618212,56741.84,46323.208249558884 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_111,tyramine,0.019416509019875093,1.0008441559014705,52742.51,44109.90422979873 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_111,tyramine,0.020654021707620863,1.0646330347424848,55319.18,46921.25235029511 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_111,tyramine,0.021288388365843517,1.097332124055141,58991.12,48362.389503845014 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_111,tyramine,0.01869297354253366,0.9635487670474131,56174.46,42466.19574545052 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_111,tyramine,0.019739261166639807,1.094699089243118,68397.99,260.5055422671848 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_111,tyramine,0.02028684481920594,1.1250669596860932,72079.55,267.7321843964996 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_111,tyramine,0.019922159899044122,1.1048422792083588,67627.35,262.91931718321314 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_111,tyramine,0.02007164206113274,1.1131322544670605,71949.69,264.8920825955264 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_111,tyramine,0.020076575677710037,1.1134058627611223,72709.53,264.9571931612643 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_111,tyramine,0.01992897430293887,1.1052201921238594,77442.93,263.0092491197148 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_112,L-tyrosine,0.023206606506711757,1.6771940912802803,398642.74,318352.80597772007 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_112,L-tyrosine,0.02290904586107294,1.65568870846963,398837.83,314270.81034168164 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_112,L-tyrosine,0.007169792140336222,0.5181771410654904,134169.62,98356.62295100724 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_112,L-tyrosine,0.0190120311341744,1.3740426146430238,383217.72,260810.79356215647 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_112,L-tyrosine,0.023222415524105085,1.6783366448265462,409944.51,318569.67719693354 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_112,L-tyrosine,0.02163119331038738,1.5633354061064686,420849.33,296740.9769720815 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_112,L-tyrosine,0.021144988924805815,1.5281963123136681,411069.95,290071.1292981531 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_112,L-tyrosine,0.02073311591914259,1.4984293159518163,412585.55,284420.97415713995 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_112,L-tyrosine,0.020364960441191515,1.471821884481238,419459.1,279370.54468534724 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_112,L-tyrosine,0.01841399830244069,1.3308214253887785,429235.66,252606.8612037496 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_112,L-tyrosine,0.024003001576271138,1.7347513694029317,420997.98,329277.91064512264 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_112,L-tyrosine,0.01174351898633461,0.8487307547108071,160172.6,161099.91007392618 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_112,L-tyrosine,0.011337986296795504,0.8194219873768466,143640.04,155536.73264024465 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_112,L-tyrosine,0.019643373587684677,1.4196711658185515,400517.68,269471.6738830136 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_112,L-tyrosine,0.03455643644160247,2.4974720452469343,413779.14,474052.0119817246 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_112,L-tyrosine,0.012579824462222312,0.909172448426712,161572.07,172572.51356838288 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_112,L-tyrosine,0.012251224707161099,0.8854237987727688,150007.24,168064.71730626788 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_112,L-tyrosine,0.035354904789408774,2.5551791638912627,421644.07,485005.5582891096 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_112,L-tyrosine,0.016852929598760155,1.2179994492356374,161954.85,231191.81277790724 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_112,L-tyrosine,0.017736488642894267,1.2818562655129502,179839.86,243312.65004318056 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_112,L-tyrosine,0.019528666730715582,1.0216491402776544,10213.86,3095.1678024023763 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_112,L-tyrosine,0.020522864682760066,1.073660959465212,10989.76,3252.741769576617 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_112,L-tyrosine,0.019687250225207474,1.0299454921507212,9846.39,3120.302264109982 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_112,L-tyrosine,0.02030490161614462,1.0622581441736947,10709.08,3218.196028425742 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_112,L-tyrosine,0.01995382708997869,1.0438915555695343,10450.41,3162.5529789223497 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_112,L-tyrosine,0.020036733410178743,1.0482288291747386,11250.07,3175.6930962912043 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_113,unannotated_peak_5,0.0252224811833075,1.2090910602578369,141.44,NA -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_113,unannotated_peak_5,0.017166512415103564,0.8229117724803119,156.89,NA -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_113,unannotated_peak_5,0.019000558527976066,0.9108305122370635,190.54,NA -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_113,unannotated_peak_5,0.015268007211446053,0.7319030547846697,104.97,NA -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_113,unannotated_peak_5,0.028050982013856487,1.3446810144456898,268.05,NA -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_113,unannotated_peak_5,0.020860696114921935,1,210.34,NA -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_113,unannotated_peak_5,0.010221611863103797,0.48999380494269035,79.08,NA -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_113,unannotated_peak_5,0.013062688807134164,0.6261866207710225,101.84,NA -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_113,unannotated_peak_5,0.030189446925457532,1.4471926899823164,196.71,NA -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_113,unannotated_peak_5,0.01709788531789179,0.8196219926554341,124.01,NA -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_113,unannotated_peak_5,0.022094796292747625,1.059159108163362,282.43,NA -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_113,unannotated_peak_5,0.011872835362906571,0.5691485699949281,106.03,NA -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_113,unannotated_peak_5,0.014426636743832742,0.6915702459954428,118.49,NA -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_113,unannotated_peak_5,0.020728049313687213,0.9936413051365128,306.32,NA -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_113,unannotated_peak_5,0.020216755596753892,0.9691313983665472,138.69,NA -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_113,unannotated_peak_5,0.025636518171048114,1.2289387674225296,187.04,NA -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_113,unannotated_peak_5,0.0320854035429385,1.5380792360034132,235.53,NA -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_113,unannotated_peak_5,0.012546851165363783,0.6014588916996328,90.97,NA -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_113,unannotated_peak_5,0.025129947092761187,1.2046552499648082,201.21,NA -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_113,unannotated_peak_5,0.013066597923840205,0.6263740122504106,114.46,NA -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_113,unannotated_peak_5,0.025640438257790242,1.2175922392508478,172.88,NA -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_113,unannotated_peak_5,0.01366877715902963,0.6490917519253848,92.74,NA -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_113,unannotated_peak_5,0.02195358810806176,1.0425141035163181,108.8,NA -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_113,unannotated_peak_5,0.018295023248898933,0.8687791566123162,94.15,NA -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_113,unannotated_peak_5,0.009516925171395362,0.45193198781231353,38.32,NA -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_113,unannotated_peak_5,0.02973266887444009,1.4119207522802106,127.1,NA -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_114,unannotated_peak_2,0.018255434219851353,1.2034087370313769,1604.68,NA -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_114,unannotated_peak_2,0.02002030120541248,1.3197497851020363,2495.11,NA -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_114,unannotated_peak_2,0.020226139839600563,1.3333187864096678,2760.66,NA -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_114,unannotated_peak_2,0.021762145533667322,1.434573166344375,2305.6,NA -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_114,unannotated_peak_2,0.02105955494121294,1.3882579898696221,2941.57,NA -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_114,unannotated_peak_2,0.018694212110734697,1.2323332282894937,2829.27,NA -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_114,unannotated_peak_2,0.020642364732314802,1.3607565710402623,3147.53,NA -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_114,unannotated_peak_2,0.019506462754982756,1.2858772585314342,3055.79,NA -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_114,unannotated_peak_2,0.02267449287900987,1.4947156287679033,3893.6,NA -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_114,unannotated_peak_2,0.01748610415027811,1.1526940557898515,3414.07,NA -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_114,unannotated_peak_2,0.02232289404211838,1.4715380309551283,2885.89,NA -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_114,unannotated_peak_2,0.01692620908669251,1.1157854507561258,2509.36,NA -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_114,unannotated_peak_2,0.018098036961663354,1.1930330191269378,2554.53,NA -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_114,unannotated_peak_2,0.019010355133047302,1.2531735583863142,2937.05,NA -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_114,unannotated_peak_2,0.020861332975755872,1.3751910837511596,3055.89,NA -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_114,unannotated_peak_2,0.02370747612311046,1.5628104791114736,3589.74,NA -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_114,unannotated_peak_2,0.01859125865209078,1.225546477005048,2653.11,NA -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_114,unannotated_peak_2,0.01753604155036423,1.1559859579623517,2463.83,NA -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_114,unannotated_peak_2,0.021570214935529762,1.421920990782797,3107.45,NA -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_114,unannotated_peak_2,0.019541565127978534,1.2881912271746845,3054.56,NA -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_114,unannotated_peak_2,0.020416864801911638,2.054322191182279,1553.43,NA -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_114,unannotated_peak_2,0.019648268989570828,1.976986936790348,1545.27,NA -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_114,unannotated_peak_2,0.01625656247882562,1.6357172061728973,1288.51,NA -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_114,unannotated_peak_2,0.0237515514230339,2.389854644028256,1986,NA -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_114,unannotated_peak_2,0.020239700273874478,2.0364960937393946,1483.53,NA -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_114,unannotated_peak_2,0.019672299173736644,1.9794048271505473,1519.62,NA -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_115,unannotated,0.01652944798844588,0.7887358227322098,9569.02,NA -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_115,unannotated,0.020092847207563103,0.9587705762689485,19920.24,NA -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_115,unannotated,0.02130523622002725,1.0166221540037783,23305.35,NA -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_115,unannotated,0.02287416416101045,1.0914867030924065,16273.92,NA -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_115,unannotated,0.020246956226230295,0.9661241977397856,23311.6,NA -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_115,unannotated,0.019883939328271122,0.9488021170582248,24657.12,NA -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_115,unannotated,0.01884424335796293,0.8991909348151391,22352.57,NA -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_115,unannotated,0.01954879515908217,0.9328100396335022,23720.33,NA -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_115,unannotated,0.02027117292689608,0.9672797462697087,25104.46,NA -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_115,unannotated,0.02038427052880105,0.9726764255871252,28513.74,NA -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_115,unannotated,0.017137541652645753,0.8177522337379609,13230.58,NA -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_115,unannotated,0.020066491680262085,0.9575129693286659,21188.64,NA -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_115,unannotated,0.020786784139345586,0.9918831712688728,21087.79,NA -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_115,unannotated,0.022715282440877914,1.083905342581551,21291.54,NA -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_115,unannotated,0.019699390129296755,0.9399959812217852,21881.53,NA -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_115,unannotated,0.01961869152602815,0.9361452852223244,22522.6,NA -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_115,unannotated,0.01983560903337442,0.9464959399290861,22297.83,NA -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_115,unannotated,0.020641142930505087,0.9849336083579504,22879.77,NA -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_115,unannotated,0.019872246782570192,0.9482441837467371,22665.23,NA -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_115,unannotated,0.02000012888424485,0.9543463351765725,24712.95,NA -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_115,unannotated,0.020015378026791528,0.9451807710617163,17713.79,NA -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_115,unannotated,0.01997654288815975,0.943346869837011,18080.59,NA -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_115,unannotated,0.020268819899029865,0.9571489878948387,16982.21,NA -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_115,unannotated,0.019731593646895692,0.9317796982143195,17434.12,NA -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_115,unannotated,0.019969253253405664,0.9430026333909941,17614.47,NA -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_115,unannotated,0.020034458981026914,0.9460818257913673,18961.55,NA -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_116,unannotated_peak_3,0.02315809722804724,1.3268346452806468,1891.74,NA -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_116,unannotated_peak_3,0.02258197806764062,1.2938261103258966,2814.48,NA -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_116,unannotated_peak_3,0.01923384883583245,1.1019962800123912,2585.5,NA -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_116,unannotated_peak_3,0.016280621244114925,0.9327921936186337,1528.78,NA -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_116,unannotated_peak_3,0.017498747401358265,1.0025842828320588,2565.26,NA -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_116,unannotated_peak_3,0.01921654952418319,1.1010051223274695,3123.88,NA -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_116,unannotated_peak_3,0.022553692693512036,1.2922055102403645,3880.47,NA -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_116,unannotated_peak_3,0.021843367032990585,1.251507663326143,3840.81,NA -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_116,unannotated_peak_3,0.02001851798669406,1.146953609804806,3569.74,NA -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_116,unannotated_peak_3,0.01853079794259303,1.0617152382083264,3692.25,NA -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_116,unannotated_peak_3,0.011486161616414381,0.6580953963477446,1259.25,NA -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_116,unannotated_peak_3,0.019353331920991364,1.108842019338585,3020.88,NA -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_116,unannotated_peak_3,0.021272565807910895,1.2188038175159133,3224.64,NA -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_116,unannotated_peak_3,0.02898174755530611,1.6604985443530063,4380.59,NA -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_116,unannotated_peak_3,0.020510362141604885,1.175133639380988,3488.69,NA -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_116,unannotated_peak_3,0.017646996830157587,1.0110781792146932,3074.93,NA -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_116,unannotated_peak_3,0.02012128159439499,1.1528414128323574,3840.12,NA -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_116,unannotated_peak_3,0.02258280298933446,1.293873373910303,4326.05,NA -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_116,unannotated_peak_3,0.02085410321650966,1.194828157574706,4486.52,NA -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_116,unannotated_peak_3,0.01836892173449671,1.0524406005283047,4263.33,NA -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_116,unannotated_peak_3,0.019993110256407865,1.1882176460165552,2931.7,NA -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_116,unannotated_peak_3,0.0199222492702055,1.1840062815444965,3059.91,NA -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_116,unannotated_peak_3,0.022865385546974967,1.3589208603088545,4123.36,NA -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_116,unannotated_peak_3,0.017143732484370577,1.0188752622912955,3181.11,NA -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_116,unannotated_peak_3,0.020089518827499847,1.193947338091955,3766.94,NA -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_116,unannotated_peak_3,0.01998533199082073,1.1877553731481767,3992.55,NA -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_117,unannotated_peak_4,0.020166571594308187,1.0114707822158329,6541,NA -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_117,unannotated_peak_4,0.01993815746682305,1.0000144860816034,9498.02,NA -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_117,unannotated_peak_4,0.01955699466659393,0.9808969561684803,10209,NA -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_117,unannotated_peak_4,0.01993786864523086,1,7826.79,NA -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_117,unannotated_peak_4,0.020398460043320778,1.023101335768911,10749.99,NA -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_117,unannotated_peak_4,0.020430578752242336,1.0247122757090354,11619.52,NA -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_117,unannotated_peak_4,0.019405474779017978,0.9732973531079898,10383.13,NA -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_117,unannotated_peak_4,0.019513500654641514,0.9787154786632194,10663.24,NA -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_117,unannotated_peak_4,0.01998776983209114,1.0025028345681382,10933.93,NA -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_117,unannotated_peak_4,0.020362696358729542,1.0213075791127906,12565.43,NA -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_117,unannotated_peak_4,0.02009352357655168,1.007806999538943,8782.42,NA -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_117,unannotated_peak_4,0.020028520351182747,1.0045467099600724,10992.58,NA -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_117,unannotated_peak_4,0.019822031627246283,0.9941901002536555,10408.09,NA -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_117,unannotated_peak_4,0.01996016838633576,1.0011184616320679,10509.66,NA -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_117,unannotated_peak_4,0.019963545078180576,1.0012878223548662,11156.09,NA -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_117,unannotated_peak_4,0.020073434139479932,1.0067993975013723,11593.13,NA -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_117,unannotated_peak_4,0.01969701844734566,0.9879199626514337,11035.7,NA -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_117,unannotated_peak_4,0.020435794645973088,1.0249738830966435,11287.74,NA -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_117,unannotated_peak_4,0.020171057098937246,1.0116957563446565,11528.46,NA -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_117,unannotated_peak_4,0.019768705976681823,0.9915155089263015,12254.41,NA -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_117,unannotated_peak_4,0.01970178710541077,0.9749417790239453,5395.72,NA -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_117,unannotated_peak_4,0.020321169872098685,1.00559189889483,5702.99,NA -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_117,unannotated_peak_4,0.02019784210310922,0.9994890314819229,5387.32,NA -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_117,unannotated_peak_4,0.019794647378624332,0.9795369641958842,5575.32,NA -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_117,unannotated_peak_4,0.020107007529265766,0.9949940879244678,5764.77,NA -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_117,unannotated_peak_4,0.019907694197795728,0.9851310794102187,6129.99,NA -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_118,dehydroascorbic_acid_peak_2,0.021276977152368603,1.0686837062514933,10460.88,10342.186567248827 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_118,dehydroascorbic_acid_peak_2,0.019909517687885,1,11353.48,9677.5 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_118,dehydroascorbic_acid_peak_2,0.01969425334170816,0.9891878673531188,12122.8,9572.865586309807 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_118,dehydroascorbic_acid_peak_2,0.018741797305413956,0.9413486353222105,10951.28,9109.901418330692 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_118,dehydroascorbic_acid_peak_2,0.021145385350611955,1.062074214056877,11161.25,10278.223206535427 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_118,dehydroascorbic_acid_peak_2,0.01901672622736589,0.9551575545668605,10739.33,9243.537234320793 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_118,dehydroascorbic_acid_peak_2,0.020217558175517628,1.0154720215959863,9668.93,9827.230488995157 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_118,dehydroascorbic_acid_peak_2,0.019936135126048707,1.0013369202901337,9677.5,9690.438046107769 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_118,dehydroascorbic_acid_peak_2,0.018880773410385243,0.9483290206409294,8766.5,9177.454097252594 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_118,dehydroascorbic_acid_peak_2,0.020985167141348272,1.0540268965991983,10983.68,10200.345291838743 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_118,dehydroascorbic_acid_peak_2,0.02182742061904345,1.0963309589526369,12466.01,10609.742855264143 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_118,dehydroascorbic_acid_peak_2,0.01854302730145925,0.9313649678587008,10211.82,9013.284476452578 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_118,dehydroascorbic_acid_peak_2,0.01831953955872805,0.9201397967503523,9493.65,8904.652883051534 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_118,dehydroascorbic_acid_peak_2,0.018905288953073862,0.9495603685355867,12747.3,9189.37046650314 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_118,dehydroascorbic_acid_peak_2,0.019678266074052302,0.9883848711225478,9383.56,9565.094590288456 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_118,dehydroascorbic_acid_peak_2,0.022455249284997442,1.1278650561515875,11036.59,10914.914080906989 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_118,dehydroascorbic_acid_peak_2,0.019547712533224616,0.9818275279023688,8820.88,9501.635901275175 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_118,dehydroascorbic_acid_peak_2,0.02005485689405229,1.007299986290262,8908.66,9748.145617324011 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_118,dehydroascorbic_acid_peak_2,0.020521672686440704,1.0307468522418402,9668.67,9975.052662570408 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_118,dehydroascorbic_acid_peak_2,0.01938053636878933,0.9734307316034302,9956.93,9420.375905092196 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_118,dehydroascorbic_acid_peak_2,0.019679474937583107,0.9097180804643077,4433.94,737.4083788435632 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_118,dehydroascorbic_acid_peak_2,0.020410503171436542,0.9435111366192924,4643.4,764.8006922322322 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_118,dehydroascorbic_acid_peak_2,0.01732751464952919,0.8009946106886724,3072.91,649.278221478131 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_118,dehydroascorbic_acid_peak_2,0.022687123547820733,1.048751887468538,4209.32,850.1077924631222 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_118,dehydroascorbic_acid_peak_2,0.020204985279730595,0.9340107133337733,3431.58,757.0997441212234 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_118,dehydroascorbic_acid_peak_2,0.01974378815521629,0.9126910712112309,3588.32,739.8182554131117 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_119,sinapic_acid,0.01993039328056623,1.0268819438928734,21.6,98.5293225165212 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_119,sinapic_acid,0.019562154323177747,1.0079090149066257,18.19,96.70886998029073 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_119,sinapic_acid,0.019576845893003954,1.0086659747703672,25.74,96.78150027921674 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_119,sinapic_acid,0.020406033474568517,1.051388551471305,90.53,100.88073151367172 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_119,sinapic_acid,0.020436988228704576,1.0529834461456091,228.33,101.03376165767119 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_119,sinapic_acid,0.019884569421955847,1.0245209421632995,153.05,98.30278440056858 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_119,sinapic_acid,0.020061146970847942,1.0336188206698396,187.21,99.17572584327111 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_119,sinapic_acid,0.020172134019238314,1.0393372525338593,208.5,99.72440938062381 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_119,sinapic_acid,0.019856801873318765,1.0230902632037733,72.16,98.16551075440205 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_119,sinapic_acid,0.020002852949041854,1.0306153135344365,100.86,98.88753933362918 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_119,sinapic_acid,0.019814749512965066,1.0209235819477944,70.47,97.95761768789087 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_119,sinapic_acid,0.019624790083155305,1.0111362232239687,32.41,97.01852061833979 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_119,sinapic_acid,0.020270436936380212,1.044402154627058,139.93,100.21038673646623 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_119,sinapic_acid,0.020232081285802193,1.0424259404866558,153.41,100.02076898969463 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_119,sinapic_acid,0.020084684316614698,1.0348315451271444,107.85,99.29208675494951 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_119,sinapic_acid,0.02007054465577903,1.0341030214999123,108.05,99.22218491291659 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_119,sinapic_acid,0.01996844848194477,1.028842677864186,95.95,98.71745494106864 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_119,sinapic_acid,0.019790950223481887,1.0196973612554219,64.63,97.83996181245773 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_119,sinapic_acid,0.020292441166099698,1.0455358877084941,197.01,100.31916842563001 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_119,sinapic_acid,0.01980479746270586,1.020410818322309,119.48,97.90841801802556 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_119,sinapic_acid,0.019998291459244467,0.9884236917140243,71.41,23.94950605023081 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_119,sinapic_acid,0.0199967224080069,0.9883461407182363,79.08,23.947626989602867 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_119,sinapic_acid,0.0202098787836567,0.9988814813077826,183.12,24.202898292087575 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_119,sinapic_acid,0.01978907671857475,0.97808316803703,119.1,23.69895516153724 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_119,sinapic_acid,0.020073783346066215,0.9921549089341993,204.64,24.03991344347565 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_119,sinapic_acid,0.019937253527567547,0.9854068671075003,192.36,23.87640839001473 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_120,uracil,0.014061092726880308,0.5720547635881604,52.7,102.9298136124177 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_120,uracil,0.009890742479657799,0.40239023103059723,46.48,72.40207426933536 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_120,uracil,0.024026877962147693,0.9774979981550461,123.77,175.88121480803744 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_120,uracil,0.02894436983317479,1.1775588827795682,128.65,211.8781697785277 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_120,uracil,0.02963427767345682,1.2056267630031072,182.61,216.9284234671491 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_120,uracil,0.009414994772347064,0.38303513910996856,64.88,68.91951258005665 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_120,uracil,0.026227612082421626,1.0670316113206155,222.99,191.99099782491837 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_120,uracil,0.01851549317046329,0.7532754583219056,163.51,135.53685321586048 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_120,uracil,0.02181552689341041,0.8875324501419368,237.59,159.6937137540387 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_120,uracil,0.01701447267963913,0.6922086594110424,212.26,124.54910408782885 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_120,uracil,0.02579805378138937,1.0495556670880184,99.05,188.84655117914716 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_120,uracil,0.011887793486763049,0.48363729795016497,78.52,87.02085902017319 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_120,uracil,0.032562758046340554,1.3247676562410866,210.64,238.36544438745872 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_120,uracil,0.012558262924006138,0.5109143554922126,59.34,91.92881998371382 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_120,uracil,0.02003614411345063,0.8151408931488713,186.51,146.6683009042764 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_120,uracil,0.01595919825760501,0.6492763801250003,157.03,116.82429907589132 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_120,uracil,0.022501815670810377,0.9154530941441082,286.04,164.7174752293494 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_120,uracil,0.019958461581116603,0.8119804942003372,255.39,146.0996503214667 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_120,uracil,0.01888471495927292,0.7682967007823378,323.15,138.23962537176604 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_120,uracil,0.020568390026268504,0.8367945310091591,388.85,150.564439964478 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_120,uracil,0.01795689357850878,0.7543838169637345,153.36,154.39973581796752 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_120,uracil,0.022126312062602193,0.9295445047963979,218.22,190.24987379667874 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_120,uracil,0.017158804884067992,0.7208554567852006,334.95,147.537486340227 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_120,uracil,0.022799978606566244,0.9578457884552039,475.02,196.04229752312656 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_120,uracil,0.019657167402138426,0.8258137138635173,338.47,169.01929281644607 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_120,uracil,0.020248373735241354,0.850650776478462,358.55,174.1026944218468 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_121,urea,0.01976088280724067,1.0008788298068514,351.22,248.33805525167597 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_121,urea,0.014959892221388986,0.7577110580856281,214.79,188.00326773220604 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_121,urea,0.019426965497311214,0.9839660850841314,293.27,244.1416650310747 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_121,urea,0.021762507812006476,1.1022601350867989,448.81,273.4927847177365 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_121,urea,0.017868740816739788,0.9050427844360943,187.67,224.55921567428373 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_121,urea,0.021654502583839847,1.0967897243042994,247.56,272.1354663943828 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_121,urea,0.0270565645354039,1.3704014600433734,270.7,340.0240102659618 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_121,urea,0.022259568729628577,1.1274360219348316,226.89,279.73942576247043 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_121,urea,0.016105395988970702,0.8157302509334512,175.73,202.3989898616079 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_121,urea,0.020129182721349545,1.0195330362331039,250.86,252.96653695015775 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_121,urea,0.016592718070508522,0.8404128706051742,452.66,208.52324145455583 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_121,urea,0.013068413739120219,0.6619086190749414,305.91,164.23276656487445 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_121,urea,0.032540967705821024,1.6481837373303347,710.53,408.9473489064027 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_121,urea,0.022936478337130334,1.161721154965079,733.46,288.2462529699354 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_121,urea,0.011910446418010203,0.6032581534751708,213.16,149.68041304025937 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_121,urea,0.019116672601339674,0.9682499051114645,351.4,240.24216645625657 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_121,urea,0.01417455481866285,0.7179341114627741,262.76,178.1338117361435 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_121,urea,0.03524542519406632,1.7851631563421972,651.5,442.934682351626 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_121,urea,0.012821154290708223,0.6493850516918785,312.41,161.12541902578891 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_121,urea,0.02414657322361507,1.223011855676907,653.1,303.4537016305542 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_121,urea,0.01927263759820781,1.9039519017885072,771.93,108.39198176881972 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_121,urea,0.020784299027902534,2.05328956453765,847.86,116.89377490912841 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_121,urea,0.020600093667554442,2.0350918402060825,726.53,115.85777846293227 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_121,urea,0.019390201412753796,1.9155660800319232,717.87,109.05317693621738 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_121,urea,0.01942097105672075,1.9186058259852057,684.07,109.22622967333776 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_121,urea,0.02054960438724762,2.030103983158999,775.39,115.57381976124182 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_122,L-valine,0.0168590481881081,0.8564197377308685,6620.64,9233.121141858135 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_122,L-valine,0.019643651218548025,0.9978742831123869,10781.07,10758.152497434461 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_122,L-valine,0.019713246163103125,1.0014096241054398,11823.09,10796.267256154433 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_122,L-valine,0.023512111098042795,1.1943874764109395,11127.43,12876.774990309686 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_122,L-valine,0.021052958868754756,1.0694654473765421,12385.08,11529.981850747818 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_122,L-valine,0.01957597570381571,0.9944364468875203,12421.49,10721.088944445639 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_122,L-valine,0.01948432476903671,0.989780687638811,11602.84,10670.894878082156 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_122,L-valine,0.019972386744488268,1.0145736595995571,12148.99,10938.189644298996 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_122,L-valine,0.02050549491168155,1.041654924902061,12612.38,11230.154661213863 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_122,L-valine,0.019685497011987463,1,13676.84,10781.07 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_122,L-valine,0.016873506126609462,0.857154183932179,8054.86,9241.039257765697 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_122,L-valine,0.020023359473700538,1.0171630140456873,12447,10966.105655837539 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_122,L-valine,0.020294968123139454,1.0309604126723777,12085.69,11114.85637624979 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_122,L-valine,0.02320767640679411,1.1789225536272627,13395.19,12710.046575234273 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_122,L-valine,0.020192309175179425,1.0257454593543327,12771.93,11058.633599481216 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_122,L-valine,0.019368412638131022,0.9838924882788912,12644.13,10607.413788608905 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_122,L-valine,0.020438718778852397,1.0382627762157217,12745.15,11193.583668776031 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_122,L-valine,0.02005014584061703,1.0185237298508396,12304.19,10980.775628182992 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_122,L-valine,0.020250566819778305,1.0287048788987518,12461.23,11090.539308748967 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_122,L-valine,0.01963166482564037,0.997265388508387,13061.63,10751.587962086116 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_122,L-valine,0.020385628014025284,1.0367698662487157,11518.73,1785.3591804749383 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_122,L-valine,0.019590524371874175,0.996332578952012,11343.85,1715.7245542585226 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_122,L-valine,0.01956979852314232,0.995278506180605,10813.87,1713.909398783249 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_122,L-valine,0.02043193682460377,1.0391250342777096,11928.63,1789.414874027587 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_122,L-valine,0.020316108681838273,1.0332342602480744,11960.44,1779.270725517594 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_122,L-valine,0.019698719239722967,1.0018351407858301,12437,1725.200185838831 -1,leaf,NA,4,1,Pooled Sample,21110rA_1,m_123,D-Xylose,0.021961628847367524,1.0862692325196843,183.9,229.10504383072663 -1,leaf,NA,4,15,Pooled Sample,21110rA_15,m_123,D-Xylose,0.021856519350935785,1.081070291548003,229.1,228.00853519038932 -1,leaf,NA,4,16,Pooled Sample,21110rA_16,m_123,D-Xylose,0.015737153617355313,0.7783933469041405,179.63,164.17094079555227 -1,leaf,NA,4,2,Pooled Sample,21110rA_2,m_123,D-Xylose,0.018999899848617545,0.9397757684527386,189.66,198.2081073243671 -1,leaf,NA,4,29,Pooled Sample,21110rA_29,m_123,D-Xylose,0.01811195672537127,0.8958561984739626,211.49,188.94503082014344 -1,leaf,NA,4,30,Pooled Sample,21110rA_30,m_123,D-Xylose,0.019813607442827626,0.9800234900585053,254.56,206.69675428823936 -1,leaf,NA,4,43,Pooled Sample,21110rA_43,m_123,D-Xylose,0.01945584992721783,0.9623280365650281,249.12,202.96460619193007 -1,leaf,NA,4,44,Pooled Sample,21110rA_44,m_123,D-Xylose,0.027297242406176904,1.3501801148058235,356.41,284.76648801369623 -1,leaf,NA,4,57,Pooled Sample,21110rA_57,m_123,D-Xylose,0.01711807307259118,0.8466965828451474,209.57,178.57677628787002 -1,leaf,NA,4,58,Pooled Sample,21110rA_58,m_123,D-Xylose,0.019837480161866535,0.9812042859078834,271.47,206.9457959408317 -1,leaf,NA,5,1,Pooled Sample,21111rA_1,m_123,D-Xylose,0.024611810444407543,1.2173528943674496,183.57,256.7518989510388 -1,leaf,NA,5,15,Pooled Sample,21111rA_15,m_123,D-Xylose,0.015099262135174707,0.7468418670209793,155.31,157.51641817339475 -1,leaf,NA,5,16,Pooled Sample,21111rA_16,m_123,D-Xylose,0.02586827567226303,1.2795003574830488,255.73,269.85942039674984 -1,leaf,NA,5,2,Pooled Sample,21111rA_2,m_123,D-Xylose,0.014853637800116464,0.7346927609694098,134.61,154.95405021605822 -1,leaf,NA,5,29,Pooled Sample,21111rA_29,m_123,D-Xylose,0.020755721759996914,1.0266224833922788,226.12,216.52494797226552 -1,leaf,NA,5,30,Pooled Sample,21111rA_30,m_123,D-Xylose,0.01932239843758293,0.9557272398649377,216.83,201.572432159914 -1,leaf,NA,5,43,Pooled Sample,21111rA_43,m_123,D-Xylose,0.022620467938335692,1.1188568260298872,246.49,235.9780931779635 -1,leaf,NA,5,44,Pooled Sample,21111rA_44,m_123,D-Xylose,0.015253721995856355,0.7544817827796806,164.05,159.12775280606243 -1,leaf,NA,5,57,Pooled Sample,21111rA_57,m_123,D-Xylose,0.02332724358223451,1.1538154641890783,264.23,243.3512195521185 -1,leaf,NA,5,58,Pooled Sample,21111rA_58,m_123,D-Xylose,0.01777217040971562,0.8790496390473745,218.71,185.40035937148176 -2,fruit,NA,6,1,Pooled Sample,21111rA_59,m_123,D-Xylose,0.023013044183656017,1.2539848963982658,266.43,139.8443956463346 -2,fruit,NA,6,2,Pooled Sample,21111rA_60,m_123,D-Xylose,0.01671445090288612,0.9107734212188762,197.69,101.56945193432907 -2,fruit,NA,6,18,Pooled Sample,21111rA_76,m_123,D-Xylose,0.019554341201197385,1.0655195518520177,219.01,118.82674042253701 -2,fruit,NA,6,19,Pooled Sample,21111rA_77,m_123,D-Xylose,0.020474702091184772,1.115670181471871,242.92,124.41953863774305 -2,fruit,NA,6,35,Pooled Sample,21111rA_93,m_123,D-Xylose,0.02155304409742293,1.1744292303913884,262.57,130.97234777324763 -2,fruit,NA,6,36,Pooled Sample,21111rA_94,m_123,D-Xylose,0.01855590882293566,1.0111147928630095,242.6,112.75952170008281 -1,fruit,0.8,1,8,Sample,21106rA_10,m_1,adenine,2.4240348167446765e-4,0.012117876813480354,8.32,0.8984193869514334 -1,fruit,0.6,1,9,Sample,21106rA_11,m_1,adenine,0.004399300286164515,0.21992332191351366,141.87,16.305115086667904 -1,fruit,0.6,1,10,Sample,21106rA_12,m_1,adenine,0.03203771788237297,1.6015822710211691,1118.94,118.74130957350948 -1,fruit,0.6,1,11,Sample,21106rA_13,m_1,adenine,0.01768222219101023,0.8839435342228411,746.04,65.53557362728144 -1,fruit,1,1,12,Sample,21106rA_14,m_1,adenine,0.025955398975191404,1.297523968110696,1053.67,96.198426995727 -1,fruit,0.8,1,13,Sample,21106rA_15,m_1,adenine,0.03266712149784663,1.6330464869044692,1185.7,121.07406653909734 -1,fruit,0.8,1,14,Sample,21106rA_16,m_1,adenine,0.031654062747812406,1.5824031502125517,1514.08,117.31936955675859 -1,fruit,1,1,17,Sample,21106rA_19,m_1,adenine,0.0015042620457275697,0.07519884631772862,56.82,5.5752424659964 -1,fruit,0.6,1,18,Sample,21106rA_20,m_1,adenine,0.036983456965561275,1.8488223541573339,1611.74,137.07168933722474 -1,fruit,0.6,1,19,Sample,21106rA_21,m_1,adenine,0.0018328057853017085,0.0916229196705452,81.31,6.792923264374221 -1,fruit,1,1,20,Sample,21106rA_22,m_1,adenine,0.06026802847427647,3.0128302605132635,2689.22,223.37123551445336 -1,fruit,0.8,1,21,Sample,21106rA_23,m_1,adenine,7.200319473098055e-4,0.03599477358575263,31.63,2.6686525136476997 -1,fruit,1,1,22,Sample,21106rA_24,m_1,adenine,0.03230683686134608,1.6150356695154422,1141.86,119.73874453787488 -1,fruit,0.8,1,23,Sample,21106rA_25,m_1,adenine,0.017767176513099142,0.8881904452108139,832.28,65.85043960792974 -1,fruit,1,1,24,Sample,21106rA_26,m_1,adenine,0.04744025390306663,2.371563101431078,2334.86,175.8276883401001 -1,fruit,1,1,25,Sample,21106rA_27,m_1,adenine,0.001177716055050089,0.05887464147697608,49.23,4.364965919103007 -1,fruit,0.6,1,26,Sample,21106rA_28,m_1,adenine,0.02836449695786715,1.4179560360991965,1245.46,105.12726051639443 -1,fruit,0.8,1,27,Sample,21106rA_29,m_1,adenine,0.10933130121796772,5.4655289225426795,5039.21,405.2143143173143 -1,fruit,1,1,28,Sample,21106rA_30,m_1,adenine,0.01641697187714668,0.8206930093718576,738.59,60.846179714829525 -1,fruit,0.8,1,31,Sample,21106rA_33,m_1,adenine,0.0077593578004381235,0.3878943541895954,324.13,28.758487419616603 -1,fruit,1,1,32,Sample,21106rA_34,m_1,adenine,0.025668458266707654,1.283179652038337,896.79,95.1349394021223 -1,fruit,0.8,1,33,Sample,21106rA_35,m_1,adenine,0.0173376117800473,0.8667162795652548,721.8,64.25834496696798 -1,fruit,0.8,1,34,Sample,21106rA_36,m_1,adenine,0.016108128865780346,0.8052537857246184,760.55,59.701515673623206 -1,fruit,0.8,1,35,Sample,21106rA_37,m_1,adenine,0.016511435412561854,0.8254152909068405,877.08,61.196289667833156 -1,fruit,0.6,1,36,Sample,21106rA_38,m_1,adenine,0.02052244941494951,1.0259279784405608,895.89,76.06230032158318 -1,fruit,0.4,1,37,Sample,21106rA_39,m_1,adenine,0.039768882012762144,1.988067208901176,1636.82,147.3953028679332 -1,fruit,0.4,1,38,Sample,21106rA_40,m_1,adenine,0.008396851685182108,0.4197630068645141,412.86,31.121229328935076 -1,fruit,0.8,1,39,Sample,21106rA_41,m_1,adenine,0.04372691981034356,2.185931588252797,2194.59,162.0649679530624 -1,fruit,0.6,1,40,Sample,21106rA_42,m_1,adenine,0.009441850773537347,0.472003057772256,487.38,34.99430670323506 -1,fruit,1,1,41,Sample,21106rA_43,m_1,adenine,0.011142173764859388,0.5570030932900593,470.82,41.296209336524996 -1,fruit,0.6,1,42,Sample,21106rA_44,m_1,adenine,0.026243616811275232,1.311932128459655,1165.96,97.26664800399882 -1,fruit,1,1,45,Sample,21106rA_47,m_1,adenine,0.01558249946224802,0.77897729696485,802.19,57.753376796973974 -1,fruit,0.6,1,46,Sample,21106rA_48,m_1,adenine,0.0029873087433455355,0.14933712628892049,127.66,11.071854543060565 -1,fruit,0.8,1,47,Sample,21106rA_49,m_1,adenine,0.001447231040638786,0.07234783654905315,69.21,5.363868601746801 -1,fruit,0.4,1,3,Sample,21106rA_5,m_1,adenine,0.02074056646264231,1.0368317637187396,686.17,76.87070696210736 -1,fruit,0.4,1,48,Sample,21106rA_50,m_1,adenine,0.060346608724599966,3.0167585283203713,2786.67,223.66247728967232 -1,fruit,0.8,1,49,Sample,21106rA_51,m_1,adenine,0.032190182017339,1.609204032859035,1332.53,119.30638699616885 -1,fruit,0.6,1,50,Sample,21106rA_52,m_1,adenine,0.009829974156013669,0.4914055486308466,464.58,36.43280737549097 -1,fruit,0.4,1,51,Sample,21106rA_53,m_1,adenine,0.002234544165267163,0.11170603137356208,120.37,8.281885166035893 -1,fruit,0.8,1,52,Sample,21106rA_54,m_1,adenine,0.019850277410022266,0.9923257484028046,826.18,73.57103098658393 -1,fruit,0.4,1,53,Sample,21106rA_55,m_1,adenine,0.003465250326550688,0.1732296759722522,137.93,12.843248176582778 -1,fruit,0.6,1,54,Sample,21106rA_56,m_1,adenine,0.01849769324218955,0.9247093585207813,741.87,68.55795184073072 -1,fruit,1,1,55,Sample,21106rA_57,m_1,adenine,0.0010420122553298945,0.052090737562844575,50.29,3.8620072829092966 -1,fruit,0.6,1,56,Sample,21106rA_58,m_1,adenine,0.04462588603658169,2.230871380015617,1998.49,165.39680411435782 -1,fruit,0.4,1,4,Sample,21106rA_6,m_1,adenine,0.023308235337960507,1.1651908735548706,1149.25,86.38725136535811 -1,fruit,NA,1,59,blank sample,21106rA_61,m_1,adenine,0.08399258619236065,4.198833307565744,3.42,311.3015014229243 -1,fruit,0.8,1,5,Sample,21106rA_7,m_1,adenine,0.038768365882548415,1.9380508843332311,1391.6,143.68709256446576 -1,fruit,1,1,6,Sample,21106rA_8,m_1,adenine,0.025347780695198753,1.2671488125407036,809.36,93.94641296176776 -1,fruit,1,1,7,Sample,21106rA_9,m_1,adenine,0.03326743315385192,1.6630563805203444,1090.21,123.29900005177834 -1,fruit,1,2,10,Sample,21108rA_10,m_1,adenine,0.001348795897457783,0.06742701226490949,4.84,4.99903868932039 -1,fruit,0.8,2,11,Sample,21108rA_11,m_1,adenine,0.03975405585070321,1.9873260413065286,196.54,147.34035270246602 -1,fruit,0.4,2,12,Sample,21108rA_12,m_1,adenine,0.05872059001031195,2.9354730024688203,312.82,217.63596840303833 -1,fruit,0.6,2,13,Sample,21108rA_13,m_1,adenine,0.02116981271509905,1.0582900083528006,137.77,78.46162121927664 -1,fruit,1,2,14,Sample,21108rA_14,m_1,adenine,0.017232912792746725,0.8614823224379049,131.83,63.87029938554627 -1,fruit,1,2,17,Sample,21108rA_17,m_1,adenine,0.014611363283876421,0.7304296915536994,92.64,54.15405733179127 -1,fruit,0.8,2,18,Sample,21108rA_18,m_1,adenine,0.0016592249245797903,0.08294552166917957,11.76,6.149580976552973 -1,fruit,0.6,2,19,Sample,21108rA_19,m_1,adenine,0.04121413354290431,2.0603160886853207,295.63,152.75183481512968 -1,fruit,0.4,2,20,Sample,21108rA_20,m_1,adenine,0.0391097463730796,1.9551166735793521,261.32,144.95235017917318 -1,fruit,0.6,2,21,Sample,21108rA_21,m_1,adenine,0.06384183270646787,3.191486602996614,439.84,236.61681674616895 -1,fruit,0.8,2,22,Sample,21108rA_22,m_1,adenine,0.05398737574322,2.698857146028878,404.17,200.09326880658102 -1,fruit,0.6,2,23,Sample,21108rA_23,m_1,adenine,0.0034811327034830384,0.17402364430076797,29.87,12.902112988458937 -1,fruit,0.4,2,24,Sample,21108rA_24,m_1,adenine,0.03166064967810271,1.5827324343023903,270.72,117.34378267917921 -1,fruit,0.4,2,25,Sample,21108rA_25,m_1,adenine,0.08012657672181073,4.005569472408516,798.67,296.9729206843674 -1,fruit,0.6,2,26,Sample,21108rA_26,m_1,adenine,0.009161732497746563,0.45799979867800034,72.93,33.95610507398695 -1,fruit,0.4,2,27,Sample,21108rA_27,m_1,adenine,0.044495104107420094,2.2243335229845953,391.23,164.9120873940779 -1,fruit,0.4,2,28,Sample,21108rA_28,m_1,adenine,0.011106299149793662,0.555209702522342,111.93,41.16324734500644 -1,fruit,0.8,2,3,Sample,21108rA_3,m_1,adenine,0.016918866630779912,0.8457829905711671,40.67,62.70635092094633 -1,fruit,0.6,2,31,Sample,21108rA_31,m_1,adenine,0.005496131108688221,0.27475446831767264,47.39,20.37029628107225 -1,fruit,1,2,32,Sample,21108rA_32,m_1,adenine,0.03085210938108415,1.542313082029375,295.4,114.34709190165786 -1,fruit,1,2,33,Sample,21108rA_33,m_1,adenine,0.04183115391265767,2.0911612596392612,432.26,155.03869578965484 -1,fruit,0.6,2,34,Sample,21108rA_34,m_1,adenine,0.01914444977336453,0.957041055734674,166.14,70.95502387216874 -1,fruit,0.4,2,35,Sample,21108rA_35,m_1,adenine,0.03319005130811377,1.6591880215851622,316.68,123.01219992032392 -1,fruit,1,2,36,Sample,21108rA_36,m_1,adenine,0.06979633319870876,3.489155196501735,713.68,258.68596626863865 -1,fruit,0.4,2,37,Sample,21108rA_37,m_1,adenine,0.0037829603083836395,0.18911216411008783,43.5,14.02077584712191 -1,fruit,1,2,38,Sample,21108rA_38,m_1,adenine,0.09753504099326533,4.875827705071437,988.17,361.4938660539963 -1,fruit,1,2,39,Sample,21108rA_39,m_1,adenine,0.01845702091839147,0.9226761277845786,166.51,68.40720811394866 -1,fruit,1,2,4,Sample,21108rA_4,m_1,adenine,0.05167150068437039,2.583085340753249,163.89,191.50994716344587 -1,fruit,0.8,2,40,Sample,21108rA_40,m_1,adenine,0.03950059801729078,1.974655551668809,393.33,146.4009626007255 -1,fruit,0.4,2,41,Sample,21108rA_41,m_1,adenine,0.03234590517446899,1.616988714919178,299.7,119.88354332410785 -1,fruit,0.4,2,42,Sample,21108rA_42,m_1,adenine,0.03245551393304297,1.6224681140800437,328.8,120.28978597789444 -1,fruit,0.8,2,45,Sample,21108rA_45,m_1,adenine,0.0021398651804970087,0.10697297941265473,21.12,7.930976693654221 -1,fruit,0.4,2,46,Sample,21108rA_46,m_1,adenine,0.041669016281376474,2.0830559146618586,418.17,154.4377655130302 -1,fruit,0.4,2,47,Sample,21108rA_47,m_1,adenine,0.03317094911292365,1.6582330928581408,336.11,122.94140150450256 -1,fruit,0.4,2,48,Sample,21108rA_48,m_1,adenine,0.09009094395574511,4.5036934012852985,993.33,333.903828771292 -1,fruit,0.4,2,49,Sample,21108rA_49,m_1,adenine,0.03446621627823073,1.7229841758100586,388.4,127.74204679455775 -1,fruit,0.4,2,5,Sample,21108rA_5,m_1,adenine,0.01266630031077842,0.6331949763604727,42.02,46.94507554736545 -1,fruit,1,2,50,Sample,21108rA_50,m_1,adenine,0.008482965586080434,0.4240678858035698,92.54,31.440393053476665 -1,fruit,0.4,2,51,Sample,21108rA_51,m_1,adenine,0.010552713469589898,0.5275356648720713,127.38,39.111494193615364 -1,fruit,0.6,2,52,Sample,21108rA_52,m_1,adenine,0.01750859242712322,0.8752636915266786,179.52,64.89205008978796 -1,fruit,1,2,53,Sample,21108rA_53,m_1,adenine,0.016168160055109994,0.808254776272437,161.44,59.92400911283848 -1,fruit,0.6,2,54,Sample,21108rA_54,m_1,adenine,0.006386285015407468,0.3192537276193524,70.73,23.669471365698787 -1,fruit,0.6,2,55,Sample,21108rA_55,m_1,adenine,0.010575165850817567,0.5286580711510849,140.27,39.19470939514143 -1,fruit,0.8,2,56,Sample,21108rA_56,m_1,adenine,0.001466474582644503,0.07330983127730327,15.88,5.435190890899264 -1,fruit,0.8,2,6,Sample,21108rA_6,m_1,adenine,0.054290500727127454,2.7140105224932136,212.48,201.21674013764687 -1,fruit,0.6,2,7,Sample,21108rA_7,m_1,adenine,0.009986517952420558,0.4992312548775941,35.59,37.01300523662483 -1,fruit,0.8,2,8,Sample,21108rA_8,m_1,adenine,0.037378336561629005,1.8685625916665118,161.51,138.5352305461552 -1,fruit,0.4,2,9,Sample,21108rA_9,m_1,adenine,0.017085570365079506,0.8541165974262969,73.98,63.32420453318565 -2,fruit,NA,3,43,blank sample,21108rA_101,m_1,adenine,0.23725030589386903,11.635769935442983,47.94,1427.5926133794997 -2,fruit,1,3,3,Sample,21108rA_61,m_1,adenine,0.03927024882116977,1.9259809966067598,455.73,236.29860847368334 -2,fruit,1,3,4,Sample,21108rA_62,m_1,adenine,0.009769393663859562,0.4791328578193493,115.22,58.784810325855965 -2,fruit,1,3,5,Sample,21108rA_63,m_1,adenine,0.009291767159124942,0.4557080107860733,120.8,55.910815843343336 -2,fruit,NA,3,6,Sample,21108rA_64,m_1,adenine,0.03136775302249125,1.5384087965086852,422.12,188.7473752436506 -2,fruit,1,3,7,Sample,21108rA_65,m_1,adenine,0.011344060596063844,0.5563612604511046,166.78,68.25996304474602 -2,fruit,1,3,8,Sample,21108rA_66,m_1,adenine,0.03302141446246066,1.619511427732288,455.59,198.6978570684744 -2,fruit,1,3,9,Sample,21108rA_67,m_1,adenine,0.015433162190185663,0.7569082954173688,196.13,92.86507876475697 -2,fruit,1,3,10,Sample,21108rA_68,m_1,adenine,0.03954132231374651,1.93927560030953,485.77,237.92972340197622 -2,fruit,1,3,11,Sample,21108rA_69,m_1,adenine,0.009042712729168486,0.44349331610967285,138.39,54.412194953495764 -2,fruit,1,3,12,Sample,21108rA_70,m_1,adenine,0.02726157475723019,1.3370242485373658,335.55,164.0395050530494 -2,fruit,1,3,13,Sample,21108rA_71,m_1,adenine,0.01624171151640042,0.7965630132726156,185.3,97.7303160984172 -2,fruit,1,3,14,Sample,21108rA_72,m_1,adenine,0.01115084685228845,0.5468852319062064,134.05,67.09734910257247 -2,fruit,1,3,17,Sample,21108rA_75,m_1,adenine,0.02139245381683212,1.0491774500750188,250.3,128.72358134970406 -2,fruit,1,3,18,Sample,21108rA_76,m_1,adenine,0.02045570070970374,1.003235070360098,312.51,123.08691078248043 -2,fruit,1,3,19,Sample,21108rA_77,m_1,adenine,0.027192918258412774,1.3336570401293402,320.16,163.62638225346873 -2,fruit,1,3,20,Sample,21108rA_78,m_1,adenine,0.04060994772154509,1.991685561786568,512.99,244.35990157559402 -2,fruit,1,3,21,Sample,21108rA_79,m_1,adenine,0.010822537668556634,0.5307835450603088,163.02,65.12183314344928 -2,fruit,1,3,22,Sample,21108rA_80,m_1,adenine,0.01913288361248433,0.9383584610258155,255.99,115.12719958325731 -2,fruit,NA,3,23,Sample,21108rA_81,m_1,adenine,0.02898803657975866,1.4216973219548277,433.24,174.4280444306378 -2,fruit,1,3,24,Sample,21108rA_82,m_1,adenine,0.006178544265996314,0.3030222420334564,170.87,37.17779887508477 -2,fruit,1,3,25,Sample,21108rA_83,m_1,adenine,0.03548402770052845,1.740288515754047,811.77,213.51599799786402 -2,fruit,NA,3,26,Sample,21108rA_84,m_1,adenine,0.029991143021375996,1.4708939530463867,944.99,180.4639790992612 -2,fruit,1,3,27,Sample,21108rA_85,m_1,adenine,0.014855843269371841,0.7285941058248256,343.15,89.39121084364785 -2,fruit,1,3,28,Sample,21108rA_86,m_1,adenine,0.03920051188751999,1.9225607990525568,1087.03,235.87898443575818 -2,fruit,1,3,31,Sample,21108rA_89,m_1,adenine,0.03760153704377721,1.844140232452003,1062.61,226.25756511953625 -2,fruit,1,3,32,Sample,21108rA_90,m_1,adenine,0.017538057138743162,0.8601413482364761,399.91,105.53074201513326 -2,fruit,1,3,33,Sample,21108rA_91,m_1,adenine,0.012494546615753591,0.6127860165272541,398.75,75.1827163677288 -2,fruit,1,3,34,Sample,21108rA_92,m_1,adenine,0.03428669551685245,1.6815662233925452,1035.18,206.31135994803137 -2,fruit,1,3,35,Sample,21108rA_93,m_1,adenine,0.013541551156330146,0.6641355981836956,445.51,81.48279654115761 -2,fruit,1,3,36,Sample,21108rA_94,m_1,adenine,0.008429071966890458,0.4133977480303168,313.05,50.71976970583957 -2,fruit,1,3,37,Sample,21108rA_95,m_1,adenine,0.010759189565831119,0.5276766831054474,442.08,64.74065225020733 -2,fruit,1,3,38,Sample,21108rA_96,m_1,adenine,0.00579568471057143,0.28424517159839124,162.25,34.87404010340662 -2,fruit,NA,3,39,Sample,21108rA_97,m_1,adenine,0.025367393702764404,1.2441255064986596,1113.79,152.64175839232055 -2,fruit,1,3,40,Sample,21108rA_98,m_1,adenine,0.015442259671697347,0.7573544748288688,763.23,92.9198205167539 -1,fruit,0.8,1,8,Sample,21106rA_10,m_2,adenosine-5-monophosphate,0.048160870808595956,2.793181647456657,1213.75,108.26372065542002 -1,fruit,0.6,1,9,Sample,21106rA_11,m_2,adenosine-5-monophosphate,0.0014778750925046422,0.08571218743163792,27.19,3.3222043848502856 -1,fruit,0.6,1,10,Sample,21106rA_12,m_2,adenosine-5-monophosphate,5.54609622305361e-4,0.03216564386227227,7.23,1.246740356101673 -1,fruit,0.6,1,11,Sample,21106rA_13,m_2,adenosine-5-monophosphate,0.05117298218590998,2.967874797267961,1076.49,115.03482714210617 -1,fruit,1,1,12,Sample,21106rA_14,m_2,adenosine-5-monophosphate,0.041203689267377726,2.389686621874882,721.5,92.62425346387042 -1,fruit,0.8,1,13,Sample,21106rA_15,m_2,adenosine-5-monophosphate,0.057351272607069036,3.3261965453447964,772.07,128.9233780975643 -1,fruit,0.8,1,14,Sample,21106rA_16,m_2,adenosine-5-monophosphate,0.11124188460211745,6.451685471676881,1680.54,250.06732888219588 -1,fruit,1,1,17,Sample,21106rA_19,m_2,adenosine-5-monophosphate,0.0052447393441222906,0.30417867110246555,30.73,11.789965291931564 -1,fruit,0.6,1,18,Sample,21106rA_20,m_2,adenosine-5-monophosphate,0.1436420998073707,8.330797808424885,872.91,322.90172305454854 -1,fruit,0.6,1,19,Sample,21106rA_21,m_2,adenosine-5-monophosphate,0.2106022059406718,12.214276998545849,995.78,473.42537646363706 -1,fruit,1,1,20,Sample,21106rA_22,m_2,adenosine-5-monophosphate,0.1720572952931003,9.978791318655748,596.17,386.7779515110968 -1,fruit,0.8,1,21,Sample,21106rA_23,m_2,adenosine-5-monophosphate,0.02971142365209273,1.7231707373950296,65.51,66.79009778143134 -1,fruit,1,1,22,Sample,21106rA_24,m_2,adenosine-5-monophosphate,0.04343793260089404,2.5192658294422063,47.31,97.64674354917992 -1,fruit,0.8,1,23,Sample,21106rA_25,m_2,adenosine-5-monophosphate,0.04558499129331495,2.6437885973032054,32.74,102.47324603147223 -1,fruit,1,1,24,Sample,21106rA_26,m_2,adenosine-5-monophosphate,0.04779623009155419,2.7720336129287033,10.2,107.44402283711653 -1,fruit,1,1,25,Sample,21106rA_27,m_2,adenosine-5-monophosphate,45.18799804226869,2620.764215800771,548.42,101580.82100443788 -1,fruit,0.6,1,26,Sample,21106rA_28,m_2,adenosine-5-monophosphate,3862.530291751042,224014.8183063749,878.63,8682814.35755509 -1,fruit,0.8,1,27,Sample,21106rA_29,m_2,adenosine-5-monophosphate,0.21699307286481326,12.584927526747336,62.98,487.7917909367267 -1,fruit,1,1,28,Sample,21106rA_30,m_2,adenosine-5-monophosphate,0.06756384682752391,3.9184942842962305,65.04,151.8808384593219 -1,fruit,0.8,1,31,Sample,21106rA_33,m_2,adenosine-5-monophosphate,0.1325522599437714,7.68762137369335,830.42,297.97220444435425 -1,fruit,1,1,32,Sample,21106rA_34,m_2,adenosine-5-monophosphate,0.12488460031658337,7.242920815127384,795.67,280.7356107943374 -1,fruit,0.8,1,33,Sample,21106rA_35,m_2,adenosine-5-monophosphate,0.10452502723748554,6.062128505524073,903.4,234.96810087411305 -1,fruit,0.8,1,34,Sample,21106rA_36,m_2,adenosine-5-monophosphate,0.036536267480221464,2.1189905846575208,392.4,82.1320750613255 -1,fruit,0.8,1,35,Sample,21106rA_37,m_2,adenosine-5-monophosphate,0.18625214604956375,10.802048787959299,2464.13,418.6874110213024 -1,fruit,0.6,1,36,Sample,21106rA_38,m_2,adenosine-5-monophosphate,0.001832359273080206,0.10627117423718073,16.93,4.119070713433125 -1,fruit,0.4,1,37,Sample,21106rA_39,m_2,adenosine-5-monophosphate,0.15526269862974887,9.004756622253678,1822.48,349.02436667855255 -1,fruit,0.4,1,38,Sample,21106rA_40,m_2,adenosine-5-monophosphate,0.2686807846156075,15.582655047811592,4010.6,603.9837096531772 -1,fruit,0.8,1,39,Sample,21106rA_41,m_2,adenosine-5-monophosphate,0.04806879926553972,2.7878417825414274,772.71,108.05674749130573 -1,fruit,0.6,1,40,Sample,21106rA_42,m_2,adenosine-5-monophosphate,0.00331097970606993,0.19202658911319584,53.02,7.4429505940274705 -1,fruit,1,1,41,Sample,21106rA_43,m_2,adenosine-5-monophosphate,0.00180518852944806,0.10469535508800715,23.23,4.0579919632111565 -1,fruit,0.6,1,42,Sample,21106rA_44,m_2,adenosine-5-monophosphate,0.04675392773164599,2.7115832976848866,789.24,105.1009686182662 -1,fruit,1,1,45,Sample,21106rA_47,m_2,adenosine-5-monophosphate,0.023120148680527232,1.3408971618800465,531.86,51.9731739944706 -1,fruit,0.6,1,46,Sample,21106rA_48,m_2,adenosine-5-monophosphate,0.0019099496458738598,0.11077117603673024,34.36,4.293490783183664 -1,fruit,0.8,1,47,Sample,21106rA_49,m_2,adenosine-5-monophosphate,0.03148882927086434,1.826254769537428,752.91,70.7856348672707 -1,fruit,0.4,1,3,Sample,21106rA_5,m_2,adenosine-5-monophosphate,2.8662046442097327e-4,0.016623101027136634,8.11,0.644311395811816 -1,fruit,0.4,1,48,Sample,21106rA_50,m_2,adenosine-5-monophosphate,0.09163440771513456,5.314512416577634,2242.49,205.9905012665491 -1,fruit,0.8,1,49,Sample,21106rA_51,m_2,adenosine-5-monophosphate,0.026996532730771985,1.5657154553587604,621.12,60.68713104970555 -1,fruit,0.6,1,50,Sample,21106rA_52,m_2,adenosine-5-monophosphate,0.019312208278843623,1.120048388466818,533.73,43.413075536973864 -1,fruit,0.4,1,51,Sample,21106rA_53,m_2,adenosine-5-monophosphate,0.07138917756721298,4.140351643562339,2385.75,160.48002970447627 -1,fruit,0.8,1,52,Sample,21106rA_54,m_2,adenosine-5-monophosphate,0.0172258536196429,0.9990462669037455,464.55,38.723033305189176 -1,fruit,0.4,1,53,Sample,21106rA_55,m_2,adenosine-5-monophosphate,0.1054753454789866,6.11724402621209,2886.11,237.1043784559806 -1,fruit,0.6,1,54,Sample,21106rA_56,m_2,adenosine-5-monophosphate,0.025737271714433203,1.492682208635005,742.46,57.85636240669279 -1,fruit,1,1,55,Sample,21106rA_57,m_2,adenosine-5-monophosphate,0.0013316397988947877,0.07723099239791818,43.7,2.9934732653433085 -1,fruit,0.6,1,56,Sample,21106rA_58,m_2,adenosine-5-monophosphate,3.11568660723115e-4,0.018070019300795645,6.39,0.7003939480988391 -1,fruit,0.4,1,4,Sample,21106rA_6,m_2,adenosine-5-monophosphate,2.1139525538225247e-4,0.01226027141493737,6.06,0.47520812004297247 -1,fruit,NA,1,59,blank sample,21106rA_61,m_2,adenosine-5-monophosphate,0.09922390666882412,5.754679897665902,3.72,223.05139283353034 -1,fruit,0.8,1,5,Sample,21106rA_7,m_2,adenosine-5-monophosphate,2.4337151570437296e-4,0.014114795678857076,4.76,0.5470894805125003 -1,fruit,1,1,6,Sample,21106rA_8,m_2,adenosine-5-monophosphate,0.013459558553635589,0.7806127942390335,395.09,30.25655190470494 -1,fruit,1,1,7,Sample,21106rA_9,m_2,adenosine-5-monophosphate,0.017182256118128198,0.9965177465705108,462.82,38.625027857073 -1,fruit,1,2,10,Sample,21108rA_10,m_2,adenosine-5-monophosphate,0.0788286784554135,4.571819700478168,299.48,177.2037315905338 -1,fruit,0.8,2,11,Sample,21108rA_11,m_2,adenosine-5-monophosphate,0.0026112702383952516,0.15144560270562146,13.42,5.870031560869887 -1,fruit,0.4,2,12,Sample,21108rA_12,m_2,adenosine-5-monophosphate,0.007909171112037573,0.4587074782043741,44.51,17.779501855201538 -1,fruit,0.6,2,13,Sample,21108rA_13,m_2,adenosine-5-monophosphate,6.475483085536218e-4,0.037555800402403625,4.07,1.4556628235971645 -1,fruit,1,2,14,Sample,21108rA_14,m_2,adenosine-5-monophosphate,0.0033402249970343324,0.19372272559546475,26.59,7.508692844080213 -1,fruit,1,2,17,Sample,21108rA_17,m_2,adenosine-5-monophosphate,7.86653760949746e-4,0.045623486683206094,4.71,1.7683663438410682 -1,fruit,0.8,2,18,Sample,21108rA_18,m_2,adenosine-5-monophosphate,0.06103956169302115,3.5401059122733813,442.54,137.21450515971625 -1,fruit,0.6,2,19,Sample,21108rA_19,m_2,adenosine-5-monophosphate,0.028245535288936932,1.6381537432160902,203.92,63.49483908705565 -1,fruit,0.4,2,20,Sample,21108rA_20,m_2,adenosine-5-monophosphate,0.007217386484166508,0.41858610801068546,47.38,16.224397546494167 -1,fruit,0.6,2,21,Sample,21108rA_21,m_2,adenosine-5-monophosphate,0.004203969667546274,0.24381724675457636,27.62,9.45035648420738 -1,fruit,0.8,2,22,Sample,21108rA_22,m_2,adenosine-5-monophosphate,0.01180362567419204,0.684573805520079,83.15,26.53408070195826 -1,fruit,0.6,2,23,Sample,21108rA_23,m_2,adenosine-5-monophosphate,0.05392255260115547,3.1273413827617333,424.73,121.21575199584478 -1,fruit,0.4,2,24,Sample,21108rA_24,m_2,adenosine-5-monophosphate,0.006712709444593834,0.38931639961131925,50.33,15.089903648934733 -1,fruit,0.4,2,25,Sample,21108rA_25,m_2,adenosine-5-monophosphate,0.0015650945852057508,0.09077064842337176,12.57,3.518270332889889 -1,fruit,0.6,2,26,Sample,21108rA_26,m_2,adenosine-5-monophosphate,0.012473274019925474,0.7234113397703626,79.36,28.039423529499256 -1,fruit,0.4,2,27,Sample,21108rA_27,m_2,adenosine-5-monophosphate,0.11576544899978877,6.714038224949952,763.39,260.23612159906014 -1,fruit,0.4,2,28,Sample,21108rA_28,m_2,adenosine-5-monophosphate,0.001643018578467513,0.09528999917889096,10.65,3.6934403681738135 -1,fruit,0.8,2,3,Sample,21108rA_3,m_2,adenosine-5-monophosphate,0.036804863458441466,2.134568321196513,86.42,82.73586812957684 -1,fruit,0.6,2,31,Sample,21108rA_31,m_2,adenosine-5-monophosphate,0.09401649897618762,5.452666346961981,345.4,211.34534760824636 -1,fruit,1,2,32,Sample,21108rA_32,m_2,adenosine-5-monophosphate,0.015391244444357546,0.8926446052928426,54.85,34.598904901150576 -1,fruit,1,2,33,Sample,21108rA_33,m_2,adenosine-5-monophosphate,0.013480678520270397,0.7818376870245832,46.21,30.304028749072845 -1,fruit,0.6,2,34,Sample,21108rA_34,m_2,adenosine-5-monophosphate,0.13776784708620232,7.990109307203655,362.69,309.69663674721363 -1,fruit,0.4,2,35,Sample,21108rA_35,m_2,adenosine-5-monophosphate,0.016350141263662087,0.9482576569781116,42.7,36.7544667844716 -1,fruit,1,2,36,Sample,21108rA_36,m_2,adenosine-5-monophosphate,0.002286694473365922,0.13262121155845571,5.38,5.140398160005743 -1,fruit,0.4,2,37,Sample,21108rA_37,m_2,adenosine-5-monophosphate,0.2595686828417846,15.054181309337231,715.31,583.500067549911 -1,fruit,1,2,38,Sample,21108rA_38,m_2,adenosine-5-monophosphate,0.010779800496881467,0.6251951097561823,24.24,24.232562454149626 -1,fruit,1,2,39,Sample,21108rA_39,m_2,adenosine-5-monophosphate,0.009515829228278953,0.5518886829599519,18.24,21.391205351527734 -1,fruit,1,2,4,Sample,21108rA_4,m_2,adenosine-5-monophosphate,0.06340324980466491,3.677192516873904,200.03,142.5279819540325 -1,fruit,0.8,2,40,Sample,21108rA_40,m_2,adenosine-5-monophosphate,0.024611003499233137,1.4273621333125899,51.99,55.32455628719598 -1,fruit,0.4,2,41,Sample,21108rA_41,m_2,adenosine-5-monophosphate,0.009769282967480648,0.566588216438717,18.75,21.960959269164672 -1,fruit,0.4,2,42,Sample,21108rA_42,m_2,adenosine-5-monophosphate,0.12968539669721288,7.521352166521415,282.9,291.52760997437 -1,fruit,0.8,2,45,Sample,21108rA_45,m_2,adenosine-5-monophosphate,0.1918515729894561,11.126798243319856,457.32,431.27469991107756 -1,fruit,0.4,2,46,Sample,21108rA_46,m_2,adenosine-5-monophosphate,0.22595742229906435,13.104832086211188,581.3,507.94329166154563 -1,fruit,0.4,2,47,Sample,21108rA_47,m_2,adenosine-5-monophosphate,0.18154683130262017,10.52915507619684,504.14,408.1100507533895 -1,fruit,0.4,2,48,Sample,21108rA_48,m_2,adenosine-5-monophosphate,0.1881464696980906,10.911913704447974,611.44,422.94577518440343 -1,fruit,0.4,2,49,Sample,21108rA_49,m_2,adenosine-5-monophosphate,0.001305641878587046,0.07572319337650464,4.01,2.9350309752733197 -1,fruit,0.4,2,5,Sample,21108rA_5,m_2,adenosine-5-monophosphate,0.0021135313701340806,0.12257828679727191,6.89,4.751134396262259 -1,fruit,1,2,50,Sample,21108rA_50,m_2,adenosine-5-monophosphate,0.009483126299961132,0.5499920141983246,35.05,21.317690470327058 -1,fruit,0.4,2,51,Sample,21108rA_51,m_2,adenosine-5-monophosphate,0.013669513896099742,0.7927895551553182,60.98,30.728523157820135 -1,fruit,0.6,2,52,Sample,21108rA_52,m_2,adenosine-5-monophosphate,0.00202804986685779,0.11762062382026185,7.8,4.558975379273349 -1,fruit,1,2,53,Sample,21108rA_53,m_2,adenosine-5-monophosphate,0.05462511553080606,3.168087861144204,239.52,122.79508549794933 -1,fruit,0.6,2,54,Sample,21108rA_54,m_2,adenosine-5-monophosphate,0.005417156380325964,0.3141783262820188,27.94,12.177551926691049 -1,fruit,0.6,2,55,Sample,21108rA_55,m_2,adenosine-5-monophosphate,0.0015355815190513003,0.08905898180774088,9.75,3.4519261348680366 -1,fruit,0.8,2,56,Sample,21108rA_56,m_2,adenosine-5-monophosphate,0.0017327358197365525,0.10049332186732529,9.8,3.8951211555775282 -1,fruit,0.8,2,6,Sample,21108rA_6,m_2,adenosine-5-monophosphate,0.008801315132340646,0.510449073872407,35.06,19.785006103294496 -1,fruit,0.6,2,7,Sample,21108rA_7,m_2,adenosine-5-monophosphate,0.009634039276621343,0.5587445003908109,35.34,21.65693683514783 -1,fruit,0.8,2,8,Sample,21108rA_8,m_2,adenosine-5-monophosphate,0.0020425131136560387,0.11845944743040916,8.98,4.591488182402659 -1,fruit,0.4,2,9,Sample,21108rA_9,m_2,adenosine-5-monophosphate,0.14067260050691793,8.158576027362745,641.69,316.22640682058 -2,fruit,NA,3,43,blank sample,21108rA_101,m_2,adenosine-5-monophosphate,0.9960778888470287,54.90822746411462,100.65,1720.2747664507108 -2,fruit,1,3,3,Sample,21108rA_61,m_2,adenosine-5-monophosphate,0.037885267363725834,2.0884038298994123,280.96,65.42969199074858 -2,fruit,1,3,4,Sample,21108rA_62,m_2,adenosine-5-monophosphate,0.0012683129130733688,0.06991502843950927,8.14,2.190437841009825 -2,fruit,1,3,5,Sample,21108rA_63,m_2,adenosine-5-monophosphate,0.00166848931423756,0.09197452509827775,11.05,2.881561871329042 -2,fruit,NA,3,6,Sample,21108rA_64,m_2,adenosine-5-monophosphate,0.004743346024032152,0.26147425351448506,31.42,8.191988362608816 -2,fruit,1,3,7,Sample,21108rA_65,m_2,adenosine-5-monophosphate,0.0011488357979977208,0.06332892038030571,7.18,1.984095075514978 -2,fruit,1,3,8,Sample,21108rA_66,m_2,adenosine-5-monophosphate,0.00748454452934842,0.412581263056097,44.5,12.926170971547519 -2,fruit,1,3,9,Sample,21108rA_67,m_2,adenosine-5-monophosphate,0.017346281966804867,0.9562039340040634,89.88,29.957869252347304 -2,fruit,1,3,10,Sample,21108rA_68,m_2,adenosine-5-monophosphate,0.001332389682090926,0.07344722391114461,5.71,2.3011015251361604 -2,fruit,1,3,11,Sample,21108rA_69,m_2,adenosine-5-monophosphate,0.0010869978926362127,0.05992014099516716,5.39,1.8772980173785871 -2,fruit,1,3,12,Sample,21108rA_70,m_2,adenosine-5-monophosphate,0.09936459627313644,5.477416891926589,427.24,171.60747122406002 -2,fruit,1,3,13,Sample,21108rA_71,m_2,adenosine-5-monophosphate,0.01369625292531099,0.7549981577239027,51.83,23.65409228148987 -2,fruit,1,3,14,Sample,21108rA_72,m_2,adenosine-5-monophosphate,0.006368793020816877,0.3510760953279059,24.11,10.999214066623292 -2,fruit,1,3,17,Sample,21108rA_75,m_2,adenosine-5-monophosphate,0.02614566194751805,1.4412647539801369,90.67,45.15482474219768 -2,fruit,1,3,18,Sample,21108rA_76,m_2,adenosine-5-monophosphate,0.007693457563831072,0.424097475338321,33.87,13.286973902349596 -2,fruit,1,3,19,Sample,21108rA_77,m_2,adenosine-5-monophosphate,0.1103751909507914,6.084369665243993,379.49,190.62330161209428 -2,fruit,1,3,20,Sample,21108rA_78,m_2,adenosine-5-monophosphate,0.011999270669210358,0.6614529754004653,44.09,20.723321719296578 -2,fruit,1,3,21,Sample,21108rA_79,m_2,adenosine-5-monophosphate,0.017473018949513464,0.9631902381401127,79.36,30.176750160929732 -2,fruit,1,3,22,Sample,21108rA_80,m_2,adenosine-5-monophosphate,0.06307334396301016,3.4768822358380502,276.24,108.93072044880611 -2,fruit,NA,3,23,Sample,21108rA_81,m_2,adenosine-5-monophosphate,0.0967629241220274,5.334001193355565,496.75,167.11425738782984 -2,fruit,1,3,24,Sample,21108rA_82,m_2,adenosine-5-monophosphate,0.006876298491361984,0.3790520459317575,65.89,11.875700599041963 -2,fruit,1,3,25,Sample,21108rA_83,m_2,adenosine-5-monophosphate,0.0018119512937783727,0.09988278517841775,13.9,3.129327659639828 -2,fruit,NA,3,26,Sample,21108rA_84,m_2,adenosine-5-monophosphate,0.001839470991023441,0.10139979284719038,19.85,3.1768555099024742 -2,fruit,1,3,27,Sample,21108rA_85,m_2,adenosine-5-monophosphate,0.0030044600444085016,0.16561915224940896,24.94,5.1888480399739825 -2,fruit,1,3,28,Sample,21108rA_86,m_2,adenosine-5-monophosphate,0.09922787979916381,5.469880474006832,1052.6,171.37135525063402 -2,fruit,1,3,31,Sample,21108rA_89,m_2,adenosine-5-monophosphate,0.04481270360546765,2.4702748152547818,513.71,77.3937099619323 -2,fruit,1,3,32,Sample,21108rA_90,m_2,adenosine-5-monophosphate,0.0016279535829394139,0.08974001595048493,14.23,2.811554699728693 -2,fruit,1,3,33,Sample,21108rA_91,m_2,adenosine-5-monophosphate,7.045555787005176e-4,0.038838225815029666,7.92,1.2168016147848795 -2,fruit,1,3,34,Sample,21108rA_92,m_2,adenosine-5-monophosphate,0.00224909311356658,0.12397997952814001,27.73,3.8842927586166263 -2,fruit,1,3,35,Sample,21108rA_93,m_2,adenosine-5-monophosphate,0.041175151033912824,2.269756797288537,593.58,71.11148045904986 -2,fruit,1,3,36,Sample,21108rA_94,m_2,adenosine-5-monophosphate,0.022748843230593386,1.25401705292018,376.11,39.288354267989234 -2,fruit,1,3,37,Sample,21108rA_95,m_2,adenosine-5-monophosphate,2.494600480635205e-4,0.013751343359439143,2.79,0.4308295874512283 -2,fruit,1,3,38,Sample,21108rA_96,m_2,adenosine-5-monophosphate,0.001151491054288548,0.06347528987412213,13.55,1.988680831756246 -2,fruit,NA,3,39,Sample,21108rA_97,m_2,adenosine-5-monophosphate,0.03216302600977837,1.7729685277155656,662.22,55.54710397332867 -2,fruit,1,3,40,Sample,21108rA_98,m_2,adenosine-5-monophosphate,7.335936323411028e-4,0.04043893201708981,15.08,1.2669517400954238 -1,fruit,0.8,1,8,Sample,21106rA_10,m_3,2-aminoadipic_acid,0.0014075679433216309,0.0699874264382873,12.09,3.4440812550281183 -1,fruit,0.6,1,9,Sample,21106rA_11,m_3,2-aminoadipic_acid,0.016652527054240408,0.8280008917153415,132.1,40.74592388131196 -1,fruit,0.6,1,10,Sample,21106rA_12,m_3,2-aminoadipic_acid,0.003119912010452479,0.15512900344276853,26.38,7.63389825941864 -1,fruit,0.6,1,11,Sample,21106rA_13,m_3,2-aminoadipic_acid,0.030318568311616587,1.5075070297609026,305.15,74.18442093453402 -1,fruit,1,1,12,Sample,21106rA_14,m_3,2-aminoadipic_acid,0.018204828809904042,0.9051848070282722,173.92,44.54414435386128 -1,fruit,0.8,1,13,Sample,21106rA_15,m_3,2-aminoadipic_acid,0.01429135104621944,0.710597939372418,120.57,34.96852459651669 -1,fruit,0.8,1,14,Sample,21106rA_16,m_3,2-aminoadipic_acid,0.040248588120959154,2.0012498250799458,442.48,98.48150389218414 -1,fruit,1,1,17,Sample,21106rA_19,m_3,2-aminoadipic_acid,0.014847834496770981,0.7382675412160719,125.5,36.3301457032429 -1,fruit,0.6,1,18,Sample,21106rA_20,m_3,2-aminoadipic_acid,0.03632925042237243,1.806371588353887,351.95,88.89154586289477 -1,fruit,0.6,1,19,Sample,21106rA_21,m_3,2-aminoadipic_acid,0.032403870454630404,1.6111929164907297,317.84,79.2868034205088 -1,fruit,1,1,20,Sample,21106rA_22,m_3,2-aminoadipic_acid,0.020192144600623567,1.0039985931567106,198.37,49.40677076924173 -1,fruit,0.8,1,21,Sample,21106rA_23,m_3,2-aminoadipic_acid,0.013452366759967397,0.6688817641103001,129.72,32.91567161186787 -1,fruit,1,1,22,Sample,21106rA_24,m_3,2-aminoadipic_acid,0.010030546102942387,0.4987411874832099,77.69,24.54305383604876 -1,fruit,0.8,1,23,Sample,21106rA_25,m_3,2-aminoadipic_acid,0.018599517555019533,0.924809614232679,190.86,45.50988111639013 -1,fruit,1,1,24,Sample,21106rA_26,m_3,2-aminoadipic_acid,0.034236315287958494,1.702306172218993,369.5,83.77048673489665 -1,fruit,1,1,25,Sample,21106rA_27,m_3,2-aminoadipic_acid,0.04629754089832828,2.3020172868166466,425.47,113.28227068424718 -1,fruit,0.6,1,26,Sample,21106rA_28,m_3,2-aminoadipic_acid,0.018842351844279,0.936883878240237,182.66,46.10405564820206 -1,fruit,0.8,1,27,Sample,21106rA_29,m_3,2-aminoadipic_acid,0.02783446684578856,1.383991948709391,284.98,68.10624379598913 -1,fruit,1,1,28,Sample,21106rA_30,m_3,2-aminoadipic_acid,0.0020172215833638824,0.10030076902877101,20.33,4.935800843905821 -1,fruit,0.8,1,31,Sample,21106rA_33,m_3,2-aminoadipic_acid,0.019125923174019316,0.9509836790167262,184.92,46.7979068444131 -1,fruit,1,1,32,Sample,21106rA_34,m_3,2-aminoadipic_acid,0.011982184693682122,0.5957810234297357,97.69,29.318384162977296 -1,fruit,0.8,1,33,Sample,21106rA_35,m_3,2-aminoadipic_acid,0.02082004384079739,1.0352191477955288,203.85,50.943134263017974 -1,fruit,0.8,1,34,Sample,21106rA_36,m_3,2-aminoadipic_acid,0.011838949213635201,0.5886590349881121,132.47,28.967911111764998 -1,fruit,0.8,1,35,Sample,21106rA_37,m_3,2-aminoadipic_acid,0.08974366986088171,4.462255994455537,1138.44,219.587617487157 -1,fruit,0.6,1,36,Sample,21106rA_38,m_3,2-aminoadipic_acid,0.004158363432135657,0.20676313082512196,43.69,10.174813667904251 -1,fruit,0.4,1,37,Sample,21106rA_39,m_3,2-aminoadipic_acid,0.012545666966749249,0.6237986223830767,125.27,30.697130207471204 -1,fruit,0.4,1,38,Sample,21106rA_40,m_3,2-aminoadipic_acid,0.02415730324254655,1.201155149672798,290.53,59.108844915398386 -1,fruit,0.8,1,39,Sample,21106rA_41,m_3,2-aminoadipic_acid,0.014191811575850855,0.7056486142665281,175.7,34.72496830805585 -1,fruit,0.6,1,40,Sample,21106rA_42,m_3,2-aminoadipic_acid,0.03171021416267737,1.57670277415916,407.32,77.58954351637226 -1,fruit,1,1,41,Sample,21106rA_43,m_3,2-aminoadipic_acid,0.01267791379510936,0.6303742304846,134.52,31.020715882147165 -1,fruit,0.6,1,42,Sample,21106rA_44,m_3,2-aminoadipic_acid,0.015985144883615972,0.7948171574633536,180.01,39.11295231877163 -1,fruit,1,1,45,Sample,21106rA_47,m_3,2-aminoadipic_acid,0.002391567799144649,0.11891410017467721,32.16,5.8517628695958654 -1,fruit,0.6,1,46,Sample,21106rA_48,m_3,2-aminoadipic_acid,0.030551864211322867,1.5191070237054338,344.72,74.7552566365444 -1,fruit,0.8,1,47,Sample,21106rA_49,m_3,2-aminoadipic_acid,0.02812655886502016,1.3985154172255472,359.1,68.82094368166918 -1,fruit,0.4,1,3,Sample,21106rA_5,m_3,2-aminoadipic_acid,0.020031307380791404,0.9960014068432894,184.19,49.01322923075827 -1,fruit,0.4,1,48,Sample,21106rA_50,m_3,2-aminoadipic_acid,0.024246144031894772,1.2055725124286982,302.35,59.32622333661624 -1,fruit,0.8,1,49,Sample,21106rA_51,m_3,2-aminoadipic_acid,3.766185001992385e-4,0.0187263142095936,4.26,0.9215219222541011 -1,fruit,0.6,1,50,Sample,21106rA_52,m_3,2-aminoadipic_acid,0.012446647514412547,0.6188751537368525,162.7,30.454846315390515 -1,fruit,0.4,1,51,Sample,21106rA_53,m_3,2-aminoadipic_acid,0.03212524832703378,1.597339201114667,484.65,78.60506208685277 -1,fruit,0.8,1,52,Sample,21106rA_54,m_3,2-aminoadipic_acid,0.010163488519704762,0.5053513817959109,120,24.868341498176775 -1,fruit,0.4,1,53,Sample,21106rA_55,m_3,2-aminoadipic_acid,0.029525724856706854,1.4680850798359653,337.82,72.24446677872785 -1,fruit,0.6,1,54,Sample,21106rA_56,m_3,2-aminoadipic_acid,0.0012904700866583324,0.06416505909311747,15.08,3.1575625579723106 -1,fruit,1,1,55,Sample,21106rA_57,m_3,2-aminoadipic_acid,0.009869615473972151,0.49073935665851626,140.73,24.149283741165586 -1,fruit,0.6,1,56,Sample,21106rA_58,m_3,2-aminoadipic_acid,0.0241609671422664,1.201337326961885,324.26,59.11780985979436 -1,fruit,0.4,1,4,Sample,21106rA_6,m_3,2-aminoadipic_acid,0.04216131500245649,2.0963548838094206,564.29,103.16162383226158 -1,fruit,NA,1,59,blank sample,21106rA_61,m_3,2-aminoadipic_acid,1.1628311591937492,57.818566130576215,14.84,2845.2516392856555 -1,fruit,0.8,1,5,Sample,21106rA_7,m_3,2-aminoadipic_acid,0.020493298071108553,1.0189726172968632,195.28,50.14364249717864 -1,fruit,1,1,6,Sample,21106rA_8,m_3,2-aminoadipic_acid,0.0063898956697800895,0.3177199049317053,53.04,15.634996521689219 -1,fruit,1,1,7,Sample,21106rA_9,m_3,2-aminoadipic_acid,9.589042244718779e-4,0.04767886281440661,8.01,2.3462768390969493 -1,fruit,1,2,10,Sample,21108rA_10,m_3,2-aminoadipic_acid,0.08105074816396748,4.030024484294215,159.08,198.3175048721183 -1,fruit,0.8,2,11,Sample,21108rA_11,m_3,2-aminoadipic_acid,0.013008438878131929,0.6468086768953798,33.8,31.82945499002164 -1,fruit,0.4,2,12,Sample,21108rA_12,m_3,2-aminoadipic_acid,0.05726771163565883,2.8474787127727907,153.83,140.12442745554904 -1,fruit,0.6,2,13,Sample,21108rA_13,m_3,2-aminoadipic_acid,0.009162381997303003,0.4555741263348771,28.8,22.418802756939304 -1,fruit,1,2,14,Sample,21108rA_14,m_3,2-aminoadipic_acid,0.009008069434754826,0.4479013605752662,31.83,22.04122595390885 -1,fruit,1,2,17,Sample,21108rA_17,m_3,2-aminoadipic_acid,0.004553999083953393,0.22643502034870325,11.54,11.142867351359687 -1,fruit,0.8,2,18,Sample,21108rA_18,m_3,2-aminoadipic_acid,0.027484295526202185,1.3665806474740734,73.9,67.24943366219915 -1,fruit,0.6,2,19,Sample,21108rA_19,m_3,2-aminoadipic_acid,0.01805013542020522,0.8974931056909381,46.52,44.16563573105106 -1,fruit,0.4,2,20,Sample,21108rA_20,m_3,2-aminoadipic_acid,0.02962551826163749,1.4730470311362536,67.2,72.48864440221504 -1,fruit,0.6,2,21,Sample,21108rA_21,m_3,2-aminoadipic_acid,0.09441894123330594,4.694720944235801,208.1,231.02721766584378 -1,fruit,0.8,2,22,Sample,21108rA_22,m_3,2-aminoadipic_acid,0.045259416899767965,2.2503994396443066,101.84,110.74215642489632 -1,fruit,0.6,2,23,Sample,21108rA_23,m_3,2-aminoadipic_acid,0.01662656363292914,0.8267099323355616,40.15,40.682395770232986 -1,fruit,0.4,2,24,Sample,21108rA_24,m_3,2-aminoadipic_acid,0.01189739447531592,0.5915650641229424,26.7,29.110916805489996 -1,fruit,0.4,2,25,Sample,21108rA_25,m_3,2-aminoadipic_acid,0.019465064689360184,0.9678465537146793,47.26,47.62772890829937 -1,fruit,0.6,2,26,Sample,21108rA_26,m_3,2-aminoadipic_acid,0.004383159294500093,0.21794048390104898,7.84,10.72485121277062 -1,fruit,0.4,2,27,Sample,21108rA_27,m_3,2-aminoadipic_acid,0.006045188278087435,0.30058028241238877,10.93,14.791555697513651 -1,fruit,0.4,2,28,Sample,21108rA_28,m_3,2-aminoadipic_acid,0.0502985252232333,2.5009551764216287,94.34,123.07200423170835 -1,fruit,0.8,2,3,Sample,21108rA_3,m_3,2-aminoadipic_acid,0.022427510691439594,1.1151459950181355,37.55,54.87633441484245 -1,fruit,0.6,2,31,Sample,21108rA_31,m_3,2-aminoadipic_acid,0.020440676679135256,1.0163561639900902,25.09,50.01488682995234 -1,fruit,1,2,32,Sample,21108rA_32,m_3,2-aminoadipic_acid,0.03358642568420209,1.6699922075171725,43.09,82.18031653192006 -1,fruit,1,2,33,Sample,21108rA_33,m_3,2-aminoadipic_acid,0.04440488992046126,2.2079104469192896,57.89,108.65127309289825 -1,fruit,0.6,2,34,Sample,21108rA_34,m_3,2-aminoadipic_acid,0.14390456560054612,7.155256871888392,148.67,352.1101906656278 -1,fruit,0.4,2,35,Sample,21108rA_35,m_3,2-aminoadipic_acid,0.02517950768614386,1.2519814409652317,27.09,61.610006709899054 -1,fruit,1,2,36,Sample,21108rA_36,m_3,2-aminoadipic_acid,0.2619792883127833,13.026196181960186,287.6,641.0191141142608 -1,fruit,0.4,2,37,Sample,21108rA_37,m_3,2-aminoadipic_acid,0.07906412747642659,3.9312452602505497,93.55,193.45657925692956 -1,fruit,1,2,38,Sample,21108rA_38,m_3,2-aminoadipic_acid,0.09370661155474985,4.6593023193557075,94.36,229.28426713549436 -1,fruit,1,2,39,Sample,21108rA_39,m_3,2-aminoadipic_acid,0.13794056903605012,6.858713623076648,120.53,337.51729739160186 -1,fruit,1,2,4,Sample,21108rA_4,m_3,2-aminoadipic_acid,0.007263905989126054,0.3611776529017103,15.56,17.77355229929316 -1,fruit,0.8,2,40,Sample,21108rA_40,m_3,2-aminoadipic_acid,0.2399183329733911,11.92927613891737,227.67,587.0396787961238 -1,fruit,0.4,2,41,Sample,21108rA_41,m_3,2-aminoadipic_acid,0.06286042960350792,3.1255611593232846,55.17,153.80886465029883 -1,fruit,0.4,2,42,Sample,21108rA_42,m_3,2-aminoadipic_acid,0.010885051092111112,0.5412290868093813,10.49,26.633883361889655 -1,fruit,0.8,2,45,Sample,21108rA_45,m_3,2-aminoadipic_acid,0.07671265420096214,3.814324749472363,77.33,187.70292092153497 -1,fruit,0.4,2,46,Sample,21108rA_46,m_3,2-aminoadipic_acid,0.046898470510908126,2.3318968512487346,50.06,114.75264404995023 -1,fruit,0.4,2,47,Sample,21108rA_47,m_3,2-aminoadipic_acid,0.012425806687483427,0.6178389012074202,14.04,30.403852328417152 -1,fruit,0.4,2,48,Sample,21108rA_48,m_3,2-aminoadipic_acid,0.29457837631019335,14.647095751319489,381.84,720.7835819224321 -1,fruit,0.4,2,49,Sample,21108rA_49,m_3,2-aminoadipic_acid,0.05833178078272101,2.9003866107599565,81.84,142.72802511549747 -1,fruit,0.4,2,5,Sample,21108rA_5,m_3,2-aminoadipic_acid,0.007331904110993978,0.36455867161185695,15.91,17.93993223001948 -1,fruit,1,2,50,Sample,21108rA_50,m_3,2-aminoadipic_acid,0.047817122561616784,2.3775742859519085,69.02,117.00043061169342 -1,fruit,0.4,2,51,Sample,21108rA_51,m_3,2-aminoadipic_acid,0.04493875076610254,2.234455202247,76.48,109.95754050257487 -1,fruit,0.6,2,52,Sample,21108rA_52,m_3,2-aminoadipic_acid,0.08012828321487712,3.9841574637552224,123.66,196.0603887913945 -1,fruit,1,2,53,Sample,21108rA_53,m_3,2-aminoadipic_acid,0.021931052751106166,1.0904609958011207,35.23,53.66158560337315 -1,fruit,0.6,2,54,Sample,21108rA_54,m_3,2-aminoadipic_acid,0.008594928796702962,0.4273590839828567,16.38,21.03034052279638 -1,fruit,0.6,2,55,Sample,21108rA_55,m_3,2-aminoadipic_acid,0.01705720763055002,0.8481225151153715,41.65,41.73610896882743 -1,fruit,0.8,2,56,Sample,21108rA_56,m_3,2-aminoadipic_acid,0.024550151421240937,1.2206884397979667,52.35,60.07007812245794 -1,fruit,0.8,2,6,Sample,21108rA_6,m_3,2-aminoadipic_acid,0.00432878439955981,0.215236842504711,10.72,10.591805019656828 -1,fruit,0.6,2,7,Sample,21108rA_7,m_3,2-aminoadipic_acid,0.04102931197663774,2.040069161423297,89.39,100.39180343364043 -1,fruit,0.8,2,8,Sample,21108rA_8,m_3,2-aminoadipic_acid,0.005771227271483301,0.28695832839756596,14.71,14.121219340444222 -1,fruit,0.4,2,9,Sample,21108rA_9,m_3,2-aminoadipic_acid,0.003404815396237309,0.16929503702519044,8.38,8.331008772009621 -2,fruit,NA,3,43,blank sample,21108rA_101,m_3,2-aminoadipic_acid,1.2504774871348345,77.57113160162402,113.03,5069.273450166129 -2,fruit,1,3,3,Sample,21108rA_61,m_3,2-aminoadipic_acid,0.05325089952432846,3.303324192082107,234.19,215.8722359525657 -2,fruit,1,3,4,Sample,21108rA_62,m_3,2-aminoadipic_acid,0.03425635958155664,2.1250319215118796,142.45,138.87083607080132 -2,fruit,1,3,5,Sample,21108rA_63,m_3,2-aminoadipic_acid,0.03999140150411386,2.4807949770586344,171.25,162.11995175078175 -2,fruit,NA,3,6,Sample,21108rA_64,m_3,2-aminoadipic_acid,0.022374067477734474,1.3879352092580417,93.03,90.70156592501301 -2,fruit,1,3,7,Sample,21108rA_65,m_3,2-aminoadipic_acid,0.08689881258151186,5.3906122230399465,371.86,352.2765087756605 -2,fruit,1,3,8,Sample,21108rA_66,m_3,2-aminoadipic_acid,0.04697053547620779,2.9137330550204394,178.46,190.4124551455857 -2,fruit,1,3,9,Sample,21108rA_67,m_3,2-aminoadipic_acid,0.006058545234845553,0.375831004205773,20.15,24.560556124847263 -2,fruit,1,3,10,Sample,21108rA_68,m_3,2-aminoadipic_acid,0.0430954028121653,2.6733461396630585,132.28,174.70317022698086 -2,fruit,1,3,11,Sample,21108rA_69,m_3,2-aminoadipic_acid,0.022698510668206603,1.4080614615770892,83.25,92.01681651406277 -2,fruit,1,3,12,Sample,21108rA_70,m_3,2-aminoadipic_acid,0.027208855995710452,1.6878526569949446,77.35,110.30117113461962 -2,fruit,1,3,13,Sample,21108rA_71,m_3,2-aminoadipic_acid,0.007159843844084,0.444148091261583,18.27,29.025077763944445 -2,fruit,1,3,14,Sample,21108rA_72,m_3,2-aminoadipic_acid,0.02032661608835776,1.2609252288247486,53.18,82.40146370369732 -2,fruit,1,3,17,Sample,21108rA_75,m_3,2-aminoadipic_acid,0.04768224464284324,2.9578826586679683,115.13,193.2976317439517 -2,fruit,1,3,18,Sample,21108rA_76,m_3,2-aminoadipic_acid,0.0826750347899358,5.128597731537923,258.74,335.1538617560032 -2,fruit,1,3,19,Sample,21108rA_77,m_3,2-aminoadipic_acid,0.021078416675716628,1.3075618319624942,50.78,85.44916571874899 -2,fruit,1,3,20,Sample,21108rA_78,m_3,2-aminoadipic_acid,0.0035659755234653066,0.22120890576982516,9.28,14.456001992058074 -2,fruit,1,3,21,Sample,21108rA_79,m_3,2-aminoadipic_acid,0.0026103771474626034,0.16193007176774527,8.26,10.582130190022152 -2,fruit,1,3,22,Sample,21108rA_80,m_3,2-aminoadipic_acid,0.07356068272485938,4.563205222854283,215.38,298.2054613135274 -2,fruit,NA,3,23,Sample,21108rA_81,m_3,2-aminoadipic_acid,0.010635696081790484,0.6597663603890913,35.88,43.11573165142711 -2,fruit,1,3,24,Sample,21108rA_82,m_3,2-aminoadipic_acid,0.01685536244358635,1.045592225174963,107.89,68.32945191518382 -2,fruit,1,3,25,Sample,21108rA_83,m_3,2-aminoadipic_acid,0.032307886213221323,2.004161865367397,175.31,130.9719779017594 -2,fruit,NA,3,26,Sample,21108rA_84,m_3,2-aminoadipic_acid,0.008521314152434595,0.5286044637651369,65.35,34.544301707051694 -2,fruit,1,3,27,Sample,21108rA_85,m_3,2-aminoadipic_acid,0.020511999921464644,1.2724251829324364,118.57,83.15298570463472 -2,fruit,1,3,28,Sample,21108rA_86,m_3,2-aminoadipic_acid,0.01447709386267316,0.8980605926809407,103.52,58.688259731699475 -2,fruit,1,3,31,Sample,21108rA_89,m_3,2-aminoadipic_acid,0.05320670448291872,3.300582631831239,429.06,215.69307499017143 -2,fruit,1,3,32,Sample,21108rA_90,m_3,2-aminoadipic_acid,0.006774265643966222,0.42022943809767493,45.72,27.461993779683056 -2,fruit,1,3,33,Sample,21108rA_91,m_3,2-aminoadipic_acid,0.02681691197263009,1.663539111403253,262.96,108.71228093020257 -2,fruit,1,3,34,Sample,21108rA_92,m_3,2-aminoadipic_acid,0.016117973288072438,0.9998496094042142,155.3,65.3401719745654 -2,fruit,1,3,35,Sample,21108rA_93,m_3,2-aminoadipic_acid,0.001000152680247364,0.06204268047955649,10.91,4.054489169339016 -2,fruit,1,3,36,Sample,21108rA_94,m_3,2-aminoadipic_acid,0.01340508160088764,0.8315602317443727,171.52,54.34246114449475 -2,fruit,1,3,37,Sample,21108rA_95,m_3,2-aminoadipic_acid,0.03200198408576067,1.9851857746895578,470.68,129.7318903759626 -2,fruit,1,3,38,Sample,21108rA_96,m_3,2-aminoadipic_acid,0.0014985877327662364,0.0929622063819327,15.6,6.075080187059301 -2,fruit,NA,3,39,Sample,21108rA_97,m_3,2-aminoadipic_acid,6.346183459956864e-4,0.039367412640774924,10.76,2.572660416074641 -2,fruit,1,3,40,Sample,21108rA_98,m_3,2-aminoadipic_acid,0.015859184342983005,0.9837961006260802,314.23,64.29107517591434 -1,fruit,0.8,1,8,Sample,21106rA_10,m_4,adipic_acid,0.015093174271552559,0.7589906082808497,481.06,34.67828089235202 -1,fruit,0.6,1,9,Sample,21106rA_11,m_4,adipic_acid,0.01687715773790021,0.8487018030186085,472.88,38.77718537992022 -1,fruit,0.6,1,10,Sample,21106rA_12,m_4,adipic_acid,0.013889233804441571,0.6984480417520329,394.28,31.91209102765038 -1,fruit,0.6,1,11,Sample,21106rA_13,m_4,adipic_acid,0.008571916332584554,0.43105604390080776,274.94,19.694950645827905 -1,fruit,1,1,12,Sample,21106rA_14,m_4,adipic_acid,0.009238103497662818,0.4645566046545951,266.6,21.22559126666845 -1,fruit,0.8,1,13,Sample,21106rA_15,m_4,adipic_acid,0.018719413515097108,0.9413433380454053,451.58,43.00997711529457 -1,fruit,0.8,1,14,Sample,21106rA_16,m_4,adipic_acid,0.014149820403626263,0.7115521627186744,420.48,32.51081831461623 -1,fruit,1,1,17,Sample,21106rA_19,m_4,adipic_acid,0.01985227287369651,0.9983114481467119,380.23,45.61285006582327 -1,fruit,0.6,1,18,Sample,21106rA_20,m_4,adipic_acid,0.01606628222036854,0.8079252976116977,331.81,36.914106847878465 -1,fruit,0.6,1,19,Sample,21106rA_21,m_4,adipic_acid,0.023510557922568065,1.182275665650055,462.11,54.018175163551014 -1,fruit,1,1,20,Sample,21106rA_22,m_4,adipic_acid,0.009132909035236352,0.4592666896514055,168.9,20.983895050172716 -1,fruit,0.8,1,21,Sample,21106rA_23,m_4,adipic_acid,0.03232121829595722,1.6253374335618316,551.01,74.26166733944008 -1,fruit,1,1,22,Sample,21106rA_24,m_4,adipic_acid,0.017387348807250597,0.8743577865180872,223.64,39.9494072660114 -1,fruit,0.8,1,23,Sample,21106rA_25,m_4,adipic_acid,0.019735165315672577,0.9924224591839066,316.14,45.34378216011269 -1,fruit,1,1,24,Sample,21106rA_26,m_4,adipic_acid,0.018542078293147173,0.9324256799334808,294.14,42.602529316160734 -1,fruit,1,1,25,Sample,21106rA_27,m_4,adipic_acid,0.015476666969935016,0.7782753095093492,197.37,35.55939889148216 -1,fruit,0.6,1,26,Sample,21106rA_28,m_4,adipic_acid,0.022162920516850725,1.1145070097063365,282.7,50.92182527348251 -1,fruit,0.8,1,27,Sample,21106rA_29,m_4,adipic_acid,0.023592338527335437,1.1863881677547286,303.38,54.20607538471354 -1,fruit,1,1,28,Sample,21106rA_30,m_4,adipic_acid,0.014782417863586417,0.7433635976291578,180.47,33.96428277567622 -1,fruit,0.8,1,31,Sample,21106rA_33,m_4,adipic_acid,0.016008004159602955,0.8049946681765584,181.89,36.780206388986954 -1,fruit,1,1,32,Sample,21106rA_34,m_4,adipic_acid,0.017358495161192634,0.8729068229249661,162.91,39.8831127394417 -1,fruit,0.8,1,33,Sample,21106rA_35,m_4,adipic_acid,0.01279843633978143,0.643595098539548,140.52,29.405860052271947 -1,fruit,0.8,1,34,Sample,21106rA_36,m_4,adipic_acid,0.013032871109428128,0.6553841221879197,158.83,29.94450054276605 -1,fruit,0.8,1,35,Sample,21106rA_37,m_4,adipic_acid,0.0344624225847818,1.733012195436913,461.76,79.18132720951256 -1,fruit,0.6,1,36,Sample,21106rA_38,m_4,adipic_acid,0.0145146539529821,0.7298985511300742,156.12,33.34906480113309 -1,fruit,0.4,1,37,Sample,21106rA_39,m_4,adipic_acid,0.02156671855622032,1.0845257956412477,213.7,49.55198360284861 -1,fruit,0.4,1,38,Sample,21106rA_40,m_4,adipic_acid,0.025802396225211403,1.297525361711882,298.69,59.28393377661589 -1,fruit,0.8,1,39,Sample,21106rA_41,m_4,adipic_acid,0.01971923082943228,0.9916211615120868,228.17,45.307170869487244 -1,fruit,0.6,1,40,Sample,21106rA_42,m_4,adipic_acid,0.012003699114083196,0.6036301395783944,140.13,27.57986107733684 -1,fruit,1,1,41,Sample,21106rA_43,m_4,adipic_acid,0.006610851197141737,0.33243994146611405,62.1,15.18918092558675 -1,fruit,0.6,1,42,Sample,21106rA_44,m_4,adipic_acid,0.021478330840805106,1.080081041696149,209.02,49.34890279509705 -1,fruit,1,1,45,Sample,21106rA_47,m_4,adipic_acid,0.021060554105129487,1.0590722987351888,231.01,48.389013329210776 -1,fruit,0.6,1,46,Sample,21106rA_48,m_4,adipic_acid,0.02322595664120459,1.1679639181161579,210.83,53.36427141872725 -1,fruit,0.8,1,47,Sample,21106rA_49,m_4,adipic_acid,0.025038107178383416,1.2590915506316172,254.38,57.527892948358584 -1,fruit,0.4,1,3,Sample,21106rA_5,m_4,adipic_acid,0.022054615635478874,1.1090606810339685,943.74,50.67298251644202 -1,fruit,0.4,1,48,Sample,21106rA_50,m_4,adipic_acid,0.030765764991666642,1.547118337410461,302.86,70.68783683628395 -1,fruit,0.8,1,49,Sample,21106rA_51,m_4,adipic_acid,0.034235980086888766,1.7216250792396,304.16,78.66104987045732 -1,fruit,0.6,1,50,Sample,21106rA_52,m_4,adipic_acid,0.013180608412997043,0.662813389476835,135.04,30.28394376519659 -1,fruit,0.4,1,51,Sample,21106rA_53,m_4,adipic_acid,0.032055628397242665,1.6119817116207853,379.33,73.65144440395368 -1,fruit,0.8,1,52,Sample,21106rA_54,m_4,adipic_acid,0.02101826581122053,1.0569457468687855,195.36,48.29185117443481 -1,fruit,0.4,1,53,Sample,21106rA_55,m_4,adipic_acid,0.0162358717905941,0.816453450056488,147.17,37.30375813308093 -1,fruit,0.6,1,54,Sample,21106rA_56,m_4,adipic_acid,0.0187338972725713,0.9420716829049919,175,43.04325519192908 -1,fruit,1,1,55,Sample,21106rA_57,m_4,adipic_acid,0.018999506128645482,0.9554283581549747,219.06,43.653521684100795 -1,fruit,0.6,1,56,Sample,21106rA_58,m_4,adipic_acid,0.01752635405702167,0.8813479449287557,192.84,40.26878760379485 -1,fruit,0.4,1,4,Sample,21106rA_6,m_4,adipic_acid,0.012430696363556556,0.6251025546105902,741.93,28.560935720157865 -1,fruit,NA,1,59,blank sample,21106rA_61,m_4,adipic_acid,12.430933414805281,625.1144752091486,137.24,28561.480372306 -1,fruit,0.8,1,5,Sample,21106rA_7,m_4,adipic_acid,0.009345156822570694,0.4699399962943153,380.04,21.471558430687267 -1,fruit,1,1,6,Sample,21106rA_8,m_4,adipic_acid,0.014554447053482846,0.7318996271801511,492.77,33.4404939658611 -1,fruit,1,1,7,Sample,21106rA_9,m_4,adipic_acid,0.01351035953114411,0.67939558731281,439.36,31.041584384322288 -1,fruit,1,2,10,Sample,21108rA_10,m_4,adipic_acid,0.0051782092132002955,0.2603966594316751,6.08,11.897523369433236 -1,fruit,0.8,2,11,Sample,21108rA_11,m_4,adipic_acid,0.01916476439269884,0.9637387021621795,29.22,44.03322130178998 -1,fruit,0.4,2,12,Sample,21108rA_12,m_4,adipic_acid,0.03511950430028497,1.766054870355201,54.28,80.69104702652913 -1,fruit,0.6,2,13,Sample,21108rA_13,m_4,adipic_acid,0.02949298289420763,1.483113931115348,52.29,67.76347551266025 -1,fruit,1,2,14,Sample,21108rA_14,m_4,adipic_acid,0.018787784314696986,0.9447815011410747,36.7,43.1670667871357 -1,fruit,1,2,17,Sample,21108rA_17,m_4,adipic_acid,0.1644769326561468,8.271053187277346,216.93,377.9044201267019 -1,fruit,0.8,2,18,Sample,21108rA_18,m_4,adipic_acid,0.07106776633136655,3.5737854891578538,97.55,163.28625899962233 -1,fruit,0.6,2,19,Sample,21108rA_19,m_4,adipic_acid,0.032271674209876394,1.622846009600599,41.69,74.14783417865137 -1,fruit,0.4,2,20,Sample,21108rA_20,m_4,adipic_acid,0.055000828271684774,2.765827211347933,61.51,126.37064528648706 -1,fruit,0.6,2,21,Sample,21108rA_21,m_4,adipic_acid,0.025211031013278075,1.2677873732777738,27.02,57.925205085061485 -1,fruit,0.8,2,22,Sample,21108rA_22,m_4,adipic_acid,0.010705052858803639,0.5383251021155964,11.6,24.596073915661595 -1,fruit,0.6,2,23,Sample,21108rA_23,m_4,adipic_acid,0.02195950568690991,1.1042778860818174,25.44,50.454456615078236 -1,fruit,0.4,2,24,Sample,21108rA_24,m_4,adipic_acid,0.03444572937269941,1.7321727437109462,37.26,79.14297266015313 -1,fruit,0.4,2,25,Sample,21108rA_25,m_4,adipic_acid,0.010831855046364447,0.5447016050126388,12.89,24.887416333027463 -1,fruit,0.6,2,26,Sample,21108rA_26,m_4,adipic_acid,0.008767260157979028,0.4408793008375216,7.95,20.14377525526636 -1,fruit,0.4,2,27,Sample,21108rA_27,m_4,adipic_acid,0.002666424180708226,0.13408649992632238,2.59,6.126412181633669 -1,fruit,0.4,2,28,Sample,21108rA_28,m_4,adipic_acid,0.05590883926094435,2.8114883692107138,61.82,128.4569035892375 -1,fruit,0.8,2,3,Sample,21108rA_3,m_4,adipic_acid,0.03866084220913368,1.9441381658373933,43.81,88.8276727971105 -1,fruit,0.6,2,31,Sample,21108rA_31,m_4,adipic_acid,0.038857712498669796,1.954038184091941,38.12,89.28000463116078 -1,fruit,1,2,32,Sample,21108rA_32,m_4,adipic_acid,0.03277742200029051,1.6482785538869653,35.16,75.30984712709544 -1,fruit,1,2,33,Sample,21108rA_33,m_4,adipic_acid,0.010698511872783518,0.5379961754849986,12.22,24.581045257909583 -1,fruit,0.6,2,34,Sample,21108rA_34,m_4,adipic_acid,0.014077213496003665,0.707900978415732,13.36,32.34399570381479 -1,fruit,0.4,2,35,Sample,21108rA_35,m_4,adipic_acid,0.016395814254734502,0.8244964783793415,16.98,37.67124409715211 -1,fruit,1,2,36,Sample,21108rA_36,m_4,adipic_acid,0.06417432708303225,3.227135039483947,70.93,147.44779995402152 -1,fruit,0.4,2,37,Sample,21108rA_37,m_4,adipic_acid,0.08498790725006883,4.273787757279429,105.57,195.2693626300971 -1,fruit,1,2,38,Sample,21108rA_38,m_4,adipic_acid,0.06369887927526381,3.2032261907334156,69.92,146.35540465460974 -1,fruit,1,2,39,Sample,21108rA_39,m_4,adipic_acid,0.17036419689238366,8.567106103872462,167.6,391.4310778859328 -1,fruit,1,2,4,Sample,21108rA_4,m_4,adipic_acid,0.02036655508748217,1.0241731630680653,29.05,46.7944718205799 -1,fruit,0.8,2,40,Sample,21108rA_40,m_4,adipic_acid,0.04597109238857538,2.3117487910481036,50.42,105.62380226298785 -1,fruit,0.4,2,41,Sample,21108rA_41,m_4,adipic_acid,0.02146226450008782,1.0792731134569022,22.2,49.31198855384586 -1,fruit,0.4,2,42,Sample,21108rA_42,m_4,adipic_acid,0.02757922198717164,1.3868766168962272,31.72,63.36639262598862 -1,fruit,0.8,2,45,Sample,21108rA_45,m_4,adipic_acid,0.05331239659893712,2.6809210306279003,64.01,122.49128188938876 -1,fruit,0.4,2,46,Sample,21108rA_46,m_4,adipic_acid,0.021354920291359308,1.0738750941395316,26.83,49.0653530512352 -1,fruit,0.4,2,47,Sample,21108rA_47,m_4,adipic_acid,0.0316475482238019,1.591460579783665,41.42,72.71383389031566 -1,fruit,0.4,2,48,Sample,21108rA_48,m_4,adipic_acid,0.008053120184226107,0.404967336705629,11.86,18.502957614080188 -1,fruit,0.4,2,49,Sample,21108rA_49,m_4,adipic_acid,0.007552444635962322,0.3797898603119248,11.78,17.352598717651844 -1,fruit,0.4,2,5,Sample,21108rA_5,m_4,adipic_acid,0.08944282069568747,4.497812035081716,127.09,205.5050318828836 -1,fruit,1,2,50,Sample,21108rA_50,m_4,adipic_acid,0.008822612917675693,0.44366282562802106,13.83,20.27095450294428 -1,fruit,0.4,2,51,Sample,21108rA_51,m_4,adipic_acid,0.01835668743474376,0.9231029279491931,33.11,42.17657277799863 -1,fruit,0.6,2,52,Sample,21108rA_52,m_4,adipic_acid,0.004826066383617218,0.2426884493747123,7.7,11.088435251930603 -1,fruit,1,2,53,Sample,21108rA_53,m_4,adipic_acid,0.033529543274196875,1.6861004840464213,54.32,77.03793111608098 -1,fruit,0.6,2,54,Sample,21108rA_54,m_4,adipic_acid,0.008082756492579335,0.40645765804556155,15.16,18.571050396101707 -1,fruit,0.6,2,55,Sample,21108rA_55,m_4,adipic_acid,0.005220227295576952,0.262509623168002,12.25,11.994064682546012 -1,fruit,0.8,2,56,Sample,21108rA_56,m_4,adipic_acid,0.020241433016383398,1.0178811482046572,40.54,46.50698966147079 -1,fruit,0.8,2,6,Sample,21108rA_6,m_4,adipic_acid,0.002572250214115354,0.1293507727093337,4.1,5.910036805089456 -1,fruit,0.6,2,7,Sample,21108rA_7,m_4,adipic_acid,0.03861350873558773,1.9417579069712114,53.2,88.71891876951464 -1,fruit,0.8,2,8,Sample,21108rA_8,m_4,adipic_acid,0.02879434001457911,1.4479812695134895,45.58,66.15826420407133 -1,fruit,0.4,2,9,Sample,21108rA_9,m_4,adipic_acid,0.04347916295563524,2.1864371102796,65.24,99.89831156867491 -2,fruit,NA,3,43,blank sample,21108rA_101,m_4,adipic_acid,1.08408013854271,50.20402603484878,37.38,1567.369692807979 -2,fruit,1,3,3,Sample,21108rA_61,m_4,adipic_acid,0.007503038715760957,0.34746762497918515,11.78,10.84793925185016 -2,fruit,1,3,4,Sample,21108rA_62,m_4,adipic_acid,0.005374071264094969,0.24887460259020983,7.73,7.76986509286635 -2,fruit,1,3,5,Sample,21108rA_63,m_4,adipic_acid,0.012120588988259145,0.5613075486672521,17.39,17.524021669391608 -2,fruit,NA,3,6,Sample,21108rA_64,m_4,adipic_acid,0.06473305617056238,2.9978042413644,87.37,93.59144841539656 -2,fruit,1,3,7,Sample,21108rA_65,m_4,adipic_acid,0.07952236402951815,3.6827008374652217,107.11,114.97392014566422 -2,fruit,1,3,8,Sample,21108rA_66,m_4,adipic_acid,0.043460460225841525,2.0126649304706334,50.48,62.83539912929317 -2,fruit,1,3,9,Sample,21108rA_67,m_4,adipic_acid,0.04134931743041165,1.9148973724305787,40.94,59.78309596728266 -2,fruit,1,3,10,Sample,21108rA_68,m_4,adipic_acid,0.038159714047475465,1.767186031188751,34.08,55.171547893712805 -2,fruit,1,3,11,Sample,21108rA_69,m_4,adipic_acid,0.050647159859633695,2.3454828123705385,53.08,73.22597340220821 -2,fruit,1,3,12,Sample,21108rA_70,m_4,adipic_acid,0.010229044221476514,0.4737096310028876,8.21,14.78921467991015 -2,fruit,1,3,13,Sample,21108rA_71,m_4,adipic_acid,0.08801859994964352,4.076163676758248,63.1,127.25782998839249 -2,fruit,1,3,14,Sample,21108rA_72,m_4,adipic_acid,0.04227402758425115,1.9577209340728516,31.17,61.120047561754426 -2,fruit,1,3,17,Sample,21108rA_75,m_4,adipic_acid,0.07196554588166472,3.3327426733525187,52.13,104.04822626206563 -2,fruit,1,3,18,Sample,21108rA_76,m_4,adipic_acid,0.051226220497261894,2.3722992572934403,49.99,74.0631828127012 -2,fruit,1,3,19,Sample,21108rA_77,m_4,adipic_acid,0.028644438598864515,1.326531213000694,22.56,41.41430446988167 -2,fruit,1,3,20,Sample,21108rA_78,m_4,adipic_acid,0.04850952993233456,2.2464886285390175,43.67,70.13537498298813 -2,fruit,1,3,21,Sample,21108rA_79,m_4,adipic_acid,0.02662432324695324,1.2329791589458308,31.22,38.493609342288835 -2,fruit,1,3,22,Sample,21108rA_80,m_4,adipic_acid,0.004072784580872634,0.1886116864084627,4.83,5.888456849672205 -2,fruit,NA,3,23,Sample,21108rA_81,m_4,adipic_acid,0.04059808292624676,1.8801075121015538,59.39,58.69695652781051 -2,fruit,1,3,24,Sample,21108rA_82,m_4,adipic_acid,0.05686151963613841,2.633271388987163,165.51,82.21073276417923 -2,fruit,1,3,25,Sample,21108rA_83,m_4,adipic_acid,0.014339480641136887,0.6640649836105121,36.61,20.73210878832019 -2,fruit,NA,3,26,Sample,21108rA_84,m_4,adipic_acid,0.0161647844398827,0.7485952652527239,59.74,23.37114418119004 -2,fruit,1,3,27,Sample,21108rA_85,m_4,adipic_acid,5.548652837653837e-4,0.0256959519518894,1.57,0.802227619937987 -2,fruit,1,3,28,Sample,21108rA_86,m_4,adipic_acid,0.005548542652147349,0.25695441680015607,19.59,8.022116892500872 -2,fruit,1,3,31,Sample,21108rA_89,m_4,adipic_acid,0.00874697658867457,0.4050747032173675,34.61,12.646432234446213 -2,fruit,1,3,32,Sample,21108rA_90,m_4,adipic_acid,0.006146039968384333,0.2846246689832072,20.14,8.88598216565573 -2,fruit,1,3,33,Sample,21108rA_91,m_4,adipic_acid,0.009724744210158136,0.4503553696365311,45.67,14.060094640052501 -2,fruit,1,3,34,Sample,21108rA_92,m_4,adipic_acid,0.02112868276746974,0.9784746551726637,95.92,30.54797873449056 -2,fruit,1,3,35,Sample,21108rA_93,m_4,adipic_acid,0.004709364866351988,0.2180918808048273,23.76,6.808828518726708 -2,fruit,1,3,36,Sample,21108rA_94,m_4,adipic_acid,0.023351757000035667,1.0814257864415853,135.41,33.76211305270629 -2,fruit,1,3,37,Sample,21108rA_95,m_4,adipic_acid,8.878403484889184e-4,0.041116111609834465,5.79,1.283645004459032 -2,fruit,1,3,38,Sample,21108rA_96,m_4,adipic_acid,0.013302697237520618,0.6160512813600307,60,19.23312100406016 -2,fruit,NA,3,39,Sample,21108rA_97,m_4,adipic_acid,0.010784446452448235,0.49943044911602086,77.34,15.592218621402171 -2,fruit,1,3,40,Sample,21108rA_98,m_4,adipic_acid,0.005095167046535311,0.2359584775716141,41.65,7.366623669785792 -1,fruit,0.8,1,8,Sample,21106rA_10,m_5,L-alanine,0.01818355348473095,0.944668644621548,156035.19,708.6290137331849 -1,fruit,0.6,1,9,Sample,21106rA_11,m_5,L-alanine,0.003911043411443159,0.20318581192870241,30140.89,152.41678903113717 -1,fruit,0.6,1,10,Sample,21106rA_12,m_5,L-alanine,0.031158711710095693,1.618751691414247,261570.82,1214.2823000390263 -1,fruit,0.6,1,11,Sample,21106rA_13,m_5,L-alanine,0.016703690755384748,0.8677870867934078,165623.5,650.957466351773 -1,fruit,1,1,12,Sample,21106rA_14,m_5,L-alanine,0.03198179156531333,1.6615121855001067,300371.69,1246.3584432701225 -1,fruit,0.8,1,13,Sample,21106rA_15,m_5,L-alanine,0.01060304867558187,0.5508476453532113,86818.11,413.21009844703116 -1,fruit,0.8,1,14,Sample,21106rA_16,m_5,L-alanine,0.014629090081349019,0.7600078120483493,155665.93,570.1084600908886 -1,fruit,1,1,17,Sample,21106rA_19,m_5,L-alanine,0.017735452813890867,0.9213890005337206,142489.63,691.1661379153625 -1,fruit,0.6,1,18,Sample,21106rA_20,m_5,L-alanine,0.02566158966576862,1.3331662124651347,235330.62,1000.0546367875338 -1,fruit,0.6,1,19,Sample,21106rA_21,m_5,L-alanine,0.03218930250260786,1.6722927557578826,296975.52,1254.4453263404394 -1,fruit,1,1,20,Sample,21106rA_22,m_5,L-alanine,0.034225710648523464,1.7780878592679727,313953.46,1333.8059363119808 -1,fruit,0.8,1,21,Sample,21106rA_23,m_5,L-alanine,0.017689813720480334,0.9190179667008624,157490.19,689.3875424511515 -1,fruit,1,1,22,Sample,21106rA_24,m_5,L-alanine,0.012774251371694204,0.6636455706793807,90284.77,497.8237701615772 -1,fruit,0.8,1,23,Sample,21106rA_25,m_5,L-alanine,0.01542908347608441,0.80156892256206,143603.93,601.2849037260909 -1,fruit,1,1,24,Sample,21106rA_26,m_5,L-alanine,0.06522421705860275,3.3885165942394777,636583.59,2541.8448954198307 -1,fruit,1,1,25,Sample,21106rA_27,m_5,L-alanine,0.03700098066147888,1.922268179346714,304142.18,1441.9606407142473 -1,fruit,0.6,1,26,Sample,21106rA_28,m_5,L-alanine,0.01970143681943241,1.023525441984623,168726.64,767.7822574231351 -1,fruit,0.8,1,27,Sample,21106rA_29,m_5,L-alanine,0.0314423295943076,1.6334861558572877,282273.06,1225.3351375240065 -1,fruit,1,1,28,Sample,21106rA_30,m_5,L-alanine,0.003757531628186602,0.19521059584433348,31954.98,146.43430031368908 -1,fruit,0.8,1,31,Sample,21106rA_33,m_5,L-alanine,0.005336398957962388,0.27723562256471457,42419.08,207.96414373258216 -1,fruit,1,1,32,Sample,21106rA_34,m_5,L-alanine,0.012133959399056201,0.6303812392349293,81713.35,472.8710308934937 -1,fruit,0.8,1,33,Sample,21106rA_35,m_5,L-alanine,0.007670461524219254,0.39849441407536573,60968.53,298.9246073024245 -1,fruit,0.8,1,34,Sample,21106rA_36,m_5,L-alanine,0.00878999996838988,0.4566564705482362,79318.96,342.5540015347012 -1,fruit,0.8,1,35,Sample,21106rA_37,m_5,L-alanine,0.024810210274904602,1.2889355060797414,253294.61,966.8756358531268 -1,fruit,0.6,1,36,Sample,21106rA_38,m_5,L-alanine,0.019908595559524712,1.0342877149577705,166331.97,775.8554150598471 -1,fruit,0.4,1,37,Sample,21106rA_39,m_5,L-alanine,0.012138564873916421,0.630620502022464,94819.39,473.05051028462105 -1,fruit,0.4,1,38,Sample,21106rA_40,m_5,L-alanine,0.007063287239204588,0.3669506066806502,65303.9,275.2624933423895 -1,fruit,0.8,1,39,Sample,21106rA_41,m_5,L-alanine,0.03521737217806277,1.8296064776623293,336235,1372.4518551212313 -1,fruit,0.6,1,40,Sample,21106rA_42,m_5,L-alanine,0.00807559935495955,0.41954206055281185,78120.66,314.71318359278354 -1,fruit,1,1,41,Sample,21106rA_43,m_5,L-alanine,0.010065212457334058,0.5229060765202997,79771.82,392.25014971055504 -1,fruit,0.6,1,42,Sample,21106rA_44,m_5,L-alanine,0.01940065028235218,1.0078990348281454,162251.75,756.0603424908109 -1,fruit,1,1,45,Sample,21106rA_47,m_5,L-alanine,0.005735359002439779,0.29796232182023064,54426.07,223.5119662786187 -1,fruit,0.6,1,46,Sample,21106rA_48,m_5,L-alanine,0.012646661191716133,0.6570170289871248,100729.91,492.8514690392568 -1,fruit,0.8,1,47,Sample,21106rA_49,m_5,L-alanine,0.039382346528455764,2.04598446328396,353252.08,1534.7645553655132 -1,fruit,0.4,1,3,Sample,21106rA_5,m_5,L-alanine,0.013630029155577553,0.7081047815743889,127048.15,531.1741803263043 -1,fruit,0.4,1,48,Sample,21106rA_50,m_5,L-alanine,0.012858819900665711,0.6680390594277839,110521.13,501.11947984386063 -1,fruit,0.8,1,49,Sample,21106rA_51,m_5,L-alanine,0.02206603084335395,1.1463703981992537,170614.52,859.9325586531971 -1,fruit,0.6,1,50,Sample,21106rA_52,m_5,L-alanine,0.008315736564363322,0.432017624931422,72701.1,324.07154107793224 -1,fruit,0.4,1,51,Sample,21106rA_53,m_5,L-alanine,0.005187185068255214,0.2694836898598805,51256.06,202.14914769304147 -1,fruit,0.8,1,52,Sample,21106rA_54,m_5,L-alanine,0.010093321031231856,0.5243663680100008,77950.26,393.3455654671819 -1,fruit,0.4,1,53,Sample,21106rA_55,m_5,L-alanine,0.031063384599157803,1.6137992747834162,231785.51,1210.567318989658 -1,fruit,0.6,1,54,Sample,21106rA_56,m_5,L-alanine,0.014758701071506203,0.766741338501397,110515.2,575.1595139567454 -1,fruit,1,1,55,Sample,21106rA_57,m_5,L-alanine,0.01737563208069964,0.9026956596190354,157204.22,677.1436086283251 -1,fruit,0.6,1,56,Sample,21106rA_58,m_5,L-alanine,0.023638828560660977,1.2280800975228718,199255.58,921.2258639553195 -1,fruit,0.4,1,4,Sample,21106rA_6,m_5,L-alanine,0.014925951818473452,0.7754303187154221,202068.16,581.6774221295932 -1,fruit,NA,1,59,blank sample,21106rA_61,m_5,L-alanine,0.15020973404986507,7.8036686279721845,1165.6,5853.804966243914 -1,fruit,0.8,1,5,Sample,21106rA_7,m_5,L-alanine,0.02314183782175935,1.2022605255617642,222928.93,901.857699342274 -1,fruit,1,1,6,Sample,21106rA_8,m_5,L-alanine,0.00966517001652473,0.5021231448085317,80369.39,376.66014523094793 -1,fruit,1,1,7,Sample,21106rA_9,m_5,L-alanine,0.00930739086832748,0.48353586794402015,77564.3,362.7171783001875 -1,fruit,1,2,10,Sample,21108rA_10,m_5,L-alanine,0.002616359117822074,0.13592461032171996,1888.37,101.9618075636834 -1,fruit,0.8,2,11,Sample,21108rA_11,m_5,L-alanine,0.03536539080616435,1.8372963143548589,36043.64,1378.220270768582 -1,fruit,0.4,2,12,Sample,21108rA_12,m_5,L-alanine,0.03697407030590303,1.9208701374761044,40512.86,1440.9119205756376 -1,fruit,0.6,2,13,Sample,21108rA_13,m_5,L-alanine,0.013234820500712377,0.6875729738258269,17608.55,515.7725527208366 -1,fruit,1,2,14,Sample,21108rA_14,m_5,L-alanine,0.023353566927668382,1.2132602373438408,36508.63,910.108968139922 -1,fruit,1,2,17,Sample,21108rA_17,m_5,L-alanine,0.024082389567808504,1.2511238978329091,30904.76,938.5118251008893 -1,fruit,0.8,2,18,Sample,21108rA_18,m_5,L-alanine,0.008220554098266998,0.4270727228629427,11685.15,320.3621969647935 -1,fruit,0.6,2,19,Sample,21108rA_19,m_5,L-alanine,0.011265822079977785,0.5852799280281926,16173.92,439.03895881142824 -1,fruit,0.4,2,20,Sample,21108rA_20,m_5,L-alanine,0.008759251970726316,0.45505905619784226,11652.39,341.3557251209684 -1,fruit,0.6,2,21,Sample,21108rA_21,m_5,L-alanine,0.03805710121116508,1.9771355609653178,52305.85,1483.1185840247188 -1,fruit,0.8,2,22,Sample,21108rA_22,m_5,L-alanine,0.03265007674508305,1.6962308149211296,48523,1272.4021023508615 -1,fruit,0.6,2,23,Sample,21108rA_23,m_5,L-alanine,0.015693560914287752,0.8153090060551094,26534.12,611.5918212571495 -1,fruit,0.4,2,24,Sample,21108rA_24,m_5,L-alanine,0.00610376930511857,0.3171019064777857,10144.53,237.86923861571375 -1,fruit,0.4,2,25,Sample,21108rA_25,m_5,L-alanine,0.02664644381725375,1.384331175199982,51875.31,1038.4352661086384 -1,fruit,0.6,2,26,Sample,21108rA_26,m_5,L-alanine,0.006899177095074269,0.35842478649075077,10567.85,268.86697721423934 -1,fruit,0.4,2,27,Sample,21108rA_27,m_5,L-alanine,0.019554887369096354,1.0159119317466352,33146.58,762.0710969207622 -1,fruit,0.4,2,28,Sample,21108rA_28,m_5,L-alanine,0.010276348648580244,0.5338749853082644,19765.72,400.4783121042149 -1,fruit,0.8,2,3,Sample,21108rA_3,m_5,L-alanine,0.03381526650516064,1.7567645402077572,16978.41,1317.8105683687459 -1,fruit,0.6,2,31,Sample,21108rA_31,m_5,L-alanine,0.009110287824460632,0.47329600666185495,14623.12,355.03589995729055 -1,fruit,1,2,32,Sample,21108rA_32,m_5,L-alanine,0.009145572095589194,0.4751290886615569,16193.07,356.410958923137 -1,fruit,1,2,33,Sample,21108rA_33,m_5,L-alanine,0.02884923121823558,1.4987699833362629,55108.58,1124.2798214499476 -1,fruit,0.6,2,34,Sample,21108rA_34,m_5,L-alanine,0.023945618348060797,1.2440183844418773,38154.59,933.1817308133076 -1,fruit,0.4,2,35,Sample,21108rA_35,m_5,L-alanine,0.018297465914188012,0.9505866023205815,31854.32,713.0682809317493 -1,fruit,1,2,36,Sample,21108rA_36,m_5,L-alanine,0.06705031579850174,3.4833857419566194,124855.09,2613.0095635426287 -1,fruit,0.4,2,37,Sample,21108rA_37,m_5,L-alanine,0.006798909514478629,0.353215703483939,14017.29,264.9594617329246 -1,fruit,1,2,38,Sample,21108rA_38,m_5,L-alanine,0.0504944354155698,2.6232776725963696,92260.59,1967.8123969330777 -1,fruit,1,2,39,Sample,21108rA_39,m_5,L-alanine,0.0450585038356998,2.34087114946417,72973.06,1755.969379703305 -1,fruit,1,2,4,Sample,21108rA_4,m_5,L-alanine,0.02116637383630588,1.0996315819284939,13990.05,824.8721367099307 -1,fruit,0.8,2,40,Sample,21108rA_40,m_5,L-alanine,0.05235409165145567,2.7198901932069037,93237.05,2040.2848300812607 -1,fruit,0.4,2,41,Sample,21108rA_41,m_5,L-alanine,0.00998808850934341,0.5188993472812999,16377.07,389.2445618728579 -1,fruit,0.4,2,42,Sample,21108rA_42,m_5,L-alanine,0.003931199599379546,0.20423296251753492,6934.03,153.20229333809107 -1,fruit,0.8,2,45,Sample,21108rA_45,m_5,L-alanine,0.024299272401479586,1.2623913551369936,42059.79,946.9639391856887 -1,fruit,0.4,2,46,Sample,21108rA_46,m_5,L-alanine,0.014289872113405258,0.7423848222252768,25001.76,556.888838619958 -1,fruit,0.4,2,47,Sample,21108rA_47,m_5,L-alanine,0.02823022741871497,1.4666116111677123,49873.78,1100.156700943292 -1,fruit,0.4,2,48,Sample,21108rA_48,m_5,L-alanine,0.03834073932562227,1.991871076406361,73553.76,1494.1722099000856 -1,fruit,0.4,2,49,Sample,21108rA_49,m_5,L-alanine,0.034722996202018734,1.8039227473829238,67889.13,1353.1855901080896 -1,fruit,0.4,2,5,Sample,21108rA_5,m_5,L-alanine,0.006388302599350215,0.3318839281347307,4377.64,248.95775043134623 -1,fruit,1,2,50,Sample,21108rA_50,m_5,L-alanine,0.033869820378894765,1.7595987130773532,63938.85,1319.9365806342803 -1,fruit,0.4,2,51,Sample,21108rA_51,m_5,L-alanine,0.009520026578823879,0.4945826794817896,19709.62,371.0037782730722 -1,fruit,0.6,2,52,Sample,21108rA_52,m_5,L-alanine,0.028965948504116167,1.5048336584231654,51117.52,1128.8283963612612 -1,fruit,1,2,53,Sample,21108rA_53,m_5,L-alanine,0.0130751760160147,0.6792791527579428,22329.98,509.55106725407944 -1,fruit,0.6,2,54,Sample,21108rA_54,m_5,L-alanine,0.006467136387074424,0.33597948665481575,12145.42,252.0299722218102 -1,fruit,0.6,2,55,Sample,21108rA_55,m_5,L-alanine,0.005595691605844283,0.2907063467793521,12549.1,218.06900544132927 -1,fruit,0.8,2,56,Sample,21108rA_56,m_5,L-alanine,0.016434959296319666,0.8538259991866672,30312.98,640.4847658998906 -1,fruit,0.8,2,6,Sample,21108rA_6,m_5,L-alanine,0.0248909511068475,1.2931301390122516,20252.89,970.0221768279554 -1,fruit,0.6,2,7,Sample,21108rA_7,m_5,L-alanine,0.046509739638226445,2.4162654864264312,34443.43,1812.525310660491 -1,fruit,0.8,2,8,Sample,21108rA_8,m_5,L-alanine,0.03438313680692494,1.7862664342538783,30812.63,1339.940971659033 -1,fruit,0.4,2,9,Sample,21108rA_9,m_5,L-alanine,0.012025424942935467,0.6247426770229609,10735.24,468.6413480286188 -2,fruit,NA,3,43,blank sample,21108rA_101,m_5,L-alanine,0.005042216720005223,0.280701756996945,271.7,4219.21407433323 -2,fruit,1,3,3,Sample,21108rA_61,m_5,L-alanine,0.03894880642745712,2.1682920438036613,163192.5,32591.489295810643 -2,fruit,1,3,4,Sample,21108rA_62,m_5,L-alanine,0.011292062701495133,0.6286326067369175,46851.63,9448.94528023227 -2,fruit,1,3,5,Sample,21108rA_63,m_5,L-alanine,0.012432149566121077,0.6921015934545905,55640.91,10402.944446136278 -2,fruit,NA,3,6,Sample,21108rA_64,m_5,L-alanine,0.03180212445304679,1.7704340582561264,144626.02,26611.305807944926 -2,fruit,1,3,7,Sample,21108rA_65,m_5,L-alanine,0.01499446418214105,0.8347464369104691,72996.73,12547.031955879416 -2,fruit,1,3,8,Sample,21108rA_66,m_5,L-alanine,0.05344042614637237,2.975044974650884,240179.47,44717.75226172871 -2,fruit,1,3,9,Sample,21108rA_67,m_5,L-alanine,0.03922768383634501,2.1838172350059755,159604.47,32824.847668513066 -2,fruit,1,3,10,Sample,21108rA_68,m_5,L-alanine,0.034129188403044464,1.8999824247150598,132060.52,28558.54082677083 -2,fruit,1,3,11,Sample,21108rA_69,m_5,L-alanine,0.007552040845281304,0.42042443867445656,35718.91,6319.378716493823 -2,fruit,1,3,12,Sample,21108rA_70,m_5,L-alanine,0.020264041073811585,1.1281054046544987,76174.91,16956.495932091537 -2,fruit,1,3,13,Sample,21108rA_71,m_5,L-alanine,0.010355001102874541,0.5764660990769901,35510.58,8664.833111921285 -2,fruit,1,3,14,Sample,21108rA_72,m_5,L-alanine,0.005766832549838292,0.3210413433092388,20485.22,4825.556379214003 -2,fruit,1,3,17,Sample,21108rA_75,m_5,L-alanine,0.026323340492142328,1.465428468565612,88003.55,22026.782039586287 -2,fruit,1,3,18,Sample,21108rA_76,m_5,L-alanine,0.027801968842382493,1.5477441640039231,119878.91,23264.06514193477 -2,fruit,1,3,19,Sample,21108rA_77,m_5,L-alanine,0.014638837797335741,0.814948606592454,47982.03,12249.451758260848 -2,fruit,1,3,20,Sample,21108rA_78,m_5,L-alanine,0.01064703614552072,0.5927237798010696,36952.75,8909.201498000888 -2,fruit,1,3,21,Sample,21108rA_79,m_5,L-alanine,0.003702827418815683,0.20613754228258327,15030.95,3098.4430911723953 -2,fruit,1,3,22,Sample,21108rA_80,m_5,L-alanine,0.021695945892265832,1.2078199866949317,77387.68,18154.681829012185 -2,fruit,NA,3,23,Sample,21108rA_81,m_5,L-alanine,0.03720709700101901,2.0713305438666234,144977.88,31134.065838332026 -2,fruit,1,3,24,Sample,21108rA_82,m_5,L-alanine,0.0040994776982408495,0.22821918544286734,28682.53,3430.351165432467 -2,fruit,1,3,25,Sample,21108rA_83,m_5,L-alanine,0.01983861649323591,1.104421887291295,113953.22,16600.510166781092 -2,fruit,NA,3,26,Sample,21108rA_84,m_5,L-alanine,0.029416980401285434,1.6376523546526505,229626.68,24615.47066016626 -2,fruit,1,3,27,Sample,21108rA_85,m_5,L-alanine,0.015106090123691802,0.8409606874394908,85323.12,12640.438044868615 -2,fruit,1,3,28,Sample,21108rA_86,m_5,L-alanine,0.029146201958385597,1.622578035380074,196186.13,24388.889320896124 -2,fruit,1,3,31,Sample,21108rA_89,m_5,L-alanine,0.02484334096415863,1.383036439240216,168282.23,20788.351566397723 -2,fruit,1,3,32,Sample,21108rA_90,m_5,L-alanine,0.0101088660236439,0.5627636834460825,55093.33,8458.872787693894 -2,fruit,1,3,33,Sample,21108rA_91,m_5,L-alanine,0.015077422204794013,0.8393647355693287,115477.04,12616.4493721058 -2,fruit,1,3,34,Sample,21108rA_92,m_5,L-alanine,0.020615563482927608,1.1476747653825248,150132.33,17250.64201472646 -2,fruit,1,3,35,Sample,21108rA_93,m_5,L-alanine,0.00363908512207525,0.2025889890006367,28781.56,3045.1049642191206 -2,fruit,1,3,36,Sample,21108rA_94,m_5,L-alanine,0.011668744978376477,0.6496026250486439,105831.84,9764.144576974913 -2,fruit,1,3,37,Sample,21108rA_95,m_5,L-alanine,0.03319044021347815,1.8477220240179848,336999.62,27773.01735691313 -2,fruit,1,3,38,Sample,21108rA_96,m_5,L-alanine,0.0042876697849284565,0.2386958968417534,29700.68,3587.8260906335536 -2,fruit,NA,3,39,Sample,21108rA_97,m_5,L-alanine,0.021626844874816645,1.203973111781502,239900.49,18096.859644532167 -2,fruit,1,3,40,Sample,21108rA_98,m_5,L-alanine,0.01822576552499516,1.0146339773898472,230574.33,15250.912582447923 -1,fruit,0.8,1,8,Sample,21106rA_10,m_6,L-alanine_peak_2,0.015635415340022444,0.801785555595512,347.14,82.95273358191167 -1,fruit,0.6,1,9,Sample,21106rA_11,m_6,L-alanine_peak_2,0.003805134982027733,0.1951276764533103,83.53,20.187909405859486 -1,fruit,0.6,1,10,Sample,21106rA_12,m_6,L-alanine_peak_2,0.034396087478124025,1.7638345710181764,858.41,182.48632471754055 -1,fruit,0.6,1,11,Sample,21106rA_13,m_6,L-alanine_peak_2,0.015711133435123273,0.8056683865679424,496.14,83.35445127431933 -1,fruit,1,1,12,Sample,21106rA_14,m_6,L-alanine_peak_2,0.035560753321690376,1.8235587440036332,1129.59,188.6653876546159 -1,fruit,0.8,1,13,Sample,21106rA_15,m_6,L-alanine_peak_2,0.0126789871532531,0.6501796426883281,375.83,67.26758583253442 -1,fruit,0.8,1,14,Sample,21106rA_16,m_6,L-alanine_peak_2,0.013793685377724458,0.7073414715104471,561.52,73.18154864247087 -1,fruit,1,1,17,Sample,21106rA_19,m_6,L-alanine_peak_2,0.02139574116078439,1.0971756004501925,772.77,113.51378762257693 -1,fruit,0.6,1,18,Sample,21106rA_20,m_6,L-alanine_peak_2,0.024891481742209353,1.2764375032102102,1076.19,132.06022408212837 -1,fruit,0.6,1,19,Sample,21106rA_21,m_6,L-alanine_peak_2,0.02977695051298039,1.5269647970193145,1358.74,157.97977789961828 -1,fruit,1,1,20,Sample,21106rA_22,m_6,L-alanine_peak_2,0.03937705025486608,2.019258806351919,1872.49,208.91251610516954 -1,fruit,0.8,1,21,Sample,21106rA_23,m_6,L-alanine_peak_2,0.02055269921558046,1.053944330942728,996.44,109.04108047933465 -1,fruit,1,1,22,Sample,21106rA_24,m_6,L-alanine_peak_2,0.01823619966726085,0.9351540182458908,736.44,96.75103472771987 -1,fruit,0.8,1,23,Sample,21106rA_25,m_6,L-alanine_peak_2,0.01968807642577399,1.0096063937130717,1090.71,104.4538774935544 -1,fruit,1,1,24,Sample,21106rA_26,m_6,L-alanine_peak_2,0.05750668225302345,2.948948024595859,3464.64,305.0981626246876 -1,fruit,1,1,25,Sample,21106rA_27,m_6,L-alanine_peak_2,0.03378888695009462,1.7326972713598965,1790.03,179.2648596948949 -1,fruit,0.6,1,26,Sample,21106rA_28,m_6,L-alanine_peak_2,0.01922179741927856,0.9856955628105825,1108.03,101.98006292838286 -1,fruit,0.8,1,27,Sample,21106rA_29,m_6,L-alanine_peak_2,0.025965845133238484,1.3315309580148802,1629.15,137.76019291621952 -1,fruit,1,1,28,Sample,21106rA_30,m_6,L-alanine_peak_2,0.0038618456176662984,0.19803580313333854,245.66,20.488784192175206 -1,fruit,0.8,1,31,Sample,21106rA_33,m_6,L-alanine_peak_2,0.007869667020723909,0.4035572581440449,520.47,41.75203392758289 -1,fruit,1,1,32,Sample,21106rA_34,m_6,L-alanine_peak_2,0.014052632760694066,0.720620317438693,802.08,74.55537804220718 -1,fruit,0.8,1,33,Sample,21106rA_35,m_6,L-alanine_peak_2,0.008021760236724214,0.4113566124330841,562.34,42.558955122326886 -1,fruit,0.8,1,34,Sample,21106rA_36,m_6,L-alanine_peak_2,0.010076469522490241,0.5167222960717003,824.94,53.46008875157811 -1,fruit,0.8,1,35,Sample,21106rA_37,m_6,L-alanine_peak_2,0.020216961943618612,1.036727692351427,1915.95,107.25984705067864 -1,fruit,0.6,1,36,Sample,21106rA_38,m_6,L-alanine_peak_2,0.02302556692748545,1.1807532176391207,1843.85,122.16072789694343 -1,fruit,0.4,1,37,Sample,21106rA_39,m_6,L-alanine_peak_2,0.012492186462536923,0.6406004858617028,969.14,66.27652626725178 -1,fruit,0.4,1,38,Sample,21106rA_40,m_6,L-alanine_peak_2,0.00879640784346637,0.4510806138910205,837.21,46.668800313164986 -1,fruit,0.8,1,39,Sample,21106rA_41,m_6,L-alanine_peak_2,0.02916220271017504,1.4954404724072443,2908,154.7182712752535 -1,fruit,0.6,1,40,Sample,21106rA_42,m_6,L-alanine_peak_2,0.009422074183160857,0.4831648420921905,991.4,49.98823456285803 -1,fruit,1,1,41,Sample,21106rA_43,m_6,L-alanine_peak_2,0.011337124712069676,0.5813688116653092,1001.42,60.14841725489289 -1,fruit,0.6,1,42,Sample,21106rA_44,m_6,L-alanine_peak_2,0.01860431290561704,0.9540308994107924,1771.21,98.70403685304059 -1,fruit,1,1,45,Sample,21106rA_47,m_6,L-alanine_peak_2,0.007347968020380643,0.37680448479282236,871.47,38.9841919966654 -1,fruit,0.6,1,46,Sample,21106rA_48,m_6,L-alanine_peak_2,0.012626393881732523,0.6474826548239397,1272.75,66.98855546808481 -1,fruit,0.8,1,47,Sample,21106rA_49,m_6,L-alanine_peak_2,0.03500158047188574,1.7948843081600958,4041.58,185.69873052224352 -1,fruit,0.4,1,3,Sample,21106rA_5,m_6,L-alanine_peak_2,0.012281849854843799,0.6298144050193462,193.04,65.16059834330156 -1,fruit,0.4,1,48,Sample,21106rA_50,m_6,L-alanine_peak_2,0.012110400474974999,0.6210224648434599,1381.9,64.25098421270437 -1,fruit,0.8,1,49,Sample,21106rA_51,m_6,L-alanine_peak_2,0.022411418643449515,1.1492596364054113,2345.74,118.90240198250386 -1,fruit,0.6,1,50,Sample,21106rA_52,m_6,L-alanine_peak_2,0.009945831217038882,0.5100231515948498,1215.92,52.766995264003164 -1,fruit,0.4,1,51,Sample,21106rA_53,m_6,L-alanine_peak_2,0.0056172444632034985,0.2880528195062943,800.65,29.801944706121212 -1,fruit,0.8,1,52,Sample,21106rA_54,m_6,L-alanine_peak_2,0.010841156509183842,0.5559355160053836,1221.1,57.51708848591699 -1,fruit,0.4,1,53,Sample,21106rA_55,m_6,L-alanine_peak_2,0.030829829333214185,1.580956521031597,3396.18,163.56576166592905 -1,fruit,0.6,1,54,Sample,21106rA_56,m_6,L-alanine_peak_2,0.016159385667628066,0.8286548028203978,1834.07,85.73262589979836 -1,fruit,1,1,55,Sample,21106rA_57,m_6,L-alanine_peak_2,0.02071086637368974,1.0620551575491053,2892.26,109.88022660003044 -1,fruit,0.6,1,56,Sample,21106rA_58,m_6,L-alanine_peak_2,0.02854936730837722,1.4640142158970442,3782.35,151.4669107767082 -1,fruit,0.4,1,4,Sample,21106rA_6,m_6,L-alanine_peak_2,0.013001963508278749,0.6667419002700369,326.97,68.98111700193802 -1,fruit,NA,1,59,blank sample,21106rA_61,m_6,L-alanine_peak_2,0.18111968278031906,9.287834210299433,23.31,960.9193273975794 -1,fruit,0.8,1,5,Sample,21106rA_7,m_6,L-alanine_peak_2,0.025631323521620265,1.3143766585992795,501.05,135.98540909868146 -1,fruit,1,1,6,Sample,21106rA_8,m_6,L-alanine_peak_2,0.010356825147165377,0.5310989586294956,191.43,54.947498259807624 -1,fruit,1,1,7,Sample,21106rA_9,m_6,L-alanine_peak_2,0.010434343027367537,0.5350740827496322,209.59,55.35876460127695 -1,fruit,1,2,10,Sample,21108rA_10,m_6,L-alanine_peak_2,0.08099683777258954,4.1535253885287595,194.79,429.7237366971855 -1,fruit,0.8,2,11,Sample,21108rA_11,m_6,L-alanine_peak_2,0.056744975181204596,2.9098876149746307,206.25,301.0569726452753 -1,fruit,0.4,2,12,Sample,21108rA_12,m_6,L-alanine_peak_2,0.056727054906985444,2.908968661642803,241.88,300.9618977335644 -1,fruit,0.6,2,13,Sample,21108rA_13,m_6,L-alanine_peak_2,0.043188496927797006,2.2147101469028887,243.33,229.13391179857288 -1,fruit,1,2,14,Sample,21108rA_14,m_6,L-alanine_peak_2,0.008233740926024748,0.4222270019334697,58.65,43.68360562003678 -1,fruit,1,2,17,Sample,21108rA_17,m_6,L-alanine_peak_2,0.01674365776153743,0.8586163302404555,119.6,88.83244552667753 -1,fruit,0.8,2,18,Sample,21108rA_18,m_6,L-alanine_peak_2,0.019842252843487625,1.01751257478009,167.51,105.27185098674812 -1,fruit,0.6,2,19,Sample,21108rA_19,m_6,L-alanine_peak_2,0.022272280447621827,1.142124616758015,200.5,118.16421284978425 -1,fruit,0.4,2,20,Sample,21108rA_20,m_6,L-alanine_peak_2,0.007744368359391511,0.3971319311151803,68.21,41.08726959317656 -1,fruit,0.6,2,21,Sample,21108rA_21,m_6,L-alanine_peak_2,0.04478855059436414,2.296761048022687,425.96,237.62289802842724 -1,fruit,0.8,2,22,Sample,21108rA_22,m_6,L-alanine_peak_2,0.04734630874291114,2.4279231242204506,510.96,251.19292643184784 -1,fruit,0.6,2,23,Sample,21108rA_23,m_6,L-alanine_peak_2,0.02710320470616408,1.3898548628973912,349.15,143.7943841153641 -1,fruit,0.4,2,24,Sample,21108rA_24,m_6,L-alanine_peak_2,0.013716462066983263,0.7033814529397179,182.91,72.77184512114322 -1,fruit,0.4,2,25,Sample,21108rA_25,m_6,L-alanine_peak_2,0.02158275839279559,1.1067658615346045,347.62,114.5059960343702 -1,fruit,0.6,2,26,Sample,21108rA_26,m_6,L-alanine_peak_2,0.01818072464301047,0.9323092538329871,241.69,96.45671540156086 -1,fruit,0.4,2,27,Sample,21108rA_27,m_6,L-alanine_peak_2,0.015834416015535424,0.8119903287793516,239.68,84.00851941551173 -1,fruit,0.4,2,28,Sample,21108rA_28,m_6,L-alanine_peak_2,0.01334891287398625,0.6845334960733946,238.09,70.82183550375342 -1,fruit,0.8,2,3,Sample,21108rA_3,m_6,L-alanine_peak_2,0.4516278511419905,23.159518290722186,246.67,2396.0837623581174 -1,fruit,0.6,2,31,Sample,21108rA_31,m_6,L-alanine_peak_2,0.0063578114036174724,0.3260291612191736,104.41,33.730977019735704 -1,fruit,1,2,32,Sample,21108rA_32,m_6,L-alanine_peak_2,0.010078836237758886,0.5168436614512146,188.18,53.47264521374267 -1,fruit,1,2,33,Sample,21108rA_33,m_6,L-alanine_peak_2,0.02575799674425189,1.3208724732596546,530.85,136.65746608344386 -1,fruit,0.6,2,34,Sample,21108rA_34,m_6,L-alanine_peak_2,0.02445326779580657,1.2539658512044662,432.46,129.7353069656141 -1,fruit,0.4,2,35,Sample,21108rA_35,m_6,L-alanine_peak_2,0.015332719889553603,0.7862633046893173,304.36,81.34680150315677 -1,fruit,1,2,36,Sample,21108rA_36,m_6,L-alanine_peak_2,0.06661903411298185,3.416230277093288,1445.57,353.4431844680716 -1,fruit,0.4,2,37,Sample,21108rA_37,m_6,L-alanine_peak_2,0.006837656257915498,0.35063565006108993,170.06,36.27676435532037 -1,fruit,1,2,38,Sample,21108rA_38,m_6,L-alanine_peak_2,0.041635692215087304,2.135082176539711,929.2,220.8956019847985 -1,fruit,1,2,39,Sample,21108rA_39,m_6,L-alanine_peak_2,0.04364483534861075,2.2381112236453244,882.67,231.5549871983453 -1,fruit,1,2,4,Sample,21108rA_4,m_6,L-alanine_peak_2,0.019225329609058706,0.9858766938316494,17.61,101.99880274382245 -1,fruit,0.8,2,40,Sample,21108rA_40,m_6,L-alanine_peak_2,0.04192551702483931,2.149944419790618,951.75,222.43324967153734 -1,fruit,0.4,2,41,Sample,21108rA_41,m_6,L-alanine_peak_2,0.007257805712733793,0.37218095325507305,155.8,38.50584142376986 -1,fruit,0.4,2,42,Sample,21108rA_42,m_6,L-alanine_peak_2,0.0029987124261081992,0.15377425264066422,71.48,15.90948417820312 -1,fruit,0.8,2,45,Sample,21108rA_45,m_6,L-alanine_peak_2,0.02489373667422457,1.2765531363340725,603.2,132.07218748512315 -1,fruit,0.4,2,46,Sample,21108rA_46,m_6,L-alanine_peak_2,0.016633645695500292,0.8529749012427867,415.15,88.24878328257873 -1,fruit,0.4,2,47,Sample,21108rA_47,m_6,L-alanine_peak_2,0.034062197290400095,1.7467126510787132,869.03,180.7148908806037 -1,fruit,0.4,2,48,Sample,21108rA_48,m_6,L-alanine_peak_2,0.033284641683363224,1.7068395270946868,935,176.58961747321632 -1,fruit,0.4,2,49,Sample,21108rA_49,m_6,L-alanine_peak_2,0.037699220258466455,1.9332195277908568,1094.6,200.01089234524207 -1,fruit,0.4,2,5,Sample,21108rA_5,m_6,L-alanine_peak_2,0.0880277552263006,4.514071490718957,102.51,467.0258364297834 -1,fruit,1,2,50,Sample,21108rA_50,m_6,L-alanine_peak_2,0.032770523367286836,1.6804754919390628,931.02,173.86199439601543 -1,fruit,0.4,2,51,Sample,21108rA_51,m_6,L-alanine_peak_2,0.009116406367437794,0.4674901680187846,289.53,48.36653278322346 -1,fruit,0.6,2,52,Sample,21108rA_52,m_6,L-alanine_peak_2,0.03037327945959883,1.5575446009697906,827.4,161.14356441633456 -1,fruit,1,2,53,Sample,21108rA_53,m_6,L-alanine_peak_2,0.014156141628103525,0.7259282618047451,379.04,75.10453796631893 -1,fruit,0.6,2,54,Sample,21108rA_54,m_6,L-alanine_peak_2,0.0061353460746139225,0.31462111841782425,183.83,32.5507009115081 -1,fruit,0.6,2,55,Sample,21108rA_55,m_6,L-alanine_peak_2,0.0072245673253343795,0.3704764856519694,261.43,38.329497205552755 -1,fruit,0.8,2,56,Sample,21108rA_56,m_6,L-alanine_peak_2,0.017399089205733784,0.8922269157740911,518.12,92.30979670598747 -1,fruit,0.8,2,6,Sample,21108rA_6,m_6,L-alanine_peak_2,0.0401039770639528,2.0565356808593043,64.96,212.76918154170363 -1,fruit,0.6,2,7,Sample,21108rA_7,m_6,L-alanine_peak_2,0.19248715569108893,9.870759280422032,327.4,1021.2287551524635 -1,fruit,0.8,2,8,Sample,21108rA_8,m_6,L-alanine_peak_2,0.045823010283623046,2.3498082372822227,107.15,243.11116022921877 -1,fruit,0.4,2,9,Sample,21108rA_9,m_6,L-alanine_peak_2,0.00255552270344327,0.13104744236453816,6.7,13.558168387035119 -2,fruit,NA,3,43,blank sample,21108rA_101,m_6,L-alanine_peak_2,0.0027786798132467595,0.15993478471336905,15.51,60.71604232073629 -2,fruit,1,3,3,Sample,21108rA_61,m_6,L-alanine_peak_2,0.041280456766353994,2.3760135782186507,2896.71,902.0060346991463 -2,fruit,1,3,4,Sample,21108rA_62,m_6,L-alanine_peak_2,0.010661384577256777,0.6136461779371528,702.27,232.95849853028133 -2,fruit,1,3,5,Sample,21108rA_63,m_6,L-alanine_peak_2,0.014954448843267945,0.8607456479343388,1009.77,326.76487032531304 -2,fruit,NA,3,6,Sample,21108rA_64,m_6,L-alanine_peak_2,0.031706132765832104,1.8249362498775001,2075.43,692.8005485409954 -2,fruit,1,3,7,Sample,21108rA_65,m_6,L-alanine_peak_2,0.015851309279969437,0.9123669899032752,1069.52,346.36188037698037 -2,fruit,1,3,8,Sample,21108rA_66,m_6,L-alanine_peak_2,0.07614829951556022,4.3829309988328395,4584.02,1663.8920950869108 -2,fruit,1,3,9,Sample,21108rA_67,m_6,L-alanine_peak_2,0.05247356229133596,3.0202644609140137,2788.12,1146.582997296787 -2,fruit,1,3,10,Sample,21108rA_68,m_6,L-alanine_peak_2,0.049398132615449244,2.843249397584597,2450.86,1079.3827688050405 -2,fruit,1,3,11,Sample,21108rA_69,m_6,L-alanine_peak_2,0.00948093285669195,0.545701936613262,570.59,207.16482619649267 -2,fruit,1,3,12,Sample,21108rA_70,m_6,L-alanine_peak_2,0.03836188475744372,2.2080269020675334,1822.56,838.2332528318977 -2,fruit,1,3,13,Sample,21108rA_71,m_6,L-alanine_peak_2,0.019900315324946016,1.1454189979177558,866.95,434.8354141795176 -2,fruit,1,3,14,Sample,21108rA_72,m_6,L-alanine_peak_2,0.008296452115111005,0.477525793576282,379.63,181.28311701536393 -2,fruit,1,3,17,Sample,21108rA_75,m_6,L-alanine_peak_2,0.03958291821150019,2.2783069399730738,1820.46,864.913663621978 -2,fruit,1,3,18,Sample,21108rA_76,m_6,L-alanine_peak_2,0.028459651302759237,1.6380758165892864,1747.03,621.8627222517907 -2,fruit,1,3,19,Sample,21108rA_77,m_6,L-alanine_peak_2,0.027931574399887815,1.607680855151049,1354.71,610.3238830409928 -2,fruit,1,3,20,Sample,21108rA_78,m_6,L-alanine_peak_2,0.019244820993200556,1.1076901655676739,1025.92,420.512417554456 -2,fruit,1,3,21,Sample,21108rA_79,m_6,L-alanine_peak_2,0.00731073093648997,0.42078981998961834,471.24,159.7444393626588 -2,fruit,1,3,22,Sample,21108rA_80,m_6,L-alanine_peak_2,0.03363107157984156,1.9357315539414415,1833.81,734.8617698227894 -2,fruit,NA,3,23,Sample,21108rA_81,m_6,L-alanine_peak_2,0.03923441912807719,2.2582480884226546,2327.23,857.2987218078923 -2,fruit,1,3,24,Sample,21108rA_82,m_6,L-alanine_peak_2,0.009107769430494987,0.5242234589753585,1032.04,199.01095173081535 -2,fruit,1,3,25,Sample,21108rA_83,m_6,L-alanine_peak_2,0.03354823065323654,1.930963409839747,3376.11,733.0516392774631 -2,fruit,NA,3,26,Sample,21108rA_84,m_6,L-alanine_peak_2,0.02252713306969659,1.2966129312688064,3439.6,492.23316709757694 -2,fruit,1,3,27,Sample,21108rA_85,m_6,L-alanine_peak_2,0.018960148489249293,1.0913050335289944,2375.15,414.2921298786122 -2,fruit,1,3,28,Sample,21108rA_86,m_6,L-alanine_peak_2,0.02833986674722386,1.6311812773155614,4810.86,619.2453483073066 -2,fruit,1,3,31,Sample,21108rA_89,m_6,L-alanine_peak_2,0.021328753228268865,1.227636786183693,5350.84,466.04775313891537 -2,fruit,1,3,32,Sample,21108rA_90,m_6,L-alanine_peak_2,0.008163970618639105,0.4699004459145157,1861.45,178.3883062825276 -2,fruit,1,3,33,Sample,21108rA_91,m_6,L-alanine_peak_2,0.006491977667199843,0.37366415720795443,2323.65,141.85412400085573 -2,fruit,1,3,34,Sample,21108rA_92,m_6,L-alanine_peak_2,0.007847333124348578,0.4516754783453434,2966.61,171.46956184424272 -2,fruit,1,3,35,Sample,21108rA_93,m_6,L-alanine_peak_2,0.00228593514454668,0.1315734700590098,1046.31,49.949236438501885 -2,fruit,1,3,36,Sample,21108rA_94,m_6,L-alanine_peak_2,0.00600430645535551,0.34559485972884085,3430.78,131.19817659885985 -2,fruit,1,3,37,Sample,21108rA_95,m_6,L-alanine_peak_2,0.012316930989986317,0.70893583953854,8570.12,269.13331276401595 -2,fruit,1,3,38,Sample,21108rA_96,m_6,L-alanine_peak_2,0.0019771521421223064,0.11380059000983793,1027.08,43.202117985434775 -2,fruit,NA,3,39,Sample,21108rA_97,m_6,L-alanine_peak_2,0.005548317313050058,0.3193491134724405,4932.18,121.23450394754258 -2,fruit,1,3,40,Sample,21108rA_98,m_6,L-alanine_peak_2,0.0067149220453199,0.3864963521761196,7302.04,146.72561017662028 -1,fruit,0.8,1,8,Sample,21106rA_10,m_7,beta-cyano-L-alanine,0.015783502302827088,1.0167073772361068,1212.39,75.6786136245696 -1,fruit,0.6,1,9,Sample,21106rA_11,m_7,beta-cyano-L-alanine,0.014259636103279422,0.918546273491512,1018.83,68.3719918673407 -1,fruit,0.6,1,10,Sample,21106rA_12,m_7,beta-cyano-L-alanine,0.009852860279378504,0.6346801578459831,755.12,47.24241754926575 -1,fruit,0.6,1,11,Sample,21106rA_13,m_7,beta-cyano-L-alanine,0.024420300718206885,1.5730539026232457,2240.21,117.0902672417613 -1,fruit,1,1,12,Sample,21106rA_14,m_7,beta-cyano-L-alanine,0.010671948420204249,0.6874423990397502,933.71,51.16977497252381 -1,fruit,0.8,1,13,Sample,21106rA_15,m_7,beta-cyano-L-alanine,0.01616117270031553,1.0410353287846938,1253.65,77.48946469808868 -1,fruit,0.8,1,14,Sample,21106rA_16,m_7,beta-cyano-L-alanine,0.015400186230395832,0.9920157548587196,1561.7,73.84069271290879 -1,fruit,1,1,17,Sample,21106rA_19,m_7,beta-cyano-L-alanine,0.008412246416963195,0.5418818223711057,659.07,40.33497344819325 -1,fruit,0.6,1,18,Sample,21106rA_20,m_7,beta-cyano-L-alanine,0.008964700415576588,0.5774686043917994,805,42.98387556790359 -1,fruit,0.6,1,19,Sample,21106rA_21,m_7,beta-cyano-L-alanine,0.022414265321608815,1.4438334705805616,2036.12,107.4717443826641 -1,fruit,1,1,20,Sample,21106rA_22,m_7,beta-cyano-L-alanine,0.004897069531547762,0.31544879102472545,444.79,23.48043075992544 -1,fruit,0.8,1,21,Sample,21106rA_23,m_7,beta-cyano-L-alanine,0.02044510498428231,1.3169883760312995,1818.01,98.03002976988978 -1,fruit,1,1,22,Sample,21106rA_24,m_7,beta-cyano-L-alanine,0.01254102317169575,0.8078403976580149,892.58,60.131599999674336 -1,fruit,0.8,1,23,Sample,21106rA_25,m_7,beta-cyano-L-alanine,0.007065543380489353,0.45513283055298603,663.27,33.87781224221152 -1,fruit,1,1,24,Sample,21106rA_26,m_7,beta-cyano-L-alanine,0.018586615587261414,1.1972722417910693,1825.05,89.11895931771825 -1,fruit,1,1,25,Sample,21106rA_27,m_7,beta-cyano-L-alanine,0.009083738021284704,0.5851365103843931,754.5,43.5546361504623 -1,fruit,0.6,1,26,Sample,21106rA_28,m_7,beta-cyano-L-alanine,0.019373457334313345,1.2479573048142334,1684.23,92.89170198384747 -1,fruit,0.8,1,27,Sample,21106rA_29,m_7,beta-cyano-L-alanine,0.020277921037867176,1.3062190836135281,1844.67,97.22841748877296 -1,fruit,1,1,28,Sample,21106rA_30,m_7,beta-cyano-L-alanine,0.00472588291092849,0.3044216630319378,418.53,22.65962648778229 -1,fruit,0.8,1,31,Sample,21106rA_33,m_7,beta-cyano-L-alanine,0.011147518966343218,0.7180766697724942,906.16,53.45003691451561 -1,fruit,1,1,32,Sample,21106rA_34,m_7,beta-cyano-L-alanine,0.007145605378916033,0.46029009051182873,483.33,34.261692887247975 -1,fruit,0.8,1,33,Sample,21106rA_35,m_7,beta-cyano-L-alanine,0.014232926872025152,0.916825776232063,1141.54,68.24392665383361 -1,fruit,0.8,1,34,Sample,21106rA_36,m_7,beta-cyano-L-alanine,0.00665282384276347,0.4285471595983069,602.21,31.898907824699975 -1,fruit,0.8,1,35,Sample,21106rA_37,m_7,beta-cyano-L-alanine,0.03668894015096289,2.3633484760715358,3718.35,175.91584381638478 -1,fruit,0.6,1,36,Sample,21106rA_38,m_7,beta-cyano-L-alanine,0.011492057798043687,0.7402704240618342,952.54,55.10202901504263 -1,fruit,0.4,1,37,Sample,21106rA_39,m_7,beta-cyano-L-alanine,0.01806352753307925,1.1635770914101664,1404.78,86.61086079911574 -1,fruit,0.4,1,38,Sample,21106rA_40,m_7,beta-cyano-L-alanine,0.02092095938111261,1.3476409312414916,1934.14,100.31165271696044 -1,fruit,0.8,1,39,Sample,21106rA_41,m_7,beta-cyano-L-alanine,0.020737515978845527,1.335824272504297,1947.3,99.43207972385736 -1,fruit,0.6,1,40,Sample,21106rA_42,m_7,beta-cyano-L-alanine,0.01292793347971624,0.8327635456986539,1242.34,61.9867545240793 -1,fruit,1,1,41,Sample,21106rA_43,m_7,beta-cyano-L-alanine,0.007740207128543252,0.49859185483286966,605.82,37.11268471448466 -1,fruit,0.6,1,42,Sample,21106rA_44,m_7,beta-cyano-L-alanine,0.010893188428652075,0.7016937574780098,891.87,52.23057483787566 -1,fruit,1,1,45,Sample,21106rA_47,m_7,beta-cyano-L-alanine,0.004577204551568035,0.2948444233359003,427.48,21.946744651007737 -1,fruit,0.6,1,46,Sample,21106rA_48,m_7,beta-cyano-L-alanine,0.011618253088718994,0.7483993982616263,895.92,55.707109209604155 -1,fruit,0.8,1,47,Sample,21106rA_49,m_7,beta-cyano-L-alanine,0.02041779665530857,1.315229287395907,1752.46,97.89909200731435 -1,fruit,0.4,1,3,Sample,21106rA_5,m_7,beta-cyano-L-alanine,0.02453154800202031,1.580219988576826,1924.32,117.62367484971605 -1,fruit,0.4,1,48,Sample,21106rA_50,m_7,beta-cyano-L-alanine,0.04972686839234058,3.2031974254716538,4098.87,238.43000036498256 -1,fruit,0.8,1,49,Sample,21106rA_51,m_7,beta-cyano-L-alanine,0.012857145022010881,0.8282036485483671,944.82,61.64733857969771 -1,fruit,0.6,1,50,Sample,21106rA_52,m_7,beta-cyano-L-alanine,0.01564808322493976,1.0079842451412806,1305.6,75.02930728709123 -1,fruit,0.4,1,51,Sample,21106rA_53,m_7,beta-cyano-L-alanine,0.03205101169943181,2.064592472410658,3030.97,153.67794068388733 -1,fruit,0.8,1,52,Sample,21106rA_54,m_7,beta-cyano-L-alanine,0.012727596034847941,0.819858643210836,924.73,61.02617810739858 -1,fruit,0.4,1,53,Sample,21106rA_55,m_7,beta-cyano-L-alanine,0.025992786465633442,1.6743468748250396,1795.84,124.63000962760182 -1,fruit,0.6,1,54,Sample,21106rA_56,m_7,beta-cyano-L-alanine,0.013193187692817862,0.8498501155948088,913.19,63.2585933542996 -1,fruit,1,1,55,Sample,21106rA_57,m_7,beta-cyano-L-alanine,0.018955511001437095,1.2210349455196203,1569.77,90.88773616975294 -1,fruit,0.6,1,56,Sample,21106rA_58,m_7,beta-cyano-L-alanine,0.021776209972991258,1.4027326066798904,1663.64,104.41240157821764 -1,fruit,0.4,1,4,Sample,21106rA_6,m_7,beta-cyano-L-alanine,0.0171702469002643,1.1060356793775263,1982.11,82.32776579446617 -1,fruit,NA,1,59,blank sample,21106rA_61,m_7,beta-cyano-L-alanine,3.956305908085014,254.8487228105481,269.97,18969.66468240315 -1,fruit,0.8,1,5,Sample,21106rA_7,m_7,beta-cyano-L-alanine,0.012044491547058835,0.7758559016878803,1000.07,57.75083404213737 -1,fruit,1,1,6,Sample,21106rA_8,m_7,beta-cyano-L-alanine,0.0071082651055131025,0.45788478586471165,519,34.082654035839816 -1,fruit,1,1,7,Sample,21106rA_9,m_7,beta-cyano-L-alanine,0.004311604202903898,0.2777355568307177,319.56,20.673246172694473 -1,fruit,1,2,10,Sample,21108rA_10,m_7,beta-cyano-L-alanine,0.011986393893034207,0.7721134931708321,68.05,57.47226786417089 -1,fruit,0.8,2,11,Sample,21108rA_11,m_7,beta-cyano-L-alanine,0.01060554790063553,0.6831651545598774,81.22,50.85139827966447 -1,fruit,0.4,2,12,Sample,21108rA_12,m_7,beta-cyano-L-alanine,0.008619522822940482,0.5552337037875863,69.66,41.328820741428984 -1,fruit,0.6,2,13,Sample,21108rA_13,m_7,beta-cyano-L-alanine,0.004249576647892575,0.2737400004857464,41.1,20.375836936156535 -1,fruit,1,2,14,Sample,21108rA_14,m_7,beta-cyano-L-alanine,0.004672974028235025,0.30101349351900725,52.06,22.405939390087305 -1,fruit,1,2,17,Sample,21108rA_17,m_7,beta-cyano-L-alanine,0.004066392038064623,0.26194001207792406,35.4,19.497504799020277 -1,fruit,0.8,2,18,Sample,21108rA_18,m_7,beta-cyano-L-alanine,0.0037730283187857486,0.24304274505304901,36.03,18.090886728023705 -1,fruit,0.6,2,19,Sample,21108rA_19,m_7,beta-cyano-L-alanine,0.009782225179958203,0.6301301393966835,92.81,46.903736925992135 -1,fruit,0.4,2,20,Sample,21108rA_20,m_7,beta-cyano-L-alanine,0.024581523057174537,1.5834391731581834,213.39,117.86329485402939 -1,fruit,0.6,2,21,Sample,21108rA_21,m_7,beta-cyano-L-alanine,0.007167427533094036,0.46169578265253847,63.06,34.366325581741705 -1,fruit,0.8,2,22,Sample,21108rA_22,m_7,beta-cyano-L-alanine,0.009181848040488891,0.5914563485541385,86.36,44.025053304627306 -1,fruit,0.6,2,23,Sample,21108rA_23,m_7,beta-cyano-L-alanine,0.012494888252702964,0.8048685786289927,132.67,59.91039265024908 -1,fruit,0.4,2,24,Sample,21108rA_24,m_7,beta-cyano-L-alanine,0.04300237891316108,2.770033864529683,448.86,206.18747070626696 -1,fruit,0.4,2,25,Sample,21108rA_25,m_7,beta-cyano-L-alanine,0.020278529110738644,1.3062582531313232,243.93,97.23133307183004 -1,fruit,0.6,2,26,Sample,21108rA_26,m_7,beta-cyano-L-alanine,0.003080115248595146,0.19840817556843468,29.34,14.768512548436435 -1,fruit,0.4,2,27,Sample,21108rA_27,m_7,beta-cyano-L-alanine,0.02841232906922848,1.8302037161910722,297.73,136.23121361468247 -1,fruit,0.4,2,28,Sample,21108rA_28,m_7,beta-cyano-L-alanine,0.020111680200309474,1.29551054233416,242.19,96.4313272186432 -1,fruit,0.8,2,3,Sample,21108rA_3,m_7,beta-cyano-L-alanine,0.001972988865425554,0.12709171235864156,8.74,9.460071609415484 -1,fruit,0.6,2,31,Sample,21108rA_31,m_7,beta-cyano-L-alanine,0.01868977304463664,1.2039172148723307,193.18,89.61357788902194 -1,fruit,1,2,32,Sample,21108rA_32,m_7,beta-cyano-L-alanine,0.025495505501456857,1.6423141095276406,290.27,122.24565074268993 -1,fruit,1,2,33,Sample,21108rA_33,m_7,beta-cyano-L-alanine,0.004725328682283152,0.3043859619345781,57.8,22.656969076600323 -1,fruit,0.6,2,34,Sample,21108rA_34,m_7,beta-cyano-L-alanine,0.010119404041027598,0.6518497950801955,103.75,48.52043949679435 -1,fruit,0.4,2,35,Sample,21108rA_35,m_7,beta-cyano-L-alanine,0.025979217516070106,1.6734728196972422,292.84,124.56494933416423 -1,fruit,1,2,36,Sample,21108rA_36,m_7,beta-cyano-L-alanine,0.006474663432643159,0.4170708091771278,78.33,31.04466568109951 -1,fruit,0.4,2,37,Sample,21108rA_37,m_7,beta-cyano-L-alanine,0.03181393892277087,2.0493212330907347,434.01,152.54122598510884 -1,fruit,1,2,38,Sample,21108rA_38,m_7,beta-cyano-L-alanine,0.009570554300632667,0.616495184338719,115.47,45.88881904625255 -1,fruit,1,2,39,Sample,21108rA_39,m_7,beta-cyano-L-alanine,0.0030666209740389952,0.19753893069309225,33.1,14.703810306140323 -1,fruit,1,2,4,Sample,21108rA_4,m_7,beta-cyano-L-alanine,0.024366155516107928,1.569566094571538,139.32,116.83065224943243 -1,fruit,0.8,2,40,Sample,21108rA_40,m_7,beta-cyano-L-alanine,0.014315874259002936,0.922168900884927,171.49,68.64164213736954 -1,fruit,0.4,2,41,Sample,21108rA_41,m_7,beta-cyano-L-alanine,0.02879030833592726,1.8545515638057368,322.91,138.04354565188004 -1,fruit,0.4,2,42,Sample,21108rA_42,m_7,beta-cyano-L-alanine,0.025872752692692,1.6666147998948013,319.49,124.05447263016954 -1,fruit,0.8,2,45,Sample,21108rA_45,m_7,beta-cyano-L-alanine,0.028715635882917773,1.8497414758801018,354.12,137.68550675713539 -1,fruit,0.4,2,46,Sample,21108rA_46,m_7,beta-cyano-L-alanine,0.07647208496753326,4.92601270918123,968.15,366.66775600790487 -1,fruit,0.4,2,47,Sample,21108rA_47,m_7,beta-cyano-L-alanine,0.05565334584980759,3.584956380893793,718.79,266.8462282118295 -1,fruit,0.4,2,48,Sample,21108rA_48,m_7,beta-cyano-L-alanine,0.035904018209022746,2.3127870788851776,510.21,172.1523062168182 -1,fruit,0.4,2,49,Sample,21108rA_49,m_7,beta-cyano-L-alanine,0.06974991998624334,4.492998882696629,1025.07,334.4363718335236 -1,fruit,0.4,2,5,Sample,21108rA_5,m_7,beta-cyano-L-alanine,0.032215614655130176,2.075195508173096,188.47,154.46717765086441 -1,fruit,1,2,50,Sample,21108rA_50,m_7,beta-cyano-L-alanine,0.01422048069898334,0.9160240456841033,204.87,68.18424984049624 -1,fruit,0.4,2,51,Sample,21108rA_51,m_7,beta-cyano-L-alanine,0.05635917744814508,3.6304231080717995,910.48,270.2305440493244 -1,fruit,0.6,2,52,Sample,21108rA_52,m_7,beta-cyano-L-alanine,0.058351902241821664,3.7587861265996576,812.08,279.7852453334455 -1,fruit,1,2,53,Sample,21108rA_53,m_7,beta-cyano-L-alanine,0.009085942894896443,0.5852785391447985,124.98,43.565208061243084 -1,fruit,0.6,2,54,Sample,21108rA_54,m_7,beta-cyano-L-alanine,0.02720490220532413,1.7524263144172767,421.58,130.44185271365 -1,fruit,0.6,2,55,Sample,21108rA_55,m_7,beta-cyano-L-alanine,0.030713526773218786,1.9784372728020574,579.37,147.26497840102115 -1,fruit,0.8,2,56,Sample,21108rA_56,m_7,beta-cyano-L-alanine,0.015181318437479902,0.9779172046492929,237.8,72.79126712807012 -1,fruit,0.8,2,6,Sample,21108rA_6,m_7,beta-cyano-L-alanine,0.003551571988218551,0.2287774520462505,23.98,17.029049643062656 -1,fruit,0.6,2,7,Sample,21108rA_7,m_7,beta-cyano-L-alanine,0.037900597282064526,2.4413983740115586,227.98,181.72548796955036 -1,fruit,0.8,2,8,Sample,21108rA_8,m_7,beta-cyano-L-alanine,0.008807074595965551,0.5673150066308813,62.85,42.22809251856965 -1,fruit,0.4,2,9,Sample,21108rA_9,m_7,beta-cyano-L-alanine,0.00931907067513876,0.6002956582520442,65.22,44.683007321990914 -2,fruit,NA,3,43,blank sample,21108rA_101,m_7,beta-cyano-L-alanine,0.024070790292034818,1.5283302176807687,3.76,135.28779086910163 -2,fruit,1,3,3,Sample,21108rA_61,m_7,beta-cyano-L-alanine,0.009166139116215614,0.5819870150010675,251.45,51.5174905678945 -2,fruit,1,3,4,Sample,21108rA_62,m_7,beta-cyano-L-alanine,0.017851133667815048,1.133424647607362,473.67,100.33074980620367 -2,fruit,1,3,5,Sample,21108rA_63,m_7,beta-cyano-L-alanine,0.009929604767709531,0.6304618515636875,277.06,55.80848310041762 -2,fruit,NA,3,6,Sample,21108rA_64,m_7,beta-cyano-L-alanine,0.04311038842163683,2.73721421363324,1190.24,242.29820219081438 -2,fruit,1,3,7,Sample,21108rA_65,m_7,beta-cyano-L-alanine,0.03462827602698203,2.198658207567863,1000.36,194.62522453390721 -2,fruit,1,3,8,Sample,21108rA_66,m_7,beta-cyano-L-alanine,0.021631773785230783,1.373469384964184,562.63,121.57950995702956 -2,fruit,1,3,9,Sample,21108rA_67,m_7,beta-cyano-L-alanine,0.01366332377121234,0.8675274197544645,314.55,76.7935271966652 -2,fruit,1,3,10,Sample,21108rA_68,m_7,beta-cyano-L-alanine,0.014813752993649358,0.940571791070154,317.26,83.25941494553003 -2,fruit,1,3,11,Sample,21108rA_69,m_7,beta-cyano-L-alanine,0.020588325043379326,1.3072175409896107,529.31,115.71489672840033 -2,fruit,1,3,12,Sample,21108rA_70,m_7,beta-cyano-L-alanine,0.009031030782072179,0.5734085617294169,180.17,50.758125884287985 -2,fruit,1,3,13,Sample,21108rA_71,m_7,beta-cyano-L-alanine,0.003259883366734757,0.20698025262362424,58.23,18.321891962243217 -2,fruit,1,3,14,Sample,21108rA_72,m_7,beta-cyano-L-alanine,0.00868409792649699,0.5513807030571864,158.06,48.80821983462214 -2,fruit,1,3,17,Sample,21108rA_75,m_7,beta-cyano-L-alanine,0.009374336971972663,0.5952061519861599,151.09,52.68764857381487 -2,fruit,1,3,18,Sample,21108rA_76,m_7,beta-cyano-L-alanine,0.0487091905117185,3.0926997757303667,995.3,273.765784147652 -2,fruit,1,3,19,Sample,21108rA_77,m_7,beta-cyano-L-alanine,0.00862541599358927,0.5476548024861337,132.02,48.478403116072556 -2,fruit,1,3,20,Sample,21108rA_78,m_7,beta-cyano-L-alanine,0.009131263847331436,0.5797726744397995,145.92,51.32147714141105 -2,fruit,1,3,21,Sample,21108rA_79,m_7,beta-cyano-L-alanine,0.008071946538811967,0.5125132852348551,149.91,45.36767600898937 -2,fruit,1,3,22,Sample,21108rA_80,m_7,beta-cyano-L-alanine,0.026155121768785712,1.6606709817742389,418.53,147.00259530665562 -2,fruit,NA,3,23,Sample,21108rA_81,m_7,beta-cyano-L-alanine,0.04955723012007817,3.1465444789379355,853.93,278.532117275586 -2,fruit,1,3,24,Sample,21108rA_82,m_7,beta-cyano-L-alanine,0.009241684838163082,0.5867836506024766,284.31,51.94208875133123 -2,fruit,1,3,25,Sample,21108rA_83,m_7,beta-cyano-L-alanine,0.01020433809538398,0.6479055350237938,250.81,57.35259796030622 -2,fruit,NA,3,26,Sample,21108rA_84,m_7,beta-cyano-L-alanine,0.03520023751459931,2.2349738421718666,1152.21,197.83988450905363 -2,fruit,1,3,27,Sample,21108rA_85,m_7,beta-cyano-L-alanine,0.003122496684797329,0.1982571398813995,72.54,17.549722022301484 -2,fruit,1,3,28,Sample,21108rA_86,m_7,beta-cyano-L-alanine,0.01841315716848992,1.1691092881491545,497.85,103.48955418696315 -2,fruit,1,3,31,Sample,21108rA_89,m_7,beta-cyano-L-alanine,0.014459195111365989,0.9180597954590299,366.38,81.26665309403333 -2,fruit,1,3,32,Sample,21108rA_90,m_7,beta-cyano-L-alanine,0.015403629981938454,0.9780249371853885,307.3,86.57476743965059 -2,fruit,1,3,33,Sample,21108rA_91,m_7,beta-cyano-L-alanine,0.0373656527917261,2.3724628718924894,1019.94,210.01041341992314 -2,fruit,1,3,34,Sample,21108rA_92,m_7,beta-cyano-L-alanine,0.021901055792528247,1.3905669469402289,554.01,123.09298614314905 -2,fruit,1,3,35,Sample,21108rA_93,m_7,beta-cyano-L-alanine,0.0014405311570100847,0.09146385598721612,38.98,8.096380531988371 -2,fruit,1,3,36,Sample,21108rA_94,m_7,beta-cyano-L-alanine,0.011151201974252126,0.7080249021300525,335.14,62.674364336552244 -2,fruit,1,3,37,Sample,21108rA_95,m_7,beta-cyano-L-alanine,0.017591830613410048,1.1169606807506018,576.84,98.87335946004328 -2,fruit,1,3,38,Sample,21108rA_96,m_7,beta-cyano-L-alanine,0.01401443182306225,0.889820374776004,309.51,78.76689957517186 -2,fruit,NA,3,39,Sample,21108rA_97,m_7,beta-cyano-L-alanine,0.0374109379209924,2.37533816724547,1284.13,210.264934564569 -2,fruit,1,3,40,Sample,21108rA_98,m_7,beta-cyano-L-alanine,0.01375004997940732,0.8730339396086597,527.81,77.28096433415855 -1,fruit,0.8,1,8,Sample,21106rA_10,m_8,beta-alanine,0.011660259174552616,0.7258996855314594,729.41,58.253449763899624 -1,fruit,0.6,1,9,Sample,21106rA_11,m_8,beta-alanine,0.02321422862914581,1.4451823934178458,1572.05,115.97588707178213 -1,fruit,0.6,1,10,Sample,21106rA_12,m_8,beta-alanine,0.012095550372556385,0.7529983751073429,745.14,60.42811960236427 -1,fruit,0.6,1,11,Sample,21106rA_13,m_8,beta-alanine,0.015999992534610066,0.9960661573223367,1278.32,79.93430912511752 -1,fruit,1,1,12,Sample,21106rA_14,m_8,beta-alanine,0.016249209118122655,1.0115809273538487,1219.54,81.17936942014636 -1,fruit,0.8,1,13,Sample,21106rA_15,m_8,beta-alanine,0.008751490972512713,0.5448167531938352,436.16,43.72154444380527 -1,fruit,0.8,1,14,Sample,21106rA_16,m_8,beta-alanine,0.01422138328121936,0.8853403253839403,1161.06,71.04856111206121 -1,fruit,1,1,17,Sample,21106rA_19,m_8,beta-alanine,0.010878516593500545,0.6772329547789655,580.48,54.34794462101198 -1,fruit,0.6,1,18,Sample,21106rA_20,m_8,beta-alanine,0.01908448158759379,1.1880884443116841,1484.65,95.34409765601265 -1,fruit,0.6,1,19,Sample,21106rA_21,m_8,beta-alanine,0.013507835339197152,0.8409189948653231,960.86,67.48374933794217 -1,fruit,1,1,20,Sample,21106rA_22,m_8,beta-alanine,0.01289851689222639,0.8029863844127288,905.67,64.43965734912149 -1,fruit,0.8,1,21,Sample,21106rA_23,m_8,beta-alanine,0.013295944438365142,0.8277279040003265,910.77,66.4251642960262 -1,fruit,1,1,22,Sample,21106rA_24,m_8,beta-alanine,0.010182288206273182,0.6338898386628686,471.71,50.86965955269521 -1,fruit,0.8,1,23,Sample,21106rA_25,m_8,beta-alanine,0.014079917265911282,0.8765334768835542,1039.79,70.34181151990522 -1,fruit,1,1,24,Sample,21106rA_26,m_8,beta-alanine,0.02274375878692928,1.4158936867600784,1989.26,113.62546836249629 -1,fruit,1,1,25,Sample,21106rA_27,m_8,beta-alanine,0.016774348400023873,1.0442730342689541,1128.27,83.80291100008357 -1,fruit,0.6,1,26,Sample,21106rA_28,m_8,beta-alanine,0.01157447495856632,0.7205592608911637,725.54,57.82488068651589 -1,fruit,0.8,1,27,Sample,21106rA_29,m_8,beta-alanine,0.013233887363911795,0.823864592717418,933.18,66.11513356557279 -1,fruit,1,1,28,Sample,21106rA_30,m_8,beta-alanine,0.005147254708845611,0.32043803817462846,160.95,25.715152563513932 -1,fruit,0.8,1,31,Sample,21106rA_33,m_8,beta-alanine,0.009278593036820545,0.5776310514865417,469.3,46.35489188179497 -1,fruit,1,1,32,Sample,21106rA_34,m_8,beta-alanine,0.011518413415342281,0.71706919639195,567.21,57.54480301045399 -1,fruit,0.8,1,33,Sample,21106rA_35,m_8,beta-alanine,0.011732005609627047,0.7303661998583617,692.92,58.611887538633525 -1,fruit,0.8,1,34,Sample,21106rA_36,m_8,beta-alanine,0.00830064901874953,0.5167499643204532,486.79,41.46918463671636 -1,fruit,0.8,1,35,Sample,21106rA_37,m_8,beta-alanine,0.046745521315104184,2.910103344588839,4878.37,233.53579340325433 -1,fruit,0.6,1,36,Sample,21106rA_38,m_8,beta-alanine,0.009485076217638602,0.5904854892635746,555.13,47.38646051340186 -1,fruit,0.4,1,37,Sample,21106rA_39,m_8,beta-alanine,0.01871335120518973,1.1649840326647951,1301.1,93.4899686213498 -1,fruit,0.4,1,38,Sample,21106rA_40,m_8,beta-alanine,0.08551843570465262,5.323878711086325,8636.6,427.2412665646776 -1,fruit,0.8,1,39,Sample,21106rA_41,m_8,beta-alanine,0.01404501233924569,0.8743604998587082,1139.03,70.16743011366134 -1,fruit,0.6,1,40,Sample,21106rA_42,m_8,beta-alanine,0.015551079620469633,0.9681194591977597,1335.82,77.69158660062021 -1,fruit,1,1,41,Sample,21106rA_43,m_8,beta-alanine,0.00692006591548799,0.43080291756057276,313.64,34.57193413423597 -1,fruit,0.6,1,42,Sample,21106rA_44,m_8,beta-alanine,0.010754798355748666,0.6695309793310621,684.96,53.72986109131773 -1,fruit,1,1,45,Sample,21106rA_47,m_8,beta-alanine,0.006947352125421275,0.4325015977454133,389.93,34.70825321906942 -1,fruit,0.6,1,46,Sample,21106rA_48,m_8,beta-alanine,0.01785566499293681,1.11158949464991,1337.6,89.20505694565529 -1,fruit,0.8,1,47,Sample,21106rA_49,m_8,beta-alanine,0.013985838885493249,0.8706767059714806,1101.4,69.87180565421131 -1,fruit,0.4,1,3,Sample,21106rA_5,m_8,beta-alanine,0.08960558744452414,5.578320925301167,8069.67,447.66025425541864 -1,fruit,0.4,1,48,Sample,21106rA_50,m_8,beta-alanine,0.04041572480014657,2.51604715502201,3756.06,201.91278419051628 -1,fruit,0.8,1,49,Sample,21106rA_51,m_8,beta-alanine,0.01227413665283852,0.7641161146666791,772.51,61.320318202001 -1,fruit,0.6,1,50,Sample,21106rA_52,m_8,beta-alanine,0.012716435930848443,0.791651086403747,965.92,63.5299996839007 -1,fruit,0.4,1,51,Sample,21106rA_53,m_8,beta-alanine,0.013753770098199137,0.8562294576559278,1253.98,68.71241397688821 -1,fruit,0.8,1,52,Sample,21106rA_54,m_8,beta-alanine,0.00773979148847507,0.4818342477176271,379.13,38.667198379339574 -1,fruit,0.4,1,53,Sample,21106rA_55,m_8,beta-alanine,0.024670903334065283,1.5358664592172022,1871.04,123.25328335218047 -1,fruit,0.6,1,54,Sample,21106rA_56,m_8,beta-alanine,0.008391422359211373,0.5224009827334655,415.52,41.922678864360606 -1,fruit,1,1,55,Sample,21106rA_57,m_8,beta-alanine,0.00939631467213963,0.5849597134638731,661.22,46.94301700547582 -1,fruit,0.6,1,56,Sample,21106rA_58,m_8,beta-alanine,0.011480398621786559,0.714702617204082,839.67,57.35488503062758 -1,fruit,0.4,1,4,Sample,21106rA_6,m_8,beta-alanine,0.04575729502066044,2.848582142904387,5776.5,228.59871696807704 -1,fruit,NA,1,59,blank sample,21106rA_61,m_8,beta-alanine,0.03567667151425612,2.221021355127927,3.08,178.23696374901613 -1,fruit,0.8,1,5,Sample,21106rA_7,m_8,beta-alanine,0.008756828193653924,0.5451490174334219,532.97,43.74820864903211 -1,fruit,1,1,6,Sample,21106rA_8,m_8,beta-alanine,0.008249406376507614,0.5135598964727002,432.01,41.21318169193419 -1,fruit,1,1,7,Sample,21106rA_9,m_8,beta-alanine,0.00506051036095376,0.31503784132533824,160.36,25.281786766358394 -1,fruit,1,2,10,Sample,21108rA_10,m_8,beta-alanine,0.0052315707879616825,0.3256870651816075,15.22,26.136386980824003 -1,fruit,0.8,2,11,Sample,21108rA_11,m_8,beta-alanine,0.01753015340204328,1.091325042725708,126.98,87.57883467873806 -1,fruit,0.4,2,12,Sample,21108rA_12,m_8,beta-alanine,0.030756285168556198,1.914706817211672,257.09,153.65522208123667 -1,fruit,0.6,2,13,Sample,21108rA_13,m_8,beta-alanine,0.017834834839139686,1.1102927308417863,168.87,89.10099165005334 -1,fruit,1,2,14,Sample,21108rA_14,m_8,beta-alanine,0.015367972839294055,0.9567202996349853,164.8,76.77680404570756 -1,fruit,1,2,17,Sample,21108rA_17,m_8,beta-alanine,0.034169647150969165,2.1272028134452787,334.12,170.70802577898363 -1,fruit,0.8,2,18,Sample,21108rA_18,m_8,beta-alanine,0.00426000244656785,0.26520289043622375,17.82,21.282531957506954 -1,fruit,0.6,2,19,Sample,21108rA_19,m_8,beta-alanine,0.005924424731747957,0.3688201081427203,34.65,29.597813678453306 -1,fruit,0.4,2,20,Sample,21108rA_20,m_8,beta-alanine,0.009578258665610302,0.5962864846503092,76.56,47.851990393187315 -1,fruit,0.6,2,21,Sample,21108rA_21,m_8,beta-alanine,0.01850415375285873,1.1519606201841819,177.68,92.4448397697806 -1,fruit,0.8,2,22,Sample,21108rA_22,m_8,beta-alanine,0.008885011139588977,0.5531289395562354,73.24,44.38859739938789 -1,fruit,0.6,2,23,Sample,21108rA_23,m_8,beta-alanine,0.016126372600858165,1.0039338426776634,189.07,80.56569087488249 -1,fruit,0.4,2,24,Sample,21108rA_24,m_8,beta-alanine,0.013822030650981167,0.860478961295334,153.47,69.05343664395055 -1,fruit,0.4,2,25,Sample,21108rA_25,m_8,beta-alanine,0.04389562895928518,2.7326856788304017,674.03,219.29802572613974 -1,fruit,0.6,2,26,Sample,21108rA_26,m_8,beta-alanine,0.009198704061215129,0.5726576301070271,80.59,45.955774816088926 -1,fruit,0.4,2,27,Sample,21108rA_27,m_8,beta-alanine,0.03475857084070725,2.1638657653388247,459.57,173.6502276684407 -1,fruit,0.4,2,28,Sample,21108rA_28,m_8,beta-alanine,0.023752336769716994,1.4786818657859229,344.24,118.66421972932031 -1,fruit,0.8,2,3,Sample,21108rA_3,m_8,beta-alanine,0.022693553595025808,1.412768204515712,85.36,113.37464841238588 -1,fruit,0.6,2,31,Sample,21108rA_31,m_8,beta-alanine,0.007098749615185951,0.44192672188418675,55.02,35.46461943120599 -1,fruit,1,2,32,Sample,21108rA_32,m_8,beta-alanine,0.004691568312714028,0.2920696625921388,26.93,23.43859042301914 -1,fruit,1,2,33,Sample,21108rA_33,m_8,beta-alanine,0.00990062599553279,0.6163551932367397,116.31,49.46250425724836 -1,fruit,0.6,2,34,Sample,21108rA_34,m_8,beta-alanine,0.017157876000092814,1.0681492243360038,193.63,85.7189752529643 -1,fruit,0.4,2,35,Sample,21108rA_35,m_8,beta-alanine,0.03744305243488658,2.3309859224346927,521.56,187.0616202753841 -1,fruit,1,2,36,Sample,21108rA_36,m_8,beta-alanine,0.02522774803332785,1.5705323603805925,362.23,126.03522192054255 -1,fruit,0.4,2,37,Sample,21108rA_37,m_8,beta-alanine,0.06499279971684915,4.046072404568149,1125.64,324.697310466594 -1,fruit,1,2,38,Sample,21108rA_38,m_8,beta-alanine,0.017268202930980723,1.0750175351718354,230.42,86.27015719753979 -1,fruit,1,2,39,Sample,21108rA_39,m_8,beta-alanine,0.0035968657205015884,0.22391986801709898,8.51,17.969569408372195 -1,fruit,1,2,4,Sample,21108rA_4,m_8,beta-alanine,0.011707149454035922,0.7288188006747744,51.37,58.48770875415065 -1,fruit,0.8,2,40,Sample,21108rA_40,m_8,beta-alanine,0.0191183026883727,1.1901939486621635,255.54,95.51306438013863 -1,fruit,0.4,2,41,Sample,21108rA_41,m_8,beta-alanine,0.033942906166645734,2.113087243048981,453.85,169.57525125468072 -1,fruit,0.4,2,42,Sample,21108rA_42,m_8,beta-alanine,0.03594286586047825,2.2375930615814683,529.59,179.56684319191282 -1,fruit,0.8,2,45,Sample,21108rA_45,m_8,beta-alanine,0.022177523581064965,1.38064318745979,303.95,110.79661579364814 -1,fruit,0.4,2,46,Sample,21108rA_46,m_8,beta-alanine,0.02857722422793018,1.7790512003102574,409.01,142.76885882489816 -1,fruit,0.4,2,47,Sample,21108rA_47,m_8,beta-alanine,0.03686482806470265,2.294989047734071,549.46,184.1728710806592 -1,fruit,0.4,2,48,Sample,21108rA_48,m_8,beta-alanine,0.049686748876371645,3.093207007195243,826.48,248.22986232741826 -1,fruit,0.4,2,49,Sample,21108rA_49,m_8,beta-alanine,0.031929903769814895,1.9877694619466029,529.03,159.51849932121488 -1,fruit,0.4,2,5,Sample,21108rA_5,m_8,beta-alanine,0.05106361649743239,3.178922749717304,280.45,255.10855066481363 -1,fruit,1,2,50,Sample,21108rA_50,m_8,beta-alanine,0.01398999175231709,0.8709352392233023,199.92,69.89255294767001 -1,fruit,0.4,2,51,Sample,21108rA_51,m_8,beta-alanine,0.06945059244960182,4.32358856389432,1304.66,346.96798225251916 -1,fruit,0.6,2,52,Sample,21108rA_52,m_8,beta-alanine,0.00892895250560206,0.5558644725571082,102.36,44.60812392270794 -1,fruit,1,2,53,Sample,21108rA_53,m_8,beta-alanine,0.006224080029142777,0.3874748981341342,52.73,31.09486057526427 -1,fruit,0.6,2,54,Sample,21108rA_54,m_8,beta-alanine,0.00842869405426162,0.5247213009451949,101.81,42.108884400851885 -1,fruit,0.6,2,55,Sample,21108rA_55,m_8,beta-alanine,0.015532099472148364,0.9669378659337079,283.27,77.59676374118006 -1,fruit,0.8,2,56,Sample,21108rA_56,m_8,beta-alanine,0.012420677778208898,0.7732389099005906,172.62,62.052422519522395 -1,fruit,0.8,2,6,Sample,21108rA_6,m_8,beta-alanine,0.004866034170840731,0.30293088871535734,15.74,24.310203819407427 -1,fruit,0.6,2,7,Sample,21108rA_7,m_8,beta-alanine,0.014672203475703414,0.9134057596515935,72.76,73.30081221204038 -1,fruit,0.8,2,8,Sample,21108rA_8,m_8,beta-alanine,0.0171649368577311,1.0685887921245485,109.89,85.75425056799502 -1,fruit,0.4,2,9,Sample,21108rA_9,m_8,beta-alanine,0.02764875356070922,1.7212500352356621,186.64,138.1303153276619 -2,fruit,NA,3,43,blank sample,21108rA_101,m_8,beta-alanine,0.13187598049138172,7.1422451682285395,25.39,835.0713050692808 -2,fruit,1,3,3,Sample,21108rA_61,m_8,beta-alanine,0.0246385812730706,1.3343960544892015,424.64,156.01758669087744 -2,fruit,1,3,4,Sample,21108rA_62,m_8,beta-alanine,0.018262103054306346,0.989053630655926,291.73,115.64015049629087 -2,fruit,1,3,5,Sample,21108rA_63,m_8,beta-alanine,0.027497263111089548,1.4892188392678734,489.27,174.11946668719975 -2,fruit,NA,3,6,Sample,21108rA_64,m_8,beta-alanine,0.021395146791451502,1.1587355273144009,369.02,135.47935785359977 -2,fruit,1,3,7,Sample,21108rA_65,m_8,beta-alanine,0.023598291332098134,1.2780551971413927,437.47,149.43021364977164 -2,fruit,1,3,8,Sample,21108rA_66,m_8,beta-alanine,0.038404909757692486,2.0799639186080436,676.08,243.18938136365247 -2,fruit,1,3,9,Sample,21108rA_67,m_8,beta-alanine,0.04551900491907664,2.4652547926807076,722.36,288.23759036022835 -2,fruit,1,3,10,Sample,21108rA_68,m_8,beta-alanine,0.023565283532576878,1.27626753424959,328.67,149.22120010446207 -2,fruit,1,3,11,Sample,21108rA_69,m_8,beta-alanine,0.021798944883959042,1.1806047484144506,368.54,138.03630718461756 -2,fruit,1,3,12,Sample,21108rA_70,m_8,beta-alanine,0.01550327227986152,0.8396386598984084,192.1,98.17055211532191 -2,fruit,1,3,13,Sample,21108rA_71,m_8,beta-alanine,0.007587889137059223,0.4109509883777262,64.82,48.04838956112375 -2,fruit,1,3,14,Sample,21108rA_72,m_8,beta-alanine,0.040396866432584166,2.187845906545153,530.01,255.80294339325928 -2,fruit,1,3,17,Sample,21108rA_75,m_8,beta-alanine,0.023397460488729555,1.2671784391803458,266.27,148.15850310896604 -2,fruit,1,3,18,Sample,21108rA_76,m_8,beta-alanine,0.03412671160123825,1.8482618300411544,531.29,216.09877316841178 -2,fruit,1,3,19,Sample,21108rA_77,m_8,beta-alanine,0.0203189886453321,1.1004520909317352,224.37,128.66485847173848 -2,fruit,1,3,20,Sample,21108rA_78,m_8,beta-alanine,0.015338534212222497,0.8307166434460264,172.89,97.1273899517094 -2,fruit,1,3,21,Sample,21108rA_79,m_8,beta-alanine,0.013434492268607818,0.7275960120678571,174.8,85.07052573097386 -2,fruit,1,3,22,Sample,21108rA_80,m_8,beta-alanine,0.017531667115656607,0.9494940949915636,216.95,111.01484958641362 -2,fruit,NA,3,23,Sample,21108rA_81,m_8,beta-alanine,0.03954570629754519,2.1417480929841144,609.95,250.41318703170265 -2,fruit,1,3,24,Sample,21108rA_82,m_8,beta-alanine,0.008198067242756811,0.44399750383064635,150.37,51.91218814787917 -2,fruit,1,3,25,Sample,21108rA_83,m_8,beta-alanine,0.015948513500215894,0.8637523911701924,326.83,100.9899295756189 -2,fruit,NA,3,26,Sample,21108rA_84,m_8,beta-alanine,0.027226211298863618,1.4745389977304164,840.17,172.4030996146403 -2,fruit,1,3,27,Sample,21108rA_85,m_8,beta-alanine,0.013000134527694943,0.7040717170085276,248.13,82.32006515263704 -2,fruit,1,3,28,Sample,21108rA_86,m_8,beta-alanine,0.016736933243216647,0.9064522602365772,413.9,105.98239826686061 -2,fruit,1,3,31,Sample,21108rA_89,m_8,beta-alanine,0.01591920454843938,0.8621650534424905,389.86,100.80433804849599 -2,fruit,1,3,32,Sample,21108rA_90,m_8,beta-alanine,0.019281760211527953,1.0442770411456899,383.84,122.09687165075407 -2,fruit,1,3,33,Sample,21108rA_91,m_8,beta-alanine,0.020195997838715497,1.0937910561396462,566.64,127.88605028384744 -2,fruit,1,3,34,Sample,21108rA_92,m_8,beta-alanine,0.01785478252850661,0.9669936387872505,453.73,113.06089624700533 -2,fruit,1,3,35,Sample,21108rA_93,m_8,beta-alanine,0.006130094228072222,0.33199856196781596,103.88,38.81727186527704 -2,fruit,1,3,36,Sample,21108rA_94,m_8,beta-alanine,0.01839358927978802,0.996174767159601,580.6,116.47275377630055 -2,fruit,1,3,37,Sample,21108rA_95,m_8,beta-alanine,0.043297458566051404,2.3449385027333722,1690.42,274.17020973958586 -2,fruit,1,3,38,Sample,21108rA_96,m_8,beta-alanine,0.022994042640440526,1.2453298116517888,555.98,145.60396157832716 -2,fruit,NA,3,39,Sample,21108rA_97,m_8,beta-alanine,0.021908802982694278,1.1865545314754666,822.26,138.73195582011155 -2,fruit,1,3,40,Sample,21108rA_98,m_8,beta-alanine,0.027395055988771025,1.4836834239267473,1193.06,173.4722659255153 -1,fruit,0.8,1,8,Sample,21106rA_10,m_10,ascorbic_acid,0.020522786035084988,1.057352270572026,414.44,58.757065675687485 -1,fruit,0.6,1,9,Sample,21106rA_11,m_10,ascorbic_acid,0.020440750373579265,1.0531257200046389,30.59,58.522196260657786 -1,fruit,0.6,1,10,Sample,21106rA_12,m_10,ascorbic_acid,0.01909410342008372,0.9837452659326037,22.21,54.66672442787479 -1,fruit,0.6,1,11,Sample,21106rA_13,m_10,ascorbic_acid,0.019450112693830273,1.0020871817571457,145.31,55.68598469024459 -1,fruit,1,1,12,Sample,21106rA_14,m_10,ascorbic_acid,0.020492413964421415,1.0557874743585294,212.35,58.67010995010348 -1,fruit,0.8,1,13,Sample,21106rA_15,m_10,ascorbic_acid,0.020368233109563563,1.049389565779204,74.69,58.31457817035037 -1,fruit,0.8,1,14,Sample,21106rA_16,m_10,ascorbic_acid,0.020719311735463677,1.0674774502219002,179.45,59.31972190883099 -1,fruit,1,1,17,Sample,21106rA_19,m_10,ascorbic_acid,0.021838676464692862,1.1251481210570073,79.94,62.5244810871379 -1,fruit,0.6,1,18,Sample,21106rA_20,m_10,ascorbic_acid,0.019627853863781356,1.0112445656182172,180.94,56.19486051140433 -1,fruit,0.6,1,19,Sample,21106rA_21,m_10,ascorbic_acid,0.019378094659402358,0.998376748286061,105.31,55.47979590225641 -1,fruit,1,1,20,Sample,21106rA_22,m_10,ascorbic_acid,0.019348730749126,0.9968638933963544,206.07,55.39572655603541 -1,fruit,0.8,1,21,Sample,21106rA_23,m_10,ascorbic_acid,0.01965565766118961,1.012677042099231,128.34,56.27446322945427 -1,fruit,1,1,22,Sample,21106rA_24,m_10,ascorbic_acid,0.021346307928727524,1.0997808542263166,106.21,61.114822069356414 -1,fruit,0.8,1,23,Sample,21106rA_25,m_10,ascorbic_acid,0.019451501995654864,1.0021587598282824,162.71,55.68996228365765 -1,fruit,1,1,24,Sample,21106rA_26,m_10,ascorbic_acid,0.018552931465007666,0.9558636033507623,81.96,53.11734043820186 -1,fruit,1,1,25,Sample,21106rA_27,m_10,ascorbic_acid,0.02157953707635014,1.1117970282672467,283.82,61.7825608608109 -1,fruit,0.6,1,26,Sample,21106rA_28,m_10,ascorbic_acid,0.020106886818616235,1.0359247713957163,187.48,57.56633954645995 -1,fruit,0.8,1,27,Sample,21106rA_29,m_10,ascorbic_acid,0.019400180724458874,0.9995146420883736,206.51,55.54302866085092 -1,fruit,1,1,28,Sample,21106rA_30,m_10,ascorbic_acid,0.01885849111675458,0.9716063095806798,158.75,53.99216262339838 -1,fruit,0.8,1,31,Sample,21106rA_33,m_10,ascorbic_acid,0.021540764619962727,1.1097994366767676,120.09,61.67155469612798 -1,fruit,1,1,32,Sample,21106rA_34,m_10,ascorbic_acid,0.021332575173976825,1.099073330433395,180.88,61.075504972183765 -1,fruit,0.8,1,33,Sample,21106rA_35,m_10,ascorbic_acid,0.021254520806909698,1.0950518997121763,151.75,60.85203406700564 -1,fruit,0.8,1,34,Sample,21106rA_36,m_10,ascorbic_acid,0.018538579329164518,0.9551241684906333,68.72,53.076250043024494 -1,fruit,0.8,1,35,Sample,21106rA_37,m_10,ascorbic_acid,0.020539635136007896,1.0582203513037296,394.68,58.805304921948256 -1,fruit,0.6,1,36,Sample,21106rA_38,m_10,ascorbic_acid,0.018967085129648315,0.9772011701374981,87.32,54.30306902454077 -1,fruit,0.4,1,37,Sample,21106rA_39,m_10,ascorbic_acid,0.0214454172032324,1.1048870525881436,181.99,61.39857351232314 -1,fruit,0.4,1,38,Sample,21106rA_40,m_10,ascorbic_acid,0.019658175831777574,1.0128067804975323,370.25,56.28167279224787 -1,fruit,0.8,1,39,Sample,21106rA_41,m_10,ascorbic_acid,0.019074702128566035,0.9827456940614561,249.77,54.611178218995114 -1,fruit,0.6,1,40,Sample,21106rA_42,m_10,ascorbic_acid,0.0191037191180793,0.9842406752835263,188.92,54.69425432550556 -1,fruit,1,1,41,Sample,21106rA_43,m_10,ascorbic_acid,0.01882420163283931,0.9698396847368321,137.2,53.89399128082576 -1,fruit,0.6,1,42,Sample,21106rA_44,m_10,ascorbic_acid,0.01964707891292509,1.0122350573248127,166.38,56.24990213553984 -1,fruit,1,1,45,Sample,21106rA_47,m_10,ascorbic_acid,0.019236535592646948,0.9910834987049366,312.57,55.074510023033326 -1,fruit,0.6,1,46,Sample,21106rA_48,m_10,ascorbic_acid,0.019382185945909534,0.9985875350218643,185.83,55.491509321165 -1,fruit,0.8,1,47,Sample,21106rA_49,m_10,ascorbic_acid,0.01887058903141061,0.9722296049514385,128.81,54.026799147151436 -1,fruit,0.4,1,3,Sample,21106rA_5,m_10,ascorbic_acid,0.018876194928979337,0.9725184258022116,66.37,54.0428489218289 -1,fruit,0.4,1,48,Sample,21106rA_50,m_10,ascorbic_acid,0.019436982623226663,1.0014107087898907,222.4,55.648393087454224 -1,fruit,0.8,1,49,Sample,21106rA_51,m_10,ascorbic_acid,0.02089789270187023,1.07667810114659,153.76,59.831002080716004 -1,fruit,0.6,1,50,Sample,21106rA_52,m_10,ascorbic_acid,0.019810920886404536,1.0206763421668088,349.42,56.718984334209566 -1,fruit,0.4,1,51,Sample,21106rA_53,m_10,ascorbic_acid,0.01850353235430107,0.9533185170364303,276.46,52.97590999171443 -1,fruit,0.8,1,52,Sample,21106rA_54,m_10,ascorbic_acid,0.01992731253760586,1.0266729440152595,108.78,57.05221549892797 -1,fruit,0.4,1,53,Sample,21106rA_55,m_10,ascorbic_acid,0.02173278779399996,1.119692642147195,276.49,62.221320124119636 -1,fruit,0.6,1,54,Sample,21106rA_56,m_10,ascorbic_acid,0.021002185924688395,1.0820513811566013,167.7,60.129595250872335 -1,fruit,1,1,55,Sample,21106rA_57,m_10,ascorbic_acid,0.018261108980358237,0.9408286482418144,32.81,52.28184798279763 -1,fruit,0.6,1,56,Sample,21106rA_58,m_10,ascorbic_acid,0.01845219474278791,0.9506735574287831,181.44,52.82892958631748 -1,fruit,0.4,1,4,Sample,21106rA_6,m_10,ascorbic_acid,0.01949039098508452,1.0041623553052028,200.49,55.80130208431012 -1,fruit,NA,1,59,blank sample,21106rA_61,m_10,ascorbic_acid,0.353758310174162,18.225944170392665,93.46,1012.8157175487204 -1,fruit,0.8,1,5,Sample,21106rA_7,m_10,ascorbic_acid,0.01941902193159102,1.0004853579116266,87.89,55.59697133914909 -1,fruit,1,1,6,Sample,21106rA_8,m_10,ascorbic_acid,0.019468023133159047,1.003009943591667,285.59,55.73726256538894 -1,fruit,1,1,7,Sample,21106rA_9,m_10,ascorbic_acid,0.01917171820107719,0.9877440487866032,175.84,54.888936791071536 -1,fruit,1,2,10,Sample,21108rA_10,m_10,ascorbic_acid,0.02133023038220647,1.0989525246666652,76.73,61.06879179572658 -1,fruit,0.8,2,11,Sample,21108rA_11,m_10,ascorbic_acid,0.016664735764463725,0.8585820740378634,28.78,47.71140585428407 -1,fruit,0.4,2,12,Sample,21108rA_12,m_10,ascorbic_acid,0.01937794438503981,0.9983690060166549,94.94,55.479365664345515 -1,fruit,0.6,2,13,Sample,21108rA_13,m_10,ascorbic_acid,0.0160386812458856,0.826327185954501,14.88,45.919001723491625 -1,fruit,1,2,14,Sample,21108rA_14,m_10,ascorbic_acid,0.016308422389702034,0.8402244906573526,17.55,46.691274945829086 -1,fruit,1,2,17,Sample,21108rA_17,m_10,ascorbic_acid,0.022489354778097367,1.1586716490475082,157.48,64.38738353757003 -1,fruit,0.8,2,18,Sample,21108rA_18,m_10,ascorbic_acid,0.016092319991307235,0.8290907020368323,29.35,46.07257031218677 -1,fruit,0.6,2,19,Sample,21108rA_19,m_10,ascorbic_acid,0.019538428457452628,1.0066372887959152,100.22,55.938834138389005 -1,fruit,0.4,2,20,Sample,21108rA_20,m_10,ascorbic_acid,0.015593839265789495,0.8034085297400733,22.23,44.64541199765587 -1,fruit,0.6,2,21,Sample,21108rA_21,m_10,ascorbic_acid,0.01893996830586643,0.9758040871514231,75.51,54.22543312300458 -1,fruit,0.8,2,22,Sample,21108rA_22,m_10,ascorbic_acid,0.027333943221540383,1.408269173569975,416.39,78.25751797528352 -1,fruit,0.6,2,23,Sample,21108rA_23,m_10,ascorbic_acid,0.035232782221375665,1.8152244152745218,850.91,100.87202075680518 -1,fruit,0.4,2,24,Sample,21108rA_24,m_10,ascorbic_acid,0.016240917689474797,0.8367465881962768,26.15,46.4980079060671 -1,fruit,0.4,2,25,Sample,21108rA_25,m_10,ascorbic_acid,0.01704854022425052,0.8783560226780464,77.15,48.81024418021904 -1,fruit,0.6,2,26,Sample,21108rA_26,m_10,ascorbic_acid,0.024990124025419398,1.2875135147333965,378.57,71.54712601373484 -1,fruit,0.4,2,27,Sample,21108rA_27,m_10,ascorbic_acid,0.01580323266802208,0.81419666488483,49.63,45.24490866765 -1,fruit,0.4,2,28,Sample,21108rA_28,m_10,ascorbic_acid,0.01475639860384855,0.7602628387087078,25.11,42.24780594704289 -1,fruit,0.8,2,3,Sample,21108rA_3,m_10,ascorbic_acid,0.019067719373643936,0.9823859362898207,36.88,54.591186479625335 -1,fruit,0.6,2,31,Sample,21108rA_31,m_10,ascorbic_acid,0.016578592610751328,0.8541439018025574,62.29,47.46477662316811 -1,fruit,1,2,32,Sample,21108rA_32,m_10,ascorbic_acid,0.014315637882160144,0.7375544525734395,7.71,40.98590092950604 -1,fruit,1,2,33,Sample,21108rA_33,m_10,ascorbic_acid,0.019861750396030404,1.0232951239113095,333.19,56.86451003575147 -1,fruit,0.6,2,34,Sample,21108rA_34,m_10,ascorbic_acid,0.015205799517530863,0.7834163752542234,18.93,43.534447972877196 -1,fruit,0.4,2,35,Sample,21108rA_35,m_10,ascorbic_acid,0.016883400649754063,0.8698478842724411,154.76,48.33744692901955 -1,fruit,1,2,36,Sample,21108rA_36,m_10,ascorbic_acid,0.023744619352320313,1.22334400130291,549.66,67.98122615240271 -1,fruit,0.4,2,37,Sample,21108rA_37,m_10,ascorbic_acid,0.014729013268430695,0.7588519217632724,54.84,42.16940129238505 -1,fruit,1,2,38,Sample,21108rA_38,m_10,ascorbic_acid,0.017257590298307028,0.8891264692484594,194.7,49.40875789613689 -1,fruit,1,2,39,Sample,21108rA_39,m_10,ascorbic_acid,0.014791536305695735,0.7620731644981639,21.79,42.348405751162964 -1,fruit,1,2,4,Sample,21108rA_4,m_10,ascorbic_acid,0.01665913685875815,0.858293613414126,15.32,47.69537609742299 -1,fruit,0.8,2,40,Sample,21108rA_40,m_10,ascorbic_acid,0.018456266472807605,0.9508833365968805,250.08,52.84058701468865 -1,fruit,0.4,2,41,Sample,21108rA_41,m_10,ascorbic_acid,0.014066124805247012,0.724699315948203,11.15,40.27154098724164 -1,fruit,0.4,2,42,Sample,21108rA_42,m_10,ascorbic_acid,0.013887892737855415,0.7155166406124529,12.5,39.761259718834005 -1,fruit,0.8,2,45,Sample,21108rA_45,m_10,ascorbic_acid,0.014468982933564559,0.7454549266126979,43.33,41.42493027186762 -1,fruit,0.4,2,46,Sample,21108rA_46,m_10,ascorbic_acid,0.016869889134223368,0.8691517589217784,112.68,48.298763243283226 -1,fruit,0.4,2,47,Sample,21108rA_47,m_10,ascorbic_acid,0.04131332837200913,2.128499585015074,1369.85,118.28072193928766 -1,fruit,0.4,2,48,Sample,21108rA_48,m_10,ascorbic_acid,0.01577952578520082,0.8129752651033194,73.4,45.17703548179146 -1,fruit,0.4,2,49,Sample,21108rA_49,m_10,ascorbic_acid,0.013830483328352256,0.7125588565481163,5.8,39.59689565837883 -1,fruit,0.4,2,5,Sample,21108rA_5,m_10,ascorbic_acid,0.040821563471622954,2.10316341802868,353.5,116.87279113985375 -1,fruit,1,2,50,Sample,21108rA_50,m_10,ascorbic_acid,0.014426117385983171,0.7432464553073396,56.97,41.30220552142886 -1,fruit,0.4,2,51,Sample,21108rA_51,m_10,ascorbic_acid,0.014588642987737837,0.7516199195020935,26.48,41.767518926731334 -1,fruit,0.6,2,52,Sample,21108rA_52,m_10,ascorbic_acid,0.026013743579394552,1.3402513086054004,578.36,74.4777652192021 -1,fruit,1,2,53,Sample,21108rA_53,m_10,ascorbic_acid,0.01595195215629993,0.8218588257795579,13.11,45.67069494857004 -1,fruit,0.6,2,54,Sample,21108rA_54,m_10,ascorbic_acid,0.02182902693357096,1.124650968593192,363.7,62.49685432472368 -1,fruit,0.6,2,55,Sample,21108rA_55,m_10,ascorbic_acid,0.014300291713143091,0.7367638042361707,18.78,40.94196460140401 -1,fruit,0.8,2,56,Sample,21108rA_56,m_10,ascorbic_acid,0.015771165549153133,0.8125445382735201,20.31,45.15309999185951 -1,fruit,0.8,2,6,Sample,21108rA_6,m_10,ascorbic_acid,0.021149040070637365,1.0896174379481405,87.68,60.55004102677817 -1,fruit,0.6,2,7,Sample,21108rA_7,m_10,ascorbic_acid,0.02377501196635911,1.2249098559294507,90.65,68.06824069399957 -1,fruit,0.8,2,8,Sample,21108rA_8,m_10,ascorbic_acid,0.016532761683326645,0.8517826514785485,26.82,47.33356194266294 -1,fruit,0.4,2,9,Sample,21108rA_9,m_10,ascorbic_acid,0.020885077590208804,1.076017855145405,88.02,59.79431221043015 -2,fruit,NA,3,43,blank sample,21108rA_101,m_10,ascorbic_acid,0.13197572822112555,6.834476549597719,52,378.4249665512257 -2,fruit,1,3,3,Sample,21108rA_61,m_10,ascorbic_acid,0.016446018069324442,0.8516711848767525,59.34,47.15703350662579 -2,fruit,1,3,4,Sample,21108rA_62,m_10,ascorbic_acid,0.01801087300108889,0.932708542872967,153.2,51.64407201887618 -2,fruit,1,3,5,Sample,21108rA_63,m_10,ascorbic_acid,0.015117828284459131,0.7828897349811484,29.02,43.34860462590619 -2,fruit,NA,3,6,Sample,21108rA_64,m_10,ascorbic_acid,0.014425323610535203,0.7470277850740419,59.89,41.3629284595497 -2,fruit,1,3,7,Sample,21108rA_65,m_10,ascorbic_acid,0.01327140423848227,0.6872710783316585,69.79,38.05419960722393 -2,fruit,1,3,8,Sample,21108rA_66,m_10,ascorbic_acid,0.013245717428139195,0.6859408647742871,80.52,37.980545682552275 -2,fruit,1,3,9,Sample,21108rA_67,m_10,ascorbic_acid,0.01290939697864689,0.6685242211521047,48.12,37.016186125192036 -2,fruit,1,3,10,Sample,21108rA_68,m_10,ascorbic_acid,0.012547508184626684,0.6497834988266388,24.92,35.97851233003099 -2,fruit,1,3,11,Sample,21108rA_69,m_10,ascorbic_acid,0.02514558698178097,1.3021858403001587,1045.57,72.10202997741979 -2,fruit,1,3,12,Sample,21108rA_70,m_10,ascorbic_acid,0.0116025045686046,0.6008456741217311,23.91,33.26882497612025 -2,fruit,1,3,13,Sample,21108rA_71,m_10,ascorbic_acid,0.011469865408096582,0.5939768411607831,21.87,32.88849769507256 -2,fruit,1,3,14,Sample,21108rA_72,m_10,ascorbic_acid,0.012404503195145309,0.6423778625004777,33.88,35.56846224665145 -2,fruit,1,3,17,Sample,21108rA_75,m_10,ascorbic_acid,0.012719257704794039,0.6586776953869464,55.37,36.470983993575224 -2,fruit,1,3,18,Sample,21108rA_76,m_10,ascorbic_acid,0.011834576657131519,0.61286372674574,80.3,33.93426454991162 -2,fruit,1,3,19,Sample,21108rA_77,m_10,ascorbic_acid,0.011430585984586234,0.5919427224445492,14.09,32.77586854175468 -2,fruit,1,3,20,Sample,21108rA_78,m_10,ascorbic_acid,0.010750828392729193,0.5567408911413421,11.13,30.82674314249611 -2,fruit,1,3,21,Sample,21108rA_79,m_10,ascorbic_acid,0.02123594333472885,1.09972158279448,738.18,60.891584039330354 -2,fruit,1,3,22,Sample,21108rA_80,m_10,ascorbic_acid,0.011993448879538668,0.6210910613705193,33.79,34.389812068085654 -2,fruit,NA,3,23,Sample,21108rA_81,m_10,ascorbic_acid,0.014030711631852542,0.7265924644976839,127.88,40.23142475923675 -2,fruit,1,3,24,Sample,21108rA_82,m_10,ascorbic_acid,0.013537439862952534,0.7010479618640091,35.72,38.81702564841018 -2,fruit,1,3,25,Sample,21108rA_83,m_10,ascorbic_acid,0.013179424564768272,0.6825078318505731,54.46,37.790458649566226 -2,fruit,NA,3,26,Sample,21108rA_84,m_10,ascorbic_acid,0.013726523693539777,0.7108398305922603,89.91,39.35920141989345 -2,fruit,1,3,27,Sample,21108rA_85,m_10,ascorbic_acid,0.01417694034582063,0.7341650441679263,55.47,40.650718495578076 -2,fruit,1,3,28,Sample,21108rA_86,m_10,ascorbic_acid,0.014927619766064824,0.773039623327879,188.48,42.803203943664656 -2,fruit,1,3,31,Sample,21108rA_89,m_10,ascorbic_acid,0.019174011570464326,0.9929426736747289,560.79,54.979235841369736 -2,fruit,1,3,32,Sample,21108rA_90,m_10,ascorbic_acid,0.0176212980409421,0.9125340686319716,126.31,50.52701138015227 -2,fruit,1,3,33,Sample,21108rA_91,m_10,ascorbic_acid,0.016858988889098314,0.8730572338226895,82.44,48.34117903676232 -2,fruit,1,3,34,Sample,21108rA_92,m_10,ascorbic_acid,0.01802660997246605,0.9335234954653004,92.96,51.68919594391368 -2,fruit,1,3,35,Sample,21108rA_93,m_10,ascorbic_acid,0.01648281597508606,0.8535767960629298,127.68,47.26254719800442 -2,fruit,1,3,36,Sample,21108rA_94,m_10,ascorbic_acid,0.01676081410631824,0.867973168292488,9.07,48.05967432835506 -2,fruit,1,3,37,Sample,21108rA_95,m_10,ascorbic_acid,0.01896906342838819,0.98232925793698,260.75,54.39157101197058 -2,fruit,1,3,38,Sample,21108rA_96,m_10,ascorbic_acid,0.019280601265506483,0.998462512670986,37.84,55.28486932659249 -2,fruit,NA,3,39,Sample,21108rA_97,m_10,ascorbic_acid,0.019998067621070224,1.0356171247221495,153.81,57.34212019586541 -2,fruit,1,3,40,Sample,21108rA_98,m_10,ascorbic_acid,0.019787282356649345,1.0247014285854212,98.3,56.73771810077477 -1,fruit,0.8,1,8,Sampl